diff --git a/.gitignore b/.gitignore
index e2c51bd..28a38d1 100755
--- a/.gitignore
+++ b/.gitignore
@@ -86,7 +86,7 @@ results/summaries/*
!results/dms-viz
results/dms-viz/*
-!results/dms-viz/dms-viz.json
+!results/dms-viz/*.json
node_modules/
!homepage/.vitepress/
diff --git a/analysis_notebooks/configure_dms_viz.ipynb b/analysis_notebooks/configure_dms_viz.ipynb
index 3325a5d..2528cb9 100644
--- a/analysis_notebooks/configure_dms_viz.ipynb
+++ b/analysis_notebooks/configure_dms_viz.ipynb
@@ -266,7 +266,7 @@
"assert set(tooltip_cols).issubset(phenotypes.columns)\n",
"\n",
"filter_cols = [\"cell_entry\"]\n",
- "filter_limits = {\"cell_entry\": [phenotypes[\"cell_entry\"].min(), -3, 0]}"
+ "filter_limits = {\"cell_entry\": [float(phenotypes[\"cell_entry\"].min()), -3, 0]}"
]
},
{
@@ -364,7 +364,7 @@
"name": "python",
"nbconvert_exporter": "python",
"pygments_lexer": "ipython3",
- "version": "3.11.9"
+ "version": "3.11.10"
}
},
"nbformat": 4,
diff --git a/analysis_notebooks/configure_dms_viz_mabs.ipynb b/analysis_notebooks/configure_dms_viz_mabs.ipynb
new file mode 100644
index 0000000..b1c44e7
--- /dev/null
+++ b/analysis_notebooks/configure_dms_viz_mabs.ipynb
@@ -0,0 +1,324 @@
+{
+ "cells": [
+ {
+ "cell_type": "markdown",
+ "id": "6f4b8ac5-ff40-4449-a326-d63651e0d828",
+ "metadata": {},
+ "source": [
+ "# Configure structure based analysis for `dms-viz`"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "id": "c371f68d-0e22-4188-8fca-11c78d6554d3",
+ "metadata": {},
+ "source": [
+ "Imports:"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "id": "52955e16-8de2-4385-a985-932a8a6a0beb",
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "import gzip\n",
+ "import os\n",
+ "import requests\n",
+ "import subprocess\n",
+ "import textwrap\n",
+ "import warnings\n",
+ "\n",
+ "import Bio.PDB.PDBParser\n",
+ "import Bio.PDB.Polypeptide\n",
+ "\n",
+ "import matplotlib\n",
+ "\n",
+ "import pandas as pd\n",
+ "\n",
+ "import seaborn"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "id": "27c25a7d-3439-460c-84c0-13599a4fbb80",
+ "metadata": {},
+ "source": [
+ "Define variables. This next cell is tagged `parameters` for `papermill` parameterization:"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "id": "0a26981c-1c55-4ed1-ab17-18ff6ca585b5",
+ "metadata": {
+ "editable": true,
+ "slideshow": {
+ "slide_type": ""
+ },
+ "tags": [
+ "parameters"
+ ]
+ },
+ "outputs": [],
+ "source": [
+ "pdb_id = None\n",
+ "phenotypes_csv = None\n",
+ "per_antibody_escape_csv = None\n",
+ "site_numbering_map = None\n",
+ "dms_viz_json = None\n",
+ "dms_viz_sitemap = None\n",
+ "dms_viz_phenotypes = None\n",
+ "pdb_file = None\n",
+ "dms_viz_subdir = None"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "id": "36204609-74f7-488c-98dd-4da325d99f16",
+ "metadata": {},
+ "source": [
+ "Build the [sitemap](https://dms-viz.github.io/dms-viz-docs/preparing-data/data-requirements/#reference-site) used by `dms-viz`:"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "id": "6d5bfb2d-fed2-4213-86b9-e915f4ff9511",
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "phenotypes = pd.read_csv(phenotypes_csv)\n",
+ "\n",
+ "sitemap = (\n",
+ " pd.read_csv(site_numbering_map)\n",
+ " .sort_values(\"sequential_site\")\n",
+ " .assign(\n",
+ " HA_chain=lambda x: x[\"HA1_HA2_H5_site\"].str.split().str[1].str[1: -1],\n",
+ " first_ha2_site=lambda x: x.query(\"HA_chain == 'HA2'\")[\"mature_H5_site\"].min(),\n",
+ " protein_site=lambda x: x[\"mature_H5_site\"].where(\n",
+ " x[\"HA_chain\"] == \"HA1\",\n",
+ " x[\"mature_H5_site\"] - x[\"first_ha2_site\"] + 1,\n",
+ " ),\n",
+ " chains=lambda x: x[\"HA_chain\"].map({\"HA1\": \"A\", \"HA2\": \"B\"}),\n",
+ " )\n",
+ " .merge(phenotypes[[\"site\", \"wildtype\"]].drop_duplicates().rename(columns={\"site\": \"reference_site\"}))\n",
+ " [[\"sequential_site\", \"reference_site\", \"protein_site\", \"wildtype\", \"HA_chain\", \"chains\"]]\n",
+ ")\n",
+ "\n",
+ "sitemap.to_csv(dms_viz_sitemap, index=False)"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "id": "fe8a3bb1-f557-43b2-9ce9-0418aaa63928",
+ "metadata": {},
+ "source": [
+ "Get the biological assembly (see https://pdb101.rcsb.org/learn/guide-to-understanding-pdb-data/biological-assemblies#Anchor-download) as the crystallographic unit doesn't correspond to that:"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "id": "4c2afd40-067f-462e-88d6-d3128dd57ff2",
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "r = requests.get(f\"https://files.rcsb.org/download/{pdb_id}.pdb1.gz\")\n",
+ "assert r.status_code == 200\n",
+ "pdb_content = gzip.decompress(r.content).decode(\"utf-8\")\n",
+ "with open(pdb_file, \"w\") as f:\n",
+ " f.write(pdb_content)"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "id": "b6bbef2e-e52d-4735-9e8e-d5401ebb9f36",
+ "metadata": {},
+ "source": [
+ "Check the sites mismatched between the sitemap and the protein structure in terms of residue identity:"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "id": "7e1ec117-3166-471d-8485-602ab384b50f",
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "with warnings.catch_warnings():\n",
+ " warnings.simplefilter(\"ignore\")\n",
+ " pdb_obj = Bio.PDB.PDBParser().get_structure(id=pdb_id, file=pdb_file)[0]\n",
+ "\n",
+ "records = []\n",
+ "for chain in [\"A\", \"B\"]:\n",
+ " for res in pdb_obj[chain].get_residues():\n",
+ " if not res.id[0].isspace():\n",
+ " continue\n",
+ " aa = Bio.PDB.Polypeptide.protein_letters_3to1[res.resname]\n",
+ " r = res.id[1]\n",
+ " records.append((chain, r, aa))\n",
+ "pdb_df = pd.DataFrame(records, columns=[\"chains\", \"protein_site\", \"pdb_aa\"])\n",
+ "\n",
+ "mismatched_sites = sitemap.merge(pdb_df, how=\"left\")\n",
+ "\n",
+ "print(\n",
+ " f\"Of {len(sitemap)} sites, {len(mismatched_sites.query('wildtype == pdb_aa'))} match, \"\n",
+ " f\"{len(mismatched_sites.query('pdb_aa.isnull()'))} are missing from PDB, and \"\n",
+ " f\"{len(mismatched_sites.query('pdb_aa.notnull()').query('wildtype != pdb_aa'))} differ.\"\n",
+ ")\n",
+ "\n",
+ "print(\"Sites that differ:\")\n",
+ "display(mismatched_sites.query(\"pdb_aa.notnull() and (wildtype != pdb_aa)\").reset_index(drop=True))"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "id": "9f5dd45f-1627-425d-8cb2-63f5f103dcea",
+ "metadata": {},
+ "source": [
+ "Write the phenotypes after adding the antibodyd escape to a CSV file:"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "id": "562538b8-d250-40a9-ab01-6468bcccafa9",
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "per_antibody_escape = (\n",
+ " pd.read_csv(per_antibody_escape_csv)\n",
+ " .drop(columns=\"antibody_set\")\n",
+ " .merge(\n",
+ " phenotypes[\n",
+ " [\n",
+ " \"site\",\n",
+ " \"mutant\",\n",
+ " \"entry in 293T cells\",\n",
+ " \"sequential_site\",\n",
+ " \"mature_H5_site\",\n",
+ " \"HA1_HA2_H5_site\",\n",
+ " ]\n",
+ " ],\n",
+ " on=[\"site\", \"mutant\"],\n",
+ " validate=\"many_to_one\",\n",
+ " how=\"left\",\n",
+ " )\n",
+ " .rename(columns={\"entry in 293T cells\": \"cell_entry\"})\n",
+ " .assign(\n",
+ " mutation=lambda x: x[\"wildtype\"] + x[\"site\"].astype(str) + x[\"mutant\"],\n",
+ " )\n",
+ ")\n",
+ "\n",
+ "antibodies = list(per_antibody_escape[\"antibody\"].unique())\n",
+ "\n",
+ "print(f\"Read escape for {antibodies=}\")\n",
+ "\n",
+ "print(f\"Writing the phenotypes to {dms_viz_phenotypes}\")\n",
+ "per_antibody_escape.to_csv(dms_viz_phenotypes, index=False, float_format=\"%.4g\")\n",
+ "\n",
+ "print(f\"{per_antibody_escape.columns=}\")"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "id": "e7ff0c20-4fc0-497d-b114-1f50ea042fbb",
+ "metadata": {},
+ "source": [
+ "Get enough colors:"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "id": "ce9e2f01-bb4a-48e9-a99c-3d5d73da0d72",
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "def get_hex_color_palette(num_colors):\n",
+ " colors = seaborn.color_palette(\"hls\", num_colors)\n",
+ " hex_colors = [matplotlib.colors.to_hex(color) for color in colors]\n",
+ " return hex_colors\n",
+ "\n",
+ "nconditions = len(antibodies)\n",
+ "if nconditions > 4:\n",
+ " colors = \",\".join(get_hex_color_palette(nconditions))\n",
+ "else:\n",
+ " colors = \"#0072B2,#CC79A7,#4C3549,#009E73\"\n",
+ "\n",
+ "print(f\"Using {colors=}\")\n",
+ "seaborn.palplot(seaborn.color_palette(colors.split(\",\")))"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "id": "00e1953c-bd3f-40fc-83a5-84233be74526",
+ "metadata": {},
+ "source": [
+ "Run [configure-dms-viz](https://dms-viz.github.io/dms-viz-docs/preparing-data/command-line-api/).\n",
+ "First, set up some options:"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "id": "22448e4d-a621-49cb-aabc-81baaf821f88",
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "tooltip_cols = [\n",
+ " \"mutation\",\n",
+ " \"sequential_site\",\n",
+ " \"mature_H5_site\",\n",
+ " \"cell_entry\",\n",
+ "]\n",
+ "\n",
+ "cmds = [\n",
+ " \"configure-dms-viz\", \"format\",\n",
+ " \"--name\", \"VRC antibodies\",\n",
+ " \"--input\", dms_viz_phenotypes,\n",
+ " \"--output\", dms_viz_json,\n",
+ " \"--structure\", pdb_file,\n",
+ " \"--metric\", \"escape\",\n",
+ " \"--condition\", \"antibody\",\n",
+ " \"--sitemap\", dms_viz_sitemap,\n",
+ " \"--colors\", colors,\n",
+ " \"--alphabet\", \"RKHDEQNSTYWFAILMVGPC\",\n",
+ " \"--summary-stat\", \"sum\",\n",
+ " \"--floor\", \"True\",\n",
+ " \"--tooltip-cols\", str({c: c.replace(\"_\", \" \") for c in tooltip_cols}),\n",
+ " \"--filter-cols\", \"{'cell_entry': 'cell entry'}\",\n",
+ " \"--filter-limits\", f\"{{'cell_entry': [{float(per_antibody_escape['cell_entry'].min())}, -3, 0]}}\",\n",
+ " \"--title\", \"H5 HA escape from VRC antibodies as measured by pseudovirus deep mutational scanning\",\n",
+ " \"--description\", \"H5 HA escape from VRC antibodies as measured by pseudovirus deep mutational scanning\",\n",
+ "]\n",
+ "\n",
+ "print(f\"Running the following commands:\\n{cmds}\")\n",
+ "subprocess.run(cmds, check=True)"
+ ]
+ }
+ ],
+ "metadata": {
+ "kernelspec": {
+ "display_name": "Python 3 (ipykernel)",
+ "language": "python",
+ "name": "python3"
+ },
+ "language_info": {
+ "codemirror_mode": {
+ "name": "ipython",
+ "version": 3
+ },
+ "file_extension": ".py",
+ "mimetype": "text/x-python",
+ "name": "python",
+ "nbconvert_exporter": "python",
+ "pygments_lexer": "ipython3",
+ "version": "3.11.10"
+ }
+ },
+ "nbformat": 4,
+ "nbformat_minor": 5
+}
diff --git a/custom_rules.smk b/custom_rules.smk
index 09d25d3..18745f4 100755
--- a/custom_rules.smk
+++ b/custom_rules.smk
@@ -135,6 +135,42 @@ rule configure_dms_viz:
&> {log}
"""
+
+rule configure_dms_viz_vrc_mabs:
+ """Configure a JSON file for `dms-viz` for the VRC antibodies"""
+ input:
+ phenotypes_csv="results/summaries/phenotypes.csv",
+ per_antibody_escape_csv="results/summaries/VRC_antibody_escape_per_antibody_escape.csv",
+ site_numbering_map=config["site_numbering_map"],
+ nb="analysis_notebooks/configure_dms_viz_mabs.ipynb",
+ output:
+ dms_viz_json="results/dms-viz/dms-viz_vrc_mabs.json",
+ dms_viz_sitemap="results/dms-viz/sitemap_vrc_mabs.csv",
+ dms_viz_phenotypes="results/dms-viz/phenotypes_vrc_mabs.csv",
+ pdb_file="results/dms-viz/pdb_file_vrc_mabs.pdb",
+ nb="results/notebooks/configure_dms_viz_vrc_mabs.ipynb",
+ params:
+ dms_viz_subdir=lambda _, output: os.path.dirname(output.dms_viz_json),
+ pdb_id="4kwm",
+ log:
+ "results/logs/configure_dms_viz_vrc_mabs.txt",
+ conda:
+ "envs/dms-viz.yml"
+ shell:
+ """
+ papermill {input.nb} {output.nb} \
+ -p phenotypes_csv {input.phenotypes_csv} \
+ -p per_antibody_escape_csv {input.per_antibody_escape_csv} \
+ -p site_numbering_map {input.site_numbering_map} \
+ -p dms_viz_json {output.dms_viz_json} \
+ -p dms_viz_sitemap {output.dms_viz_sitemap} \
+ -p dms_viz_phenotypes {output.dms_viz_phenotypes} \
+ -p pdb_file {output.pdb_file} \
+ -p dms_viz_subdir {params.dms_viz_subdir} \
+ -p pdb_id {params.pdb_id} \
+ &> {log}
+ """
+
# Files (Jupyter notebooks, HTML plots, or CSVs) that you want included in
# the HTML docs should be added to the nested dict `docs`:
docs["Additional files"] = {
@@ -150,6 +186,8 @@ docs["Additional files"] = {
"Notebook plotting functional effect distribution":
rules.functional_effect_distribution.output.nb,
},
+ "Visualizations of DMS data on protein structure (dms-viz JSONs)": {
+ "Dadonaite (2024) phenotypes JSON": rules.configure_dms_viz.output.dms_viz_json,
+ "VRC antibodies JSON": rules.configure_dms_viz_vrc_mabs.output.dms_viz_json,
+ },
}
-
-other_target_files.append(rules.configure_dms_viz.output.dms_viz_json)
diff --git a/docs/index.html b/docs/index.html
index 8bf6ab7..671a1c5 100644
--- a/docs/index.html
+++ b/docs/index.html
@@ -732,4 +732,9 @@
Cell entry effect comparison
Functional effect distribution
+Visualizations of DMS data on protein structure (dms-viz JSONs)
+
\ No newline at end of file
diff --git a/envs/dms-viz.yml b/envs/dms-viz.yml
index 537efff..6033045 100755
--- a/envs/dms-viz.yml
+++ b/envs/dms-viz.yml
@@ -7,10 +7,11 @@ channels:
dependencies:
- biopython=1.83
- jupyterlab
- - pandas=2.1 # required because of https://github.com/matsengrp/multidms/issues/128
- - papermill=2.4
+ - pandas=2.2
+ - papermill=2.6
- pip
- pyarrow
- python=3.11
+ - seaborn=0.13
- pip:
- configure-dms-viz==1.6.0
diff --git a/homepage/public/appendix.html b/homepage/public/appendix.html
index 8bf6ab7..671a1c5 100644
--- a/homepage/public/appendix.html
+++ b/homepage/public/appendix.html
@@ -732,4 +732,9 @@ Cell entry effect comparison
Functional effect distribution
+Visualizations of DMS data on protein structure (dms-viz JSONs)
+
\ No newline at end of file
diff --git a/results/dms-viz/a26_usage.json b/results/dms-viz/a26_usage.json
new file mode 100644
index 0000000..be344e9
--- /dev/null
+++ b/results/dms-viz/a26_usage.json
@@ -0,0 +1 @@
+{"a26 usage": {"alphabet": ["R", "K", "H", "D", "E", "Q", "N", "S", "T", "Y", "W", "F", "A", "I", "L", "M", "V", "G", "P", "C"], "condition_col": null, "condition_colors": {"default": "#0072B2"}, "conditions": [], "dataChains": ["A", "B"], "description": "a26_usage", "excludeChains": ["none"], "excludedAminoAcids": null, "filter_cols": {"cell_entry": "cell_entry"}, "filter_limits": {"cell_entry": [-6.058, -3, 0]}, "floor": true, "heatmap_limits": null, "metric_col": "a26_usage", "mut_metric_df": [{"a26_usage": 0.0, "cell_entry": -1.245, "ferret_sera_escape": 0.1399, "mature_H5_site": -11, "mouse_sera_escape": 0.09076, "mutant": "A", "mutation": "L-1A", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.03853, "ferret_sera_escape": 0.03064, "mature_H5_site": -11, "mouse_sera_escape": -0.02769, "mutant": "C", "mutation": "L-1C", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.012, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.869, "ferret_sera_escape": null, "mature_H5_site": -11, "mouse_sera_escape": null, "mutant": "D", "mutation": "L-1D", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.358, "ferret_sera_escape": -0.1733, "mature_H5_site": -11, "mouse_sera_escape": -0.2392, "mutant": "E", "mutation": "L-1E", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.07267, "ferret_sera_escape": 0.06955, "mature_H5_site": -11, "mouse_sera_escape": 0.02876, "mutant": "F", "mutation": "L-1F", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": 0.04901, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3239, "ferret_sera_escape": -0.1388, "mature_H5_site": -11, "mouse_sera_escape": -0.005618, "mutant": "G", "mutation": "L-1G", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.04929, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9294, "ferret_sera_escape": 0.1216, "mature_H5_site": -11, "mouse_sera_escape": 0.051, "mutant": "H", "mutation": "L-1H", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.04745, "ferret_sera_escape": null, "mature_H5_site": -11, "mouse_sera_escape": null, "mutant": "I", "mutation": "L-1I", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1128, "ferret_sera_escape": 0.0343, "mature_H5_site": -11, "mouse_sera_escape": 0.008792, "mutant": "K", "mutation": "L-1K", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.02494, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -11, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L-1L", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.06521, "ferret_sera_escape": null, "mature_H5_site": -11, "mouse_sera_escape": null, "mutant": "M", "mutation": "L-1M", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3614, "ferret_sera_escape": null, "mature_H5_site": -11, "mouse_sera_escape": null, "mutant": "N", "mutation": "L-1N", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4627, "ferret_sera_escape": 0.05371, "mature_H5_site": -11, "mouse_sera_escape": 0.04601, "mutant": "P", "mutation": "L-1P", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.0401, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2653, "ferret_sera_escape": -0.06313, "mature_H5_site": -11, "mouse_sera_escape": -0.1085, "mutant": "Q", "mutation": "L-1Q", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.03568, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4204, "ferret_sera_escape": -0.07986, "mature_H5_site": -11, "mouse_sera_escape": -0.03362, "mutant": "R", "mutation": "L-1R", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.1429, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.324, "ferret_sera_escape": -0.1955, "mature_H5_site": -11, "mouse_sera_escape": 0.02869, "mutant": "S", "mutation": "L-1S", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.02898, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.451, "ferret_sera_escape": -0.141, "mature_H5_site": -11, "mouse_sera_escape": -0.00653, "mutant": "T", "mutation": "L-1T", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.07345, "wildtype": "L"}, {"a26_usage": 0.09625, "cell_entry": -0.3508, "ferret_sera_escape": -0.07118, "mature_H5_site": -11, "mouse_sera_escape": -0.01654, "mutant": "V", "mutation": "L-1V", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": 0.01858, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.00238, "ferret_sera_escape": -0.03238, "mature_H5_site": -11, "mouse_sera_escape": -0.01929, "mutant": "W", "mutation": "L-1W", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.04572, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1909, "ferret_sera_escape": -0.05136, "mature_H5_site": -11, "mouse_sera_escape": -0.03029, "mutant": "Y", "mutation": "L-1Y", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.01871, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4358, "ferret_sera_escape": -0.03984, "mature_H5_site": -12, "mouse_sera_escape": 0.08766, "mutant": "A", "mutation": "V-2A", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.02578, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1783, "ferret_sera_escape": null, "mature_H5_site": -12, "mouse_sera_escape": null, "mutant": "C", "mutation": "V-2C", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.839, "ferret_sera_escape": null, "mature_H5_site": -12, "mouse_sera_escape": null, "mutant": "D", "mutation": "V-2D", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": null, "wildtype": "V"}, {"a26_usage": 0.1909, "cell_entry": -0.01653, "ferret_sera_escape": -0.1249, "mature_H5_site": -12, "mouse_sera_escape": null, "mutant": "F", "mutation": "V-2F", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.05354, "ferret_sera_escape": -0.125, "mature_H5_site": -12, "mouse_sera_escape": -0.09246, "mutant": "G", "mutation": "V-2G", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.08783, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1321, "ferret_sera_escape": -0.07602, "mature_H5_site": -12, "mouse_sera_escape": -0.05556, "mutant": "H", "mutation": "V-2H", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.1425, "wildtype": "V"}, {"a26_usage": 0.05446, "cell_entry": -0.06828, "ferret_sera_escape": 0.00758, "mature_H5_site": -12, "mouse_sera_escape": 0.0334, "mutant": "I", "mutation": "V-2I", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": 0.002624, "wildtype": "V"}, {"a26_usage": 0.7789, "cell_entry": -2.523, "ferret_sera_escape": -0.1365, "mature_H5_site": -12, "mouse_sera_escape": -0.07495, "mutant": "K", "mutation": "V-2K", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": 0.02778, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.06581, "ferret_sera_escape": -0.2266, "mature_H5_site": -12, "mouse_sera_escape": 0.03579, "mutant": "L", "mutation": "V-2L", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.1385, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6403, "ferret_sera_escape": -0.07976, "mature_H5_site": -12, "mouse_sera_escape": 0.1191, "mutant": "M", "mutation": "V-2M", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2955, "ferret_sera_escape": -0.02835, "mature_H5_site": -12, "mouse_sera_escape": 0.09179, "mutant": "N", "mutation": "V-2N", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.143, "wildtype": "V"}, {"a26_usage": 0.6224, "cell_entry": -0.437, "ferret_sera_escape": -0.1216, "mature_H5_site": -12, "mouse_sera_escape": 0.1131, "mutant": "P", "mutation": "V-2P", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.07675, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7976, "ferret_sera_escape": -0.1084, "mature_H5_site": -12, "mouse_sera_escape": -0.03152, "mutant": "Q", "mutation": "V-2Q", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.282, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5964, "ferret_sera_escape": -0.04892, "mature_H5_site": -12, "mouse_sera_escape": -0.01483, "mutant": "R", "mutation": "V-2R", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.1276, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.278, "ferret_sera_escape": 0.04059, "mature_H5_site": -12, "mouse_sera_escape": 0.03146, "mutant": "S", "mutation": "V-2S", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.04184, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.236, "ferret_sera_escape": -0.01706, "mature_H5_site": -12, "mouse_sera_escape": -0.01222, "mutant": "T", "mutation": "V-2T", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.03014, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -12, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V-2V", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.02014, "ferret_sera_escape": 0.1234, "mature_H5_site": -12, "mouse_sera_escape": 0.05897, "mutant": "W", "mutation": "V-2W", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.003526, "wildtype": "V"}, {"a26_usage": 0.01565, "cell_entry": -0.2677, "ferret_sera_escape": -0.1124, "mature_H5_site": -12, "mouse_sera_escape": -0.06881, "mutant": "Y", "mutation": "V-2Y", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.02421, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.009745, "ferret_sera_escape": 0.05715, "mature_H5_site": -13, "mouse_sera_escape": -0.1669, "mutant": "A", "mutation": "I-3A", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.676, "ferret_sera_escape": null, "mature_H5_site": -13, "mouse_sera_escape": null, "mutant": "D", "mutation": "I-3D", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.694, "ferret_sera_escape": -0.1485, "mature_H5_site": -13, "mouse_sera_escape": -0.148, "mutant": "E", "mutation": "I-3E", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.2952, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2824, "ferret_sera_escape": 0.02052, "mature_H5_site": -13, "mouse_sera_escape": -0.0436, "mutant": "F", "mutation": "I-3F", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.0492, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.212, "ferret_sera_escape": -0.06512, "mature_H5_site": -13, "mouse_sera_escape": -0.1015, "mutant": "H", "mutation": "I-3H", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -13, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I-3I", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5239, "ferret_sera_escape": -0.3044, "mature_H5_site": -13, "mouse_sera_escape": -0.04926, "mutant": "K", "mutation": "I-3K", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.1119, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06609, "ferret_sera_escape": 0.02034, "mature_H5_site": -13, "mouse_sera_escape": 0.05017, "mutant": "L", "mutation": "I-3L", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": 0.03895, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.347, "ferret_sera_escape": -0.1789, "mature_H5_site": -13, "mouse_sera_escape": -0.05747, "mutant": "M", "mutation": "I-3M", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.07697, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4002, "ferret_sera_escape": -0.1069, "mature_H5_site": -13, "mouse_sera_escape": -0.1478, "mutant": "N", "mutation": "I-3N", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.08407, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.08928, "ferret_sera_escape": -0.06848, "mature_H5_site": -13, "mouse_sera_escape": -0.1155, "mutant": "P", "mutation": "I-3P", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": 0.00754, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.24, "ferret_sera_escape": -0.05439, "mature_H5_site": -13, "mouse_sera_escape": -0.0607, "mutant": "Q", "mutation": "I-3Q", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.08256, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3754, "ferret_sera_escape": -0.03504, "mature_H5_site": -13, "mouse_sera_escape": 0.01704, "mutant": "R", "mutation": "I-3R", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.04163, "wildtype": "I"}, {"a26_usage": 0.168, "cell_entry": 0.04928, "ferret_sera_escape": 0.06774, "mature_H5_site": -13, "mouse_sera_escape": 0.09582, "mutant": "S", "mutation": "I-3S", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.02985, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.228, "ferret_sera_escape": -0.07193, "mature_H5_site": -13, "mouse_sera_escape": 0.02597, "mutant": "T", "mutation": "I-3T", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.02561, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.216, "ferret_sera_escape": -0.06122, "mature_H5_site": -13, "mouse_sera_escape": -0.0356, "mutant": "V", "mutation": "I-3V", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.005692, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.05539, "ferret_sera_escape": 0.0584, "mature_H5_site": -13, "mouse_sera_escape": 0.01083, "mutant": "W", "mutation": "I-3W", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.01946, "wildtype": "I"}, {"a26_usage": 0.05035, "cell_entry": 0.06426, "ferret_sera_escape": 0.0126, "mature_H5_site": -13, "mouse_sera_escape": 0.05702, "mutant": "Y", "mutation": "I-3Y", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": 0.005714, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.05586, "ferret_sera_escape": -0.05033, "mature_H5_site": -14, "mouse_sera_escape": -0.1021, "mutant": "A", "mutation": "N-4A", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.02321, "wildtype": "N"}, {"a26_usage": 0.135, "cell_entry": 0.003655, "ferret_sera_escape": 0.02935, "mature_H5_site": -14, "mouse_sera_escape": -0.001244, "mutant": "C", "mutation": "N-4C", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.02054, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.08413, "ferret_sera_escape": -0.002813, "mature_H5_site": -14, "mouse_sera_escape": -0.163, "mutant": "D", "mutation": "N-4D", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.06871, "wildtype": "N"}, {"a26_usage": 0.0387, "cell_entry": 0.04051, "ferret_sera_escape": -0.2673, "mature_H5_site": -14, "mouse_sera_escape": -0.153, "mutant": "E", "mutation": "N-4E", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.0278, "wildtype": "N"}, {"a26_usage": 0.00718, "cell_entry": 0.06012, "ferret_sera_escape": 0.07864, "mature_H5_site": -14, "mouse_sera_escape": -0.02172, "mutant": "F", "mutation": "N-4F", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.03079, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.586, "ferret_sera_escape": 0.02851, "mature_H5_site": -14, "mouse_sera_escape": -0.04352, "mutant": "G", "mutation": "N-4G", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.0803, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.05198, "ferret_sera_escape": 0.006373, "mature_H5_site": -14, "mouse_sera_escape": 0.03972, "mutant": "H", "mutation": "N-4H", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.02858, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.01491, "ferret_sera_escape": -0.06101, "mature_H5_site": -14, "mouse_sera_escape": -0.02869, "mutant": "I", "mutation": "N-4I", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.01225, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1131, "ferret_sera_escape": 0.02878, "mature_H5_site": -14, "mouse_sera_escape": 0.07167, "mutant": "K", "mutation": "N-4K", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.00644, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02193, "ferret_sera_escape": -0.01945, "mature_H5_site": -14, "mouse_sera_escape": -0.01634, "mutant": "L", "mutation": "N-4L", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.02384, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4973, "ferret_sera_escape": -0.08876, "mature_H5_site": -14, "mouse_sera_escape": 0.01546, "mutant": "M", "mutation": "N-4M", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.0004297, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -14, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N-4N", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2194, "ferret_sera_escape": null, "mature_H5_site": -14, "mouse_sera_escape": null, "mutant": "P", "mutation": "N-4P", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.05024, "ferret_sera_escape": 0.1632, "mature_H5_site": -14, "mouse_sera_escape": 0.08081, "mutant": "Q", "mutation": "N-4Q", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.01272, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2761, "ferret_sera_escape": 0.05278, "mature_H5_site": -14, "mouse_sera_escape": 0.05871, "mutant": "R", "mutation": "N-4R", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.01737, "wildtype": "N"}, {"a26_usage": 0.2356, "cell_entry": -0.01706, "ferret_sera_escape": null, "mature_H5_site": -14, "mouse_sera_escape": null, "mutant": "S", "mutation": "N-4S", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.25, "ferret_sera_escape": -0.02431, "mature_H5_site": -14, "mouse_sera_escape": 0.07851, "mutant": "T", "mutation": "N-4T", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.103, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07004, "ferret_sera_escape": 0.07758, "mature_H5_site": -14, "mouse_sera_escape": 0.002088, "mutant": "V", "mutation": "N-4V", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.04333, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.0767, "ferret_sera_escape": -0.1399, "mature_H5_site": -14, "mouse_sera_escape": -0.1141, "mutant": "W", "mutation": "N-4W", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.03292, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1686, "ferret_sera_escape": -0.1309, "mature_H5_site": -14, "mouse_sera_escape": -0.08805, "mutant": "Y", "mutation": "N-4Y", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.01852, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2561, "ferret_sera_escape": -0.008391, "mature_H5_site": -15, "mouse_sera_escape": -0.08185, "mutant": "A", "mutation": "E-5A", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.02286, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06022, "ferret_sera_escape": 0.01947, "mature_H5_site": -15, "mouse_sera_escape": 0.04017, "mutant": "C", "mutation": "E-5C", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.09208, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -15, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E-5E", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.09452, "ferret_sera_escape": 0.02128, "mature_H5_site": -15, "mouse_sera_escape": 0.03576, "mutant": "F", "mutation": "E-5F", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": 0.02081, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1468, "ferret_sera_escape": -0.04239, "mature_H5_site": -15, "mouse_sera_escape": -0.0351, "mutant": "G", "mutation": "E-5G", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.04565, "wildtype": "E"}, {"a26_usage": 0.02133, "cell_entry": 0.01327, "ferret_sera_escape": 0.08542, "mature_H5_site": -15, "mouse_sera_escape": -0.04393, "mutant": "H", "mutation": "E-5H", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.07941, "wildtype": "E"}, {"a26_usage": 0.1075, "cell_entry": 0.0358, "ferret_sera_escape": -0.04365, "mature_H5_site": -15, "mouse_sera_escape": -0.1141, "mutant": "I", "mutation": "E-5I", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.05551, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07079, "ferret_sera_escape": 0.0177, "mature_H5_site": -15, "mouse_sera_escape": -0.02258, "mutant": "K", "mutation": "E-5K", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": 0.05094, "wildtype": "E"}, {"a26_usage": 0.2101, "cell_entry": -0.07343, "ferret_sera_escape": -0.001367, "mature_H5_site": -15, "mouse_sera_escape": -0.02937, "mutant": "L", "mutation": "E-5L", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": 0.01415, "wildtype": "E"}, {"a26_usage": 0.279, "cell_entry": -0.166, "ferret_sera_escape": 0.1469, "mature_H5_site": -15, "mouse_sera_escape": -0.0462, "mutant": "M", "mutation": "E-5M", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.0842, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1724, "ferret_sera_escape": 0.07249, "mature_H5_site": -15, "mouse_sera_escape": -0.02767, "mutant": "N", "mutation": "E-5N", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.008196, "wildtype": "E"}, {"a26_usage": 0.05953, "cell_entry": -0.02672, "ferret_sera_escape": 0.0773, "mature_H5_site": -15, "mouse_sera_escape": 0.001269, "mutant": "P", "mutation": "E-5P", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.03283, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02099, "ferret_sera_escape": 0.1871, "mature_H5_site": -15, "mouse_sera_escape": -0.01596, "mutant": "Q", "mutation": "E-5Q", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": 0.01893, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02275, "ferret_sera_escape": 0.01843, "mature_H5_site": -15, "mouse_sera_escape": -0.04472, "mutant": "R", "mutation": "E-5R", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.005445, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.05347, "ferret_sera_escape": 0.007843, "mature_H5_site": -15, "mouse_sera_escape": -0.05206, "mutant": "S", "mutation": "E-5S", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.02974, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.05712, "ferret_sera_escape": -0.04577, "mature_H5_site": -15, "mouse_sera_escape": 0.0802, "mutant": "T", "mutation": "E-5T", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.003879, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.000975, "ferret_sera_escape": -0.1021, "mature_H5_site": -15, "mouse_sera_escape": -0.1608, "mutant": "V", "mutation": "E-5V", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": 0.02445, "wildtype": "E"}, {"a26_usage": 0.1004, "cell_entry": -0.03492, "ferret_sera_escape": 0.01437, "mature_H5_site": -15, "mouse_sera_escape": -0.0247, "mutant": "W", "mutation": "E-5W", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.03784, "wildtype": "E"}, {"a26_usage": 0.1807, "cell_entry": -0.3705, "ferret_sera_escape": 0.02313, "mature_H5_site": -15, "mouse_sera_escape": 0.09003, "mutant": "Y", "mutation": "E-5Y", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.02677, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "A", "mutation": "M-6A", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "C", "mutation": "M-6C", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "D", "mutation": "M-6D", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.993, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "E", "mutation": "M-6E", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "F", "mutation": "M-6F", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "G", "mutation": "M-6G", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "H", "mutation": "M-6H", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.724, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "I", "mutation": "M-6I", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "L", "mutation": "M-6L", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -16, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M-6M", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "N", "mutation": "M-6N", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "P", "mutation": "M-6P", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.705, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "Q", "mutation": "M-6Q", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "R", "mutation": "M-6R", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "S", "mutation": "M-6S", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "T", "mutation": "M-6T", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.874, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "V", "mutation": "M-6V", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "W", "mutation": "M-6W", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "Y", "mutation": "M-6Y", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.3791, "cell_entry": -0.2586, "ferret_sera_escape": -0.06088, "mature_H5_site": -10, "mouse_sera_escape": 0.06847, "mutant": "C", "mutation": "L1C", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.01734, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": -10, "mouse_sera_escape": null, "mutant": "D", "mutation": "L1D", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.003785, "ferret_sera_escape": 0.007419, "mature_H5_site": -10, "mouse_sera_escape": 0.02466, "mutant": "G", "mutation": "L1G", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.005143, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.514, "ferret_sera_escape": -0.3188, "mature_H5_site": -10, "mouse_sera_escape": -0.04519, "mutant": "H", "mutation": "L1H", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.1634, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.001975, "ferret_sera_escape": 0.01725, "mature_H5_site": -10, "mouse_sera_escape": -0.000932, "mutant": "I", "mutation": "L1I", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.04037, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.888, "ferret_sera_escape": null, "mature_H5_site": -10, "mouse_sera_escape": null, "mutant": "K", "mutation": "L1K", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -10, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L1L", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.755, "ferret_sera_escape": -0.09714, "mature_H5_site": -10, "mouse_sera_escape": 0.02096, "mutant": "M", "mutation": "L1M", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": 0.007317, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.2, "ferret_sera_escape": null, "mature_H5_site": -10, "mouse_sera_escape": null, "mutant": "N", "mutation": "L1N", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.662, "ferret_sera_escape": null, "mature_H5_site": -10, "mouse_sera_escape": null, "mutant": "P", "mutation": "L1P", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.482, "ferret_sera_escape": null, "mature_H5_site": -10, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L1Q", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.918, "ferret_sera_escape": null, "mature_H5_site": -10, "mouse_sera_escape": null, "mutant": "R", "mutation": "L1R", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5069, "ferret_sera_escape": -0.09302, "mature_H5_site": -10, "mouse_sera_escape": -0.2003, "mutant": "S", "mutation": "L1S", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.1385, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3497, "ferret_sera_escape": -0.2964, "mature_H5_site": -10, "mouse_sera_escape": -0.2589, "mutant": "T", "mutation": "L1T", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.07914, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06815, "ferret_sera_escape": -0.2355, "mature_H5_site": -10, "mouse_sera_escape": -0.06764, "mutant": "V", "mutation": "L1V", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.0294, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06074, "ferret_sera_escape": -0.04438, "mature_H5_site": -10, "mouse_sera_escape": -0.07503, "mutant": "W", "mutation": "L1W", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.02312, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.239, "ferret_sera_escape": -0.02684, "mature_H5_site": -10, "mouse_sera_escape": -0.03437, "mutant": "Y", "mutation": "L1Y", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.02537, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.179, "ferret_sera_escape": -0.06115, "mature_H5_site": -1, "mouse_sera_escape": 0.07643, "mutant": "A", "mutation": "S10A", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": -0.05873, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.01148, "ferret_sera_escape": -0.003939, "mature_H5_site": -1, "mouse_sera_escape": 0.006246, "mutant": "C", "mutation": "S10C", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": 0.01653, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "D", "mutation": "S10D", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -6.024, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "E", "mutation": "S10E", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "F", "mutation": "S10F", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2729, "ferret_sera_escape": -0.03462, "mature_H5_site": -1, "mouse_sera_escape": -0.1214, "mutant": "G", "mutation": "S10G", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": -0.06492, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.857, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "H", "mutation": "S10H", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "I", "mutation": "S10I", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.375, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "K", "mutation": "S10K", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.461, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "L", "mutation": "S10L", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.337, "ferret_sera_escape": 0.1397, "mature_H5_site": -1, "mouse_sera_escape": 0.2008, "mutant": "N", "mutation": "S10N", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": -0.1902, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.418, "ferret_sera_escape": -0.02479, "mature_H5_site": -1, "mouse_sera_escape": -0.02458, "mutant": "P", "mutation": "S10P", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": -0.06731, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "Q", "mutation": "S10Q", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2168, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "R", "mutation": "S10R", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -1, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S10S", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6802, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "T", "mutation": "S10T", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "V", "mutation": "S10V", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "W", "mutation": "S10W", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S10Y", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3704, "ferret_sera_escape": 0.2911, "mature_H5_site": 93, "mouse_sera_escape": 0.3482, "mutant": "A", "mutation": "G100A", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": -0.01652, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.194, "ferret_sera_escape": -0.1604, "mature_H5_site": 93, "mouse_sera_escape": 0.1337, "mutant": "C", "mutation": "G100C", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "D", "mutation": "G100D", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "E", "mutation": "G100E", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.111, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "F", "mutation": "G100F", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 93, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G100G", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "I", "mutation": "G100I", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "K", "mutation": "G100K", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.537, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "L", "mutation": "G100L", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.237, "ferret_sera_escape": -1.199, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "M", "mutation": "G100M", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": 0.8172, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "P", "mutation": "G100P", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G100Q", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "R", "mutation": "G100R", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.103, "ferret_sera_escape": 0.7064, "mature_H5_site": 93, "mouse_sera_escape": 0.3669, "mutant": "S", "mutation": "G100S", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": 0.04607, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.6131, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "T", "mutation": "G100T", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.035, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "V", "mutation": "G100V", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.007, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "W", "mutation": "G100W", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.85, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G100Y", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.0956, "ferret_sera_escape": 0.08852, "mature_H5_site": 94, "mouse_sera_escape": 0.09252, "mutant": "C", "mutation": "S101C", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.1393, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.02678, "ferret_sera_escape": -0.225, "mature_H5_site": 94, "mouse_sera_escape": -0.1292, "mutant": "D", "mutation": "S101D", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.5958, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.02001, "ferret_sera_escape": -0.09533, "mature_H5_site": 94, "mouse_sera_escape": 0.01473, "mutant": "F", "mutation": "S101F", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.08201, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.088, "ferret_sera_escape": 0.001853, "mature_H5_site": 94, "mouse_sera_escape": 0.0969, "mutant": "G", "mutation": "S101G", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.1145, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.02848, "ferret_sera_escape": 0.004616, "mature_H5_site": 94, "mouse_sera_escape": 0.0515, "mutant": "H", "mutation": "S101H", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.1056, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.02118, "ferret_sera_escape": null, "mature_H5_site": 94, "mouse_sera_escape": null, "mutant": "I", "mutation": "S101I", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.04996, "ferret_sera_escape": null, "mature_H5_site": 94, "mouse_sera_escape": null, "mutant": "K", "mutation": "S101K", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2838, "ferret_sera_escape": -0.02421, "mature_H5_site": 94, "mouse_sera_escape": -0.003721, "mutant": "L", "mutation": "S101L", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.1632, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0626, "ferret_sera_escape": -0.004853, "mature_H5_site": 94, "mouse_sera_escape": -0.03908, "mutant": "M", "mutation": "S101M", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.1243, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.05616, "ferret_sera_escape": 0.1308, "mature_H5_site": 94, "mouse_sera_escape": -0.01041, "mutant": "N", "mutation": "S101N", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.1351, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8402, "ferret_sera_escape": null, "mature_H5_site": 94, "mouse_sera_escape": null, "mutant": "P", "mutation": "S101P", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06219, "ferret_sera_escape": 0.01409, "mature_H5_site": 94, "mouse_sera_escape": 0.05295, "mutant": "Q", "mutation": "S101Q", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.2181, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06874, "ferret_sera_escape": -0.001903, "mature_H5_site": 94, "mouse_sera_escape": -0.06873, "mutant": "R", "mutation": "S101R", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.2126, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 94, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S101S", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.2333, "cell_entry": -0.7448, "ferret_sera_escape": 0.02583, "mature_H5_site": 94, "mouse_sera_escape": 0.03765, "mutant": "T", "mutation": "S101T", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.05061, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1032, "ferret_sera_escape": null, "mature_H5_site": 94, "mouse_sera_escape": null, "mutant": "V", "mutation": "S101V", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.122, "ferret_sera_escape": 0.03847, "mature_H5_site": 94, "mouse_sera_escape": -0.001845, "mutant": "Y", "mutation": "S101Y", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3681, "ferret_sera_escape": -0.1296, "mature_H5_site": 95, "mouse_sera_escape": 0.1277, "mutant": "C", "mutation": "L102C", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": 1.104, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.904, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "D", "mutation": "L102D", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.018, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "E", "mutation": "L102E", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4405, "ferret_sera_escape": 0.009433, "mature_H5_site": 95, "mouse_sera_escape": -0.05607, "mutant": "F", "mutation": "L102F", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": 0.04832, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.73, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "H", "mutation": "L102H", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9331, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "I", "mutation": "L102I", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "K", "mutation": "L102K", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 95, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L102L", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.04134, "ferret_sera_escape": -0.1501, "mature_H5_site": 95, "mouse_sera_escape": 0.1145, "mutant": "M", "mutation": "L102M", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": 1.198, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.542, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "P", "mutation": "L102P", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.78, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L102Q", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "R", "mutation": "L102R", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.505, "ferret_sera_escape": -0.2277, "mature_H5_site": 95, "mouse_sera_escape": 0.1359, "mutant": "V", "mutation": "L102V", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5562, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "W", "mutation": "L102W", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4255, "ferret_sera_escape": -0.3436, "mature_H5_site": 95, "mouse_sera_escape": -0.1758, "mutant": "Y", "mutation": "L102Y", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": -0.2239, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3189, "ferret_sera_escape": -0.05702, "mature_H5_site": 96, "mouse_sera_escape": 0.0539, "mutant": "A", "mutation": "N103A", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": 0.6112, "wildtype": "N"}, {"a26_usage": 0.06635, "cell_entry": -0.084, "ferret_sera_escape": -0.07074, "mature_H5_site": 96, "mouse_sera_escape": -0.04494, "mutant": "D", "mutation": "N103D", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": 1.244, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02871, "ferret_sera_escape": 0.02547, "mature_H5_site": 96, "mouse_sera_escape": -0.003999, "mutant": "E", "mutation": "N103E", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": 0.3767, "wildtype": "N"}, {"a26_usage": 1.673, "cell_entry": -1.386, "ferret_sera_escape": -0.08738, "mature_H5_site": 96, "mouse_sera_escape": null, "mutant": "F", "mutation": "N103F", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7171, "ferret_sera_escape": -0.0101, "mature_H5_site": 96, "mouse_sera_escape": -0.07403, "mutant": "H", "mutation": "N103H", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": 0.0574, "wildtype": "N"}, {"a26_usage": 0.3988, "cell_entry": -0.4207, "ferret_sera_escape": 0.05185, "mature_H5_site": 96, "mouse_sera_escape": null, "mutant": "I", "mutation": "N103I", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.1474, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9121, "ferret_sera_escape": 0.07765, "mature_H5_site": 96, "mouse_sera_escape": 0.1095, "mutant": "K", "mutation": "N103K", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": 0.4187, "wildtype": "N"}, {"a26_usage": 0.4435, "cell_entry": -1.204, "ferret_sera_escape": -0.05798, "mature_H5_site": 96, "mouse_sera_escape": 0.0602, "mutant": "L", "mutation": "N103L", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": null, "wildtype": "N"}, {"a26_usage": 0.3476, "cell_entry": -0.1763, "ferret_sera_escape": 0.05633, "mature_H5_site": 96, "mouse_sera_escape": -0.1453, "mutant": "M", "mutation": "N103M", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.2793, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 96, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N103N", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02512, "ferret_sera_escape": -0.1215, "mature_H5_site": 96, "mouse_sera_escape": -0.1573, "mutant": "P", "mutation": "N103P", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.9346, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9675, "ferret_sera_escape": 0.09591, "mature_H5_site": 96, "mouse_sera_escape": 0.03998, "mutant": "Q", "mutation": "N103Q", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": 0.05876, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.003446, "ferret_sera_escape": 0.1779, "mature_H5_site": 96, "mouse_sera_escape": 0.1499, "mutant": "R", "mutation": "N103R", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.03089, "wildtype": "N"}, {"a26_usage": 0.3475, "cell_entry": -0.2763, "ferret_sera_escape": null, "mature_H5_site": 96, "mouse_sera_escape": null, "mutant": "S", "mutation": "N103S", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3932, "ferret_sera_escape": 0.2001, "mature_H5_site": 96, "mouse_sera_escape": 0.1697, "mutant": "T", "mutation": "N103T", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.03126, "wildtype": "N"}, {"a26_usage": 0.4491, "cell_entry": 0.02977, "ferret_sera_escape": 0.1418, "mature_H5_site": 96, "mouse_sera_escape": 0.0667, "mutant": "V", "mutation": "N103V", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.09997, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.01744, "ferret_sera_escape": -0.004827, "mature_H5_site": 96, "mouse_sera_escape": -0.05848, "mutant": "W", "mutation": "N103W", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.1065, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2094, "ferret_sera_escape": 0.01557, "mature_H5_site": 96, "mouse_sera_escape": -0.08108, "mutant": "Y", "mutation": "N103Y", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.07279, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02471, "ferret_sera_escape": -0.07998, "mature_H5_site": 97, "mouse_sera_escape": -0.01826, "mutant": "A", "mutation": "D104A", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2377, "ferret_sera_escape": 0.09037, "mature_H5_site": 97, "mouse_sera_escape": 0.1668, "mutant": "C", "mutation": "D104C", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 0.2299, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 97, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D104D", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.01429, "ferret_sera_escape": 0.1727, "mature_H5_site": 97, "mouse_sera_escape": 0.2197, "mutant": "E", "mutation": "D104E", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 0.255, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.251, "ferret_sera_escape": 0.1318, "mature_H5_site": 97, "mouse_sera_escape": 0.09558, "mutant": "F", "mutation": "D104F", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 0.1838, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2573, "ferret_sera_escape": -0.07073, "mature_H5_site": 97, "mouse_sera_escape": -0.069, "mutant": "G", "mutation": "D104G", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": -0.4201, "wildtype": "D"}, {"a26_usage": 0.3481, "cell_entry": -0.7358, "ferret_sera_escape": -0.001116, "mature_H5_site": 97, "mouse_sera_escape": -0.1315, "mutant": "H", "mutation": "D104H", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": -0.05201, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7713, "ferret_sera_escape": 0.03996, "mature_H5_site": 97, "mouse_sera_escape": 0.135, "mutant": "I", "mutation": "D104I", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 1.357, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6242, "ferret_sera_escape": 0.2878, "mature_H5_site": 97, "mouse_sera_escape": 0.1228, "mutant": "L", "mutation": "D104L", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4873, "ferret_sera_escape": 0.3085, "mature_H5_site": 97, "mouse_sera_escape": 0.1706, "mutant": "N", "mutation": "D104N", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 0.2268, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.051, "ferret_sera_escape": -0.7131, "mature_H5_site": 97, "mouse_sera_escape": -0.2221, "mutant": "P", "mutation": "D104P", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": -0.07339, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.07743, "ferret_sera_escape": 0.1311, "mature_H5_site": 97, "mouse_sera_escape": 0.2509, "mutant": "Q", "mutation": "D104Q", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 0.5107, "wildtype": "D"}, {"a26_usage": 0.02376, "cell_entry": -1.084, "ferret_sera_escape": 0.01413, "mature_H5_site": 97, "mouse_sera_escape": null, "mutant": "S", "mutation": "D104S", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.04689, "ferret_sera_escape": null, "mature_H5_site": 97, "mouse_sera_escape": null, "mutant": "T", "mutation": "D104T", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5111, "ferret_sera_escape": 0.0017, "mature_H5_site": 97, "mouse_sera_escape": -0.04573, "mutant": "V", "mutation": "D104V", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 1.073, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2975, "ferret_sera_escape": -0.268, "mature_H5_site": 97, "mouse_sera_escape": 0.00378, "mutant": "W", "mutation": "D104W", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": -0.2584, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.177, "ferret_sera_escape": 0.02099, "mature_H5_site": 97, "mouse_sera_escape": 0.1576, "mutant": "Y", "mutation": "D104Y", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 0.08196, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7893, "ferret_sera_escape": -0.07844, "mature_H5_site": 98, "mouse_sera_escape": 0.07267, "mutant": "A", "mutation": "Y105A", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4215, "ferret_sera_escape": null, "mature_H5_site": 98, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y105C", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.602, "ferret_sera_escape": null, "mature_H5_site": 98, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y105D", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3245, "ferret_sera_escape": -0.4073, "mature_H5_site": 98, "mouse_sera_escape": -0.1551, "mutant": "E", "mutation": "Y105E", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": 0.4716, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.05183, "ferret_sera_escape": 0.02107, "mature_H5_site": 98, "mouse_sera_escape": 0.02409, "mutant": "H", "mutation": "Y105H", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": -0.03956, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.09787, "ferret_sera_escape": -0.2429, "mature_H5_site": 98, "mouse_sera_escape": -0.1218, "mutant": "I", "mutation": "Y105I", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": -0.2086, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.5174, "ferret_sera_escape": 0.05186, "mature_H5_site": 98, "mouse_sera_escape": 0.07989, "mutant": "K", "mutation": "Y105K", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": 0.007635, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1983, "ferret_sera_escape": -0.1691, "mature_H5_site": 98, "mouse_sera_escape": -0.2671, "mutant": "L", "mutation": "Y105L", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": -0.1696, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.03292, "ferret_sera_escape": -0.2917, "mature_H5_site": 98, "mouse_sera_escape": -0.2249, "mutant": "M", "mutation": "Y105M", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.06217, "ferret_sera_escape": -0.05077, "mature_H5_site": 98, "mouse_sera_escape": -0.01194, "mutant": "N", "mutation": "Y105N", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": 0.1156, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.07, "ferret_sera_escape": null, "mature_H5_site": 98, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y105P", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6564, "ferret_sera_escape": -0.05188, "mature_H5_site": 98, "mouse_sera_escape": -0.05163, "mutant": "Q", "mutation": "Y105Q", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": -0.1784, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4109, "ferret_sera_escape": 0.1226, "mature_H5_site": 98, "mouse_sera_escape": 0.1273, "mutant": "R", "mutation": "Y105R", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": -0.007835, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 98, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y105T", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.1998, "cell_entry": -0.07614, "ferret_sera_escape": -0.09536, "mature_H5_site": 98, "mouse_sera_escape": -0.04518, "mutant": "V", "mutation": "Y105V", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": 0.03976, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.01433, "ferret_sera_escape": -0.6618, "mature_H5_site": 98, "mouse_sera_escape": -0.4701, "mutant": "W", "mutation": "Y105W", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": -0.2074, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 98, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y105Y", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.236, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "A", "mutation": "E106A", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6726, "ferret_sera_escape": -0.1947, "mature_H5_site": 99, "mouse_sera_escape": -0.06487, "mutant": "D", "mutation": "E106D", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": 2.314, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 99, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E106E", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7146, "ferret_sera_escape": 0.05522, "mature_H5_site": 99, "mouse_sera_escape": 0.2465, "mutant": "F", "mutation": "E106F", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": -0.2561, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3959, "ferret_sera_escape": -0.08366, "mature_H5_site": 99, "mouse_sera_escape": 0.009521, "mutant": "G", "mutation": "E106G", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": -0.312, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3512, "ferret_sera_escape": -0.05625, "mature_H5_site": 99, "mouse_sera_escape": 0.0029, "mutant": "H", "mutation": "E106H", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": -0.3134, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "I", "mutation": "E106I", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.096, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "K", "mutation": "E106K", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5907, "ferret_sera_escape": 0.086, "mature_H5_site": 99, "mouse_sera_escape": 0.4239, "mutant": "L", "mutation": "E106L", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": 0.536, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.09538, "ferret_sera_escape": 0.04506, "mature_H5_site": 99, "mouse_sera_escape": 0.06197, "mutant": "M", "mutation": "E106M", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": -0.1329, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.649, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "N", "mutation": "E106N", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.798, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "P", "mutation": "E106P", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1303, "ferret_sera_escape": -0.05695, "mature_H5_site": 99, "mouse_sera_escape": 0.106, "mutant": "Q", "mutation": "E106Q", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": -0.2405, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "R", "mutation": "E106R", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.585, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "V", "mutation": "E106V", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.778, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "W", "mutation": "E106W", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.537, "ferret_sera_escape": 0.1976, "mature_H5_site": 99, "mouse_sera_escape": 0.2566, "mutant": "Y", "mutation": "E106Y", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": -0.1213, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "A", "mutation": "E107A", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "C", "mutation": "E107C", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.242, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "D", "mutation": "E107D", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 100, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E107E", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "F", "mutation": "E107F", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.588, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "H", "mutation": "E107H", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "I", "mutation": "E107I", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "K", "mutation": "E107K", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.363, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "N", "mutation": "E107N", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "P", "mutation": "E107P", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "Q", "mutation": "E107Q", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "S", "mutation": "E107S", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "T", "mutation": "E107T", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "W", "mutation": "E107W", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E107Y", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "A", "mutation": "L108A", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.015, "ferret_sera_escape": -0.2781, "mature_H5_site": 101, "mouse_sera_escape": -0.01582, "mutant": "C", "mutation": "L108C", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "D", "mutation": "L108D", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "E", "mutation": "L108E", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.646, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "F", "mutation": "L108F", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.742, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "G", "mutation": "L108G", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 101, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L108L", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2334, "ferret_sera_escape": 0.06355, "mature_H5_site": 101, "mouse_sera_escape": 0.01203, "mutant": "M", "mutation": "L108M", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": -0.502, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "P", "mutation": "L108P", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.013, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "R", "mutation": "L108R", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.643, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "S", "mutation": "L108S", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.534, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "T", "mutation": "L108T", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "W", "mutation": "L108W", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.605, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L108Y", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.07599, "ferret_sera_escape": -0.2911, "mature_H5_site": 102, "mouse_sera_escape": -0.1074, "mutant": "A", "mutation": "K109A", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": 1.435, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6565, "ferret_sera_escape": -0.113, "mature_H5_site": 102, "mouse_sera_escape": 0.1487, "mutant": "C", "mutation": "K109C", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": 2.143, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.835, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "D", "mutation": "K109D", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.925, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "E", "mutation": "K109E", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6996, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "G", "mutation": "K109G", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.855, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "I", "mutation": "K109I", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 102, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K109K", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.582, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "L", "mutation": "K109L", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.187, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "M", "mutation": "K109M", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.342, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "N", "mutation": "K109N", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1584, "ferret_sera_escape": -0.1852, "mature_H5_site": 102, "mouse_sera_escape": -0.0456, "mutant": "Q", "mutation": "K109Q", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": 1.619, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1504, "ferret_sera_escape": -0.1975, "mature_H5_site": 102, "mouse_sera_escape": 0.1554, "mutant": "R", "mutation": "K109R", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": 0.9188, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.095, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "T", "mutation": "K109T", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K109Y", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.852, "ferret_sera_escape": -0.0044, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "A", "mutation": "D11A", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.285, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "C", "mutation": "D11C", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 1, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D11D", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.812, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "E", "mutation": "D11E", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.008, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "F", "mutation": "D11F", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.651, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "G", "mutation": "D11G", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.888, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "H", "mutation": "D11H", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.882, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "I", "mutation": "D11I", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.715, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "K", "mutation": "D11K", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "L", "mutation": "D11L", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "M", "mutation": "D11M", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 1.724, "cell_entry": -0.3773, "ferret_sera_escape": -0.06737, "mature_H5_site": 1, "mouse_sera_escape": 0.08058, "mutant": "N", "mutation": "D11N", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.978, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "P", "mutation": "D11P", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "Q", "mutation": "D11Q", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "R", "mutation": "D11R", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.739, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "S", "mutation": "D11S", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "V", "mutation": "D11V", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "W", "mutation": "D11W", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.577, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D11Y", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.366, "ferret_sera_escape": -0.02295, "mature_H5_site": 103, "mouse_sera_escape": 0.1987, "mutant": "A", "mutation": "H110A", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 0.8676, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.888, "ferret_sera_escape": 0.0003133, "mature_H5_site": 103, "mouse_sera_escape": 0.04419, "mutant": "C", "mutation": "H110C", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 0.5846, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.242, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "D", "mutation": "H110D", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.331, "ferret_sera_escape": -0.2582, "mature_H5_site": 103, "mouse_sera_escape": -0.09606, "mutant": "E", "mutation": "H110E", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.488, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "G", "mutation": "H110G", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 103, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H110H", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.191, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "I", "mutation": "H110I", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.429, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "K", "mutation": "H110K", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4132, "ferret_sera_escape": 0.1378, "mature_H5_site": 103, "mouse_sera_escape": 0.1479, "mutant": "L", "mutation": "H110L", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.883, "ferret_sera_escape": 0.4555, "mature_H5_site": 103, "mouse_sera_escape": 0.2626, "mutant": "M", "mutation": "H110M", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 1.219, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.7925, "ferret_sera_escape": -0.03114, "mature_H5_site": 103, "mouse_sera_escape": 0.007151, "mutant": "N", "mutation": "H110N", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 0.5528, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "P", "mutation": "H110P", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.601, "ferret_sera_escape": 0.0464, "mature_H5_site": 103, "mouse_sera_escape": 0.5806, "mutant": "Q", "mutation": "H110Q", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 0.7464, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.739, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "R", "mutation": "H110R", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5953, "ferret_sera_escape": -0.02457, "mature_H5_site": 103, "mouse_sera_escape": 0.2301, "mutant": "S", "mutation": "H110S", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 1.204, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.135, "ferret_sera_escape": -0.2959, "mature_H5_site": 103, "mouse_sera_escape": 0.6494, "mutant": "T", "mutation": "H110T", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 0.6905, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.335, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "V", "mutation": "H110V", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "W", "mutation": "H110W", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.351, "ferret_sera_escape": 0.02023, "mature_H5_site": 103, "mouse_sera_escape": 0.2874, "mutant": "Y", "mutation": "H110Y", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 1.377, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.491, "ferret_sera_escape": -0.1108, "mature_H5_site": 104, "mouse_sera_escape": -0.4416, "mutant": "A", "mutation": "M111A", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": -0.7941, "wildtype": "M"}, {"a26_usage": 1.469, "cell_entry": -0.8764, "ferret_sera_escape": -0.06913, "mature_H5_site": 104, "mouse_sera_escape": -0.2128, "mutant": "C", "mutation": "M111C", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": -0.173, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.17, "ferret_sera_escape": 0.1032, "mature_H5_site": 104, "mouse_sera_escape": -0.02907, "mutant": "D", "mutation": "M111D", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.907, "ferret_sera_escape": null, "mature_H5_site": 104, "mouse_sera_escape": null, "mutant": "E", "mutation": "M111E", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.3729, "ferret_sera_escape": 0.1247, "mature_H5_site": 104, "mouse_sera_escape": 0.05982, "mutant": "F", "mutation": "M111F", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.03574, "cell_entry": 0.02311, "ferret_sera_escape": 0.04219, "mature_H5_site": 104, "mouse_sera_escape": -0.1144, "mutant": "G", "mutation": "M111G", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": -0.268, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.01186, "ferret_sera_escape": -0.1427, "mature_H5_site": 104, "mouse_sera_escape": -0.122, "mutant": "H", "mutation": "M111H", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": -0.06913, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.01526, "ferret_sera_escape": -0.1681, "mature_H5_site": 104, "mouse_sera_escape": -0.1461, "mutant": "I", "mutation": "M111I", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": -0.2299, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.879, "ferret_sera_escape": -0.2589, "mature_H5_site": 104, "mouse_sera_escape": -0.0959, "mutant": "K", "mutation": "M111K", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 104, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M111M", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 104, "mouse_sera_escape": null, "mutant": "N", "mutation": "M111N", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.62, "ferret_sera_escape": null, "mature_H5_site": 104, "mouse_sera_escape": null, "mutant": "P", "mutation": "M111P", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.809, "ferret_sera_escape": -0.3003, "mature_H5_site": 104, "mouse_sera_escape": -0.2054, "mutant": "Q", "mutation": "M111Q", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.35, "ferret_sera_escape": -0.3688, "mature_H5_site": 104, "mouse_sera_escape": null, "mutant": "R", "mutation": "M111R", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.4343, "ferret_sera_escape": -0.1184, "mature_H5_site": 104, "mouse_sera_escape": -0.1352, "mutant": "S", "mutation": "M111S", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": -0.4975, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.037, "ferret_sera_escape": -0.2691, "mature_H5_site": 104, "mouse_sera_escape": -0.1786, "mutant": "T", "mutation": "M111T", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.49, "ferret_sera_escape": -0.6113, "mature_H5_site": 104, "mouse_sera_escape": null, "mutant": "V", "mutation": "M111V", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.444, "ferret_sera_escape": 0.01694, "mature_H5_site": 104, "mouse_sera_escape": -0.008168, "mutant": "W", "mutation": "M111W", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": -0.1458, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.2695, "ferret_sera_escape": 0.1096, "mature_H5_site": 104, "mouse_sera_escape": 0.1976, "mutant": "Y", "mutation": "M111Y", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": 1.441, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.5832, "ferret_sera_escape": 0.1818, "mature_H5_site": 105, "mouse_sera_escape": 0.3458, "mutant": "A", "mutation": "L112A", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5001, "ferret_sera_escape": 0.08374, "mature_H5_site": 105, "mouse_sera_escape": 0.3635, "mutant": "C", "mutation": "L112C", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": 0.4412, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "D", "mutation": "L112D", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "E", "mutation": "L112E", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.627, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "F", "mutation": "L112F", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.871, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "G", "mutation": "L112G", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.696, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "H", "mutation": "L112H", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4761, "ferret_sera_escape": 0.08279, "mature_H5_site": 105, "mouse_sera_escape": 0.1091, "mutant": "I", "mutation": "L112I", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": 0.2906, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "K", "mutation": "L112K", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 105, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L112L", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.01458, "cell_entry": 0.07681, "ferret_sera_escape": 0.007209, "mature_H5_site": 105, "mouse_sera_escape": -0.009453, "mutant": "M", "mutation": "L112M", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": -0.005374, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "P", "mutation": "L112P", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.463, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L112Q", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "R", "mutation": "L112R", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.913, "ferret_sera_escape": 0.1084, "mature_H5_site": 105, "mouse_sera_escape": 0.1756, "mutant": "S", "mutation": "L112S", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": 0.06213, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.093, "ferret_sera_escape": 0.1685, "mature_H5_site": 105, "mouse_sera_escape": 0.1705, "mutant": "V", "mutation": "L112V", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": 0.9275, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.481, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "W", "mutation": "L112W", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.751, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L112Y", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.04543, "ferret_sera_escape": 0.03732, "mature_H5_site": 106, "mouse_sera_escape": 0.02021, "mutant": "A", "mutation": "S113A", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": -0.02404, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.598, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "C", "mutation": "S113C", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "E", "mutation": "S113E", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.981, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": -0.09506, "mutant": "G", "mutation": "S113G", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": -0.1768, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "I", "mutation": "S113I", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "L", "mutation": "S113L", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.621, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "N", "mutation": "S113N", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.885, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "P", "mutation": "S113P", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "R", "mutation": "S113R", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 106, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S113S", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3958, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "T", "mutation": "S113T", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.781, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "V", "mutation": "S113V", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "W", "mutation": "S113W", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.04878, "ferret_sera_escape": -0.006683, "mature_H5_site": 107, "mouse_sera_escape": 0.09516, "mutant": "C", "mutation": "R114C", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": 1.667, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.931, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "D", "mutation": "R114D", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.925, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "E", "mutation": "R114E", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.121, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "F", "mutation": "R114F", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.109, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "G", "mutation": "R114G", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "I", "mutation": "R114I", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.285, "ferret_sera_escape": -0.1563, "mature_H5_site": 107, "mouse_sera_escape": 0.05366, "mutant": "K", "mutation": "R114K", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": 1.28, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.505, "ferret_sera_escape": 0.1208, "mature_H5_site": 107, "mouse_sera_escape": -0.05803, "mutant": "L", "mutation": "R114L", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": -0.08478, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.595, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "M", "mutation": "R114M", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.274, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "N", "mutation": "R114N", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "P", "mutation": "R114P", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.156, "ferret_sera_escape": -0.008133, "mature_H5_site": 107, "mouse_sera_escape": 0.238, "mutant": "Q", "mutation": "R114Q", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": 2.131, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 107, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R114R", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.874, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "S", "mutation": "R114S", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.959, "ferret_sera_escape": 0.9309, "mature_H5_site": 107, "mouse_sera_escape": 0.5398, "mutant": "T", "mutation": "R114T", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4584, "ferret_sera_escape": 0.1796, "mature_H5_site": 107, "mouse_sera_escape": 0.05447, "mutant": "W", "mutation": "R114W", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": -0.03309, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5778, "ferret_sera_escape": -0.02443, "mature_H5_site": 107, "mouse_sera_escape": -0.06574, "mutant": "Y", "mutation": "R114Y", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": -0.1791, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.322, "ferret_sera_escape": 0.2378, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "A", "mutation": "I115A", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.05556, "ferret_sera_escape": 0.1317, "mature_H5_site": 108, "mouse_sera_escape": 0.1036, "mutant": "C", "mutation": "I115C", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.849, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "D", "mutation": "I115D", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.696, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "E", "mutation": "I115E", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "G", "mutation": "I115G", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "H", "mutation": "I115H", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 108, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I115I", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.721, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "K", "mutation": "I115K", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.9204, "ferret_sera_escape": 0.003223, "mature_H5_site": 108, "mouse_sera_escape": 0.2126, "mutant": "L", "mutation": "I115L", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": 0.7604, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.693, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "M", "mutation": "I115M", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.441, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "N", "mutation": "I115N", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "P", "mutation": "I115P", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I115Q", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "R", "mutation": "I115R", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.51, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "S", "mutation": "I115S", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.509, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "W", "mutation": "I115W", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.964, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I115Y", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.2, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "A", "mutation": "N116A", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4717, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "C", "mutation": "N116C", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.875, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "D", "mutation": "N116D", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.873, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "E", "mutation": "N116E", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7453, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "F", "mutation": "N116F", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.67, "ferret_sera_escape": -0.2392, "mature_H5_site": 109, "mouse_sera_escape": 0.7442, "mutant": "G", "mutation": "N116G", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": 1.475, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.07, "ferret_sera_escape": -0.06054, "mature_H5_site": 109, "mouse_sera_escape": 0.3277, "mutant": "H", "mutation": "N116H", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": 0.7992, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.00154, "ferret_sera_escape": -0.04435, "mature_H5_site": 109, "mouse_sera_escape": -0.1302, "mutant": "K", "mutation": "N116K", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": -0.003525, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7297, "ferret_sera_escape": 0.203, "mature_H5_site": 109, "mouse_sera_escape": -0.05687, "mutant": "M", "mutation": "N116M", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": -0.01088, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 109, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N116N", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.405, "ferret_sera_escape": -0.006397, "mature_H5_site": 109, "mouse_sera_escape": 0.1877, "mutant": "P", "mutation": "N116P", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": 0.1759, "wildtype": "N"}, {"a26_usage": 0.2646, "cell_entry": -0.0768, "ferret_sera_escape": -0.03377, "mature_H5_site": 109, "mouse_sera_escape": -0.02719, "mutant": "Q", "mutation": "N116Q", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": -0.03417, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.368, "ferret_sera_escape": -0.2039, "mature_H5_site": 109, "mouse_sera_escape": 0.217, "mutant": "S", "mutation": "N116S", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": 1.931, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9864, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "T", "mutation": "N116T", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7876, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "V", "mutation": "N116V", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.089, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "W", "mutation": "N116W", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.573, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N116Y", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": 0.6817, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.792, "ferret_sera_escape": null, "mature_H5_site": 110, "mouse_sera_escape": null, "mutant": "A", "mutation": "H117A", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.449, "ferret_sera_escape": -0.08407, "mature_H5_site": 110, "mouse_sera_escape": 0.08362, "mutant": "C", "mutation": "H117C", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": -0.5506, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.2694, "ferret_sera_escape": 0.2168, "mature_H5_site": 110, "mouse_sera_escape": 0.298, "mutant": "D", "mutation": "H117D", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": 0.8161, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.9804, "ferret_sera_escape": null, "mature_H5_site": 110, "mouse_sera_escape": null, "mutant": "F", "mutation": "H117F", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 110, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H117H", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.6603, "ferret_sera_escape": -0.1432, "mature_H5_site": 110, "mouse_sera_escape": 0.07822, "mutant": "I", "mutation": "H117I", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": 1.152, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.02034, "ferret_sera_escape": -0.02157, "mature_H5_site": 110, "mouse_sera_escape": -0.007581, "mutant": "K", "mutation": "H117K", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": null, "wildtype": "H"}, {"a26_usage": 0.453, "cell_entry": 0.00568, "ferret_sera_escape": 0.1622, "mature_H5_site": 110, "mouse_sera_escape": 0.1682, "mutant": "L", "mutation": "H117L", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": null, "wildtype": "H"}, {"a26_usage": 0.1445, "cell_entry": -0.03195, "ferret_sera_escape": -0.0005367, "mature_H5_site": 110, "mouse_sera_escape": 0.1503, "mutant": "N", "mutation": "H117N", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": 0.551, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.776, "ferret_sera_escape": null, "mature_H5_site": 110, "mouse_sera_escape": null, "mutant": "P", "mutation": "H117P", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3424, "ferret_sera_escape": 0.1592, "mature_H5_site": 110, "mouse_sera_escape": 0.01248, "mutant": "Q", "mutation": "H117Q", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": -0.2107, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3956, "ferret_sera_escape": -0.2361, "mature_H5_site": 110, "mouse_sera_escape": -0.09411, "mutant": "R", "mutation": "H117R", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": 0.6336, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.03186, "ferret_sera_escape": -0.00175, "mature_H5_site": 110, "mouse_sera_escape": 0.03342, "mutant": "S", "mutation": "H117S", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": -0.1941, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5314, "ferret_sera_escape": 0.03427, "mature_H5_site": 110, "mouse_sera_escape": 0.1568, "mutant": "T", "mutation": "H117T", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": 1.433, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5263, "ferret_sera_escape": 0.1057, "mature_H5_site": 110, "mouse_sera_escape": 0.2452, "mutant": "V", "mutation": "H117V", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.03752, "ferret_sera_escape": -0.03046, "mature_H5_site": 110, "mouse_sera_escape": 0.146, "mutant": "W", "mutation": "H117W", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": -0.1614, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5233, "ferret_sera_escape": 0.07712, "mature_H5_site": 110, "mouse_sera_escape": 0.5755, "mutant": "Y", "mutation": "H117Y", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": 1.591, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.9971, "ferret_sera_escape": 0.3467, "mature_H5_site": 111, "mouse_sera_escape": 0.3955, "mutant": "C", "mutation": "F118C", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": -0.179, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.71, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "D", "mutation": "F118D", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.61, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "E", "mutation": "F118E", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 111, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F118F", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.575, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "G", "mutation": "F118G", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.5722, "ferret_sera_escape": -0.04881, "mature_H5_site": 111, "mouse_sera_escape": 0.0529, "mutant": "H", "mutation": "F118H", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": -0.3066, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "I", "mutation": "F118I", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.165, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "K", "mutation": "F118K", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.885, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "M", "mutation": "F118M", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "P", "mutation": "F118P", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.374, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "R", "mutation": "F118R", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.001, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "T", "mutation": "F118T", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.8548, "ferret_sera_escape": -0.2194, "mature_H5_site": 111, "mouse_sera_escape": 0.0292, "mutant": "Y", "mutation": "F118Y", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": 1.102, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.7303, "ferret_sera_escape": -0.007021, "mature_H5_site": 112, "mouse_sera_escape": 0.5059, "mutant": "A", "mutation": "E119A", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3972, "ferret_sera_escape": 0.01207, "mature_H5_site": 112, "mouse_sera_escape": 0.1987, "mutant": "D", "mutation": "E119D", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.1383, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 112, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E119E", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.011, "ferret_sera_escape": 0.07942, "mature_H5_site": 112, "mouse_sera_escape": 0.4685, "mutant": "F", "mutation": "E119F", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.2926, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.479, "ferret_sera_escape": -0.03309, "mature_H5_site": 112, "mouse_sera_escape": 0.4335, "mutant": "G", "mutation": "E119G", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": 0.1543, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07822, "ferret_sera_escape": -0.2683, "mature_H5_site": 112, "mouse_sera_escape": 0.2027, "mutant": "H", "mutation": "E119H", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.2699, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.676, "ferret_sera_escape": -0.3211, "mature_H5_site": 112, "mouse_sera_escape": null, "mutant": "I", "mutation": "E119I", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.161, "ferret_sera_escape": 0.01283, "mature_H5_site": 112, "mouse_sera_escape": 0.2333, "mutant": "K", "mutation": "E119K", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.31, "ferret_sera_escape": null, "mature_H5_site": 112, "mouse_sera_escape": null, "mutant": "L", "mutation": "E119L", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.0783, "ferret_sera_escape": -0.01155, "mature_H5_site": 112, "mouse_sera_escape": 0.3304, "mutant": "M", "mutation": "E119M", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.3872, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4814, "ferret_sera_escape": -0.1562, "mature_H5_site": 112, "mouse_sera_escape": 0.1856, "mutant": "N", "mutation": "E119N", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.1858, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5314, "ferret_sera_escape": -0.06123, "mature_H5_site": 112, "mouse_sera_escape": 0.1378, "mutant": "Q", "mutation": "E119Q", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06823, "ferret_sera_escape": 0.198, "mature_H5_site": 112, "mouse_sera_escape": 0.2477, "mutant": "R", "mutation": "E119R", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.1964, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5659, "ferret_sera_escape": 0.1639, "mature_H5_site": 112, "mouse_sera_escape": 0.5332, "mutant": "S", "mutation": "E119S", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": 1.102, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3562, "ferret_sera_escape": -0.03967, "mature_H5_site": 112, "mouse_sera_escape": 0.2888, "mutant": "T", "mutation": "E119T", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.1227, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4491, "ferret_sera_escape": -0.2743, "mature_H5_site": 112, "mouse_sera_escape": 0.1416, "mutant": "V", "mutation": "E119V", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.1525, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.804, "ferret_sera_escape": 0.1825, "mature_H5_site": 112, "mouse_sera_escape": 0.6633, "mutant": "W", "mutation": "E119W", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6957, "ferret_sera_escape": -0.08007, "mature_H5_site": 112, "mouse_sera_escape": 0.4956, "mutant": "Y", "mutation": "E119Y", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.2248, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.02366, "ferret_sera_escape": null, "mature_H5_site": 2, "mouse_sera_escape": null, "mutant": "A", "mutation": "Q12A", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.06322, "ferret_sera_escape": -0.06943, "mature_H5_site": 2, "mouse_sera_escape": 0.01982, "mutant": "C", "mutation": "Q12C", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": -0.1146, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.4799, "ferret_sera_escape": -0.04659, "mature_H5_site": 2, "mouse_sera_escape": 0.03173, "mutant": "E", "mutation": "Q12E", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": 0.06995, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.00978, "ferret_sera_escape": 0.07101, "mature_H5_site": 2, "mouse_sera_escape": 0.02075, "mutant": "F", "mutation": "Q12F", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": 0.04321, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1774, "ferret_sera_escape": -0.02569, "mature_H5_site": 2, "mouse_sera_escape": -0.01853, "mutant": "G", "mutation": "Q12G", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2583, "ferret_sera_escape": 0.04559, "mature_H5_site": 2, "mouse_sera_escape": 0.1129, "mutant": "H", "mutation": "Q12H", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": -0.03355, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.0239, "ferret_sera_escape": -0.1091, "mature_H5_site": 2, "mouse_sera_escape": -0.04236, "mutant": "I", "mutation": "Q12I", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": -0.02679, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.03238, "ferret_sera_escape": 0.0665, "mature_H5_site": 2, "mouse_sera_escape": -0.03443, "mutant": "K", "mutation": "Q12K", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": -0.06683, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.01749, "ferret_sera_escape": null, "mature_H5_site": 2, "mouse_sera_escape": null, "mutant": "L", "mutation": "Q12L", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1825, "ferret_sera_escape": 0.1607, "mature_H5_site": 2, "mouse_sera_escape": -0.1084, "mutant": "M", "mutation": "Q12M", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": 0.05007, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.05822, "ferret_sera_escape": -0.08021, "mature_H5_site": 2, "mouse_sera_escape": 0.06707, "mutant": "N", "mutation": "Q12N", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": -0.06364, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 2, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q12P", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 2, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q12Q", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1152, "ferret_sera_escape": -0.00437, "mature_H5_site": 2, "mouse_sera_escape": -0.01257, "mutant": "R", "mutation": "Q12R", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": -0.03848, "wildtype": "Q"}, {"a26_usage": 0.0511, "cell_entry": -0.372, "ferret_sera_escape": 0.08018, "mature_H5_site": 2, "mouse_sera_escape": 0.1517, "mutant": "S", "mutation": "Q12S", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": 0.007057, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.01009, "ferret_sera_escape": -0.1059, "mature_H5_site": 2, "mouse_sera_escape": -0.07769, "mutant": "V", "mutation": "Q12V", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": -0.04021, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.9424, "ferret_sera_escape": 0.08115, "mature_H5_site": 2, "mouse_sera_escape": -0.09026, "mutant": "Y", "mutation": "Q12Y", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": 0.05847, "wildtype": "Q"}, {"a26_usage": 0.2121, "cell_entry": 0.01951, "ferret_sera_escape": 0.06413, "mature_H5_site": 113, "mouse_sera_escape": 0.1999, "mutant": "A", "mutation": "K120A", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.2158, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.871, "ferret_sera_escape": null, "mature_H5_site": 113, "mouse_sera_escape": null, "mutant": "C", "mutation": "K120C", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2547, "ferret_sera_escape": 0.02695, "mature_H5_site": 113, "mouse_sera_escape": 0.4276, "mutant": "E", "mutation": "K120E", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.3969, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.074, "ferret_sera_escape": null, "mature_H5_site": 113, "mouse_sera_escape": null, "mutant": "F", "mutation": "K120F", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8044, "ferret_sera_escape": 0.1423, "mature_H5_site": 113, "mouse_sera_escape": 0.4168, "mutant": "G", "mutation": "K120G", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.2829, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5709, "ferret_sera_escape": 0.1384, "mature_H5_site": 113, "mouse_sera_escape": 0.3636, "mutant": "H", "mutation": "K120H", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.2186, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3311, "ferret_sera_escape": 0.1034, "mature_H5_site": 113, "mouse_sera_escape": 0.07147, "mutant": "I", "mutation": "K120I", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.3458, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 113, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K120K", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.737, "ferret_sera_escape": -0.0535, "mature_H5_site": 113, "mouse_sera_escape": 0.1954, "mutant": "L", "mutation": "K120L", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03023, "ferret_sera_escape": 0.1793, "mature_H5_site": 113, "mouse_sera_escape": 0.1963, "mutant": "M", "mutation": "K120M", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.1926, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.05283, "ferret_sera_escape": -0.04832, "mature_H5_site": 113, "mouse_sera_escape": 0.2196, "mutant": "P", "mutation": "K120P", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.2831, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.02981, "ferret_sera_escape": 0.1389, "mature_H5_site": 113, "mouse_sera_escape": 0.1142, "mutant": "Q", "mutation": "K120Q", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.3505, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.692, "ferret_sera_escape": -0.1712, "mature_H5_site": 113, "mouse_sera_escape": null, "mutant": "R", "mutation": "K120R", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.304, "ferret_sera_escape": null, "mature_H5_site": 113, "mouse_sera_escape": null, "mutant": "S", "mutation": "K120S", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0716, "ferret_sera_escape": 0.08107, "mature_H5_site": 113, "mouse_sera_escape": 0.04453, "mutant": "T", "mutation": "K120T", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.2676, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.463, "ferret_sera_escape": null, "mature_H5_site": 113, "mouse_sera_escape": null, "mutant": "W", "mutation": "K120W", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.438, "ferret_sera_escape": 0.08088, "mature_H5_site": 113, "mouse_sera_escape": 0.439, "mutant": "Y", "mutation": "K120Y", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.1666, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03422, "ferret_sera_escape": 0.139, "mature_H5_site": 114, "mouse_sera_escape": 0.2643, "mutant": "A", "mutation": "I121A", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.1992, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.531, "ferret_sera_escape": 0.06269, "mature_H5_site": 114, "mouse_sera_escape": 0.446, "mutant": "C", "mutation": "I121C", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.0504, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3542, "ferret_sera_escape": 0.02722, "mature_H5_site": 114, "mouse_sera_escape": 0.537, "mutant": "E", "mutation": "I121E", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.2802, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1405, "ferret_sera_escape": 0.05012, "mature_H5_site": 114, "mouse_sera_escape": -0.07388, "mutant": "F", "mutation": "I121F", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.04933, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.041, "ferret_sera_escape": null, "mature_H5_site": 114, "mouse_sera_escape": null, "mutant": "H", "mutation": "I121H", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 114, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I121I", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.04127, "cell_entry": 0.0355, "ferret_sera_escape": 0.2231, "mature_H5_site": 114, "mouse_sera_escape": 0.5063, "mutant": "K", "mutation": "I121K", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": 0.001318, "wildtype": "I"}, {"a26_usage": 0.04269, "cell_entry": 0.03692, "ferret_sera_escape": 0.1855, "mature_H5_site": 114, "mouse_sera_escape": -0.06186, "mutant": "M", "mutation": "I121M", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.1251, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.06919, "ferret_sera_escape": -0.01617, "mature_H5_site": 114, "mouse_sera_escape": 0.05666, "mutant": "N", "mutation": "I121N", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.2273, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2019, "ferret_sera_escape": 0.04829, "mature_H5_site": 114, "mouse_sera_escape": 0.1697, "mutant": "R", "mutation": "I121R", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.02168, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6339, "ferret_sera_escape": 0.01904, "mature_H5_site": 114, "mouse_sera_escape": 0.07199, "mutant": "S", "mutation": "I121S", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.2154, "wildtype": "I"}, {"a26_usage": 0.009325, "cell_entry": 0.03352, "ferret_sera_escape": 0.06616, "mature_H5_site": 114, "mouse_sera_escape": 0.1681, "mutant": "T", "mutation": "I121T", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": 0.04997, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6371, "ferret_sera_escape": null, "mature_H5_site": 114, "mouse_sera_escape": null, "mutant": "V", "mutation": "I121V", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2212, "ferret_sera_escape": 0.07685, "mature_H5_site": 114, "mouse_sera_escape": 0.6259, "mutant": "W", "mutation": "I121W", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": 0.3749, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4973, "ferret_sera_escape": 0.1542, "mature_H5_site": 115, "mouse_sera_escape": 0.791, "mutant": "E", "mutation": "L122E", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.1891, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3482, "ferret_sera_escape": 0.2659, "mature_H5_site": 115, "mouse_sera_escape": 0.5386, "mutant": "F", "mutation": "L122F", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.04354, "wildtype": "L"}, {"a26_usage": 0.04686, "cell_entry": -0.02544, "ferret_sera_escape": 0.2178, "mature_H5_site": 115, "mouse_sera_escape": 0.568, "mutant": "H", "mutation": "L122H", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.117, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3065, "ferret_sera_escape": 0.1004, "mature_H5_site": 115, "mouse_sera_escape": -0.08553, "mutant": "I", "mutation": "L122I", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.2018, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.163, "ferret_sera_escape": 0.1819, "mature_H5_site": 115, "mouse_sera_escape": 0.8897, "mutant": "K", "mutation": "L122K", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.04212, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 115, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L122L", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.4457, "cell_entry": -0.4126, "ferret_sera_escape": 0.1999, "mature_H5_site": 115, "mouse_sera_escape": 0.5115, "mutant": "M", "mutation": "L122M", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": 0.01129, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3185, "ferret_sera_escape": 0.147, "mature_H5_site": 115, "mouse_sera_escape": 0.4331, "mutant": "N", "mutation": "L122N", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.3171, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.001835, "ferret_sera_escape": -0.003034, "mature_H5_site": 115, "mouse_sera_escape": 0.5701, "mutant": "P", "mutation": "L122P", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.1419, "wildtype": "L"}, {"a26_usage": 0.01632, "cell_entry": 0.07306, "ferret_sera_escape": 0.2563, "mature_H5_site": 115, "mouse_sera_escape": 0.961, "mutant": "Q", "mutation": "L122Q", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.1612, "wildtype": "L"}, {"a26_usage": 0.02365, "cell_entry": -0.01141, "ferret_sera_escape": 0.1559, "mature_H5_site": 115, "mouse_sera_escape": 0.8943, "mutant": "R", "mutation": "L122R", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.02051, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1468, "ferret_sera_escape": 0.1748, "mature_H5_site": 115, "mouse_sera_escape": 0.811, "mutant": "W", "mutation": "L122W", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.1857, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4136, "ferret_sera_escape": null, "mature_H5_site": 115, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L122Y", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": null, "wildtype": "L"}, {"a26_usage": 0.1715, "cell_entry": -0.1908, "ferret_sera_escape": 0.01131, "mature_H5_site": 116, "mouse_sera_escape": 0.04951, "mutant": "A", "mutation": "I123A", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": -0.01557, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2295, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "C", "mutation": "I123C", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "D", "mutation": "I123D", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1483, "ferret_sera_escape": -0.189, "mature_H5_site": 116, "mouse_sera_escape": -0.03222, "mutant": "F", "mutation": "I123F", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": 0.6041, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "H", "mutation": "I123H", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 116, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I123I", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "K", "mutation": "I123K", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1876, "ferret_sera_escape": -0.3222, "mature_H5_site": 116, "mouse_sera_escape": -0.046, "mutant": "L", "mutation": "I123L", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": 0.04245, "wildtype": "I"}, {"a26_usage": 0.1931, "cell_entry": -0.001085, "ferret_sera_escape": -0.1431, "mature_H5_site": 116, "mouse_sera_escape": -0.1472, "mutant": "M", "mutation": "I123M", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": 0.2061, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "N", "mutation": "I123N", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "P", "mutation": "I123P", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.28, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I123Q", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "R", "mutation": "I123R", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.579, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "S", "mutation": "I123S", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0201, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "T", "mutation": "I123T", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2315, "ferret_sera_escape": 0.05292, "mature_H5_site": 116, "mouse_sera_escape": -0.1023, "mutant": "V", "mutation": "I123V", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": -0.1174, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06524, "ferret_sera_escape": -0.3703, "mature_H5_site": 116, "mouse_sera_escape": -0.07444, "mutant": "W", "mutation": "I123W", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": 0.8999, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.534, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I123Y", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.254, "cell_entry": -0.06385, "ferret_sera_escape": -0.03113, "mature_H5_site": 117, "mouse_sera_escape": 0.3902, "mutant": "A", "mutation": "I124A", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.1237, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5464, "ferret_sera_escape": -0.7002, "mature_H5_site": 117, "mouse_sera_escape": -0.1467, "mutant": "D", "mutation": "I124D", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.09661, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.04497, "ferret_sera_escape": -0.2474, "mature_H5_site": 117, "mouse_sera_escape": -0.1174, "mutant": "E", "mutation": "I124E", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.2519, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5749, "ferret_sera_escape": null, "mature_H5_site": 117, "mouse_sera_escape": null, "mutant": "F", "mutation": "I124F", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1112, "ferret_sera_escape": -0.4954, "mature_H5_site": 117, "mouse_sera_escape": 0.04335, "mutant": "H", "mutation": "I124H", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.3823, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 117, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I124I", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4002, "ferret_sera_escape": -0.2841, "mature_H5_site": 117, "mouse_sera_escape": -0.1498, "mutant": "K", "mutation": "I124K", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.1667, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1626, "ferret_sera_escape": -0.08846, "mature_H5_site": 117, "mouse_sera_escape": 0.01699, "mutant": "L", "mutation": "I124L", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": 0.01976, "wildtype": "I"}, {"a26_usage": 0.1139, "cell_entry": -0.4244, "ferret_sera_escape": null, "mature_H5_site": 117, "mouse_sera_escape": null, "mutant": "M", "mutation": "I124M", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0379, "ferret_sera_escape": -0.07757, "mature_H5_site": 117, "mouse_sera_escape": 0.207, "mutant": "N", "mutation": "I124N", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.2935, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.078, "ferret_sera_escape": -0.3268, "mature_H5_site": 117, "mouse_sera_escape": -0.2583, "mutant": "Q", "mutation": "I124Q", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.1901, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2653, "ferret_sera_escape": -0.6023, "mature_H5_site": 117, "mouse_sera_escape": 0.07468, "mutant": "R", "mutation": "I124R", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.2161, "wildtype": "I"}, {"a26_usage": 0.3874, "cell_entry": -0.6515, "ferret_sera_escape": -0.1699, "mature_H5_site": 117, "mouse_sera_escape": 0.2714, "mutant": "S", "mutation": "I124S", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.3359, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.07219, "ferret_sera_escape": -0.07608, "mature_H5_site": 117, "mouse_sera_escape": 0.0531, "mutant": "T", "mutation": "I124T", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.5167, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.01622, "ferret_sera_escape": 0.07459, "mature_H5_site": 117, "mouse_sera_escape": -0.06751, "mutant": "V", "mutation": "I124V", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.1503, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.0936, "ferret_sera_escape": -0.2043, "mature_H5_site": 117, "mouse_sera_escape": 0.05597, "mutant": "W", "mutation": "I124W", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.2049, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3624, "ferret_sera_escape": -0.07182, "mature_H5_site": 117, "mouse_sera_escape": 0.3287, "mutant": "Y", "mutation": "I124Y", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.1156, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03685, "ferret_sera_escape": 0.2289, "mature_H5_site": 118, "mouse_sera_escape": 0.6024, "mutant": "A", "mutation": "P125A", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.1599, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 118, "mouse_sera_escape": null, "mutant": "C", "mutation": "P125C", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": null, "wildtype": "P"}, {"a26_usage": 0.09871, "cell_entry": -0.0963, "ferret_sera_escape": 0.4523, "mature_H5_site": 118, "mouse_sera_escape": 0.9187, "mutant": "D", "mutation": "P125D", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.1304, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.017, "ferret_sera_escape": null, "mature_H5_site": 118, "mouse_sera_escape": null, "mutant": "F", "mutation": "P125F", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0373, "ferret_sera_escape": 0.1372, "mature_H5_site": 118, "mouse_sera_escape": 0.5845, "mutant": "G", "mutation": "P125G", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.1556, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.6355, "ferret_sera_escape": 0.4348, "mature_H5_site": 118, "mouse_sera_escape": 1.411, "mutant": "H", "mutation": "P125H", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.534, "ferret_sera_escape": null, "mature_H5_site": 118, "mouse_sera_escape": null, "mutant": "I", "mutation": "P125I", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": null, "wildtype": "P"}, {"a26_usage": 0.1725, "cell_entry": -0.3328, "ferret_sera_escape": -0.3311, "mature_H5_site": 118, "mouse_sera_escape": 1.394, "mutant": "K", "mutation": "P125K", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.2165, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.2, "ferret_sera_escape": -0.05693, "mature_H5_site": 118, "mouse_sera_escape": 0.3239, "mutant": "L", "mutation": "P125L", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.06372, "ferret_sera_escape": 0.2874, "mature_H5_site": 118, "mouse_sera_escape": 1.028, "mutant": "N", "mutation": "P125N", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.1436, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 118, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P125P", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.00216, "ferret_sera_escape": 0.2116, "mature_H5_site": 118, "mouse_sera_escape": 1.065, "mutant": "Q", "mutation": "P125Q", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.1913, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1268, "ferret_sera_escape": -0.2021, "mature_H5_site": 118, "mouse_sera_escape": 0.9755, "mutant": "R", "mutation": "P125R", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.105, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.06537, "ferret_sera_escape": 0.09184, "mature_H5_site": 118, "mouse_sera_escape": 0.2775, "mutant": "S", "mutation": "P125S", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.101, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.00919, "ferret_sera_escape": 0.1164, "mature_H5_site": 118, "mouse_sera_escape": 0.4352, "mutant": "T", "mutation": "P125T", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.215, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.552, "ferret_sera_escape": null, "mature_H5_site": 118, "mouse_sera_escape": null, "mutant": "W", "mutation": "P125W", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.787, "ferret_sera_escape": 0.1235, "mature_H5_site": 118, "mouse_sera_escape": 1.302, "mutant": "Y", "mutation": "P125Y", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.121, "ferret_sera_escape": -0.1366, "mature_H5_site": 119, "mouse_sera_escape": 0.2876, "mutant": "A", "mutation": "K125aA", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.0403, "ferret_sera_escape": -0.204, "mature_H5_site": 119, "mouse_sera_escape": 0.8326, "mutant": "D", "mutation": "K125aD", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.1362, "wildtype": "K"}, {"a26_usage": 1.227, "cell_entry": -0.483, "ferret_sera_escape": null, "mature_H5_site": 119, "mouse_sera_escape": null, "mutant": "E", "mutation": "K125aE", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07407, "ferret_sera_escape": -0.03902, "mature_H5_site": 119, "mouse_sera_escape": -0.1187, "mutant": "F", "mutation": "K125aF", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.5187, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.04975, "ferret_sera_escape": -0.3119, "mature_H5_site": 119, "mouse_sera_escape": 0.333, "mutant": "G", "mutation": "K125aG", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.2285, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2167, "ferret_sera_escape": -0.2056, "mature_H5_site": 119, "mouse_sera_escape": 0.4839, "mutant": "H", "mutation": "K125aH", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.1923, "wildtype": "K"}, {"a26_usage": 0.2005, "cell_entry": 0.06885, "ferret_sera_escape": -0.1094, "mature_H5_site": 119, "mouse_sera_escape": 0.1697, "mutant": "I", "mutation": "K125aI", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.3254, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 119, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K125aK", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2719, "ferret_sera_escape": -0.1423, "mature_H5_site": 119, "mouse_sera_escape": 0.02126, "mutant": "M", "mutation": "K125aM", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.2628, "wildtype": "K"}, {"a26_usage": 0.1586, "cell_entry": -0.00878, "ferret_sera_escape": -0.08409, "mature_H5_site": 119, "mouse_sera_escape": 0.6693, "mutant": "N", "mutation": "K125aN", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.1554, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.02823, "ferret_sera_escape": null, "mature_H5_site": 119, "mouse_sera_escape": null, "mutant": "P", "mutation": "K125aP", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.195, "ferret_sera_escape": -0.08836, "mature_H5_site": 119, "mouse_sera_escape": 0.553, "mutant": "Q", "mutation": "K125aQ", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.2573, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.06646, "ferret_sera_escape": -0.1653, "mature_H5_site": 119, "mouse_sera_escape": -0.1249, "mutant": "R", "mutation": "K125aR", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": 0.1364, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.05916, "ferret_sera_escape": -0.2238, "mature_H5_site": 119, "mouse_sera_escape": 0.2622, "mutant": "S", "mutation": "K125aS", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.1871, "wildtype": "K"}, {"a26_usage": 0.05549, "cell_entry": -0.1732, "ferret_sera_escape": -0.1383, "mature_H5_site": 119, "mouse_sera_escape": 0.2038, "mutant": "T", "mutation": "K125aT", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.1012, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2305, "ferret_sera_escape": -0.1828, "mature_H5_site": 119, "mouse_sera_escape": -0.1123, "mutant": "V", "mutation": "K125aV", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.2153, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.203, "ferret_sera_escape": null, "mature_H5_site": 119, "mouse_sera_escape": null, "mutant": "W", "mutation": "K125aW", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2351, "ferret_sera_escape": 0.1527, "mature_H5_site": 119, "mouse_sera_escape": 0.7076, "mutant": "Y", "mutation": "K125aY", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.4131, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4078, "ferret_sera_escape": 0.07581, "mature_H5_site": 120, "mouse_sera_escape": 0.8971, "mutant": "F", "mutation": "S125bF", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": -0.05079, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.07065, "ferret_sera_escape": 5.667e-05, "mature_H5_site": 120, "mouse_sera_escape": 0.6434, "mutant": "G", "mutation": "S125bG", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": -0.05795, "wildtype": "S"}, {"a26_usage": 0.000185, "cell_entry": 0.06391, "ferret_sera_escape": 0.08749, "mature_H5_site": 120, "mouse_sera_escape": 0.9044, "mutant": "I", "mutation": "S125bI", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": -0.1314, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.758, "ferret_sera_escape": -0.07666, "mature_H5_site": 120, "mouse_sera_escape": 1.219, "mutant": "K", "mutation": "S125bK", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3458, "ferret_sera_escape": -0.09508, "mature_H5_site": 120, "mouse_sera_escape": 0.7141, "mutant": "N", "mutation": "S125bN", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": 0.01952, "wildtype": "S"}, {"a26_usage": 0.2104, "cell_entry": -0.04187, "ferret_sera_escape": 0.001856, "mature_H5_site": 120, "mouse_sera_escape": 0.9045, "mutant": "P", "mutation": "S125bP", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": -0.2673, "wildtype": "S"}, {"a26_usage": 0.02079, "cell_entry": 0.02757, "ferret_sera_escape": 0.04404, "mature_H5_site": 120, "mouse_sera_escape": 1.206, "mutant": "Q", "mutation": "S125bQ", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": -0.05291, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 120, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S125bS", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.07107, "cell_entry": -0.1137, "ferret_sera_escape": -0.06737, "mature_H5_site": 120, "mouse_sera_escape": 0.5089, "mutant": "T", "mutation": "S125bT", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": -0.0361, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.05285, "ferret_sera_escape": null, "mature_H5_site": 120, "mouse_sera_escape": null, "mutant": "V", "mutation": "S125bV", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.0615, "ferret_sera_escape": null, "mature_H5_site": 120, "mouse_sera_escape": 0.7746, "mutant": "Y", "mutation": "S125bY", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.05417, "ferret_sera_escape": 0.0866, "mature_H5_site": 121, "mouse_sera_escape": 0.19, "mutant": "D", "mutation": "S126D", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.05232, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.07494, "ferret_sera_escape": 0.3368, "mature_H5_site": 121, "mouse_sera_escape": 0.5841, "mutant": "E", "mutation": "S126E", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.05151, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06291, "ferret_sera_escape": 0.08885, "mature_H5_site": 121, "mouse_sera_escape": 0.3642, "mutant": "F", "mutation": "S126F", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.03012, "wildtype": "S"}, {"a26_usage": 0.08582, "cell_entry": 0.06282, "ferret_sera_escape": -0.1746, "mature_H5_site": 121, "mouse_sera_escape": 0.2287, "mutant": "G", "mutation": "S126G", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.03831, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.05087, "ferret_sera_escape": -0.07557, "mature_H5_site": 121, "mouse_sera_escape": 0.2583, "mutant": "H", "mutation": "S126H", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.06371, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3866, "ferret_sera_escape": 0.3727, "mature_H5_site": 121, "mouse_sera_escape": 0.3507, "mutant": "I", "mutation": "S126I", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.06115, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4674, "ferret_sera_escape": -0.2642, "mature_H5_site": 121, "mouse_sera_escape": 0.7317, "mutant": "K", "mutation": "S126K", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": 0.01934, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3151, "ferret_sera_escape": null, "mature_H5_site": 121, "mouse_sera_escape": null, "mutant": "L", "mutation": "S126L", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.00303, "ferret_sera_escape": 0.0565, "mature_H5_site": 121, "mouse_sera_escape": -0.004226, "mutant": "M", "mutation": "S126M", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": null, "wildtype": "S"}, {"a26_usage": 0.08905, "cell_entry": 0.02509, "ferret_sera_escape": 0.01257, "mature_H5_site": 121, "mouse_sera_escape": 0.02041, "mutant": "N", "mutation": "S126N", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.06699, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4463, "ferret_sera_escape": null, "mature_H5_site": 121, "mouse_sera_escape": null, "mutant": "R", "mutation": "S126R", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 121, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S126S", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4739, "ferret_sera_escape": 0.1678, "mature_H5_site": 121, "mouse_sera_escape": 0.2315, "mutant": "V", "mutation": "S126V", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.05343, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3799, "ferret_sera_escape": -0.1019, "mature_H5_site": 121, "mouse_sera_escape": 0.4745, "mutant": "W", "mutation": "S126W", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.0185, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2207, "ferret_sera_escape": 0.0804, "mature_H5_site": 121, "mouse_sera_escape": 0.1175, "mutant": "Y", "mutation": "S126Y", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.04724, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8669, "ferret_sera_escape": 0.343, "mature_H5_site": 122, "mouse_sera_escape": 0.2889, "mutant": "A", "mutation": "W127A", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.2461, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.167, "ferret_sera_escape": 0.07442, "mature_H5_site": 122, "mouse_sera_escape": 0.519, "mutant": "C", "mutation": "W127C", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.2005, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": null, "mutant": "D", "mutation": "W127D", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.117, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": null, "mutant": "E", "mutation": "W127E", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.6939, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": null, "mutant": "F", "mutation": "W127F", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": null, "mutant": "G", "mutation": "W127G", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.4655, "cell_entry": 0.03642, "ferret_sera_escape": 0.2698, "mature_H5_site": 122, "mouse_sera_escape": 0.3101, "mutant": "H", "mutation": "W127H", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.2062, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.239, "ferret_sera_escape": -0.234, "mature_H5_site": 122, "mouse_sera_escape": 0.3829, "mutant": "I", "mutation": "W127I", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": null, "mutant": "K", "mutation": "W127K", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.1673, "ferret_sera_escape": 0.2912, "mature_H5_site": 122, "mouse_sera_escape": 0.3182, "mutant": "L", "mutation": "W127L", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.06663, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.1395, "ferret_sera_escape": 0.1936, "mature_H5_site": 122, "mouse_sera_escape": 0.184, "mutant": "M", "mutation": "W127M", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.1777, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.015, "ferret_sera_escape": 0.0079, "mature_H5_site": 122, "mouse_sera_escape": 0.3223, "mutant": "N", "mutation": "W127N", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.2415, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.039, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": null, "mutant": "P", "mutation": "W127P", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.579, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": 0.1908, "mutant": "Q", "mutation": "W127Q", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.282, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": null, "mutant": "R", "mutation": "W127R", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.3057, "ferret_sera_escape": 0.3968, "mature_H5_site": 122, "mouse_sera_escape": 0.2609, "mutant": "T", "mutation": "W127T", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.2593, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.2977, "ferret_sera_escape": 0.2686, "mature_H5_site": 122, "mouse_sera_escape": 0.3631, "mutant": "V", "mutation": "W127V", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.2031, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 122, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W127W", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.3755, "ferret_sera_escape": 0.5472, "mature_H5_site": 122, "mouse_sera_escape": 0.4295, "mutant": "Y", "mutation": "W127Y", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.1921, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.02553, "ferret_sera_escape": 0.01173, "mature_H5_site": 123, "mouse_sera_escape": 0.6237, "mutant": "A", "mutation": "P128A", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.06517, "ferret_sera_escape": null, "mature_H5_site": 123, "mouse_sera_escape": null, "mutant": "E", "mutation": "P128E", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.00625, "ferret_sera_escape": -0.2797, "mature_H5_site": 123, "mouse_sera_escape": 1.278, "mutant": "F", "mutation": "P128F", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": -0.03386, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.08099, "ferret_sera_escape": null, "mature_H5_site": 123, "mouse_sera_escape": null, "mutant": "G", "mutation": "P128G", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.03691, "ferret_sera_escape": 0.2743, "mature_H5_site": 123, "mouse_sera_escape": 1.219, "mutant": "H", "mutation": "P128H", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.02449, "wildtype": "P"}, {"a26_usage": 0.1639, "cell_entry": -0.02573, "ferret_sera_escape": -0.2017, "mature_H5_site": 123, "mouse_sera_escape": 1.184, "mutant": "I", "mutation": "P128I", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.4396, "ferret_sera_escape": 0.7022, "mature_H5_site": 123, "mouse_sera_escape": 1.538, "mutant": "K", "mutation": "P128K", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.04622, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.04475, "ferret_sera_escape": 0.2164, "mature_H5_site": 123, "mouse_sera_escape": 1.296, "mutant": "L", "mutation": "P128L", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": -0.02326, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.05714, "ferret_sera_escape": 0.9279, "mature_H5_site": 123, "mouse_sera_escape": 1.277, "mutant": "N", "mutation": "P128N", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.01802, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 123, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P128P", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.04128, "ferret_sera_escape": 0.816, "mature_H5_site": 123, "mouse_sera_escape": 0.9657, "mutant": "Q", "mutation": "P128Q", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.003147, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.006287, "ferret_sera_escape": 0.607, "mature_H5_site": 123, "mouse_sera_escape": 1.189, "mutant": "R", "mutation": "P128R", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.06397, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.07457, "ferret_sera_escape": 0.8335, "mature_H5_site": 123, "mouse_sera_escape": 0.8574, "mutant": "S", "mutation": "P128S", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": -0.1354, "wildtype": "P"}, {"a26_usage": 0.1089, "cell_entry": -0.449, "ferret_sera_escape": 0.9565, "mature_H5_site": 123, "mouse_sera_escape": 0.7175, "mutant": "T", "mutation": "P128T", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.06416, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.05711, "ferret_sera_escape": -0.7166, "mature_H5_site": 123, "mouse_sera_escape": 0.1646, "mutant": "V", "mutation": "P128V", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.0663, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.08738, "ferret_sera_escape": -0.4155, "mature_H5_site": 123, "mouse_sera_escape": 1.143, "mutant": "Y", "mutation": "P128Y", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": -0.02983, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.06982, "ferret_sera_escape": 1.102, "mature_H5_site": 124, "mouse_sera_escape": -0.2681, "mutant": "A", "mutation": "N129A", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": 0.003855, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.308, "ferret_sera_escape": null, "mature_H5_site": 124, "mouse_sera_escape": null, "mutant": "C", "mutation": "N129C", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1366, "ferret_sera_escape": 0.9875, "mature_H5_site": 124, "mouse_sera_escape": 0.41, "mutant": "E", "mutation": "N129E", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.0122, "wildtype": "N"}, {"a26_usage": 0.05192, "cell_entry": 0.07839, "ferret_sera_escape": 1.167, "mature_H5_site": 124, "mouse_sera_escape": 0.4335, "mutant": "G", "mutation": "N129G", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.02339, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07043, "ferret_sera_escape": 0.8285, "mature_H5_site": 124, "mouse_sera_escape": 0.4412, "mutant": "H", "mutation": "N129H", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.005448, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4981, "ferret_sera_escape": 1.018, "mature_H5_site": 124, "mouse_sera_escape": 0.3866, "mutant": "I", "mutation": "N129I", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.05773, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3603, "ferret_sera_escape": 1.368, "mature_H5_site": 124, "mouse_sera_escape": 0.6455, "mutant": "K", "mutation": "N129K", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.01055, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04486, "ferret_sera_escape": null, "mature_H5_site": 124, "mouse_sera_escape": null, "mutant": "L", "mutation": "N129L", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.0653, "ferret_sera_escape": 1.266, "mature_H5_site": 124, "mouse_sera_escape": 0.5631, "mutant": "M", "mutation": "N129M", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.007489, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 124, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N129N", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.088, "ferret_sera_escape": null, "mature_H5_site": 124, "mouse_sera_escape": null, "mutant": "P", "mutation": "N129P", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": null, "wildtype": "N"}, {"a26_usage": 0.1108, "cell_entry": -0.0363, "ferret_sera_escape": 0.9402, "mature_H5_site": 124, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N129Q", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": 0.006959, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2513, "ferret_sera_escape": 1.578, "mature_H5_site": 124, "mouse_sera_escape": 0.4452, "mutant": "R", "mutation": "N129R", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.0303, "wildtype": "N"}, {"a26_usage": 0.07468, "cell_entry": -0.1108, "ferret_sera_escape": 0.6417, "mature_H5_site": 124, "mouse_sera_escape": 0.2788, "mutant": "S", "mutation": "N129S", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.00207, "wildtype": "N"}, {"a26_usage": 0.03903, "cell_entry": 0.05205, "ferret_sera_escape": 1.215, "mature_H5_site": 124, "mouse_sera_escape": 0.5505, "mutant": "T", "mutation": "N129T", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.07662, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1836, "ferret_sera_escape": null, "mature_H5_site": 124, "mouse_sera_escape": null, "mutant": "W", "mutation": "N129W", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3927, "ferret_sera_escape": 1.523, "mature_H5_site": 124, "mouse_sera_escape": 0.617, "mutant": "Y", "mutation": "N129Y", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.01772, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "A", "mutation": "I13A", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.24, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "C", "mutation": "I13C", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "D", "mutation": "I13D", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "E", "mutation": "I13E", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.8341, "ferret_sera_escape": 0.1258, "mature_H5_site": 3, "mouse_sera_escape": 0.2332, "mutant": "F", "mutation": "I13F", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": -0.02318, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "G", "mutation": "I13G", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "H", "mutation": "I13H", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 3, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I13I", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.05027, "ferret_sera_escape": -0.03876, "mature_H5_site": 3, "mouse_sera_escape": -0.01954, "mutant": "L", "mutation": "I13L", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": 0.02535, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3934, "ferret_sera_escape": 0.005483, "mature_H5_site": 3, "mouse_sera_escape": 0.04868, "mutant": "M", "mutation": "I13M", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": 0.1987, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.006, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "N", "mutation": "I13N", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.532, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "P", "mutation": "I13P", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.836, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "R", "mutation": "I13R", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.012, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "S", "mutation": "I13S", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "T", "mutation": "I13T", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.8262, "ferret_sera_escape": 0.002215, "mature_H5_site": 3, "mouse_sera_escape": 0.02671, "mutant": "V", "mutation": "I13V", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": -0.06094, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "W", "mutation": "I13W", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.773, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I13Y", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1142, "ferret_sera_escape": 0.4988, "mature_H5_site": 125, "mouse_sera_escape": 0.4202, "mutant": "F", "mutation": "H130F", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": -0.24, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 125, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H130H", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4864, "ferret_sera_escape": 1.023, "mature_H5_site": 125, "mouse_sera_escape": 0.7472, "mutant": "I", "mutation": "H130I", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.739, "ferret_sera_escape": null, "mature_H5_site": 125, "mouse_sera_escape": null, "mutant": "K", "mutation": "H130K", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0569, "ferret_sera_escape": 0.6617, "mature_H5_site": 125, "mouse_sera_escape": 0.5717, "mutant": "L", "mutation": "H130L", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": -0.1888, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.583, "ferret_sera_escape": null, "mature_H5_site": 125, "mouse_sera_escape": null, "mutant": "N", "mutation": "H130N", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 125, "mouse_sera_escape": null, "mutant": "P", "mutation": "H130P", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.07983, "ferret_sera_escape": 0.1071, "mature_H5_site": 125, "mouse_sera_escape": 0.1426, "mutant": "Q", "mutation": "H130Q", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": -0.09587, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.698, "ferret_sera_escape": null, "mature_H5_site": 125, "mouse_sera_escape": null, "mutant": "S", "mutation": "H130S", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.966, "ferret_sera_escape": 1.329, "mature_H5_site": 125, "mouse_sera_escape": 1.159, "mutant": "T", "mutation": "H130T", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.488, "ferret_sera_escape": -0.0762, "mature_H5_site": 125, "mouse_sera_escape": 0.02141, "mutant": "W", "mutation": "H130W", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": 0.2098, "wildtype": "H"}, {"a26_usage": 0.1372, "cell_entry": 0.00101, "ferret_sera_escape": 0.0543, "mature_H5_site": 125, "mouse_sera_escape": 0.1582, "mutant": "Y", "mutation": "H130Y", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.02402, "ferret_sera_escape": 0.6059, "mature_H5_site": 126, "mouse_sera_escape": 0.1227, "mutant": "A", "mutation": "E131A", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": -0.07321, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01229, "ferret_sera_escape": null, "mature_H5_site": 126, "mouse_sera_escape": null, "mutant": "C", "mutation": "E131C", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.06798, "ferret_sera_escape": -0.01182, "mature_H5_site": 126, "mouse_sera_escape": 0.5242, "mutant": "D", "mutation": "E131D", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 126, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E131E", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1736, "ferret_sera_escape": 0.6612, "mature_H5_site": 126, "mouse_sera_escape": 0.4638, "mutant": "F", "mutation": "E131F", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": -0.1464, "wildtype": "E"}, {"a26_usage": 0.4801, "cell_entry": -0.1622, "ferret_sera_escape": 0.869, "mature_H5_site": 126, "mouse_sera_escape": 0.6954, "mutant": "I", "mutation": "E131I", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": -0.8429, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5302, "ferret_sera_escape": 0.916, "mature_H5_site": 126, "mouse_sera_escape": 0.6261, "mutant": "K", "mutation": "E131K", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.943, "ferret_sera_escape": 0.2028, "mature_H5_site": 126, "mouse_sera_escape": 0.666, "mutant": "M", "mutation": "E131M", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0582, "ferret_sera_escape": 0.4527, "mature_H5_site": 126, "mouse_sera_escape": 1.124, "mutant": "N", "mutation": "E131N", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": -0.1746, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 126, "mouse_sera_escape": null, "mutant": "P", "mutation": "E131P", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4504, "ferret_sera_escape": 0.6634, "mature_H5_site": 126, "mouse_sera_escape": 0.5919, "mutant": "R", "mutation": "E131R", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": -0.06238, "wildtype": "E"}, {"a26_usage": 0.01043, "cell_entry": 0.0516, "ferret_sera_escape": 0.957, "mature_H5_site": 126, "mouse_sera_escape": 0.492, "mutant": "S", "mutation": "E131S", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": -0.06959, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.091, "ferret_sera_escape": 0.7882, "mature_H5_site": 126, "mouse_sera_escape": 0.7847, "mutant": "V", "mutation": "E131V", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.428, "ferret_sera_escape": 0.6129, "mature_H5_site": 126, "mouse_sera_escape": 0.6244, "mutant": "W", "mutation": "E131W", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02217, "ferret_sera_escape": 0.3459, "mature_H5_site": 127, "mouse_sera_escape": 0.552, "mutant": "C", "mutation": "T132C", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.07873, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1347, "ferret_sera_escape": null, "mature_H5_site": 127, "mouse_sera_escape": null, "mutant": "E", "mutation": "T132E", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.09249, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7645, "ferret_sera_escape": 1.05, "mature_H5_site": 127, "mouse_sera_escape": 1.454, "mutant": "F", "mutation": "T132F", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": 0.07662, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.06669, "ferret_sera_escape": -0.3133, "mature_H5_site": 127, "mouse_sera_escape": 0.102, "mutant": "G", "mutation": "T132G", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.1468, "wildtype": "T"}, {"a26_usage": 0.1305, "cell_entry": -0.5881, "ferret_sera_escape": -0.01622, "mature_H5_site": 127, "mouse_sera_escape": 0.3317, "mutant": "I", "mutation": "T132I", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.1278, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1391, "ferret_sera_escape": -0.4659, "mature_H5_site": 127, "mouse_sera_escape": 1.114, "mutant": "K", "mutation": "T132K", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.09532, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.523, "ferret_sera_escape": null, "mature_H5_site": 127, "mouse_sera_escape": null, "mutant": "L", "mutation": "T132L", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.1323, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.00575, "ferret_sera_escape": -0.1473, "mature_H5_site": 127, "mouse_sera_escape": 0.1987, "mutant": "M", "mutation": "T132M", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.07034, "wildtype": "T"}, {"a26_usage": 0.5283, "cell_entry": -0.2738, "ferret_sera_escape": 0.0702, "mature_H5_site": 127, "mouse_sera_escape": 0.4626, "mutant": "N", "mutation": "T132N", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.07079, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3375, "ferret_sera_escape": -0.3185, "mature_H5_site": 127, "mouse_sera_escape": 0.1895, "mutant": "Q", "mutation": "T132Q", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.07467, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.08433, "ferret_sera_escape": -0.495, "mature_H5_site": 127, "mouse_sera_escape": 0.7781, "mutant": "R", "mutation": "T132R", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.1442, "wildtype": "T"}, {"a26_usage": 0.08259, "cell_entry": 0.01629, "ferret_sera_escape": 0.007933, "mature_H5_site": 127, "mouse_sera_escape": 0.1018, "mutant": "S", "mutation": "T132S", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.02971, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 127, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T132T", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1557, "ferret_sera_escape": 0.1522, "mature_H5_site": 127, "mouse_sera_escape": 0.1794, "mutant": "V", "mutation": "T132V", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.006991, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1217, "ferret_sera_escape": -0.0455, "mature_H5_site": 127, "mouse_sera_escape": 1.041, "mutant": "W", "mutation": "T132W", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": 0.02423, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1384, "ferret_sera_escape": -0.06157, "mature_H5_site": 128, "mouse_sera_escape": -0.2062, "mutant": "A", "mutation": "S133A", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.607, "ferret_sera_escape": null, "mature_H5_site": 128, "mouse_sera_escape": null, "mutant": "C", "mutation": "S133C", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": null, "wildtype": "S"}, {"a26_usage": 0.02568, "cell_entry": 0.06721, "ferret_sera_escape": -0.2533, "mature_H5_site": 128, "mouse_sera_escape": 0.2003, "mutant": "E", "mutation": "S133E", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": -0.06509, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.7262, "ferret_sera_escape": -0.2032, "mature_H5_site": 128, "mouse_sera_escape": 0.3111, "mutant": "G", "mutation": "S133G", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": 0.04624, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0365, "ferret_sera_escape": -0.02124, "mature_H5_site": 128, "mouse_sera_escape": -0.04567, "mutant": "H", "mutation": "S133H", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": -0.02982, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1876, "ferret_sera_escape": 0.2534, "mature_H5_site": 128, "mouse_sera_escape": -0.1883, "mutant": "I", "mutation": "S133I", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": -0.1216, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.01511, "ferret_sera_escape": 0.1206, "mature_H5_site": 128, "mouse_sera_escape": 0.7881, "mutant": "K", "mutation": "S133K", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": 0.005723, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.7413, "ferret_sera_escape": null, "mature_H5_site": 128, "mouse_sera_escape": null, "mutant": "M", "mutation": "S133M", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4726, "ferret_sera_escape": 0.02881, "mature_H5_site": 128, "mouse_sera_escape": 0.1795, "mutant": "N", "mutation": "S133N", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": 0.04195, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6122, "ferret_sera_escape": null, "mature_H5_site": 128, "mouse_sera_escape": null, "mutant": "P", "mutation": "S133P", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2461, "ferret_sera_escape": -0.07761, "mature_H5_site": 128, "mouse_sera_escape": 0.0685, "mutant": "Q", "mutation": "S133Q", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": null, "wildtype": "S"}, {"a26_usage": 0.5069, "cell_entry": -0.4765, "ferret_sera_escape": 0.001833, "mature_H5_site": 128, "mouse_sera_escape": 0.5465, "mutant": "R", "mutation": "S133R", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": -0.01084, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 128, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S133S", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0368, "ferret_sera_escape": 0.05302, "mature_H5_site": 128, "mouse_sera_escape": -0.01929, "mutant": "T", "mutation": "S133T", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": 0.01161, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.09649, "ferret_sera_escape": -0.3805, "mature_H5_site": 128, "mouse_sera_escape": -0.2654, "mutant": "Y", "mutation": "S133Y", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": -0.06671, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.07979, "ferret_sera_escape": null, "mature_H5_site": 129, "mouse_sera_escape": null, "mutant": "A", "mutation": "L133aA", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.004685, "ferret_sera_escape": -0.02039, "mature_H5_site": 129, "mouse_sera_escape": 0.1093, "mutant": "C", "mutation": "L133aC", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1198, "ferret_sera_escape": -0.4148, "mature_H5_site": 129, "mouse_sera_escape": 0.001553, "mutant": "D", "mutation": "L133aD", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.1118, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.03465, "ferret_sera_escape": -0.6003, "mature_H5_site": 129, "mouse_sera_escape": -0.3156, "mutant": "E", "mutation": "L133aE", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.1547, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.57, "ferret_sera_escape": -0.1945, "mature_H5_site": 129, "mouse_sera_escape": -0.04586, "mutant": "F", "mutation": "L133aF", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.069, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1576, "ferret_sera_escape": -0.365, "mature_H5_site": 129, "mouse_sera_escape": -0.0976, "mutant": "G", "mutation": "L133aG", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.07034, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.03911, "ferret_sera_escape": 0.1167, "mature_H5_site": 129, "mouse_sera_escape": 0.4647, "mutant": "H", "mutation": "L133aH", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.05335, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.592, "ferret_sera_escape": null, "mature_H5_site": 129, "mouse_sera_escape": null, "mutant": "I", "mutation": "L133aI", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": null, "wildtype": "L"}, {"a26_usage": 0.8524, "cell_entry": -0.42, "ferret_sera_escape": 0.6561, "mature_H5_site": 129, "mouse_sera_escape": 0.5582, "mutant": "K", "mutation": "L133aK", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": 0.008684, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 129, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L133aL", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.09832, "ferret_sera_escape": -0.09323, "mature_H5_site": 129, "mouse_sera_escape": -0.2441, "mutant": "M", "mutation": "L133aM", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.03474, "wildtype": "L"}, {"a26_usage": 0.07267, "cell_entry": 0.02306, "ferret_sera_escape": 0.1135, "mature_H5_site": 129, "mouse_sera_escape": 0.2949, "mutant": "N", "mutation": "L133aN", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.03652, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.02408, "ferret_sera_escape": -0.2238, "mature_H5_site": 129, "mouse_sera_escape": 0.1119, "mutant": "P", "mutation": "L133aP", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.234, "ferret_sera_escape": 0.01676, "mature_H5_site": 129, "mouse_sera_escape": -0.04361, "mutant": "Q", "mutation": "L133aQ", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.05244, "wildtype": "L"}, {"a26_usage": 0.9525, "cell_entry": -0.5591, "ferret_sera_escape": 0.6532, "mature_H5_site": 129, "mouse_sera_escape": 0.6239, "mutant": "R", "mutation": "L133aR", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": 0.03741, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.795, "ferret_sera_escape": 0.3944, "mature_H5_site": 129, "mouse_sera_escape": 0.2457, "mutant": "S", "mutation": "L133aS", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.07976, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.07417, "ferret_sera_escape": 0.09999, "mature_H5_site": 129, "mouse_sera_escape": -0.1208, "mutant": "T", "mutation": "L133aT", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1648, "ferret_sera_escape": 0.3799, "mature_H5_site": 129, "mouse_sera_escape": 0.2852, "mutant": "V", "mutation": "L133aV", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.1296, "wildtype": "L"}, {"a26_usage": 0.08923, "cell_entry": -0.2945, "ferret_sera_escape": -0.03549, "mature_H5_site": 129, "mouse_sera_escape": 0.2445, "mutant": "W", "mutation": "L133aW", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.02372, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.06, "ferret_sera_escape": -1.285, "mature_H5_site": 130, "mouse_sera_escape": -0.8322, "mutant": "A", "mutation": "G134A", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.987, "ferret_sera_escape": -0.1479, "mature_H5_site": 130, "mouse_sera_escape": 0.03293, "mutant": "C", "mutation": "G134C", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.962, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "D", "mutation": "G134D", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 130, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G134G", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.961, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "I", "mutation": "G134I", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.532, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "K", "mutation": "G134K", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.629, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "L", "mutation": "G134L", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.426, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "M", "mutation": "G134M", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.615, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "N", "mutation": "G134N", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7594, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "P", "mutation": "G134P", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.326, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G134Q", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "R", "mutation": "G134R", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.0477, "ferret_sera_escape": -1.17, "mature_H5_site": 130, "mouse_sera_escape": -0.7928, "mutant": "S", "mutation": "G134S", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": -0.22, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.835, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "W", "mutation": "G134W", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G134Y", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0584, "ferret_sera_escape": -0.5081, "mature_H5_site": 131, "mouse_sera_escape": -0.6231, "mutant": "A", "mutation": "V135A", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.1256, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1314, "ferret_sera_escape": -1.485, "mature_H5_site": 131, "mouse_sera_escape": -0.5943, "mutant": "D", "mutation": "V135D", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.1692, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.06537, "ferret_sera_escape": -0.6731, "mature_H5_site": 131, "mouse_sera_escape": -0.4901, "mutant": "E", "mutation": "V135E", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.326, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1621, "ferret_sera_escape": 0.1191, "mature_H5_site": 131, "mouse_sera_escape": -0.2342, "mutant": "F", "mutation": "V135F", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.03415, "wildtype": "V"}, {"a26_usage": 0.2292, "cell_entry": -0.1416, "ferret_sera_escape": 0.03765, "mature_H5_site": 131, "mouse_sera_escape": -0.03884, "mutant": "H", "mutation": "V135H", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.04178, "wildtype": "V"}, {"a26_usage": 0.03239, "cell_entry": 0.03009, "ferret_sera_escape": -0.3866, "mature_H5_site": 131, "mouse_sera_escape": -0.1185, "mutant": "I", "mutation": "V135I", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.01074, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.19, "ferret_sera_escape": -0.7412, "mature_H5_site": 131, "mouse_sera_escape": -0.8161, "mutant": "M", "mutation": "V135M", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.1683, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3763, "ferret_sera_escape": -0.1428, "mature_H5_site": 131, "mouse_sera_escape": -0.2637, "mutant": "N", "mutation": "V135N", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.07567, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.556, "ferret_sera_escape": null, "mature_H5_site": 131, "mouse_sera_escape": null, "mutant": "P", "mutation": "V135P", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0399, "cell_entry": -0.1167, "ferret_sera_escape": -0.6013, "mature_H5_site": 131, "mouse_sera_escape": -0.6525, "mutant": "Q", "mutation": "V135Q", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.1654, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1407, "ferret_sera_escape": null, "mature_H5_site": 131, "mouse_sera_escape": null, "mutant": "R", "mutation": "V135R", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.06751, "ferret_sera_escape": 0.05116, "mature_H5_site": 131, "mouse_sera_escape": -0.03117, "mutant": "T", "mutation": "V135T", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.08419, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 131, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V135V", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7648, "ferret_sera_escape": 0.1078, "mature_H5_site": 131, "mouse_sera_escape": -0.3941, "mutant": "W", "mutation": "V135W", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.0579, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.121, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "F", "mutation": "S136F", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.234, "ferret_sera_escape": -0.5063, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "G", "mutation": "S136G", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.538, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "H", "mutation": "S136H", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.692, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "I", "mutation": "S136I", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.44, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "K", "mutation": "S136K", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.724, "ferret_sera_escape": -0.6853, "mature_H5_site": 132, "mouse_sera_escape": 0.06785, "mutant": "L", "mutation": "S136L", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": 0.1276, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.074, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "N", "mutation": "S136N", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.934, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "P", "mutation": "S136P", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.692, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "R", "mutation": "S136R", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 132, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S136S", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.646, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "V", "mutation": "S136V", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.967, "ferret_sera_escape": -0.1901, "mature_H5_site": 132, "mouse_sera_escape": 0.03639, "mutant": "W", "mutation": "S136W", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.412, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S136Y", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 133, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A137A", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.06001, "ferret_sera_escape": -0.6195, "mature_H5_site": 133, "mouse_sera_escape": -0.2885, "mutant": "C", "mutation": "A137C", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.2137, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4466, "ferret_sera_escape": -1.254, "mature_H5_site": 133, "mouse_sera_escape": null, "mutant": "D", "mutation": "A137D", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.1919, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7334, "ferret_sera_escape": -1.306, "mature_H5_site": 133, "mouse_sera_escape": -0.7148, "mutant": "E", "mutation": "A137E", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.2919, "wildtype": "A"}, {"a26_usage": 0.08923, "cell_entry": -0.04292, "ferret_sera_escape": -0.9273, "mature_H5_site": 133, "mouse_sera_escape": -0.7063, "mutant": "F", "mutation": "A137F", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.2004, "wildtype": "A"}, {"a26_usage": 0.05625, "cell_entry": 0.04366, "ferret_sera_escape": null, "mature_H5_site": 133, "mouse_sera_escape": null, "mutant": "G", "mutation": "A137G", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2374, "ferret_sera_escape": null, "mature_H5_site": 133, "mouse_sera_escape": null, "mutant": "H", "mutation": "A137H", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.04, "ferret_sera_escape": null, "mature_H5_site": 133, "mouse_sera_escape": null, "mutant": "I", "mutation": "A137I", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": null, "wildtype": "A"}, {"a26_usage": 0.5059, "cell_entry": -0.5479, "ferret_sera_escape": -0.4655, "mature_H5_site": 133, "mouse_sera_escape": -0.3315, "mutant": "K", "mutation": "A137K", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.07949, "wildtype": "A"}, {"a26_usage": 0.07783, "cell_entry": 0.05262, "ferret_sera_escape": -1.642, "mature_H5_site": 133, "mouse_sera_escape": -1.076, "mutant": "L", "mutation": "A137L", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.1886, "wildtype": "A"}, {"a26_usage": 0.007461, "cell_entry": 0.04101, "ferret_sera_escape": -0.6409, "mature_H5_site": 133, "mouse_sera_escape": -0.4938, "mutant": "M", "mutation": "A137M", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.04891, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.425, "ferret_sera_escape": -0.4842, "mature_H5_site": 133, "mouse_sera_escape": -0.2588, "mutant": "R", "mutation": "A137R", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.09275, "wildtype": "A"}, {"a26_usage": 0.2372, "cell_entry": -0.02125, "ferret_sera_escape": -1.183, "mature_H5_site": 133, "mouse_sera_escape": -0.7764, "mutant": "S", "mutation": "A137S", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.04579, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1539, "ferret_sera_escape": -1.478, "mature_H5_site": 133, "mouse_sera_escape": -0.8343, "mutant": "T", "mutation": "A137T", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.4922, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4816, "ferret_sera_escape": -1.022, "mature_H5_site": 133, "mouse_sera_escape": -0.5071, "mutant": "V", "mutation": "A137V", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.2293, "wildtype": "A"}, {"a26_usage": 0.9008, "cell_entry": -0.06102, "ferret_sera_escape": -1.345, "mature_H5_site": 133, "mouse_sera_escape": -0.8399, "mutant": "W", "mutation": "A137W", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.1529, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 134, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A138A", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.475, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "C", "mutation": "A138C", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.587, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "D", "mutation": "A138D", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.079, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "E", "mutation": "A138E", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.225, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "G", "mutation": "A138G", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.681, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "H", "mutation": "A138H", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.296, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "I", "mutation": "A138I", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.702, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "K", "mutation": "A138K", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.53, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "M", "mutation": "A138M", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 2.474, "cell_entry": -2.856, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "N", "mutation": "A138N", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.413, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "P", "mutation": "A138P", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.236, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "R", "mutation": "A138R", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.07815, "cell_entry": 0.04583, "ferret_sera_escape": -1.234, "mature_H5_site": 134, "mouse_sera_escape": -0.8255, "mutant": "S", "mutation": "A138S", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": -0.03432, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1186, "ferret_sera_escape": -1.35, "mature_H5_site": 134, "mouse_sera_escape": -0.8478, "mutant": "T", "mutation": "A138T", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": -0.3418, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.014, "ferret_sera_escape": -1.1, "mature_H5_site": 134, "mouse_sera_escape": -0.475, "mutant": "V", "mutation": "A138V", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": -0.2705, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.821, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "W", "mutation": "A138W", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.502, "ferret_sera_escape": -1.274, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A138Y", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "A", "mutation": "C139A", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 135, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C139C", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.95, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "E", "mutation": "C139E", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "F", "mutation": "C139F", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.101, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "G", "mutation": "C139G", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -1.57, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "I", "mutation": "C139I", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.252, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "K", "mutation": "C139K", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.501, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "M", "mutation": "C139M", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.25, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "N", "mutation": "C139N", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.381, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "P", "mutation": "C139P", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.213, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "R", "mutation": "C139R", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.654, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "S", "mutation": "C139S", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.233, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "T", "mutation": "C139T", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.816, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "V", "mutation": "C139V", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.853, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "W", "mutation": "C139W", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.783, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C139Y", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 4, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C14C", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "D", "mutation": "C14D", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.024, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "E", "mutation": "C14E", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.684, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "F", "mutation": "C14F", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.719, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "G", "mutation": "C14G", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "H", "mutation": "C14H", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "I", "mutation": "C14I", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.675, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "K", "mutation": "C14K", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "L", "mutation": "C14L", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "M", "mutation": "C14M", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "N", "mutation": "C14N", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "P", "mutation": "C14P", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C14Q", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "R", "mutation": "C14R", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "S", "mutation": "C14S", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.058, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "T", "mutation": "C14T", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.735, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "V", "mutation": "C14V", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.652, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C14Y", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.2006, "ferret_sera_escape": null, "mature_H5_site": 136, "mouse_sera_escape": null, "mutant": "A", "mutation": "P140A", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.03188, "ferret_sera_escape": 0.1351, "mature_H5_site": 136, "mouse_sera_escape": -0.0009999, "mutant": "C", "mutation": "P140C", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.1304, "wildtype": "P"}, {"a26_usage": 0.122, "cell_entry": 0.009375, "ferret_sera_escape": -0.1594, "mature_H5_site": 136, "mouse_sera_escape": -0.2222, "mutant": "D", "mutation": "P140D", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.2477, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.2311, "ferret_sera_escape": null, "mature_H5_site": 136, "mouse_sera_escape": null, "mutant": "E", "mutation": "P140E", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.07475, "ferret_sera_escape": 0.2266, "mature_H5_site": 136, "mouse_sera_escape": 0.1248, "mutant": "F", "mutation": "P140F", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.006862, "wildtype": "P"}, {"a26_usage": 0.00538, "cell_entry": 0.06391, "ferret_sera_escape": -0.1248, "mature_H5_site": 136, "mouse_sera_escape": -0.08466, "mutant": "H", "mutation": "P140H", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.4241, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.0757, "ferret_sera_escape": 0.04189, "mature_H5_site": 136, "mouse_sera_escape": -0.01616, "mutant": "K", "mutation": "P140K", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.0664, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3775, "ferret_sera_escape": 0.2673, "mature_H5_site": 136, "mouse_sera_escape": 0.06134, "mutant": "L", "mutation": "P140L", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": 0.01035, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3911, "ferret_sera_escape": 0.06328, "mature_H5_site": 136, "mouse_sera_escape": -0.06081, "mutant": "M", "mutation": "P140M", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.01856, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.4926, "ferret_sera_escape": 0.05744, "mature_H5_site": 136, "mouse_sera_escape": -0.01702, "mutant": "N", "mutation": "P140N", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.09801, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 136, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P140P", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.09645, "ferret_sera_escape": null, "mature_H5_site": 136, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P140Q", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.02771, "ferret_sera_escape": 0.0359, "mature_H5_site": 136, "mouse_sera_escape": -0.1546, "mutant": "R", "mutation": "P140R", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.006545, "wildtype": "P"}, {"a26_usage": 0.2352, "cell_entry": 0.01783, "ferret_sera_escape": 0.1136, "mature_H5_site": 136, "mouse_sera_escape": 0.1258, "mutant": "S", "mutation": "P140S", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": 0.005422, "wildtype": "P"}, {"a26_usage": 0.1185, "cell_entry": -0.1215, "ferret_sera_escape": 0.1418, "mature_H5_site": 136, "mouse_sera_escape": -0.0442, "mutant": "T", "mutation": "P140T", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.04083, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.158, "ferret_sera_escape": -0.03974, "mature_H5_site": 136, "mouse_sera_escape": -0.1382, "mutant": "V", "mutation": "P140V", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": 0.01869, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.423, "ferret_sera_escape": 0.3317, "mature_H5_site": 136, "mouse_sera_escape": null, "mutant": "W", "mutation": "P140W", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": null, "wildtype": "P"}, {"a26_usage": 0.06292, "cell_entry": 0.05672, "ferret_sera_escape": -0.1593, "mature_H5_site": 137, "mouse_sera_escape": 0.02171, "mutant": "A", "mutation": "Y141A", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.1461, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.19, "ferret_sera_escape": 0.04533, "mature_H5_site": 137, "mouse_sera_escape": 0.2166, "mutant": "C", "mutation": "Y141C", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.04012, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.05149, "ferret_sera_escape": -0.09157, "mature_H5_site": 137, "mouse_sera_escape": -0.1519, "mutant": "D", "mutation": "Y141D", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.3075, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.2139, "ferret_sera_escape": 0.1761, "mature_H5_site": 137, "mouse_sera_escape": 0.3068, "mutant": "E", "mutation": "Y141E", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": 0.3077, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1863, "ferret_sera_escape": 0.01441, "mature_H5_site": 137, "mouse_sera_escape": 0.04581, "mutant": "F", "mutation": "Y141F", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.08138, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.007, "ferret_sera_escape": 0.06931, "mature_H5_site": 137, "mouse_sera_escape": 0.1555, "mutant": "H", "mutation": "Y141H", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": 0.05973, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.003315, "ferret_sera_escape": -0.4682, "mature_H5_site": 137, "mouse_sera_escape": 0.05976, "mutant": "I", "mutation": "Y141I", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.0468, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1364, "ferret_sera_escape": 0.04031, "mature_H5_site": 137, "mouse_sera_escape": 0.2216, "mutant": "K", "mutation": "Y141K", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": 0.3835, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.02181, "ferret_sera_escape": -0.1523, "mature_H5_site": 137, "mouse_sera_escape": 0.05584, "mutant": "N", "mutation": "Y141N", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": 0.3283, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.04773, "ferret_sera_escape": -1.316, "mature_H5_site": 137, "mouse_sera_escape": -0.6419, "mutant": "P", "mutation": "Y141P", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.2038, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3758, "ferret_sera_escape": 0.107, "mature_H5_site": 137, "mouse_sera_escape": 0.2954, "mutant": "R", "mutation": "Y141R", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": 0.05897, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6931, "ferret_sera_escape": -0.1755, "mature_H5_site": 137, "mouse_sera_escape": 0.009374, "mutant": "S", "mutation": "Y141S", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.6362, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4748, "ferret_sera_escape": -0.4537, "mature_H5_site": 137, "mouse_sera_escape": -0.0883, "mutant": "T", "mutation": "Y141T", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.1588, "wildtype": "Y"}, {"a26_usage": 0.3402, "cell_entry": 0.00161, "ferret_sera_escape": -0.1788, "mature_H5_site": 137, "mouse_sera_escape": 0.2634, "mutant": "V", "mutation": "Y141V", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 137, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y141Y", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.4779, "cell_entry": -0.1526, "ferret_sera_escape": -0.1971, "mature_H5_site": 138, "mouse_sera_escape": 0.1288, "mutant": "A", "mutation": "Q142A", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": 0.04142, "wildtype": "Q"}, {"a26_usage": 0.1221, "cell_entry": -0.2481, "ferret_sera_escape": null, "mature_H5_site": 138, "mouse_sera_escape": null, "mutant": "D", "mutation": "Q142D", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.003485, "ferret_sera_escape": -0.1547, "mature_H5_site": 138, "mouse_sera_escape": -0.1668, "mutant": "E", "mutation": "Q142E", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.1134, "wildtype": "Q"}, {"a26_usage": 0.02764, "cell_entry": 0.02674, "ferret_sera_escape": 0.05055, "mature_H5_site": 138, "mouse_sera_escape": -0.02252, "mutant": "F", "mutation": "Q142F", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": 0.02729, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.03895, "ferret_sera_escape": 0.1091, "mature_H5_site": 138, "mouse_sera_escape": -0.02431, "mutant": "G", "mutation": "Q142G", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.01943, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.07071, "ferret_sera_escape": -0.09697, "mature_H5_site": 138, "mouse_sera_escape": -0.09355, "mutant": "H", "mutation": "Q142H", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": 0.08323, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.05583, "ferret_sera_escape": -0.00781, "mature_H5_site": 138, "mouse_sera_escape": -0.01827, "mutant": "I", "mutation": "Q142I", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.0566, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1495, "ferret_sera_escape": 0.2063, "mature_H5_site": 138, "mouse_sera_escape": -0.001571, "mutant": "K", "mutation": "Q142K", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.06344, "ferret_sera_escape": 0.07519, "mature_H5_site": 138, "mouse_sera_escape": 0.1051, "mutant": "L", "mutation": "Q142L", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.02116, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.06843, "ferret_sera_escape": -0.07516, "mature_H5_site": 138, "mouse_sera_escape": -0.007081, "mutant": "M", "mutation": "Q142M", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.02039, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.05586, "ferret_sera_escape": 0.03197, "mature_H5_site": 138, "mouse_sera_escape": 0.09345, "mutant": "N", "mutation": "Q142N", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.00134, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.9557, "ferret_sera_escape": -0.3381, "mature_H5_site": 138, "mouse_sera_escape": -0.2151, "mutant": "P", "mutation": "Q142P", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.1584, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 138, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q142Q", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0455, "cell_entry": -0.2294, "ferret_sera_escape": null, "mature_H5_site": 138, "mouse_sera_escape": null, "mutant": "R", "mutation": "Q142R", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.07433, "ferret_sera_escape": -0.1218, "mature_H5_site": 138, "mouse_sera_escape": 0.06555, "mutant": "S", "mutation": "Q142S", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.1086, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.02991, "ferret_sera_escape": -0.01247, "mature_H5_site": 138, "mouse_sera_escape": -0.1274, "mutant": "T", "mutation": "Q142T", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.03931, "ferret_sera_escape": -0.007477, "mature_H5_site": 138, "mouse_sera_escape": -0.106, "mutant": "V", "mutation": "Q142V", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.1151, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2743, "ferret_sera_escape": 0.08913, "mature_H5_site": 138, "mouse_sera_escape": 0.01172, "mutant": "W", "mutation": "Q142W", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.0801, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.02496, "ferret_sera_escape": -0.01618, "mature_H5_site": 138, "mouse_sera_escape": -0.09149, "mutant": "Y", "mutation": "Q142Y", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.0479, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.499, "ferret_sera_escape": -0.5644, "mature_H5_site": 139, "mouse_sera_escape": -0.2673, "mutant": "C", "mutation": "G143C", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.1616, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0359, "ferret_sera_escape": -0.07701, "mature_H5_site": 139, "mouse_sera_escape": 0.05713, "mutant": "E", "mutation": "G143E", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.1339, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3977, "ferret_sera_escape": -0.02611, "mature_H5_site": 139, "mouse_sera_escape": -0.01171, "mutant": "F", "mutation": "G143F", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.116, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 139, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G143G", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8786, "ferret_sera_escape": 0.08105, "mature_H5_site": 139, "mouse_sera_escape": -0.08804, "mutant": "H", "mutation": "G143H", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.05291, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2626, "ferret_sera_escape": -0.0773, "mature_H5_site": 139, "mouse_sera_escape": 0.131, "mutant": "K", "mutation": "G143K", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.1033, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.06516, "ferret_sera_escape": -0.07744, "mature_H5_site": 139, "mouse_sera_escape": -0.05537, "mutant": "L", "mutation": "G143L", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.1297, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3786, "ferret_sera_escape": -0.02701, "mature_H5_site": 139, "mouse_sera_escape": 0.07322, "mutant": "M", "mutation": "G143M", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1142, "ferret_sera_escape": -0.07787, "mature_H5_site": 139, "mouse_sera_escape": -0.08921, "mutant": "N", "mutation": "G143N", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": 0.03558, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3872, "ferret_sera_escape": -0.9427, "mature_H5_site": 139, "mouse_sera_escape": null, "mutant": "P", "mutation": "G143P", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": null, "wildtype": "G"}, {"a26_usage": 0.3531, "cell_entry": 0.009535, "ferret_sera_escape": -0.02672, "mature_H5_site": 139, "mouse_sera_escape": 0.03664, "mutant": "R", "mutation": "G143R", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.113, "wildtype": "G"}, {"a26_usage": 0.1562, "cell_entry": -0.1981, "ferret_sera_escape": 0.04416, "mature_H5_site": 139, "mouse_sera_escape": 0.04985, "mutant": "S", "mutation": "G143S", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.06165, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.398, "ferret_sera_escape": null, "mature_H5_site": 139, "mouse_sera_escape": null, "mutant": "T", "mutation": "G143T", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3401, "ferret_sera_escape": -0.1387, "mature_H5_site": 139, "mouse_sera_escape": -0.1696, "mutant": "V", "mutation": "G143V", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.3285, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1149, "ferret_sera_escape": -0.1029, "mature_H5_site": 139, "mouse_sera_escape": -0.06403, "mutant": "W", "mutation": "G143W", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.09006, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.00378, "ferret_sera_escape": 0.027, "mature_H5_site": 139, "mouse_sera_escape": -0.003941, "mutant": "Y", "mutation": "G143Y", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.129, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 140, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A144A", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4667, "ferret_sera_escape": -0.1272, "mature_H5_site": 140, "mouse_sera_escape": -0.1396, "mutant": "D", "mutation": "A144D", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.1527, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.07616, "ferret_sera_escape": -0.214, "mature_H5_site": 140, "mouse_sera_escape": -0.148, "mutant": "E", "mutation": "A144E", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.03617, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.403, "ferret_sera_escape": 0.7396, "mature_H5_site": 140, "mouse_sera_escape": 0.5094, "mutant": "F", "mutation": "A144F", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.1525, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.01749, "ferret_sera_escape": -0.11, "mature_H5_site": 140, "mouse_sera_escape": -0.07908, "mutant": "G", "mutation": "A144G", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.04813, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3443, "ferret_sera_escape": 0.01942, "mature_H5_site": 140, "mouse_sera_escape": -0.2546, "mutant": "H", "mutation": "A144H", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.08874, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5277, "ferret_sera_escape": -0.02274, "mature_H5_site": 140, "mouse_sera_escape": -0.1282, "mutant": "I", "mutation": "A144I", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.004761, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.293, "ferret_sera_escape": null, "mature_H5_site": 140, "mouse_sera_escape": null, "mutant": "K", "mutation": "A144K", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.002535, "ferret_sera_escape": -0.03385, "mature_H5_site": 140, "mouse_sera_escape": -0.06989, "mutant": "M", "mutation": "A144M", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.009135, "wildtype": "A"}, {"a26_usage": 0.01726, "cell_entry": 0.04423, "ferret_sera_escape": 0.02021, "mature_H5_site": 140, "mouse_sera_escape": -0.08287, "mutant": "N", "mutation": "A144N", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.0005508, "wildtype": "A"}, {"a26_usage": 0.5438, "cell_entry": -0.3302, "ferret_sera_escape": -0.1502, "mature_H5_site": 140, "mouse_sera_escape": -0.1985, "mutant": "P", "mutation": "A144P", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.137, "wildtype": "A"}, {"a26_usage": 0.09518, "cell_entry": 0.00594, "ferret_sera_escape": 0.02001, "mature_H5_site": 140, "mouse_sera_escape": 0.03465, "mutant": "Q", "mutation": "A144Q", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.02713, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1412, "ferret_sera_escape": 0.2064, "mature_H5_site": 140, "mouse_sera_escape": 0.2766, "mutant": "R", "mutation": "A144R", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.04135, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.04508, "ferret_sera_escape": -0.03217, "mature_H5_site": 140, "mouse_sera_escape": -0.2069, "mutant": "S", "mutation": "A144S", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.05414, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2714, "ferret_sera_escape": 0.07443, "mature_H5_site": 140, "mouse_sera_escape": -0.06365, "mutant": "T", "mutation": "A144T", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.03793, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.00038, "ferret_sera_escape": -0.002227, "mature_H5_site": 140, "mouse_sera_escape": -0.07155, "mutant": "V", "mutation": "A144V", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.02547, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2538, "ferret_sera_escape": 0.2328, "mature_H5_site": 140, "mouse_sera_escape": -0.1786, "mutant": "W", "mutation": "A144W", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.0211, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3796, "ferret_sera_escape": 0.03711, "mature_H5_site": 140, "mouse_sera_escape": -0.4439, "mutant": "Y", "mutation": "A144Y", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.01636, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.9688, "ferret_sera_escape": 0.2549, "mature_H5_site": 141, "mouse_sera_escape": 0.08867, "mutant": "C", "mutation": "P145C", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.06011, "ferret_sera_escape": null, "mature_H5_site": 141, "mouse_sera_escape": null, "mutant": "E", "mutation": "P145E", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3834, "ferret_sera_escape": null, "mature_H5_site": 141, "mouse_sera_escape": null, "mutant": "F", "mutation": "P145F", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": null, "wildtype": "P"}, {"a26_usage": 0.3064, "cell_entry": 0.03934, "ferret_sera_escape": null, "mature_H5_site": 141, "mouse_sera_escape": null, "mutant": "I", "mutation": "P145I", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.091, "ferret_sera_escape": 0.2313, "mature_H5_site": 141, "mouse_sera_escape": 0.3082, "mutant": "K", "mutation": "P145K", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.704, "ferret_sera_escape": 0.4556, "mature_H5_site": 141, "mouse_sera_escape": 0.3124, "mutant": "L", "mutation": "P145L", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": -0.02013, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.045, "ferret_sera_escape": 0.5671, "mature_H5_site": 141, "mouse_sera_escape": 0.4693, "mutant": "M", "mutation": "P145M", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": -0.01497, "wildtype": "P"}, {"a26_usage": 0.1405, "cell_entry": -1.513, "ferret_sera_escape": 0.1117, "mature_H5_site": 141, "mouse_sera_escape": 0.03363, "mutant": "N", "mutation": "P145N", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": 0.104, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 141, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P145P", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1068, "ferret_sera_escape": 0.3358, "mature_H5_site": 141, "mouse_sera_escape": 0.1982, "mutant": "Q", "mutation": "P145Q", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": -0.04468, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.8528, "ferret_sera_escape": 0.363, "mature_H5_site": 141, "mouse_sera_escape": 0.2814, "mutant": "R", "mutation": "P145R", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": -0.04319, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.07675, "ferret_sera_escape": -0.08747, "mature_H5_site": 141, "mouse_sera_escape": -0.115, "mutant": "T", "mutation": "P145T", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": -0.08383, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.2869, "ferret_sera_escape": -0.5012, "mature_H5_site": 141, "mouse_sera_escape": -0.4067, "mutant": "V", "mutation": "P145V", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": -0.06263, "wildtype": "P"}, {"a26_usage": 0.04858, "cell_entry": -0.0126, "ferret_sera_escape": -0.8703, "mature_H5_site": 141, "mouse_sera_escape": -0.4975, "mutant": "W", "mutation": "P145W", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": -0.1619, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5789, "ferret_sera_escape": 0.04286, "mature_H5_site": 142, "mouse_sera_escape": 0.03123, "mutant": "A", "mutation": "S146A", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.216, "ferret_sera_escape": 0.2493, "mature_H5_site": 142, "mouse_sera_escape": 0.5512, "mutant": "C", "mutation": "S146C", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": -0.2059, "wildtype": "S"}, {"a26_usage": 0.1418, "cell_entry": 0.05071, "ferret_sera_escape": null, "mature_H5_site": 142, "mouse_sera_escape": null, "mutant": "E", "mutation": "S146E", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.01503, "ferret_sera_escape": 0.1651, "mature_H5_site": 142, "mouse_sera_escape": 0.5756, "mutant": "F", "mutation": "S146F", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": 0.0221, "wildtype": "S"}, {"a26_usage": 0.1526, "cell_entry": -0.134, "ferret_sera_escape": 0.01955, "mature_H5_site": 142, "mouse_sera_escape": 0.2568, "mutant": "G", "mutation": "S146G", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": 0.4316, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.04789, "ferret_sera_escape": -0.09482, "mature_H5_site": 142, "mouse_sera_escape": 0.4961, "mutant": "H", "mutation": "S146H", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": 0.3806, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8817, "ferret_sera_escape": -0.897, "mature_H5_site": 142, "mouse_sera_escape": -0.2507, "mutant": "I", "mutation": "S146I", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": -0.2662, "wildtype": "S"}, {"a26_usage": 1.095, "cell_entry": -1.206, "ferret_sera_escape": -0.1648, "mature_H5_site": 142, "mouse_sera_escape": null, "mutant": "K", "mutation": "S146K", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": null, "wildtype": "S"}, {"a26_usage": 0.5323, "cell_entry": -0.03554, "ferret_sera_escape": -0.08094, "mature_H5_site": 142, "mouse_sera_escape": 0.2317, "mutant": "L", "mutation": "S146L", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": -0.1237, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3524, "ferret_sera_escape": 0.02874, "mature_H5_site": 142, "mouse_sera_escape": 0.4124, "mutant": "N", "mutation": "S146N", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": -0.08306, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.678, "ferret_sera_escape": null, "mature_H5_site": 142, "mouse_sera_escape": null, "mutant": "P", "mutation": "S146P", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.09551, "ferret_sera_escape": 0.09578, "mature_H5_site": 142, "mouse_sera_escape": 0.4793, "mutant": "R", "mutation": "S146R", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": 0.3933, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 142, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S146S", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3361, "ferret_sera_escape": -0.1158, "mature_H5_site": 142, "mouse_sera_escape": 0.01304, "mutant": "T", "mutation": "S146T", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": -0.1401, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.316, "ferret_sera_escape": -0.4143, "mature_H5_site": 142, "mouse_sera_escape": -0.003905, "mutant": "V", "mutation": "S146V", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.09571, "ferret_sera_escape": null, "mature_H5_site": 142, "mouse_sera_escape": null, "mutant": "W", "mutation": "S146W", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.06193, "ferret_sera_escape": null, "mature_H5_site": 142, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S146Y", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.062, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "A", "mutation": "F147A", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.923, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "C", "mutation": "F147C", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "D", "mutation": "F147D", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "E", "mutation": "F147E", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 143, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F147F", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.406, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "G", "mutation": "F147G", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.917, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "H", "mutation": "F147H", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.23, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "I", "mutation": "F147I", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "K", "mutation": "F147K", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.8665, "ferret_sera_escape": 0.03166, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "L", "mutation": "F147L", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": 0.7855, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.3293, "ferret_sera_escape": 0.2108, "mature_H5_site": 143, "mouse_sera_escape": 0.2277, "mutant": "M", "mutation": "F147M", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": 0.404, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.96, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "N", "mutation": "F147N", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -4.594, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F147Q", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "R", "mutation": "F147R", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.96, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "T", "mutation": "F147T", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "V", "mutation": "F147V", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.869, "ferret_sera_escape": -0.9702, "mature_H5_site": 143, "mouse_sera_escape": -0.5048, "mutant": "W", "mutation": "F147W", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.4321, "ferret_sera_escape": -0.892, "mature_H5_site": 143, "mouse_sera_escape": -0.5806, "mutant": "Y", "mutation": "F147Y", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": -0.08845, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.8727, "ferret_sera_escape": -0.8373, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "A", "mutation": "F148A", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -4.377, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "C", "mutation": "F148C", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "D", "mutation": "F148D", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "E", "mutation": "F148E", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 144, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F148F", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.903, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "I", "mutation": "F148I", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.088, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "L", "mutation": "F148L", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.4523, "ferret_sera_escape": -0.05893, "mature_H5_site": 144, "mouse_sera_escape": -0.05586, "mutant": "M", "mutation": "F148M", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": -0.2404, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.9477, "ferret_sera_escape": 0.1189, "mature_H5_site": 144, "mouse_sera_escape": 0.1007, "mutant": "N", "mutation": "F148N", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": -0.1383, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.419, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "P", "mutation": "F148P", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.119, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F148Q", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "R", "mutation": "F148R", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.186, "ferret_sera_escape": -0.2934, "mature_H5_site": 144, "mouse_sera_escape": -0.3038, "mutant": "V", "mutation": "F148V", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": -0.1564, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.278, "ferret_sera_escape": -0.3204, "mature_H5_site": 144, "mouse_sera_escape": -0.1203, "mutant": "W", "mutation": "F148W", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": 0.08889, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.03205, "ferret_sera_escape": -0.03991, "mature_H5_site": 145, "mouse_sera_escape": -0.008117, "mutant": "A", "mutation": "R149A", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.7812, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1535, "ferret_sera_escape": -0.2572, "mature_H5_site": 145, "mouse_sera_escape": 0.04478, "mutant": "C", "mutation": "R149C", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.2421, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.815, "ferret_sera_escape": null, "mature_H5_site": 145, "mouse_sera_escape": null, "mutant": "E", "mutation": "R149E", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2118, "ferret_sera_escape": -0.001517, "mature_H5_site": 145, "mouse_sera_escape": -0.1786, "mutant": "F", "mutation": "R149F", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.2478, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.007755, "ferret_sera_escape": -0.1254, "mature_H5_site": 145, "mouse_sera_escape": -0.05685, "mutant": "G", "mutation": "R149G", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.7705, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.03546, "ferret_sera_escape": -0.1015, "mature_H5_site": 145, "mouse_sera_escape": -0.1752, "mutant": "I", "mutation": "R149I", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.162, "ferret_sera_escape": 0.01409, "mature_H5_site": 145, "mouse_sera_escape": 0.3304, "mutant": "K", "mutation": "R149K", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 1.358, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.07247, "ferret_sera_escape": -0.1603, "mature_H5_site": 145, "mouse_sera_escape": -0.1386, "mutant": "M", "mutation": "R149M", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.1503, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.832, "ferret_sera_escape": null, "mature_H5_site": 145, "mouse_sera_escape": null, "mutant": "P", "mutation": "R149P", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.07749, "ferret_sera_escape": -0.09731, "mature_H5_site": 145, "mouse_sera_escape": -0.09567, "mutant": "Q", "mutation": "R149Q", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.86, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 145, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R149R", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.03075, "ferret_sera_escape": null, "mature_H5_site": 145, "mouse_sera_escape": null, "mutant": "S", "mutation": "R149S", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.07515, "ferret_sera_escape": -0.003597, "mature_H5_site": 145, "mouse_sera_escape": 0.02727, "mutant": "T", "mutation": "R149T", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.4314, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.04122, "ferret_sera_escape": -0.1301, "mature_H5_site": 145, "mouse_sera_escape": -0.1892, "mutant": "W", "mutation": "R149W", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.3159, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.07486, "ferret_sera_escape": -0.00353, "mature_H5_site": 145, "mouse_sera_escape": -0.3294, "mutant": "Y", "mutation": "R149Y", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.2602, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2574, "ferret_sera_escape": -0.01815, "mature_H5_site": 5, "mouse_sera_escape": 0.08141, "mutant": "C", "mutation": "I15C", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": -0.2632, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "D", "mutation": "I15D", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.771, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "E", "mutation": "I15E", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "F", "mutation": "I15F", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "G", "mutation": "I15G", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.981, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "H", "mutation": "I15H", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 5, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I15I", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.994, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "K", "mutation": "I15K", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.427, "ferret_sera_escape": -0.2667, "mature_H5_site": 5, "mouse_sera_escape": -0.0613, "mutant": "L", "mutation": "I15L", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": -0.1269, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.721, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "M", "mutation": "I15M", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "N", "mutation": "I15N", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I15Q", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "R", "mutation": "I15R", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.794, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "S", "mutation": "I15S", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3174, "ferret_sera_escape": -0.03984, "mature_H5_site": 5, "mouse_sera_escape": 0.1127, "mutant": "T", "mutation": "I15T", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": -0.1527, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.155, "ferret_sera_escape": 0.05616, "mature_H5_site": 5, "mouse_sera_escape": 0.06288, "mutant": "V", "mutation": "I15V", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": 0.05382, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.347, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "W", "mutation": "I15W", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I15Y", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.366, "ferret_sera_escape": 0.01041, "mature_H5_site": 146, "mouse_sera_escape": -0.04731, "mutant": "A", "mutation": "N150A", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2597, "ferret_sera_escape": null, "mature_H5_site": 146, "mouse_sera_escape": null, "mutant": "C", "mutation": "N150C", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4099, "ferret_sera_escape": 0.003281, "mature_H5_site": 146, "mouse_sera_escape": -0.01063, "mutant": "I", "mutation": "N150I", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": 1.616, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.977, "ferret_sera_escape": null, "mature_H5_site": 146, "mouse_sera_escape": null, "mutant": "K", "mutation": "N150K", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": null, "wildtype": "N"}, {"a26_usage": 0.2103, "cell_entry": 0.04587, "ferret_sera_escape": 0.07867, "mature_H5_site": 146, "mouse_sera_escape": -0.1279, "mutant": "L", "mutation": "N150L", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": 0.6457, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 146, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N150N", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1182, "ferret_sera_escape": null, "mature_H5_site": 146, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N150Q", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04971, "ferret_sera_escape": 0.08317, "mature_H5_site": 146, "mouse_sera_escape": 0.05935, "mutant": "S", "mutation": "N150S", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": -0.1277, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.06692, "ferret_sera_escape": -0.1282, "mature_H5_site": 146, "mouse_sera_escape": 0.02148, "mutant": "V", "mutation": "N150V", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": 0.424, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.708, "ferret_sera_escape": null, "mature_H5_site": 146, "mouse_sera_escape": null, "mutant": "W", "mutation": "N150W", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.254, "ferret_sera_escape": 0.05911, "mature_H5_site": 146, "mouse_sera_escape": 0.2478, "mutant": "Y", "mutation": "N150Y", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": 1.306, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3052, "ferret_sera_escape": null, "mature_H5_site": 147, "mouse_sera_escape": null, "mutant": "A", "mutation": "V151A", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.05337, "cell_entry": 0.0663, "ferret_sera_escape": 0.1043, "mature_H5_site": 147, "mouse_sera_escape": 0.1032, "mutant": "C", "mutation": "V151C", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": -0.2014, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 147, "mouse_sera_escape": null, "mutant": "D", "mutation": "V151D", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.163, "ferret_sera_escape": -0.2195, "mature_H5_site": 147, "mouse_sera_escape": null, "mutant": "E", "mutation": "V151E", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.05281, "ferret_sera_escape": -0.07202, "mature_H5_site": 147, "mouse_sera_escape": -0.1005, "mutant": "G", "mutation": "V151G", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": -0.02074, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.332, "ferret_sera_escape": 0.09342, "mature_H5_site": 147, "mouse_sera_escape": 0.295, "mutant": "H", "mutation": "V151H", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": 0.3483, "wildtype": "V"}, {"a26_usage": 0.08605, "cell_entry": -0.0214, "ferret_sera_escape": 0.03834, "mature_H5_site": 147, "mouse_sera_escape": 0.01509, "mutant": "I", "mutation": "V151I", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": -0.1986, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.773, "ferret_sera_escape": null, "mature_H5_site": 147, "mouse_sera_escape": null, "mutant": "K", "mutation": "V151K", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.06077, "cell_entry": 0.03836, "ferret_sera_escape": -0.09348, "mature_H5_site": 147, "mouse_sera_escape": 0.003199, "mutant": "L", "mutation": "V151L", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": -0.1017, "wildtype": "V"}, {"a26_usage": 0.02176, "cell_entry": -0.03176, "ferret_sera_escape": 0.04356, "mature_H5_site": 147, "mouse_sera_escape": 0.1994, "mutant": "M", "mutation": "V151M", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": 0.3531, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 147, "mouse_sera_escape": null, "mutant": "P", "mutation": "V151P", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4025, "ferret_sera_escape": -0.09462, "mature_H5_site": 147, "mouse_sera_escape": 0.2096, "mutant": "Q", "mutation": "V151Q", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": 0.2618, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 147, "mouse_sera_escape": null, "mutant": "R", "mutation": "V151R", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.02103, "ferret_sera_escape": -0.01438, "mature_H5_site": 147, "mouse_sera_escape": 0.069, "mutant": "S", "mutation": "V151S", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": -0.09947, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.07132, "ferret_sera_escape": 0.04828, "mature_H5_site": 147, "mouse_sera_escape": -0.2424, "mutant": "T", "mutation": "V151T", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 147, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V151V", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.268, "ferret_sera_escape": null, "mature_H5_site": 147, "mouse_sera_escape": null, "mutant": "W", "mutation": "V151W", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.954, "ferret_sera_escape": 0.1162, "mature_H5_site": 147, "mouse_sera_escape": 0.374, "mutant": "Y", "mutation": "V151Y", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5331, "ferret_sera_escape": -0.303, "mature_H5_site": 148, "mouse_sera_escape": -0.00645, "mutant": "A", "mutation": "V152A", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": -0.1364, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.02353, "ferret_sera_escape": -0.04594, "mature_H5_site": 148, "mouse_sera_escape": -0.1146, "mutant": "D", "mutation": "V152D", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": -0.2145, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.536, "ferret_sera_escape": -0.7071, "mature_H5_site": 148, "mouse_sera_escape": -0.1293, "mutant": "E", "mutation": "V152E", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2452, "ferret_sera_escape": -0.1069, "mature_H5_site": 148, "mouse_sera_escape": 0.04345, "mutant": "G", "mutation": "V152G", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": -0.04286, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.00141, "ferret_sera_escape": 0.01524, "mature_H5_site": 148, "mouse_sera_escape": -0.1038, "mutant": "L", "mutation": "V152L", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": 0.005031, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.06008, "ferret_sera_escape": -0.1654, "mature_H5_site": 148, "mouse_sera_escape": 0.1656, "mutant": "M", "mutation": "V152M", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": -0.116, "wildtype": "V"}, {"a26_usage": 0.01973, "cell_entry": 0.07074, "ferret_sera_escape": -0.208, "mature_H5_site": 148, "mouse_sera_escape": -0.09026, "mutant": "N", "mutation": "V152N", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": -0.1058, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.851, "ferret_sera_escape": null, "mature_H5_site": 148, "mouse_sera_escape": null, "mutant": "P", "mutation": "V152P", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.305, "ferret_sera_escape": -0.4045, "mature_H5_site": 148, "mouse_sera_escape": -0.1815, "mutant": "Q", "mutation": "V152Q", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": -0.2555, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.867, "ferret_sera_escape": null, "mature_H5_site": 148, "mouse_sera_escape": null, "mutant": "S", "mutation": "V152S", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 148, "mouse_sera_escape": null, "mutant": "T", "mutation": "V152T", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 148, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V152V", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7711, "ferret_sera_escape": -0.6712, "mature_H5_site": 148, "mouse_sera_escape": 0.5575, "mutant": "W", "mutation": "V152W", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": -0.07291, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "A", "mutation": "W153A", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -6.034, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "C", "mutation": "W153C", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "D", "mutation": "W153D", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "E", "mutation": "W153E", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.603, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "F", "mutation": "W153F", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.608, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "H", "mutation": "W153H", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "I", "mutation": "W153I", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "K", "mutation": "W153K", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.46, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "L", "mutation": "W153L", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.005, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "M", "mutation": "W153M", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.844, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "N", "mutation": "W153N", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.74, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "P", "mutation": "W153P", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.149, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W153Q", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.764, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "R", "mutation": "W153R", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.725, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "S", "mutation": "W153S", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.981, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "T", "mutation": "W153T", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.999, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "V", "mutation": "W153V", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 149, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W153W", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "Y", "mutation": "W153Y", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.3185, "ferret_sera_escape": 0.1871, "mature_H5_site": 150, "mouse_sera_escape": 0.2445, "mutant": "A", "mutation": "L154A", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": -0.2974, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.113, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "C", "mutation": "L154C", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "D", "mutation": "L154D", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "E", "mutation": "L154E", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.522, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "G", "mutation": "L154G", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.1441, "cell_entry": -0.01898, "ferret_sera_escape": 0.04931, "mature_H5_site": 150, "mouse_sera_escape": 0.1685, "mutant": "I", "mutation": "L154I", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": -0.1071, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.44, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "K", "mutation": "L154K", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 150, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L154L", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2172, "ferret_sera_escape": 0.4043, "mature_H5_site": 150, "mouse_sera_escape": 0.1933, "mutant": "M", "mutation": "L154M", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": -0.07408, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "N", "mutation": "L154N", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.543, "ferret_sera_escape": -0.1417, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "P", "mutation": "L154P", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L154Q", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "S", "mutation": "L154S", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7226, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "T", "mutation": "L154T", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.08693, "ferret_sera_escape": -0.2049, "mature_H5_site": 150, "mouse_sera_escape": -0.1363, "mutant": "V", "mutation": "L154V", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": -0.2442, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.299, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "W", "mutation": "L154W", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9856, "ferret_sera_escape": -0.8799, "mature_H5_site": 151, "mouse_sera_escape": -0.8503, "mutant": "A", "mutation": "I155A", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": -0.2274, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.06386, "ferret_sera_escape": -0.8719, "mature_H5_site": 151, "mouse_sera_escape": -0.705, "mutant": "C", "mutation": "I155C", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": -0.2249, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.276, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "E", "mutation": "I155E", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.692, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "F", "mutation": "I155F", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.435, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "H", "mutation": "I155H", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 151, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I155I", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.728, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "K", "mutation": "I155K", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06906, "ferret_sera_escape": -0.6441, "mature_H5_site": 151, "mouse_sera_escape": -0.6382, "mutant": "L", "mutation": "I155L", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": -0.03891, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.283, "ferret_sera_escape": -1.104, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "M", "mutation": "I155M", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1159, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": -0.7482, "mutant": "N", "mutation": "I155N", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": -0.2618, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "P", "mutation": "I155P", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.163, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I155Q", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.106, "ferret_sera_escape": -0.8789, "mature_H5_site": 151, "mouse_sera_escape": -0.4626, "mutant": "S", "mutation": "I155S", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": -0.1167, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0539, "ferret_sera_escape": -0.1447, "mature_H5_site": 151, "mouse_sera_escape": -0.07585, "mutant": "V", "mutation": "I155V", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": 0.01685, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.889, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "W", "mutation": "I155W", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.572, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I155Y", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06617, "ferret_sera_escape": 0.5269, "mature_H5_site": 152, "mouse_sera_escape": 0.3731, "mutant": "C", "mutation": "K156C", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.1208, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.791, "ferret_sera_escape": null, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "D", "mutation": "K156D", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": null, "wildtype": "K"}, {"a26_usage": 1.779, "cell_entry": -1.55, "ferret_sera_escape": null, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "E", "mutation": "K156E", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": null, "wildtype": "K"}, {"a26_usage": 0.03762, "cell_entry": -1.347, "ferret_sera_escape": 0.3123, "mature_H5_site": 152, "mouse_sera_escape": 0.1644, "mutant": "G", "mutation": "K156G", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.05262, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.00381, "ferret_sera_escape": null, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "H", "mutation": "K156H", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7739, "ferret_sera_escape": null, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "I", "mutation": "K156I", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 152, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K156K", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04545, "ferret_sera_escape": 0.5128, "mature_H5_site": 152, "mouse_sera_escape": 0.2622, "mutant": "M", "mutation": "K156M", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.1777, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1758, "ferret_sera_escape": 0.3426, "mature_H5_site": 152, "mouse_sera_escape": 0.04971, "mutant": "N", "mutation": "K156N", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.1173, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.327, "ferret_sera_escape": null, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "P", "mutation": "K156P", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1166, "ferret_sera_escape": 0.5552, "mature_H5_site": 152, "mouse_sera_escape": 0.5613, "mutant": "Q", "mutation": "K156Q", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.02488, "wildtype": "K"}, {"a26_usage": 0.6295, "cell_entry": -0.05433, "ferret_sera_escape": 0.6093, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "R", "mutation": "K156R", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.0636, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04606, "ferret_sera_escape": 0.5339, "mature_H5_site": 152, "mouse_sera_escape": 0.3498, "mutant": "S", "mutation": "K156S", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.1609, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5045, "ferret_sera_escape": 0.5706, "mature_H5_site": 152, "mouse_sera_escape": 0.1814, "mutant": "T", "mutation": "K156T", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.1945, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4253, "ferret_sera_escape": 0.3315, "mature_H5_site": 152, "mouse_sera_escape": 0.1523, "mutant": "V", "mutation": "K156V", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.1901, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.45, "ferret_sera_escape": null, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "W", "mutation": "K156W", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4169, "ferret_sera_escape": 0.3003, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K156Y", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.1913, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.00304, "ferret_sera_escape": 0.6839, "mature_H5_site": 153, "mouse_sera_escape": 0.9152, "mutant": "A", "mutation": "K157A", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.09654, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4119, "ferret_sera_escape": 0.7463, "mature_H5_site": 153, "mouse_sera_escape": 0.7924, "mutant": "C", "mutation": "K157C", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.1508, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.752, "ferret_sera_escape": 0.3418, "mature_H5_site": 153, "mouse_sera_escape": 0.7354, "mutant": "D", "mutation": "K157D", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.1146, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04705, "ferret_sera_escape": 0.381, "mature_H5_site": 153, "mouse_sera_escape": 0.7894, "mutant": "E", "mutation": "K157E", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.3104, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05504, "ferret_sera_escape": 0.8934, "mature_H5_site": 153, "mouse_sera_escape": 1.057, "mutant": "F", "mutation": "K157F", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.1515, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4621, "ferret_sera_escape": 0.0893, "mature_H5_site": 153, "mouse_sera_escape": null, "mutant": "G", "mutation": "K157G", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.01434, "ferret_sera_escape": 0.8405, "mature_H5_site": 153, "mouse_sera_escape": 0.9309, "mutant": "H", "mutation": "K157H", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.1852, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 153, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K157K", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7618, "ferret_sera_escape": 0.5266, "mature_H5_site": 153, "mouse_sera_escape": 0.7113, "mutant": "M", "mutation": "K157M", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.1323, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3925, "ferret_sera_escape": 0.6051, "mature_H5_site": 153, "mouse_sera_escape": 0.9299, "mutant": "N", "mutation": "K157N", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.2589, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 153, "mouse_sera_escape": null, "mutant": "P", "mutation": "K157P", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.00357, "ferret_sera_escape": null, "mature_H5_site": 153, "mouse_sera_escape": null, "mutant": "R", "mutation": "K157R", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6924, "ferret_sera_escape": null, "mature_H5_site": 153, "mouse_sera_escape": null, "mutant": "S", "mutation": "K157S", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1694, "ferret_sera_escape": 0.9899, "mature_H5_site": 153, "mouse_sera_escape": 0.9115, "mutant": "T", "mutation": "K157T", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.7676, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.251, "ferret_sera_escape": 0.9234, "mature_H5_site": 153, "mouse_sera_escape": 1.155, "mutant": "V", "mutation": "K157V", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6327, "ferret_sera_escape": 0.9695, "mature_H5_site": 153, "mouse_sera_escape": 1.234, "mutant": "W", "mutation": "K157W", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.2319, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03411, "ferret_sera_escape": 0.5362, "mature_H5_site": 153, "mouse_sera_escape": 0.9323, "mutant": "Y", "mutation": "K157Y", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.1552, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2676, "ferret_sera_escape": 0.6228, "mature_H5_site": 154, "mouse_sera_escape": 0.6694, "mutant": "A", "mutation": "N158A", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.06027, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.00687, "ferret_sera_escape": 0.5473, "mature_H5_site": 154, "mouse_sera_escape": 0.6269, "mutant": "D", "mutation": "N158D", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.08352, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02899, "ferret_sera_escape": 1.309, "mature_H5_site": 154, "mouse_sera_escape": 1.112, "mutant": "E", "mutation": "N158E", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": 0.004055, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.0964, "ferret_sera_escape": 0.7561, "mature_H5_site": 154, "mouse_sera_escape": 0.5103, "mutant": "F", "mutation": "N158F", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.08931, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0458, "ferret_sera_escape": 0.6113, "mature_H5_site": 154, "mouse_sera_escape": 0.6711, "mutant": "G", "mutation": "N158G", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.0586, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1074, "ferret_sera_escape": 0.8923, "mature_H5_site": 154, "mouse_sera_escape": 0.6799, "mutant": "H", "mutation": "N158H", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.01561, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2683, "ferret_sera_escape": 0.7223, "mature_H5_site": 154, "mouse_sera_escape": 0.7313, "mutant": "I", "mutation": "N158I", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.1269, "wildtype": "N"}, {"a26_usage": 0.4997, "cell_entry": -0.133, "ferret_sera_escape": 0.8485, "mature_H5_site": 154, "mouse_sera_escape": 0.6897, "mutant": "K", "mutation": "N158K", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.08678, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.08541, "ferret_sera_escape": 1.012, "mature_H5_site": 154, "mouse_sera_escape": 0.8163, "mutant": "L", "mutation": "N158L", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.07008, "wildtype": "N"}, {"a26_usage": 0.000125, "cell_entry": -0.1076, "ferret_sera_escape": null, "mature_H5_site": 154, "mouse_sera_escape": null, "mutant": "M", "mutation": "N158M", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 154, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N158N", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.82, "ferret_sera_escape": 0.918, "mature_H5_site": 154, "mouse_sera_escape": 0.8069, "mutant": "P", "mutation": "N158P", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.1945, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1511, "ferret_sera_escape": 1.033, "mature_H5_site": 154, "mouse_sera_escape": 0.7507, "mutant": "Q", "mutation": "N158Q", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.02848, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2995, "ferret_sera_escape": 1.307, "mature_H5_site": 154, "mouse_sera_escape": 1.187, "mutant": "R", "mutation": "N158R", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.004643, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.00284, "ferret_sera_escape": 0.6082, "mature_H5_site": 154, "mouse_sera_escape": 0.5004, "mutant": "S", "mutation": "N158S", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.05661, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.08715, "ferret_sera_escape": null, "mature_H5_site": 154, "mouse_sera_escape": null, "mutant": "V", "mutation": "N158V", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.01745, "ferret_sera_escape": 0.8337, "mature_H5_site": 154, "mouse_sera_escape": 0.7289, "mutant": "W", "mutation": "N158W", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.08638, "wildtype": "N"}, {"a26_usage": 0.4066, "cell_entry": 0.05149, "ferret_sera_escape": 1.076, "mature_H5_site": 155, "mouse_sera_escape": 0.1702, "mutant": "A", "mutation": "D159A", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": -0.1, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 155, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D159D", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7079, "ferret_sera_escape": 1.173, "mature_H5_site": 155, "mouse_sera_escape": 0.1081, "mutant": "F", "mutation": "D159F", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": -0.05204, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2637, "ferret_sera_escape": 1.026, "mature_H5_site": 155, "mouse_sera_escape": 0.2836, "mutant": "G", "mutation": "D159G", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.756, "ferret_sera_escape": null, "mature_H5_site": 155, "mouse_sera_escape": null, "mutant": "I", "mutation": "D159I", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.345, "ferret_sera_escape": null, "mature_H5_site": 155, "mouse_sera_escape": null, "mutant": "K", "mutation": "D159K", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.346, "ferret_sera_escape": 0.8219, "mature_H5_site": 155, "mouse_sera_escape": 0.04847, "mutant": "L", "mutation": "D159L", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": -0.208, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5137, "ferret_sera_escape": 0.5399, "mature_H5_site": 155, "mouse_sera_escape": 0.1222, "mutant": "N", "mutation": "D159N", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": 0.01406, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3926, "ferret_sera_escape": 0.7015, "mature_H5_site": 155, "mouse_sera_escape": -0.3731, "mutant": "Q", "mutation": "D159Q", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": -0.05668, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.422, "ferret_sera_escape": null, "mature_H5_site": 155, "mouse_sera_escape": null, "mutant": "R", "mutation": "D159R", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.887, "ferret_sera_escape": 0.8069, "mature_H5_site": 155, "mouse_sera_escape": 1.111, "mutant": "S", "mutation": "D159S", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.791, "ferret_sera_escape": 0.9006, "mature_H5_site": 155, "mouse_sera_escape": 0.1808, "mutant": "T", "mutation": "D159T", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.181, "ferret_sera_escape": null, "mature_H5_site": 155, "mouse_sera_escape": null, "mutant": "V", "mutation": "D159V", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.594, "ferret_sera_escape": 1.265, "mature_H5_site": 155, "mouse_sera_escape": 0.191, "mutant": "W", "mutation": "D159W", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": -0.1361, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8296, "ferret_sera_escape": 1.095, "mature_H5_site": 155, "mouse_sera_escape": 0.1231, "mutant": "Y", "mutation": "D159Y", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": -0.1029, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.501, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "A", "mutation": "G16A", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "C", "mutation": "G16C", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.008, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "D", "mutation": "G16D", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "E", "mutation": "G16E", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 6, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G16G", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "H", "mutation": "G16H", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.183, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "I", "mutation": "G16I", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "K", "mutation": "G16K", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "L", "mutation": "G16L", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.486, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "M", "mutation": "G16M", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "P", "mutation": "G16P", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.553, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G16Q", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "R", "mutation": "G16R", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": -0.2747, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "S", "mutation": "G16S", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.666, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "T", "mutation": "G16T", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.978, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "V", "mutation": "G16V", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.66, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "W", "mutation": "G16W", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 156, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A160A", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.495, "ferret_sera_escape": 0.9954, "mature_H5_site": 156, "mouse_sera_escape": 0.4418, "mutant": "C", "mutation": "A160C", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.08036, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.04906, "ferret_sera_escape": 0.9352, "mature_H5_site": 156, "mouse_sera_escape": -0.2718, "mutant": "D", "mutation": "A160D", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4254, "ferret_sera_escape": 0.6771, "mature_H5_site": 156, "mouse_sera_escape": -0.2799, "mutant": "E", "mutation": "A160E", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.06171, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1028, "ferret_sera_escape": 0.6945, "mature_H5_site": 156, "mouse_sera_escape": 0.01412, "mutant": "F", "mutation": "A160F", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.08626, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.01629, "ferret_sera_escape": 0.7049, "mature_H5_site": 156, "mouse_sera_escape": 0.07536, "mutant": "H", "mutation": "A160H", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.03205, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.06469, "ferret_sera_escape": 1.224, "mature_H5_site": 156, "mouse_sera_escape": 0.323, "mutant": "I", "mutation": "A160I", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5497, "ferret_sera_escape": 1.304, "mature_H5_site": 156, "mouse_sera_escape": 0.532, "mutant": "K", "mutation": "A160K", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": 0.05874, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.07211, "ferret_sera_escape": 0.7294, "mature_H5_site": 156, "mouse_sera_escape": 0.08381, "mutant": "M", "mutation": "A160M", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": 0.002653, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3024, "ferret_sera_escape": 0.8939, "mature_H5_site": 156, "mouse_sera_escape": 0.1555, "mutant": "N", "mutation": "A160N", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.0137, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.864, "ferret_sera_escape": null, "mature_H5_site": 156, "mouse_sera_escape": null, "mutant": "P", "mutation": "A160P", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1073, "ferret_sera_escape": 0.75, "mature_H5_site": 156, "mouse_sera_escape": 0.1423, "mutant": "Q", "mutation": "A160Q", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.06077, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.0654, "ferret_sera_escape": null, "mature_H5_site": 156, "mouse_sera_escape": 0.9653, "mutant": "S", "mutation": "A160S", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.2048, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.03709, "ferret_sera_escape": 2.257, "mature_H5_site": 156, "mouse_sera_escape": 0.8809, "mutant": "T", "mutation": "A160T", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.0805, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2059, "ferret_sera_escape": 1.018, "mature_H5_site": 156, "mouse_sera_escape": 0.4591, "mutant": "V", "mutation": "A160V", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.0571, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.03065, "ferret_sera_escape": 0.8196, "mature_H5_site": 156, "mouse_sera_escape": -0.1612, "mutant": "W", "mutation": "A160W", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.1941, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.907, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y161A", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y161C", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.709, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y161D", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y161E", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y161G", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.323, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": 0.3904, "mutant": "H", "mutation": "Y161H", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y161I", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y161K", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.983, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y161L", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.824, "ferret_sera_escape": 1.015, "mature_H5_site": 157, "mouse_sera_escape": 1.166, "mutant": "M", "mutation": "Y161M", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.395, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y161N", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y161P", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.993, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y161R", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.996, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y161S", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.845, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y161T", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.179, "ferret_sera_escape": 0.2804, "mature_H5_site": 157, "mouse_sera_escape": 0.005442, "mutant": "W", "mutation": "Y161W", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": -0.1493, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 157, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y161Y", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.00162, "cell_entry": -0.414, "ferret_sera_escape": 0.5494, "mature_H5_site": 158, "mouse_sera_escape": 0.2839, "mutant": "A", "mutation": "P162A", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.09098, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.077, "ferret_sera_escape": null, "mature_H5_site": 158, "mouse_sera_escape": null, "mutant": "C", "mutation": "P162C", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5694, "ferret_sera_escape": 1.791, "mature_H5_site": 158, "mouse_sera_escape": 0.6792, "mutant": "E", "mutation": "P162E", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.2498, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.2397, "ferret_sera_escape": 1.052, "mature_H5_site": 158, "mouse_sera_escape": 0.5343, "mutant": "G", "mutation": "P162G", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.1838, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5207, "ferret_sera_escape": 1.228, "mature_H5_site": 158, "mouse_sera_escape": 0.4704, "mutant": "H", "mutation": "P162H", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.2141, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.02312, "ferret_sera_escape": 1.42, "mature_H5_site": 158, "mouse_sera_escape": 0.6862, "mutant": "K", "mutation": "P162K", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.2018, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.568, "ferret_sera_escape": null, "mature_H5_site": 158, "mouse_sera_escape": null, "mutant": "L", "mutation": "P162L", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.4015, "ferret_sera_escape": 1.041, "mature_H5_site": 158, "mouse_sera_escape": 0.4592, "mutant": "M", "mutation": "P162M", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.2043, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.02878, "ferret_sera_escape": 1.599, "mature_H5_site": 158, "mouse_sera_escape": 0.723, "mutant": "N", "mutation": "P162N", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": 0.001949, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 158, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P162P", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.3668, "cell_entry": -0.3115, "ferret_sera_escape": 1.559, "mature_H5_site": 158, "mouse_sera_escape": 0.543, "mutant": "Q", "mutation": "P162Q", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.1631, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3961, "ferret_sera_escape": 0.9104, "mature_H5_site": 158, "mouse_sera_escape": 0.5815, "mutant": "R", "mutation": "P162R", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.2041, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1376, "ferret_sera_escape": 0.9374, "mature_H5_site": 158, "mouse_sera_escape": 0.4456, "mutant": "S", "mutation": "P162S", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.2022, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.6296, "ferret_sera_escape": 1.239, "mature_H5_site": 158, "mouse_sera_escape": 0.5125, "mutant": "T", "mutation": "P162T", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.09889, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5012, "ferret_sera_escape": 0.6577, "mature_H5_site": 158, "mouse_sera_escape": 0.4012, "mutant": "V", "mutation": "P162V", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.2655, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.165, "ferret_sera_escape": null, "mature_H5_site": 158, "mouse_sera_escape": null, "mutant": "W", "mutation": "P162W", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3744, "ferret_sera_escape": -0.02211, "mature_H5_site": 159, "mouse_sera_escape": -0.109, "mutant": "A", "mutation": "T163A", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.211, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.06918, "ferret_sera_escape": 0.2852, "mature_H5_site": 159, "mouse_sera_escape": -0.07306, "mutant": "D", "mutation": "T163D", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2873, "wildtype": "T"}, {"a26_usage": 0.3155, "cell_entry": -1.032, "ferret_sera_escape": 0.02261, "mature_H5_site": 159, "mouse_sera_escape": -0.1816, "mutant": "E", "mutation": "T163E", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2351, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4447, "ferret_sera_escape": -0.04837, "mature_H5_site": 159, "mouse_sera_escape": -0.1618, "mutant": "G", "mutation": "T163G", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2326, "wildtype": "T"}, {"a26_usage": 0.08335, "cell_entry": -0.1646, "ferret_sera_escape": 0.4113, "mature_H5_site": 159, "mouse_sera_escape": -0.121, "mutant": "H", "mutation": "T163H", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2413, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.01755, "ferret_sera_escape": 0.2953, "mature_H5_site": 159, "mouse_sera_escape": 0.1689, "mutant": "I", "mutation": "T163I", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.009311, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.06674, "ferret_sera_escape": 0.4562, "mature_H5_site": 159, "mouse_sera_escape": -0.05427, "mutant": "K", "mutation": "T163K", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.03687, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.03057, "ferret_sera_escape": 0.1804, "mature_H5_site": 159, "mouse_sera_escape": 0.07446, "mutant": "M", "mutation": "T163M", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.002277, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1049, "ferret_sera_escape": 0.07733, "mature_H5_site": 159, "mouse_sera_escape": -0.06645, "mutant": "N", "mutation": "T163N", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.07433, "ferret_sera_escape": -0.6038, "mature_H5_site": 159, "mouse_sera_escape": -0.09846, "mutant": "P", "mutation": "T163P", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2193, "wildtype": "T"}, {"a26_usage": 0.07712, "cell_entry": -0.09958, "ferret_sera_escape": 0.2192, "mature_H5_site": 159, "mouse_sera_escape": 0.003765, "mutant": "Q", "mutation": "T163Q", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2177, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 159, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T163T", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.01879, "ferret_sera_escape": 0.2908, "mature_H5_site": 159, "mouse_sera_escape": 0.01255, "mutant": "V", "mutation": "T163V", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.0123, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.01324, "ferret_sera_escape": 0.04127, "mature_H5_site": 159, "mouse_sera_escape": -0.1848, "mutant": "W", "mutation": "T163W", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2085, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1734, "ferret_sera_escape": 0.1211, "mature_H5_site": 159, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T163Y", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.06499, "ferret_sera_escape": 0.07144, "mature_H5_site": 160, "mouse_sera_escape": 0.2219, "mutant": "A", "mutation": "I164A", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": -0.2212, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2772, "ferret_sera_escape": null, "mature_H5_site": 160, "mouse_sera_escape": null, "mutant": "C", "mutation": "I164C", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.316, "ferret_sera_escape": null, "mature_H5_site": 160, "mouse_sera_escape": null, "mutant": "D", "mutation": "I164D", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.329, "ferret_sera_escape": 0.1718, "mature_H5_site": 160, "mouse_sera_escape": 0.8442, "mutant": "E", "mutation": "I164E", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.07838, "ferret_sera_escape": -0.3422, "mature_H5_site": 160, "mouse_sera_escape": -0.01459, "mutant": "F", "mutation": "I164F", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.303, "ferret_sera_escape": null, "mature_H5_site": 160, "mouse_sera_escape": null, "mutant": "G", "mutation": "I164G", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1712, "ferret_sera_escape": -0.5242, "mature_H5_site": 160, "mouse_sera_escape": -0.1238, "mutant": "H", "mutation": "I164H", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": -0.3458, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 160, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I164I", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.936, "ferret_sera_escape": 0.08734, "mature_H5_site": 160, "mouse_sera_escape": 0.0555, "mutant": "K", "mutation": "I164K", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.167, "ferret_sera_escape": null, "mature_H5_site": 160, "mouse_sera_escape": null, "mutant": "N", "mutation": "I164N", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.945, "ferret_sera_escape": null, "mature_H5_site": 160, "mouse_sera_escape": null, "mutant": "P", "mutation": "I164P", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.674, "ferret_sera_escape": 0.06604, "mature_H5_site": 160, "mouse_sera_escape": 0.02297, "mutant": "Q", "mutation": "I164Q", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.295, "ferret_sera_escape": null, "mature_H5_site": 160, "mouse_sera_escape": null, "mutant": "R", "mutation": "I164R", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6368, "ferret_sera_escape": null, "mature_H5_site": 160, "mouse_sera_escape": null, "mutant": "T", "mutation": "I164T", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6973, "ferret_sera_escape": -0.1434, "mature_H5_site": 160, "mouse_sera_escape": -0.1621, "mutant": "W", "mutation": "I164W", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": -0.6107, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.667, "ferret_sera_escape": 0.2362, "mature_H5_site": 161, "mouse_sera_escape": -0.206, "mutant": "A", "mutation": "K165A", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.1865, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3008, "ferret_sera_escape": -0.1999, "mature_H5_site": 161, "mouse_sera_escape": -0.153, "mutant": "C", "mutation": "K165C", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": null, "wildtype": "K"}, {"a26_usage": 0.1989, "cell_entry": 0.0386, "ferret_sera_escape": -0.1349, "mature_H5_site": 161, "mouse_sera_escape": -0.5527, "mutant": "D", "mutation": "K165D", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.279, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1588, "ferret_sera_escape": -0.1098, "mature_H5_site": 161, "mouse_sera_escape": -0.4628, "mutant": "E", "mutation": "K165E", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.1858, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.01622, "ferret_sera_escape": 0.005283, "mature_H5_site": 161, "mouse_sera_escape": -0.4205, "mutant": "F", "mutation": "K165F", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.1384, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3926, "ferret_sera_escape": -0.06418, "mature_H5_site": 161, "mouse_sera_escape": -0.3506, "mutant": "G", "mutation": "K165G", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.3726, "wildtype": "K"}, {"a26_usage": 0.04977, "cell_entry": -0.01079, "ferret_sera_escape": 0.1971, "mature_H5_site": 161, "mouse_sera_escape": -0.3415, "mutant": "H", "mutation": "K165H", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.01703, "wildtype": "K"}, {"a26_usage": 0.0464, "cell_entry": 0.04642, "ferret_sera_escape": 0.05038, "mature_H5_site": 161, "mouse_sera_escape": -0.379, "mutant": "I", "mutation": "K165I", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.163, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 161, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K165K", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7407, "ferret_sera_escape": 0.1628, "mature_H5_site": 161, "mouse_sera_escape": -0.3493, "mutant": "M", "mutation": "K165M", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.1191, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05429, "ferret_sera_escape": -0.2081, "mature_H5_site": 161, "mouse_sera_escape": -0.5565, "mutant": "N", "mutation": "K165N", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.4939, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.242, "ferret_sera_escape": null, "mature_H5_site": 161, "mouse_sera_escape": null, "mutant": "P", "mutation": "K165P", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07213, "ferret_sera_escape": 0.03513, "mature_H5_site": 161, "mouse_sera_escape": -0.3964, "mutant": "Q", "mutation": "K165Q", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.2112, "wildtype": "K"}, {"a26_usage": 0.01222, "cell_entry": 0.07884, "ferret_sera_escape": -0.09317, "mature_H5_site": 161, "mouse_sera_escape": -0.05732, "mutant": "R", "mutation": "K165R", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.02349, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04617, "ferret_sera_escape": 0.1435, "mature_H5_site": 161, "mouse_sera_escape": -0.3486, "mutant": "V", "mutation": "K165V", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.1436, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5598, "ferret_sera_escape": null, "mature_H5_site": 161, "mouse_sera_escape": null, "mutant": "W", "mutation": "K165W", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0739, "ferret_sera_escape": 0.2782, "mature_H5_site": 161, "mouse_sera_escape": -0.2974, "mutant": "Y", "mutation": "K165Y", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.1365, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.235, "ferret_sera_escape": 0.1057, "mature_H5_site": 162, "mouse_sera_escape": 0.1153, "mutant": "A", "mutation": "I166A", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": -0.09841, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.01314, "ferret_sera_escape": -0.1672, "mature_H5_site": 162, "mouse_sera_escape": null, "mutant": "C", "mutation": "I166C", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 162, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I166I", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.03416, "ferret_sera_escape": 0.06387, "mature_H5_site": 162, "mouse_sera_escape": 0.01819, "mutant": "L", "mutation": "I166L", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": 0.1887, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.04372, "ferret_sera_escape": 0.009895, "mature_H5_site": 162, "mouse_sera_escape": 0.1206, "mutant": "M", "mutation": "I166M", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.05155, "ferret_sera_escape": null, "mature_H5_site": 162, "mouse_sera_escape": null, "mutant": "N", "mutation": "I166N", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.866, "ferret_sera_escape": null, "mature_H5_site": 162, "mouse_sera_escape": null, "mutant": "P", "mutation": "I166P", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03975, "ferret_sera_escape": -0.01186, "mature_H5_site": 162, "mouse_sera_escape": 0.03153, "mutant": "S", "mutation": "I166S", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": -0.1656, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.105, "ferret_sera_escape": -0.1138, "mature_H5_site": 162, "mouse_sera_escape": 0.04174, "mutant": "V", "mutation": "I166V", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.06066, "ferret_sera_escape": 0.08912, "mature_H5_site": 162, "mouse_sera_escape": 0.1097, "mutant": "W", "mutation": "I166W", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": -0.06538, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.01236, "ferret_sera_escape": -0.05659, "mature_H5_site": 163, "mouse_sera_escape": 0.002162, "mutant": "A", "mutation": "S167A", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.09579, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6672, "ferret_sera_escape": 0.1898, "mature_H5_site": 163, "mouse_sera_escape": 0.05593, "mutant": "C", "mutation": "S167C", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.2096, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.01852, "ferret_sera_escape": -0.1991, "mature_H5_site": 163, "mouse_sera_escape": -0.1834, "mutant": "D", "mutation": "S167D", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.2467, "wildtype": "S"}, {"a26_usage": 0.114, "cell_entry": 0.00225, "ferret_sera_escape": -0.1936, "mature_H5_site": 163, "mouse_sera_escape": -0.3681, "mutant": "E", "mutation": "S167E", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.04089, "wildtype": "S"}, {"a26_usage": 0.05252, "cell_entry": -0.495, "ferret_sera_escape": -0.1233, "mature_H5_site": 163, "mouse_sera_escape": -0.06811, "mutant": "F", "mutation": "S167F", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.162, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1599, "ferret_sera_escape": -0.0789, "mature_H5_site": 163, "mouse_sera_escape": 0.02432, "mutant": "G", "mutation": "S167G", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.05972, "wildtype": "S"}, {"a26_usage": 0.09237, "cell_entry": 0.07393, "ferret_sera_escape": -0.2162, "mature_H5_site": 163, "mouse_sera_escape": -0.1052, "mutant": "H", "mutation": "S167H", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6193, "ferret_sera_escape": 0.05962, "mature_H5_site": 163, "mouse_sera_escape": -0.05059, "mutant": "I", "mutation": "S167I", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.05342, "wildtype": "S"}, {"a26_usage": 1.753, "cell_entry": -0.1715, "ferret_sera_escape": 0.2321, "mature_H5_site": 163, "mouse_sera_escape": 0.2421, "mutant": "K", "mutation": "S167K", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": 0.04683, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1144, "ferret_sera_escape": -0.1469, "mature_H5_site": 163, "mouse_sera_escape": -0.05289, "mutant": "L", "mutation": "S167L", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.1434, "wildtype": "S"}, {"a26_usage": 0.1464, "cell_entry": -0.05107, "ferret_sera_escape": 0.02701, "mature_H5_site": 163, "mouse_sera_escape": -0.4168, "mutant": "M", "mutation": "S167M", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.02662, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1458, "ferret_sera_escape": 0.006297, "mature_H5_site": 163, "mouse_sera_escape": -0.01862, "mutant": "N", "mutation": "S167N", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.05605, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.718, "ferret_sera_escape": 0.01305, "mature_H5_site": 163, "mouse_sera_escape": 0.2542, "mutant": "P", "mutation": "S167P", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": null, "wildtype": "S"}, {"a26_usage": 0.06023, "cell_entry": 0.01687, "ferret_sera_escape": -0.0002467, "mature_H5_site": 163, "mouse_sera_escape": -0.05768, "mutant": "Q", "mutation": "S167Q", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.0358, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3122, "ferret_sera_escape": -0.04527, "mature_H5_site": 163, "mouse_sera_escape": 0.09775, "mutant": "R", "mutation": "S167R", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.005479, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 163, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S167S", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1629, "ferret_sera_escape": -0.02258, "mature_H5_site": 163, "mouse_sera_escape": 0.05395, "mutant": "T", "mutation": "S167T", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.009375, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.00976, "ferret_sera_escape": 0.03602, "mature_H5_site": 163, "mouse_sera_escape": -0.06302, "mutant": "V", "mutation": "S167V", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.07212, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1233, "ferret_sera_escape": null, "mature_H5_site": 163, "mouse_sera_escape": -0.1506, "mutant": "W", "mutation": "S167W", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.1027, "wildtype": "S"}, {"a26_usage": 0.06689, "cell_entry": -0.03838, "ferret_sera_escape": -0.1863, "mature_H5_site": 163, "mouse_sera_escape": -0.1862, "mutant": "Y", "mutation": "S167Y", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.1772, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y168D", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.533, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y168G", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.116, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y168K", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.2135, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y168L", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y168N", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.773, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y168Q", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.543, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y168R", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.242, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": 0.2936, "mutant": "T", "mutation": "Y168T", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.04275, "ferret_sera_escape": 0.008316, "mature_H5_site": 164, "mouse_sera_escape": -0.004664, "mutant": "W", "mutation": "Y168W", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": -0.07622, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 164, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y168Y", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1239, "ferret_sera_escape": 0.3203, "mature_H5_site": 165, "mouse_sera_escape": 0.02164, "mutant": "A", "mutation": "N169A", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.0268, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4773, "ferret_sera_escape": 0.1517, "mature_H5_site": 165, "mouse_sera_escape": null, "mutant": "C", "mutation": "N169C", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8375, "ferret_sera_escape": 0.0556, "mature_H5_site": 165, "mouse_sera_escape": 0.005089, "mutant": "D", "mutation": "N169D", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.1534, "wildtype": "N"}, {"a26_usage": 0.562, "cell_entry": -1.044, "ferret_sera_escape": 0.1866, "mature_H5_site": 165, "mouse_sera_escape": 0.06771, "mutant": "E", "mutation": "N169E", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.0699, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8632, "ferret_sera_escape": 0.3308, "mature_H5_site": 165, "mouse_sera_escape": 0.01366, "mutant": "F", "mutation": "N169F", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.0919, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6752, "ferret_sera_escape": 0.1528, "mature_H5_site": 165, "mouse_sera_escape": 0.006806, "mutant": "G", "mutation": "N169G", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.1923, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3942, "ferret_sera_escape": 0.2325, "mature_H5_site": 165, "mouse_sera_escape": 0.04409, "mutant": "H", "mutation": "N169H", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.01155, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5725, "ferret_sera_escape": 0.1767, "mature_H5_site": 165, "mouse_sera_escape": -0.06636, "mutant": "I", "mutation": "N169I", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.002381, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5608, "ferret_sera_escape": 0.1622, "mature_H5_site": 165, "mouse_sera_escape": -0.02267, "mutant": "K", "mutation": "N169K", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.09381, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1149, "ferret_sera_escape": 0.1518, "mature_H5_site": 165, "mouse_sera_escape": -0.2403, "mutant": "L", "mutation": "N169L", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.1013, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.62, "ferret_sera_escape": 0.1987, "mature_H5_site": 165, "mouse_sera_escape": -0.07931, "mutant": "M", "mutation": "N169M", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.007434, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 165, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N169N", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9624, "ferret_sera_escape": 0.3603, "mature_H5_site": 165, "mouse_sera_escape": -0.3962, "mutant": "P", "mutation": "N169P", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.004168, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4913, "ferret_sera_escape": 0.1981, "mature_H5_site": 165, "mouse_sera_escape": -0.02213, "mutant": "Q", "mutation": "N169Q", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.004183, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8052, "ferret_sera_escape": 0.2264, "mature_H5_site": 165, "mouse_sera_escape": 0.003825, "mutant": "R", "mutation": "N169R", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.06424, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3594, "ferret_sera_escape": 0.2862, "mature_H5_site": 165, "mouse_sera_escape": 0.1053, "mutant": "S", "mutation": "N169S", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.02601, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.203, "ferret_sera_escape": -0.01131, "mature_H5_site": 165, "mouse_sera_escape": 0.01684, "mutant": "T", "mutation": "N169T", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.1139, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.061, "ferret_sera_escape": 0.3044, "mature_H5_site": 165, "mouse_sera_escape": -0.02194, "mutant": "V", "mutation": "N169V", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.01005, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.636, "ferret_sera_escape": 0.245, "mature_H5_site": 165, "mouse_sera_escape": 0.103, "mutant": "W", "mutation": "N169W", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.00184, "wildtype": "N"}, {"a26_usage": 0.4512, "cell_entry": -0.1939, "ferret_sera_escape": 0.041, "mature_H5_site": 165, "mouse_sera_escape": 0.1008, "mutant": "Y", "mutation": "N169Y", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.005351, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.573, "ferret_sera_escape": -0.1707, "mature_H5_site": 7, "mouse_sera_escape": 0.5134, "mutant": "C", "mutation": "Y17C", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": 1.06, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y17D", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y17E", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.0, "ferret_sera_escape": -0.0588, "mature_H5_site": 7, "mouse_sera_escape": 0.07518, "mutant": "F", "mutation": "Y17F", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": 1.153, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.171, "ferret_sera_escape": 0.03577, "mature_H5_site": 7, "mouse_sera_escape": 0.07871, "mutant": "H", "mutation": "Y17H", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.561, "ferret_sera_escape": null, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y17L", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.2625, "ferret_sera_escape": -0.1929, "mature_H5_site": 7, "mouse_sera_escape": 0.2087, "mutant": "M", "mutation": "Y17M", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": 1.779, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.609, "ferret_sera_escape": null, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y17N", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y17P", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.791, "ferret_sera_escape": -0.4558, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y17Q", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.508, "ferret_sera_escape": null, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y17R", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.694, "ferret_sera_escape": null, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y17S", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.212, "ferret_sera_escape": -0.2496, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y17T", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": 1.609, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.9518, "ferret_sera_escape": 0.01583, "mature_H5_site": 7, "mouse_sera_escape": 0.4351, "mutant": "W", "mutation": "Y17W", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": 1.08, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 7, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y17Y", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.859, "ferret_sera_escape": null, "mature_H5_site": 166, "mouse_sera_escape": null, "mutant": "D", "mutation": "N170D", "reference_site": "170", "region": "HA1", "sequential_site": 182, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 166, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N170N", "reference_site": "170", "region": "HA1", "sequential_site": 182, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2983, "ferret_sera_escape": 0.2701, "mature_H5_site": 167, "mouse_sera_escape": 0.02445, "mutant": "A", "mutation": "T171A", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.09637, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.056, "ferret_sera_escape": 0.07308, "mature_H5_site": 167, "mouse_sera_escape": 0.1993, "mutant": "D", "mutation": "T171D", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.09455, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5969, "ferret_sera_escape": null, "mature_H5_site": 167, "mouse_sera_escape": null, "mutant": "E", "mutation": "T171E", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.197, "ferret_sera_escape": 0.2418, "mature_H5_site": 167, "mouse_sera_escape": -0.1285, "mutant": "F", "mutation": "T171F", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.09649, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4069, "ferret_sera_escape": 0.2481, "mature_H5_site": 167, "mouse_sera_escape": -0.07925, "mutant": "G", "mutation": "T171G", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.1058, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4696, "ferret_sera_escape": 0.2607, "mature_H5_site": 167, "mouse_sera_escape": 0.3925, "mutant": "I", "mutation": "T171I", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.06396, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.103, "ferret_sera_escape": 0.4282, "mature_H5_site": 167, "mouse_sera_escape": 0.1438, "mutant": "K", "mutation": "T171K", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": 0.01693, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.549, "ferret_sera_escape": 0.33, "mature_H5_site": 167, "mouse_sera_escape": -0.01351, "mutant": "L", "mutation": "T171L", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.05591, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5026, "ferret_sera_escape": 0.2229, "mature_H5_site": 167, "mouse_sera_escape": 0.03059, "mutant": "N", "mutation": "T171N", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.05, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7733, "ferret_sera_escape": 0.1796, "mature_H5_site": 167, "mouse_sera_escape": -0.1433, "mutant": "P", "mutation": "T171P", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.1724, "wildtype": "T"}, {"a26_usage": 0.4895, "cell_entry": -0.2303, "ferret_sera_escape": 0.2752, "mature_H5_site": 167, "mouse_sera_escape": 0.1957, "mutant": "Q", "mutation": "T171Q", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.008205, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.8508, "ferret_sera_escape": 0.2267, "mature_H5_site": 167, "mouse_sera_escape": 0.1032, "mutant": "R", "mutation": "T171R", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.01106, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.929, "ferret_sera_escape": null, "mature_H5_site": 167, "mouse_sera_escape": null, "mutant": "S", "mutation": "T171S", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 167, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T171T", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.9328, "ferret_sera_escape": null, "mature_H5_site": 167, "mouse_sera_escape": null, "mutant": "V", "mutation": "T171V", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.8176, "ferret_sera_escape": 0.2958, "mature_H5_site": 167, "mouse_sera_escape": -0.06192, "mutant": "W", "mutation": "T171W", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.3096, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3792, "ferret_sera_escape": 0.2414, "mature_H5_site": 167, "mouse_sera_escape": -0.0194, "mutant": "Y", "mutation": "T171Y", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.06889, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.01337, "ferret_sera_escape": 0.2236, "mature_H5_site": 168, "mouse_sera_escape": -0.08415, "mutant": "A", "mutation": "N172A", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": -0.04478, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9611, "ferret_sera_escape": 0.02685, "mature_H5_site": 168, "mouse_sera_escape": 0.288, "mutant": "C", "mutation": "N172C", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2963, "ferret_sera_escape": -0.2969, "mature_H5_site": 168, "mouse_sera_escape": -0.2148, "mutant": "D", "mutation": "N172D", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": null, "wildtype": "N"}, {"a26_usage": 0.6679, "cell_entry": -0.1689, "ferret_sera_escape": -0.3221, "mature_H5_site": 168, "mouse_sera_escape": 0.1622, "mutant": "E", "mutation": "N172E", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": -0.002466, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2781, "ferret_sera_escape": -0.01008, "mature_H5_site": 168, "mouse_sera_escape": 0.1778, "mutant": "F", "mutation": "N172F", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.1274, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07768, "ferret_sera_escape": null, "mature_H5_site": 168, "mouse_sera_escape": null, "mutant": "G", "mutation": "N172G", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07389, "ferret_sera_escape": -0.3148, "mature_H5_site": 168, "mouse_sera_escape": 0.008718, "mutant": "I", "mutation": "N172I", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.421, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07534, "ferret_sera_escape": -0.02003, "mature_H5_site": 168, "mouse_sera_escape": 0.5226, "mutant": "K", "mutation": "N172K", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.2524, "wildtype": "N"}, {"a26_usage": 0.1364, "cell_entry": -0.05631, "ferret_sera_escape": -0.09923, "mature_H5_site": 168, "mouse_sera_escape": -0.1085, "mutant": "L", "mutation": "N172L", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.06923, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1514, "ferret_sera_escape": -0.2337, "mature_H5_site": 168, "mouse_sera_escape": -0.066, "mutant": "M", "mutation": "N172M", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": -0.02846, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 168, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N172N", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 168, "mouse_sera_escape": null, "mutant": "P", "mutation": "N172P", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2112, "ferret_sera_escape": -0.2501, "mature_H5_site": 168, "mouse_sera_escape": 0.2512, "mutant": "Q", "mutation": "N172Q", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1487, "ferret_sera_escape": -0.06362, "mature_H5_site": 168, "mouse_sera_escape": 0.2336, "mutant": "R", "mutation": "N172R", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": -0.02646, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3085, "ferret_sera_escape": -0.2898, "mature_H5_site": 168, "mouse_sera_escape": -0.196, "mutant": "S", "mutation": "N172S", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.851, "ferret_sera_escape": null, "mature_H5_site": 168, "mouse_sera_escape": null, "mutant": "T", "mutation": "N172T", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1809, "ferret_sera_escape": -0.2453, "mature_H5_site": 168, "mouse_sera_escape": 0.05441, "mutant": "V", "mutation": "N172V", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.0662, "wildtype": "N"}, {"a26_usage": 0.1049, "cell_entry": 0.00201, "ferret_sera_escape": -0.155, "mature_H5_site": 168, "mouse_sera_escape": 0.3009, "mutant": "W", "mutation": "N172W", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.1994, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07883, "ferret_sera_escape": -0.2529, "mature_H5_site": 168, "mouse_sera_escape": 0.5559, "mutant": "Y", "mutation": "N172Y", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.3851, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1192, "ferret_sera_escape": -0.05476, "mature_H5_site": 169, "mouse_sera_escape": 0.0102, "mutant": "A", "mutation": "R173A", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.04628, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.05112, "ferret_sera_escape": null, "mature_H5_site": 169, "mouse_sera_escape": null, "mutant": "C", "mutation": "R173C", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.8701, "ferret_sera_escape": -0.05081, "mature_H5_site": 169, "mouse_sera_escape": 0.0706, "mutant": "D", "mutation": "R173D", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.335, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.01784, "ferret_sera_escape": -0.04108, "mature_H5_site": 169, "mouse_sera_escape": -0.01077, "mutant": "E", "mutation": "R173E", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.1345, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.00217, "ferret_sera_escape": -0.1136, "mature_H5_site": 169, "mouse_sera_escape": -0.008103, "mutant": "F", "mutation": "R173F", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.09475, "wildtype": "R"}, {"a26_usage": 0.1851, "cell_entry": -0.4831, "ferret_sera_escape": -0.08098, "mature_H5_site": 169, "mouse_sera_escape": 0.2034, "mutant": "G", "mutation": "R173G", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.264, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.09069, "ferret_sera_escape": 0.01925, "mature_H5_site": 169, "mouse_sera_escape": 0.05204, "mutant": "I", "mutation": "R173I", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.1311, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.03937, "ferret_sera_escape": 0.073, "mature_H5_site": 169, "mouse_sera_escape": 0.02946, "mutant": "K", "mutation": "R173K", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": -0.005191, "wildtype": "R"}, {"a26_usage": 0.06454, "cell_entry": -0.214, "ferret_sera_escape": -0.07804, "mature_H5_site": 169, "mouse_sera_escape": 0.003801, "mutant": "M", "mutation": "R173M", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.06981, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3454, "ferret_sera_escape": -0.09467, "mature_H5_site": 169, "mouse_sera_escape": 0.06375, "mutant": "N", "mutation": "R173N", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.1003, "wildtype": "R"}, {"a26_usage": 0.1102, "cell_entry": -0.1161, "ferret_sera_escape": -0.04076, "mature_H5_site": 169, "mouse_sera_escape": -0.003677, "mutant": "P", "mutation": "R173P", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": -0.1617, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.196, "ferret_sera_escape": -0.03601, "mature_H5_site": 169, "mouse_sera_escape": -0.05003, "mutant": "Q", "mutation": "R173Q", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.003862, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 169, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R173R", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.05164, "ferret_sera_escape": -0.1974, "mature_H5_site": 169, "mouse_sera_escape": 0.0421, "mutant": "S", "mutation": "R173S", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.03646, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.499, "ferret_sera_escape": -0.162, "mature_H5_site": 169, "mouse_sera_escape": -0.1028, "mutant": "T", "mutation": "R173T", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.07099, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1727, "ferret_sera_escape": -0.03062, "mature_H5_site": 169, "mouse_sera_escape": -0.008879, "mutant": "V", "mutation": "R173V", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.09207, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.02192, "ferret_sera_escape": -0.05799, "mature_H5_site": 169, "mouse_sera_escape": -0.1572, "mutant": "W", "mutation": "R173W", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.2482, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0249, "ferret_sera_escape": 0.0199, "mature_H5_site": 169, "mouse_sera_escape": 0.03356, "mutant": "Y", "mutation": "R173Y", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": -0.1068, "wildtype": "R"}, {"a26_usage": 0.1214, "cell_entry": 0.07123, "ferret_sera_escape": 0.02115, "mature_H5_site": 170, "mouse_sera_escape": 0.05337, "mutant": "D", "mutation": "E174D", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.3127, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 170, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E174E", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06942, "ferret_sera_escape": 0.09974, "mature_H5_site": 170, "mouse_sera_escape": 0.03997, "mutant": "F", "mutation": "E174F", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.1865, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5007, "ferret_sera_escape": 0.1117, "mature_H5_site": 170, "mouse_sera_escape": 0.4344, "mutant": "G", "mutation": "E174G", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.1179, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1451, "ferret_sera_escape": 0.2307, "mature_H5_site": 170, "mouse_sera_escape": 0.1005, "mutant": "H", "mutation": "E174H", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.322, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.00608, "ferret_sera_escape": 0.05935, "mature_H5_site": 170, "mouse_sera_escape": 0.2376, "mutant": "K", "mutation": "E174K", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.2544, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.02964, "ferret_sera_escape": 0.07709, "mature_H5_site": 170, "mouse_sera_escape": 0.1252, "mutant": "L", "mutation": "E174L", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.06789, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4166, "ferret_sera_escape": 0.006627, "mature_H5_site": 170, "mouse_sera_escape": 0.2988, "mutant": "M", "mutation": "E174M", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": 1.559, "wildtype": "E"}, {"a26_usage": 0.1209, "cell_entry": -0.2261, "ferret_sera_escape": 0.07548, "mature_H5_site": 170, "mouse_sera_escape": 0.2062, "mutant": "N", "mutation": "E174N", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.2823, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.605, "ferret_sera_escape": null, "mature_H5_site": 170, "mouse_sera_escape": null, "mutant": "P", "mutation": "E174P", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02478, "ferret_sera_escape": -0.04029, "mature_H5_site": 170, "mouse_sera_escape": 0.118, "mutant": "Q", "mutation": "E174Q", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.09024, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2184, "ferret_sera_escape": 0.1043, "mature_H5_site": 170, "mouse_sera_escape": 0.2598, "mutant": "R", "mutation": "E174R", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.472, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.07085, "ferret_sera_escape": 0.2168, "mature_H5_site": 170, "mouse_sera_escape": 0.3969, "mutant": "S", "mutation": "E174S", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.1071, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.62, "ferret_sera_escape": 0.3792, "mature_H5_site": 170, "mouse_sera_escape": 0.8269, "mutant": "T", "mutation": "E174T", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": 0.2447, "wildtype": "E"}, {"a26_usage": 0.2123, "cell_entry": -0.4203, "ferret_sera_escape": null, "mature_H5_site": 170, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E174Y", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.01863, "ferret_sera_escape": 0.009104, "mature_H5_site": 171, "mouse_sera_escape": -0.03883, "mutant": "A", "mutation": "D175A", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 0.751, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 171, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D175D", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.1249, "cell_entry": -0.501, "ferret_sera_escape": -0.1347, "mature_H5_site": 171, "mouse_sera_escape": -0.149, "mutant": "E", "mutation": "D175E", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": -0.1798, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1506, "ferret_sera_escape": 0.1095, "mature_H5_site": 171, "mouse_sera_escape": 0.08514, "mutant": "F", "mutation": "D175F", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": -0.03241, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4955, "ferret_sera_escape": 0.057, "mature_H5_site": 171, "mouse_sera_escape": -0.2018, "mutant": "G", "mutation": "D175G", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 0.2863, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.157, "ferret_sera_escape": null, "mature_H5_site": 171, "mouse_sera_escape": null, "mutant": "H", "mutation": "D175H", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.07175, "ferret_sera_escape": 0.01746, "mature_H5_site": 171, "mouse_sera_escape": 0.2082, "mutant": "K", "mutation": "D175K", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 1.733, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1011, "ferret_sera_escape": -0.02987, "mature_H5_site": 171, "mouse_sera_escape": 0.1499, "mutant": "L", "mutation": "D175L", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 0.5159, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.02339, "ferret_sera_escape": -0.02074, "mature_H5_site": 171, "mouse_sera_escape": 0.219, "mutant": "M", "mutation": "D175M", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 1.426, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.995, "ferret_sera_escape": -0.03059, "mature_H5_site": 171, "mouse_sera_escape": 0.3295, "mutant": "N", "mutation": "D175N", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 1.575, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.05921, "ferret_sera_escape": -0.01679, "mature_H5_site": 171, "mouse_sera_escape": 0.06982, "mutant": "Q", "mutation": "D175Q", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 0.7819, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.877, "ferret_sera_escape": -0.03632, "mature_H5_site": 171, "mouse_sera_escape": 0.1616, "mutant": "R", "mutation": "D175R", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 1.482, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.05575, "ferret_sera_escape": -0.09201, "mature_H5_site": 171, "mouse_sera_escape": -0.08841, "mutant": "S", "mutation": "D175S", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 0.95, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.05895, "ferret_sera_escape": 0.1043, "mature_H5_site": 171, "mouse_sera_escape": 0.1483, "mutant": "T", "mutation": "D175T", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3582, "ferret_sera_escape": -0.07807, "mature_H5_site": 171, "mouse_sera_escape": 0.1036, "mutant": "V", "mutation": "D175V", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 0.9092, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.685, "ferret_sera_escape": -0.03313, "mature_H5_site": 171, "mouse_sera_escape": 0.1949, "mutant": "W", "mutation": "D175W", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1897, "ferret_sera_escape": -0.01229, "mature_H5_site": 171, "mouse_sera_escape": 0.06416, "mutant": "Y", "mutation": "D175Y", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": -0.1275, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.828, "ferret_sera_escape": 0.01138, "mature_H5_site": 172, "mouse_sera_escape": 0.3178, "mutant": "C", "mutation": "L176C", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": -0.2393, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "D", "mutation": "L176D", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.806, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "E", "mutation": "L176E", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.455, "ferret_sera_escape": 0.4976, "mature_H5_site": 172, "mouse_sera_escape": 0.04095, "mutant": "F", "mutation": "L176F", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.545, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "H", "mutation": "L176H", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4143, "ferret_sera_escape": -0.04867, "mature_H5_site": 172, "mouse_sera_escape": 0.03309, "mutant": "I", "mutation": "L176I", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": -0.2138, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.681, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "K", "mutation": "L176K", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 172, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L176L", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.3014, "cell_entry": -0.09796, "ferret_sera_escape": 0.1412, "mature_H5_site": 172, "mouse_sera_escape": 0.05206, "mutant": "M", "mutation": "L176M", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": -0.1098, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7219, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "N", "mutation": "L176N", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "P", "mutation": "L176P", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.311, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L176Q", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "R", "mutation": "L176R", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.134, "ferret_sera_escape": -0.08808, "mature_H5_site": 172, "mouse_sera_escape": 0.48, "mutant": "S", "mutation": "L176S", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06912, "ferret_sera_escape": -0.02395, "mature_H5_site": 172, "mouse_sera_escape": 0.0316, "mutant": "V", "mutation": "L176V", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": -0.1792, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.134, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": 0.111, "mutant": "Y", "mutation": "L176Y", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.8057, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "C", "mutation": "L177C", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "D", "mutation": "L177D", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "E", "mutation": "L177E", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.161, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "F", "mutation": "L177F", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.847, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "G", "mutation": "L177G", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1164, "ferret_sera_escape": -0.1717, "mature_H5_site": 173, "mouse_sera_escape": -0.02231, "mutant": "I", "mutation": "L177I", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": -0.1773, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "K", "mutation": "L177K", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 173, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L177L", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.79, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "P", "mutation": "L177P", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.657, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L177Q", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.745, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "R", "mutation": "L177R", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.024, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "S", "mutation": "L177S", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06807, "ferret_sera_escape": 0.08619, "mature_H5_site": 173, "mouse_sera_escape": 0.1302, "mutant": "V", "mutation": "L177V", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": -0.2152, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.945, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "W", "mutation": "L177W", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.09, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L177Y", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.656, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "C", "mutation": "I178C", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "D", "mutation": "I178D", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "E", "mutation": "I178E", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.24, "ferret_sera_escape": -0.3071, "mature_H5_site": 174, "mouse_sera_escape": -0.2078, "mutant": "F", "mutation": "I178F", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": 0.04503, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "G", "mutation": "I178G", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.977, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "H", "mutation": "I178H", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 174, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I178I", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "K", "mutation": "I178K", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.373, "ferret_sera_escape": -0.09354, "mature_H5_site": 174, "mouse_sera_escape": -0.05568, "mutant": "M", "mutation": "I178M", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": -0.04447, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "P", "mutation": "I178P", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "R", "mutation": "I178R", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "S", "mutation": "I178S", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.285, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "T", "mutation": "I178T", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4272, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "V", "mutation": "I178V", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.728, "ferret_sera_escape": -0.3298, "mature_H5_site": 174, "mouse_sera_escape": 0.05702, "mutant": "W", "mutation": "I178W", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": 0.4048, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I178Y", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03488, "ferret_sera_escape": -0.1308, "mature_H5_site": 175, "mouse_sera_escape": 0.01245, "mutant": "A", "mutation": "L179A", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": -0.003845, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 175, "mouse_sera_escape": null, "mutant": "D", "mutation": "L179D", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.229, "ferret_sera_escape": null, "mature_H5_site": 175, "mouse_sera_escape": null, "mutant": "E", "mutation": "L179E", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.889, "ferret_sera_escape": -0.1965, "mature_H5_site": 175, "mouse_sera_escape": -0.2149, "mutant": "F", "mutation": "L179F", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": -0.7407, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.203, "ferret_sera_escape": null, "mature_H5_site": 175, "mouse_sera_escape": null, "mutant": "G", "mutation": "L179G", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.869, "ferret_sera_escape": -0.1079, "mature_H5_site": 175, "mouse_sera_escape": -0.0281, "mutant": "H", "mutation": "L179H", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.2397, "cell_entry": -0.4528, "ferret_sera_escape": 0.05773, "mature_H5_site": 175, "mouse_sera_escape": 0.02409, "mutant": "I", "mutation": "L179I", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": 0.08892, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 175, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L179L", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.02475, "ferret_sera_escape": 0.1025, "mature_H5_site": 175, "mouse_sera_escape": -0.05598, "mutant": "M", "mutation": "L179M", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": -0.2714, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.542, "ferret_sera_escape": -0.3792, "mature_H5_site": 175, "mouse_sera_escape": -0.1166, "mutant": "N", "mutation": "L179N", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": 0.4598, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.047, "ferret_sera_escape": -0.05963, "mature_H5_site": 175, "mouse_sera_escape": -0.05192, "mutant": "P", "mutation": "L179P", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": 0.06633, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7952, "ferret_sera_escape": -0.3079, "mature_H5_site": 175, "mouse_sera_escape": -0.1477, "mutant": "Q", "mutation": "L179Q", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": -0.2748, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 175, "mouse_sera_escape": null, "mutant": "R", "mutation": "L179R", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06563, "ferret_sera_escape": 0.07781, "mature_H5_site": 175, "mouse_sera_escape": -0.07206, "mutant": "S", "mutation": "L179S", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": -0.1657, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6379, "ferret_sera_escape": -0.2147, "mature_H5_site": 175, "mouse_sera_escape": -0.02911, "mutant": "T", "mutation": "L179T", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2922, "ferret_sera_escape": null, "mature_H5_site": 175, "mouse_sera_escape": null, "mutant": "V", "mutation": "L179V", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.619, "ferret_sera_escape": -0.3976, "mature_H5_site": 175, "mouse_sera_escape": null, "mutant": "W", "mutation": "L179W", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.272, "ferret_sera_escape": null, "mature_H5_site": 8, "mouse_sera_escape": null, "mutant": "A", "mutation": "H18A", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3407, "ferret_sera_escape": 0.01539, "mature_H5_site": 8, "mouse_sera_escape": 0.0468, "mutant": "C", "mutation": "H18C", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": 0.001073, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.2797, "ferret_sera_escape": -0.002957, "mature_H5_site": 8, "mouse_sera_escape": 0.1216, "mutant": "F", "mutation": "H18F", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": 1.068, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.165, "ferret_sera_escape": -0.05145, "mature_H5_site": 8, "mouse_sera_escape": -0.1817, "mutant": "G", "mutation": "H18G", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": -0.1583, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 8, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H18H", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5484, "ferret_sera_escape": 0.07955, "mature_H5_site": 8, "mouse_sera_escape": 0.01151, "mutant": "I", "mutation": "H18I", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.02036, "ferret_sera_escape": -0.2388, "mature_H5_site": 8, "mouse_sera_escape": -0.06804, "mutant": "K", "mutation": "H18K", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.253, "ferret_sera_escape": 0.03133, "mature_H5_site": 8, "mouse_sera_escape": null, "mutant": "L", "mutation": "H18L", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.227, "ferret_sera_escape": 0.2191, "mature_H5_site": 8, "mouse_sera_escape": 0.145, "mutant": "M", "mutation": "H18M", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": 0.7004, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.2332, "ferret_sera_escape": 0.01203, "mature_H5_site": 8, "mouse_sera_escape": -0.01388, "mutant": "N", "mutation": "H18N", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": -0.02016, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.751, "ferret_sera_escape": 0.07359, "mature_H5_site": 8, "mouse_sera_escape": 0.196, "mutant": "Q", "mutation": "H18Q", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": 0.6954, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3651, "ferret_sera_escape": 0.07273, "mature_H5_site": 8, "mouse_sera_escape": -0.08267, "mutant": "R", "mutation": "H18R", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": -0.1622, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.04067, "ferret_sera_escape": -0.03843, "mature_H5_site": 8, "mouse_sera_escape": 0.09591, "mutant": "S", "mutation": "H18S", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": -0.2308, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.0621, "ferret_sera_escape": -0.06642, "mature_H5_site": 8, "mouse_sera_escape": 0.04733, "mutant": "T", "mutation": "H18T", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": 0.1048, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.109, "ferret_sera_escape": null, "mature_H5_site": 8, "mouse_sera_escape": null, "mutant": "V", "mutation": "H18V", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.495, "ferret_sera_escape": null, "mature_H5_site": 8, "mouse_sera_escape": null, "mutant": "W", "mutation": "H18W", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.355, "ferret_sera_escape": -0.1429, "mature_H5_site": 8, "mouse_sera_escape": -0.07471, "mutant": "Y", "mutation": "H18Y", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": 0.4552, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.964, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "C", "mutation": "W180C", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "D", "mutation": "W180D", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "E", "mutation": "W180E", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.894, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "G", "mutation": "W180G", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.986, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "H", "mutation": "W180H", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "I", "mutation": "W180I", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "L", "mutation": "W180L", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "M", "mutation": "W180M", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.977, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "N", "mutation": "W180N", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.928, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "P", "mutation": "W180P", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W180Q", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.766, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "R", "mutation": "W180R", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -6.024, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "S", "mutation": "W180S", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "T", "mutation": "W180T", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 176, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W180W", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.9538, "ferret_sera_escape": 0.01951, "mature_H5_site": 176, "mouse_sera_escape": 0.02281, "mutant": "Y", "mutation": "W180Y", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": -0.0317, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.04537, "ferret_sera_escape": -0.2169, "mature_H5_site": 177, "mouse_sera_escape": -0.1166, "mutant": "A", "mutation": "G181A", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": 0.8074, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.004, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "C", "mutation": "G181C", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.821, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "D", "mutation": "G181D", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.984, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "E", "mutation": "G181E", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "F", "mutation": "G181F", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 177, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G181G", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.039, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "H", "mutation": "G181H", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "I", "mutation": "G181I", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.724, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "K", "mutation": "G181K", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.811, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "L", "mutation": "G181L", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.246, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "M", "mutation": "G181M", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "N", "mutation": "G181N", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "P", "mutation": "G181P", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "S", "mutation": "G181S", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.658, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "T", "mutation": "G181T", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.812, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "W", "mutation": "G181W", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.9902, "ferret_sera_escape": -0.5719, "mature_H5_site": 178, "mouse_sera_escape": -0.1073, "mutant": "A", "mutation": "I182A", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.07884, "ferret_sera_escape": -0.3295, "mature_H5_site": 178, "mouse_sera_escape": -0.1597, "mutant": "C", "mutation": "I182C", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": -0.2143, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.742, "ferret_sera_escape": null, "mature_H5_site": 178, "mouse_sera_escape": null, "mutant": "D", "mutation": "I182D", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.806, "ferret_sera_escape": -0.2813, "mature_H5_site": 178, "mouse_sera_escape": -0.05419, "mutant": "E", "mutation": "I182E", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": -0.1926, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.622, "ferret_sera_escape": null, "mature_H5_site": 178, "mouse_sera_escape": null, "mutant": "G", "mutation": "I182G", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.7576, "ferret_sera_escape": null, "mature_H5_site": 178, "mouse_sera_escape": null, "mutant": "H", "mutation": "I182H", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 178, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I182I", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 178, "mouse_sera_escape": null, "mutant": "K", "mutation": "I182K", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06189, "ferret_sera_escape": -0.1636, "mature_H5_site": 178, "mouse_sera_escape": -0.01692, "mutant": "L", "mutation": "I182L", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": -0.09195, "wildtype": "I"}, {"a26_usage": 0.06279, "cell_entry": 0.07634, "ferret_sera_escape": -0.2152, "mature_H5_site": 178, "mouse_sera_escape": -0.1293, "mutant": "M", "mutation": "I182M", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": -0.2088, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 178, "mouse_sera_escape": null, "mutant": "P", "mutation": "I182P", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2174, "ferret_sera_escape": -0.1946, "mature_H5_site": 178, "mouse_sera_escape": -0.09341, "mutant": "Q", "mutation": "I182Q", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": -0.2523, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.643, "ferret_sera_escape": null, "mature_H5_site": 178, "mouse_sera_escape": null, "mutant": "S", "mutation": "I182S", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5711, "ferret_sera_escape": -0.519, "mature_H5_site": 178, "mouse_sera_escape": -0.2576, "mutant": "T", "mutation": "I182T", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": -0.3219, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.01915, "ferret_sera_escape": -0.1276, "mature_H5_site": 178, "mouse_sera_escape": -0.135, "mutant": "V", "mutation": "I182V", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 178, "mouse_sera_escape": null, "mutant": "W", "mutation": "I182W", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.126, "ferret_sera_escape": -0.392, "mature_H5_site": 178, "mouse_sera_escape": -0.2656, "mutant": "Y", "mutation": "I182Y", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.861, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "E", "mutation": "H183E", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.132, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "F", "mutation": "H183F", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "G", "mutation": "H183G", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 179, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H183H", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "I", "mutation": "H183I", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.861, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "K", "mutation": "H183K", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "L", "mutation": "H183L", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.7515, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": -0.6247, "mutant": "M", "mutation": "H183M", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": -0.09854, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "N", "mutation": "H183N", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.411, "ferret_sera_escape": -0.923, "mature_H5_site": 179, "mouse_sera_escape": -0.4123, "mutant": "Q", "mutation": "H183Q", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": -0.1774, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.016, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "S", "mutation": "H183S", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.986, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "V", "mutation": "H183V", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "W", "mutation": "H183W", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.614, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "Y", "mutation": "H183Y", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.806, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "A", "mutation": "H184A", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.633, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "C", "mutation": "H184C", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.371, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "D", "mutation": "H184D", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.731, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "E", "mutation": "H184E", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "F", "mutation": "H184F", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "G", "mutation": "H184G", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 180, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H184H", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "I", "mutation": "H184I", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "K", "mutation": "H184K", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "L", "mutation": "H184L", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "M", "mutation": "H184M", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.6389, "ferret_sera_escape": -0.5426, "mature_H5_site": 180, "mouse_sera_escape": -0.6153, "mutant": "N", "mutation": "H184N", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.2, "ferret_sera_escape": -0.5873, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "Q", "mutation": "H184Q", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "R", "mutation": "H184R", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.213, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "S", "mutation": "H184S", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.939, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "V", "mutation": "H184V", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "W", "mutation": "H184W", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.187, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "Y", "mutation": "H184Y", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3085, "ferret_sera_escape": -1.075, "mature_H5_site": 181, "mouse_sera_escape": -1.008, "mutant": "C", "mutation": "S185C", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "D", "mutation": "S185D", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.853, "ferret_sera_escape": null, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "E", "mutation": "S185E", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.62, "ferret_sera_escape": null, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "F", "mutation": "S185F", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.86, "ferret_sera_escape": -0.6334, "mature_H5_site": 181, "mouse_sera_escape": -0.4934, "mutant": "G", "mutation": "S185G", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": -0.07411, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.7509, "ferret_sera_escape": -1.458, "mature_H5_site": 181, "mouse_sera_escape": -1.014, "mutant": "I", "mutation": "S185I", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": 0.8878, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "K", "mutation": "S185K", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.776, "ferret_sera_escape": null, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "L", "mutation": "S185L", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6169, "ferret_sera_escape": -1.299, "mature_H5_site": 181, "mouse_sera_escape": -0.8221, "mutant": "N", "mutation": "S185N", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": 0.06389, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.09438, "ferret_sera_escape": -1.283, "mature_H5_site": 181, "mouse_sera_escape": -0.6445, "mutant": "Q", "mutation": "S185Q", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "R", "mutation": "S185R", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 181, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S185S", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4204, "ferret_sera_escape": -1.701, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "V", "mutation": "S185V", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": 0.04737, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "W", "mutation": "S185W", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S185Y", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.3623, "cell_entry": -0.8998, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "A", "mutation": "N186A", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.398, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "D", "mutation": "N186D", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.595, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "E", "mutation": "N186E", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.116, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "F", "mutation": "N186F", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.27, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "I", "mutation": "N186I", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.41, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "K", "mutation": "N186K", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "L", "mutation": "N186L", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.724, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "M", "mutation": "N186M", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 182, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N186N", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.118, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "P", "mutation": "N186P", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.444, "ferret_sera_escape": -1.162, "mature_H5_site": 182, "mouse_sera_escape": -0.337, "mutant": "Q", "mutation": "N186Q", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.49, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "R", "mutation": "N186R", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.07026, "cell_entry": -0.01905, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "S", "mutation": "N186S", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3488, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "T", "mutation": "N186T", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.564, "ferret_sera_escape": -0.7961, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N186Y", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.205, "ferret_sera_escape": -0.5518, "mature_H5_site": 183, "mouse_sera_escape": -0.4276, "mutant": "A", "mutation": "N187A", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.1883, "wildtype": "N"}, {"a26_usage": 0.1554, "cell_entry": -0.1002, "ferret_sera_escape": -0.1155, "mature_H5_site": 183, "mouse_sera_escape": -0.4269, "mutant": "C", "mutation": "N187C", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.05238, "wildtype": "N"}, {"a26_usage": 0.02048, "cell_entry": -0.2446, "ferret_sera_escape": -0.6811, "mature_H5_site": 183, "mouse_sera_escape": -0.6013, "mutant": "D", "mutation": "N187D", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.2622, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07847, "ferret_sera_escape": -1.252, "mature_H5_site": 183, "mouse_sera_escape": -0.8497, "mutant": "E", "mutation": "N187E", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.23, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.136, "ferret_sera_escape": 0.09549, "mature_H5_site": 183, "mouse_sera_escape": 0.01992, "mutant": "F", "mutation": "N187F", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": null, "wildtype": "N"}, {"a26_usage": 0.01962, "cell_entry": 0.06036, "ferret_sera_escape": -0.8259, "mature_H5_site": 183, "mouse_sera_escape": -0.6419, "mutant": "G", "mutation": "N187G", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.1047, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.08441, "ferret_sera_escape": -0.1079, "mature_H5_site": 183, "mouse_sera_escape": -0.07595, "mutant": "H", "mutation": "N187H", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.1368, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4657, "ferret_sera_escape": 0.02345, "mature_H5_site": 183, "mouse_sera_escape": -0.1386, "mutant": "K", "mutation": "N187K", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.1836, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2213, "ferret_sera_escape": -0.747, "mature_H5_site": 183, "mouse_sera_escape": -0.791, "mutant": "M", "mutation": "N187M", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 183, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N187N", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.031, "ferret_sera_escape": 0.3054, "mature_H5_site": 183, "mouse_sera_escape": 0.8416, "mutant": "P", "mutation": "N187P", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8596, "ferret_sera_escape": null, "mature_H5_site": 183, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N187Q", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.098, "ferret_sera_escape": -0.1052, "mature_H5_site": 183, "mouse_sera_escape": 0.02999, "mutant": "R", "mutation": "N187R", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.145, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07217, "ferret_sera_escape": 0.237, "mature_H5_site": 183, "mouse_sera_escape": 0.0547, "mutant": "T", "mutation": "N187T", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": 0.06224, "wildtype": "N"}, {"a26_usage": 0.752, "cell_entry": -0.4867, "ferret_sera_escape": -0.7585, "mature_H5_site": 183, "mouse_sera_escape": -0.7501, "mutant": "V", "mutation": "N187V", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.239, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3038, "ferret_sera_escape": -0.7448, "mature_H5_site": 183, "mouse_sera_escape": -0.238, "mutant": "W", "mutation": "N187W", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.2089, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.01341, "ferret_sera_escape": -0.142, "mature_H5_site": 183, "mouse_sera_escape": -0.1573, "mutant": "Y", "mutation": "N187Y", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.08976, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 184, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A188A", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.009199, "ferret_sera_escape": 0.052, "mature_H5_site": 184, "mouse_sera_escape": -0.06557, "mutant": "C", "mutation": "A188C", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": -0.1235, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.03025, "ferret_sera_escape": 0.1706, "mature_H5_site": 184, "mouse_sera_escape": 0.07211, "mutant": "D", "mutation": "A188D", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": -0.2786, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.06724, "ferret_sera_escape": 0.1694, "mature_H5_site": 184, "mouse_sera_escape": 0.04745, "mutant": "E", "mutation": "A188E", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": -0.07991, "wildtype": "A"}, {"a26_usage": 0.1472, "cell_entry": -0.1551, "ferret_sera_escape": -0.02706, "mature_H5_site": 184, "mouse_sera_escape": -0.1803, "mutant": "F", "mutation": "A188F", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": -0.03935, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.06618, "ferret_sera_escape": 0.03375, "mature_H5_site": 184, "mouse_sera_escape": -0.05123, "mutant": "G", "mutation": "A188G", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.004294, "wildtype": "A"}, {"a26_usage": 0.241, "cell_entry": -0.01178, "ferret_sera_escape": 0.1061, "mature_H5_site": 184, "mouse_sera_escape": -0.02621, "mutant": "H", "mutation": "A188H", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.03205, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.002775, "ferret_sera_escape": -0.00921, "mature_H5_site": 184, "mouse_sera_escape": -0.09913, "mutant": "I", "mutation": "A188I", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.09838, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5312, "ferret_sera_escape": 0.3149, "mature_H5_site": 184, "mouse_sera_escape": 0.2426, "mutant": "K", "mutation": "A188K", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.1917, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1761, "ferret_sera_escape": -0.2715, "mature_H5_site": 184, "mouse_sera_escape": -0.1304, "mutant": "M", "mutation": "A188M", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": -0.03421, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.04956, "ferret_sera_escape": 0.2428, "mature_H5_site": 184, "mouse_sera_escape": 0.08836, "mutant": "N", "mutation": "A188N", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": -0.01085, "wildtype": "A"}, {"a26_usage": 0.172, "cell_entry": -0.09303, "ferret_sera_escape": 0.09481, "mature_H5_site": 184, "mouse_sera_escape": -0.003613, "mutant": "P", "mutation": "A188P", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.05893, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.06341, "ferret_sera_escape": -0.04367, "mature_H5_site": 184, "mouse_sera_escape": 0.005798, "mutant": "Q", "mutation": "A188Q", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.1225, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.05409, "ferret_sera_escape": 0.4485, "mature_H5_site": 184, "mouse_sera_escape": 0.1141, "mutant": "R", "mutation": "A188R", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.06571, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.067, "ferret_sera_escape": null, "mature_H5_site": 184, "mouse_sera_escape": null, "mutant": "S", "mutation": "A188S", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.383, "ferret_sera_escape": null, "mature_H5_site": 184, "mouse_sera_escape": null, "mutant": "T", "mutation": "A188T", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.01764, "ferret_sera_escape": -0.1279, "mature_H5_site": 184, "mouse_sera_escape": 0.001258, "mutant": "V", "mutation": "A188V", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.06581, "wildtype": "A"}, {"a26_usage": 0.03191, "cell_entry": 0.006285, "ferret_sera_escape": -0.02487, "mature_H5_site": 184, "mouse_sera_escape": 0.004347, "mutant": "Y", "mutation": "A188Y", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.08506, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.441, "ferret_sera_escape": 0.3734, "mature_H5_site": 185, "mouse_sera_escape": 0.1881, "mutant": "A", "mutation": "E189A", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 185, "mouse_sera_escape": null, "mutant": "C", "mutation": "E189C", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1052, "ferret_sera_escape": 0.1036, "mature_H5_site": 185, "mouse_sera_escape": 0.06786, "mutant": "D", "mutation": "E189D", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": -0.04327, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 185, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E189E", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7629, "ferret_sera_escape": 0.4981, "mature_H5_site": 185, "mouse_sera_escape": 0.2864, "mutant": "G", "mutation": "E189G", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": 0.03169, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5244, "ferret_sera_escape": 0.04687, "mature_H5_site": 185, "mouse_sera_escape": 0.03085, "mutant": "H", "mutation": "E189H", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": 0.1252, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.341, "ferret_sera_escape": 0.5784, "mature_H5_site": 185, "mouse_sera_escape": 0.4274, "mutant": "K", "mutation": "E189K", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": 0.01372, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.232, "ferret_sera_escape": 0.2569, "mature_H5_site": 185, "mouse_sera_escape": 0.1549, "mutant": "L", "mutation": "E189L", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.0163, "ferret_sera_escape": 0.3405, "mature_H5_site": 185, "mouse_sera_escape": 0.2533, "mutant": "M", "mutation": "E189M", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": 0.03054, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7946, "ferret_sera_escape": 0.3788, "mature_H5_site": 185, "mouse_sera_escape": 0.143, "mutant": "N", "mutation": "E189N", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": 0.007499, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7278, "ferret_sera_escape": 0.487, "mature_H5_site": 185, "mouse_sera_escape": 0.2311, "mutant": "P", "mutation": "E189P", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": -0.04613, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.635, "ferret_sera_escape": null, "mature_H5_site": 185, "mouse_sera_escape": 0.1184, "mutant": "R", "mutation": "E189R", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.363, "ferret_sera_escape": -0.7539, "mature_H5_site": 185, "mouse_sera_escape": -0.1924, "mutant": "S", "mutation": "E189S", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1914, "ferret_sera_escape": 0.1772, "mature_H5_site": 185, "mouse_sera_escape": 0.1439, "mutant": "V", "mutation": "E189V", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": 0.1054, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.276, "ferret_sera_escape": null, "mature_H5_site": 185, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E189Y", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 9, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A19A", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7371, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "C", "mutation": "A19C", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.758, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "D", "mutation": "A19D", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.9811, "ferret_sera_escape": -0.2707, "mature_H5_site": 9, "mouse_sera_escape": -0.1378, "mutant": "E", "mutation": "A19E", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": -0.3152, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "F", "mutation": "A19F", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.6456, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "G", "mutation": "A19G", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.291, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "H", "mutation": "A19H", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.147, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "I", "mutation": "A19I", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.9955, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "K", "mutation": "A19K", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.06347, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "M", "mutation": "A19M", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.8216, "ferret_sera_escape": -0.05663, "mature_H5_site": 9, "mouse_sera_escape": 0.6575, "mutant": "N", "mutation": "A19N", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": 1.431, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "P", "mutation": "A19P", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.07206, "ferret_sera_escape": -0.09182, "mature_H5_site": 9, "mouse_sera_escape": 0.09182, "mutant": "Q", "mutation": "A19Q", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": 0.7691, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.454, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "R", "mutation": "A19R", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.02567, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "S", "mutation": "A19S", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7174, "ferret_sera_escape": -0.09924, "mature_H5_site": 9, "mouse_sera_escape": -0.003144, "mutant": "T", "mutation": "A19T", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": -0.4482, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.204, "ferret_sera_escape": -0.2603, "mature_H5_site": 9, "mouse_sera_escape": 0.09815, "mutant": "W", "mutation": "A19W", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": 0.8972, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.699, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A19Y", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.351, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "A", "mutation": "E190A", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.901, "ferret_sera_escape": -0.5848, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "C", "mutation": "E190C", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 186, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E190E", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.876, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "F", "mutation": "E190F", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 2.219, "cell_entry": -0.9957, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "G", "mutation": "E190G", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.236, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "H", "mutation": "E190H", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.883, "ferret_sera_escape": -0.1258, "mature_H5_site": 186, "mouse_sera_escape": -0.002602, "mutant": "K", "mutation": "E190K", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 4.892, "cell_entry": -4.434, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "N", "mutation": "E190N", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.876, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "P", "mutation": "E190P", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 2.537, "cell_entry": -1.825, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": -0.07207, "mutant": "Q", "mutation": "E190Q", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 2.372, "cell_entry": -3.242, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "V", "mutation": "E190V", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.955, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "W", "mutation": "E190W", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.95, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E190Y", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "C", "mutation": "Q191C", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.868, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "D", "mutation": "Q191D", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.575, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "E", "mutation": "Q191E", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "F", "mutation": "Q191F", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.319, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "G", "mutation": "Q191G", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.102, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "I", "mutation": "Q191I", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "K", "mutation": "Q191K", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.859, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "M", "mutation": "Q191M", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.004065, "ferret_sera_escape": 0.09331, "mature_H5_site": 187, "mouse_sera_escape": -0.4166, "mutant": "N", "mutation": "Q191N", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": 0.001378, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q191P", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 187, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q191Q", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "R", "mutation": "Q191R", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.361, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "S", "mutation": "Q191S", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.473, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "V", "mutation": "Q191V", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "W", "mutation": "Q191W", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "Y", "mutation": "Q191Y", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.01022, "ferret_sera_escape": -0.1913, "mature_H5_site": 188, "mouse_sera_escape": -0.06092, "mutant": "A", "mutation": "T192A", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.0178, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.289, "ferret_sera_escape": -0.00647, "mature_H5_site": 188, "mouse_sera_escape": -0.002782, "mutant": "C", "mutation": "T192C", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": 0.03059, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.07811, "ferret_sera_escape": -0.6769, "mature_H5_site": 188, "mouse_sera_escape": -0.2095, "mutant": "D", "mutation": "T192D", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.1501, "wildtype": "T"}, {"a26_usage": 0.7691, "cell_entry": 0.05019, "ferret_sera_escape": null, "mature_H5_site": 188, "mouse_sera_escape": null, "mutant": "F", "mutation": "T192F", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": null, "wildtype": "T"}, {"a26_usage": 0.06496, "cell_entry": -0.05183, "ferret_sera_escape": 0.09152, "mature_H5_site": 188, "mouse_sera_escape": 0.2292, "mutant": "G", "mutation": "T192G", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.03511, "ferret_sera_escape": -0.2323, "mature_H5_site": 188, "mouse_sera_escape": -0.07476, "mutant": "H", "mutation": "T192H", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.1041, "wildtype": "T"}, {"a26_usage": 0.03627, "cell_entry": 0.03367, "ferret_sera_escape": 0.1872, "mature_H5_site": 188, "mouse_sera_escape": 0.0586, "mutant": "I", "mutation": "T192I", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": 0.1702, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7805, "ferret_sera_escape": 0.5586, "mature_H5_site": 188, "mouse_sera_escape": 0.3087, "mutant": "K", "mutation": "T192K", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.003926, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.05107, "ferret_sera_escape": 0.07559, "mature_H5_site": 188, "mouse_sera_escape": 0.00494, "mutant": "M", "mutation": "T192M", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.007249, "wildtype": "T"}, {"a26_usage": 0.04052, "cell_entry": 0.03194, "ferret_sera_escape": -0.2255, "mature_H5_site": 188, "mouse_sera_escape": -0.1745, "mutant": "N", "mutation": "T192N", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.009294, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.03218, "ferret_sera_escape": 0.0703, "mature_H5_site": 188, "mouse_sera_escape": 0.02403, "mutant": "Q", "mutation": "T192Q", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": 0.05031, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.154, "ferret_sera_escape": 0.4215, "mature_H5_site": 188, "mouse_sera_escape": 0.09231, "mutant": "R", "mutation": "T192R", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": 0.025, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.0295, "ferret_sera_escape": -0.4007, "mature_H5_site": 188, "mouse_sera_escape": -0.2293, "mutant": "S", "mutation": "T192S", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.02185, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 188, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T192T", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.3955, "cell_entry": -0.3159, "ferret_sera_escape": 0.1918, "mature_H5_site": 188, "mouse_sera_escape": 0.02617, "mutant": "V", "mutation": "T192V", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": 0.03059, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2659, "ferret_sera_escape": 0.05345, "mature_H5_site": 188, "mouse_sera_escape": -0.03944, "mutant": "W", "mutation": "T192W", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.03779, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.002195, "ferret_sera_escape": -0.1966, "mature_H5_site": 188, "mouse_sera_escape": 0.1462, "mutant": "Y", "mutation": "T192Y", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.09272, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.03588, "ferret_sera_escape": 0.08359, "mature_H5_site": 189, "mouse_sera_escape": 0.1325, "mutant": "A", "mutation": "N193A", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": 0.01061, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3964, "ferret_sera_escape": null, "mature_H5_site": 189, "mouse_sera_escape": null, "mutant": "D", "mutation": "N193D", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": null, "wildtype": "N"}, {"a26_usage": 0.1896, "cell_entry": -0.3979, "ferret_sera_escape": -0.3286, "mature_H5_site": 189, "mouse_sera_escape": -0.3024, "mutant": "F", "mutation": "N193F", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": -0.1505, "wildtype": "N"}, {"a26_usage": 0.214, "cell_entry": -0.7438, "ferret_sera_escape": null, "mature_H5_site": 189, "mouse_sera_escape": null, "mutant": "G", "mutation": "N193G", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2481, "ferret_sera_escape": 0.5183, "mature_H5_site": 189, "mouse_sera_escape": 0.4621, "mutant": "K", "mutation": "N193K", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": -0.0002146, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.007055, "ferret_sera_escape": null, "mature_H5_site": 189, "mouse_sera_escape": null, "mutant": "L", "mutation": "N193L", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1422, "ferret_sera_escape": 0.1292, "mature_H5_site": 189, "mouse_sera_escape": 0.12, "mutant": "M", "mutation": "N193M", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": 0.08702, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 189, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N193N", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.01775, "ferret_sera_escape": 0.1603, "mature_H5_site": 189, "mouse_sera_escape": 0.1673, "mutant": "Q", "mutation": "N193Q", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": 0.06642, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.397, "ferret_sera_escape": 0.345, "mature_H5_site": 189, "mouse_sera_escape": 0.1694, "mutant": "R", "mutation": "N193R", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": -0.01494, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07625, "ferret_sera_escape": -0.1134, "mature_H5_site": 189, "mouse_sera_escape": -0.03392, "mutant": "S", "mutation": "N193S", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": -0.02832, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0722, "ferret_sera_escape": -0.5167, "mature_H5_site": 189, "mouse_sera_escape": -0.2643, "mutant": "V", "mutation": "N193V", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": 0.01241, "wildtype": "N"}, {"a26_usage": 2.11, "cell_entry": -0.2069, "ferret_sera_escape": -0.2756, "mature_H5_site": 189, "mouse_sera_escape": -0.1186, "mutant": "W", "mutation": "N193W", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": 0.01802, "wildtype": "N"}, {"a26_usage": 0.1032, "cell_entry": -0.4655, "ferret_sera_escape": -0.3188, "mature_H5_site": 189, "mouse_sera_escape": -0.1476, "mutant": "Y", "mutation": "N193Y", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": -0.1316, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.07, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "C", "mutation": "L194C", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.98, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "D", "mutation": "L194D", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "E", "mutation": "L194E", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.476, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "F", "mutation": "L194F", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "G", "mutation": "L194G", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.619, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "H", "mutation": "L194H", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.383, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "K", "mutation": "L194K", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 190, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L194L", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1717, "ferret_sera_escape": -1.344, "mature_H5_site": 190, "mouse_sera_escape": -0.7348, "mutant": "M", "mutation": "L194M", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": -0.1652, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.869, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "N", "mutation": "L194N", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "P", "mutation": "L194P", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.59, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L194Q", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.306, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "R", "mutation": "L194R", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.216, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "S", "mutation": "L194S", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.23, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "T", "mutation": "L194T", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3064, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "V", "mutation": "L194V", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.582, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y195C", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y195D", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y195E", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.636, "ferret_sera_escape": 0.08324, "mature_H5_site": 191, "mouse_sera_escape": -0.1447, "mutant": "F", "mutation": "Y195F", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y195I", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y195K", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y195L", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y195M", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.01, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y195N", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y195P", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y195Q", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.037, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y195R", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.288, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y195S", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y195T", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y195V", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.825, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y195W", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 191, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y195Y", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.08088, "ferret_sera_escape": 0.2056, "mature_H5_site": 192, "mouse_sera_escape": 0.1514, "mutant": "A", "mutation": "K196A", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05601, "ferret_sera_escape": 0.5091, "mature_H5_site": 192, "mouse_sera_escape": 0.126, "mutant": "C", "mutation": "K196C", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": 0.07479, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2559, "ferret_sera_escape": 0.8063, "mature_H5_site": 192, "mouse_sera_escape": 0.1059, "mutant": "D", "mutation": "K196D", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.04622, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3713, "ferret_sera_escape": 0.4882, "mature_H5_site": 192, "mouse_sera_escape": 0.3209, "mutant": "E", "mutation": "K196E", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.007365, "ferret_sera_escape": 0.5122, "mature_H5_site": 192, "mouse_sera_escape": 0.1861, "mutant": "F", "mutation": "K196F", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07444, "ferret_sera_escape": 0.3501, "mature_H5_site": 192, "mouse_sera_escape": 0.1724, "mutant": "H", "mutation": "K196H", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.02333, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 192, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K196K", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07812, "ferret_sera_escape": 0.6195, "mature_H5_site": 192, "mouse_sera_escape": 0.1202, "mutant": "L", "mutation": "K196L", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.1136, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.02107, "ferret_sera_escape": 0.3728, "mature_H5_site": 192, "mouse_sera_escape": 0.2573, "mutant": "M", "mutation": "K196M", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.05403, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.01249, "ferret_sera_escape": 0.3399, "mature_H5_site": 192, "mouse_sera_escape": 0.1411, "mutant": "N", "mutation": "K196N", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.1051, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07326, "ferret_sera_escape": -0.04565, "mature_H5_site": 192, "mouse_sera_escape": 0.2884, "mutant": "Q", "mutation": "K196Q", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.04808, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.09238, "ferret_sera_escape": -0.008822, "mature_H5_site": 192, "mouse_sera_escape": 0.1116, "mutant": "R", "mutation": "K196R", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.0592, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.06693, "ferret_sera_escape": 0.4781, "mature_H5_site": 192, "mouse_sera_escape": 0.1488, "mutant": "S", "mutation": "K196S", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": 0.04075, "wildtype": "K"}, {"a26_usage": 0.07515, "cell_entry": 0.07787, "ferret_sera_escape": 1.104, "mature_H5_site": 192, "mouse_sera_escape": 0.4541, "mutant": "V", "mutation": "K196V", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": 0.0767, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.05117, "ferret_sera_escape": 0.6124, "mature_H5_site": 192, "mouse_sera_escape": 0.2142, "mutant": "W", "mutation": "K196W", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.1273, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5802, "ferret_sera_escape": null, "mature_H5_site": 193, "mouse_sera_escape": null, "mutant": "D", "mutation": "N197D", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04911, "ferret_sera_escape": 0.3136, "mature_H5_site": 193, "mouse_sera_escape": -0.002119, "mutant": "E", "mutation": "N197E", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.1331, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7059, "ferret_sera_escape": 0.1696, "mature_H5_site": 193, "mouse_sera_escape": -0.09793, "mutant": "F", "mutation": "N197F", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8245, "ferret_sera_escape": 0.1203, "mature_H5_site": 193, "mouse_sera_escape": -0.2292, "mutant": "G", "mutation": "N197G", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.08882, "wildtype": "N"}, {"a26_usage": 0.05041, "cell_entry": -0.0681, "ferret_sera_escape": 0.1999, "mature_H5_site": 193, "mouse_sera_escape": null, "mutant": "H", "mutation": "N197H", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.06992, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7363, "ferret_sera_escape": 0.1644, "mature_H5_site": 193, "mouse_sera_escape": -0.329, "mutant": "K", "mutation": "N197K", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.08806, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04824, "ferret_sera_escape": null, "mature_H5_site": 193, "mouse_sera_escape": null, "mutant": "L", "mutation": "N197L", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1396, "ferret_sera_escape": 0.1748, "mature_H5_site": 193, "mouse_sera_escape": -0.2698, "mutant": "M", "mutation": "N197M", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.1385, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 193, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N197N", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.01682, "cell_entry": 0.03522, "ferret_sera_escape": 0.4659, "mature_H5_site": 193, "mouse_sera_escape": 0.1115, "mutant": "Q", "mutation": "N197Q", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.02697, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.02481, "ferret_sera_escape": 0.1059, "mature_H5_site": 193, "mouse_sera_escape": -0.07357, "mutant": "R", "mutation": "N197R", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.01479, "ferret_sera_escape": 0.357, "mature_H5_site": 193, "mouse_sera_escape": -0.007594, "mutant": "S", "mutation": "N197S", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.04635, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.219, "ferret_sera_escape": 0.3178, "mature_H5_site": 193, "mouse_sera_escape": -0.04718, "mutant": "T", "mutation": "N197T", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.08826, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.439, "ferret_sera_escape": 0.1678, "mature_H5_site": 193, "mouse_sera_escape": -0.2652, "mutant": "V", "mutation": "N197V", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.1902, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.0356, "ferret_sera_escape": 0.5977, "mature_H5_site": 193, "mouse_sera_escape": 0.1613, "mutant": "W", "mutation": "N197W", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.09866, "ferret_sera_escape": 0.5507, "mature_H5_site": 193, "mouse_sera_escape": 0.1048, "mutant": "Y", "mutation": "N197Y", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.1224, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4095, "ferret_sera_escape": 0.2783, "mature_H5_site": 194, "mouse_sera_escape": -0.3596, "mutant": "D", "mutation": "P198D", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.076, "ferret_sera_escape": 0.4202, "mature_H5_site": 194, "mouse_sera_escape": -0.1571, "mutant": "E", "mutation": "P198E", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.1019, "wildtype": "P"}, {"a26_usage": 0.04939, "cell_entry": 0.037, "ferret_sera_escape": null, "mature_H5_site": 194, "mouse_sera_escape": null, "mutant": "F", "mutation": "P198F", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.2687, "ferret_sera_escape": 0.4967, "mature_H5_site": 194, "mouse_sera_escape": -0.1075, "mutant": "G", "mutation": "P198G", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.04776, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3047, "ferret_sera_escape": 0.3173, "mature_H5_site": 194, "mouse_sera_escape": -0.274, "mutant": "H", "mutation": "P198H", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.1406, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3696, "ferret_sera_escape": 0.6792, "mature_H5_site": 194, "mouse_sera_escape": -0.3129, "mutant": "I", "mutation": "P198I", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.03493, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.459, "ferret_sera_escape": 0.626, "mature_H5_site": 194, "mouse_sera_escape": -0.0989, "mutant": "L", "mutation": "P198L", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.04215, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.02524, "ferret_sera_escape": -0.06573, "mature_H5_site": 194, "mouse_sera_escape": -0.4877, "mutant": "M", "mutation": "P198M", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.1501, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 194, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P198P", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.06929, "cell_entry": 0.0473, "ferret_sera_escape": 0.367, "mature_H5_site": 194, "mouse_sera_escape": -0.206, "mutant": "Q", "mutation": "P198Q", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.06342, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.281, "ferret_sera_escape": 0.7673, "mature_H5_site": 194, "mouse_sera_escape": 0.01955, "mutant": "R", "mutation": "P198R", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.05373, "ferret_sera_escape": 0.2756, "mature_H5_site": 194, "mouse_sera_escape": -0.3024, "mutant": "S", "mutation": "P198S", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.02385, "wildtype": "P"}, {"a26_usage": 0.4298, "cell_entry": -0.5757, "ferret_sera_escape": 0.3379, "mature_H5_site": 194, "mouse_sera_escape": -0.1912, "mutant": "T", "mutation": "P198T", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": 0.04321, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.09659, "ferret_sera_escape": 0.4351, "mature_H5_site": 194, "mouse_sera_escape": -0.1511, "mutant": "V", "mutation": "P198V", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.07904, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.539, "ferret_sera_escape": -0.07353, "mature_H5_site": 194, "mouse_sera_escape": -0.2521, "mutant": "W", "mutation": "P198W", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.2287, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.03991, "ferret_sera_escape": 0.6442, "mature_H5_site": 194, "mouse_sera_escape": -0.073, "mutant": "Y", "mutation": "P198Y", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": 0.04096, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.05763, "ferret_sera_escape": 0.0604, "mature_H5_site": 195, "mouse_sera_escape": -0.1723, "mutant": "A", "mutation": "T199A", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.07795, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.566, "ferret_sera_escape": -0.03389, "mature_H5_site": 195, "mouse_sera_escape": 0.0006675, "mutant": "C", "mutation": "T199C", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": 0.02651, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.05215, "ferret_sera_escape": 0.1401, "mature_H5_site": 195, "mouse_sera_escape": 0.1501, "mutant": "D", "mutation": "T199D", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.02936, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2546, "ferret_sera_escape": 0.05044, "mature_H5_site": 195, "mouse_sera_escape": -0.007077, "mutant": "F", "mutation": "T199F", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.027, "wildtype": "T"}, {"a26_usage": 0.05929, "cell_entry": -0.1286, "ferret_sera_escape": -0.005935, "mature_H5_site": 195, "mouse_sera_escape": 0.07855, "mutant": "G", "mutation": "T199G", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.07857, "wildtype": "T"}, {"a26_usage": 0.0721, "cell_entry": 0.03299, "ferret_sera_escape": -0.02455, "mature_H5_site": 195, "mouse_sera_escape": -0.0466, "mutant": "H", "mutation": "T199H", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": 0.01462, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1948, "ferret_sera_escape": -0.02639, "mature_H5_site": 195, "mouse_sera_escape": 0.03451, "mutant": "I", "mutation": "T199I", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.002265, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.03725, "ferret_sera_escape": -0.07949, "mature_H5_site": 195, "mouse_sera_escape": 0.04444, "mutant": "K", "mutation": "T199K", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": 0.05717, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.00957, "ferret_sera_escape": -0.1086, "mature_H5_site": 195, "mouse_sera_escape": 0.08204, "mutant": "L", "mutation": "T199L", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.04928, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2989, "ferret_sera_escape": 0.04022, "mature_H5_site": 195, "mouse_sera_escape": 0.04424, "mutant": "Q", "mutation": "T199Q", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.007199, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4187, "ferret_sera_escape": 0.2488, "mature_H5_site": 195, "mouse_sera_escape": null, "mutant": "R", "mutation": "T199R", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": null, "wildtype": "T"}, {"a26_usage": 0.004465, "cell_entry": 0.03191, "ferret_sera_escape": -0.085, "mature_H5_site": 195, "mouse_sera_escape": 0.08293, "mutant": "S", "mutation": "T199S", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.04285, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 195, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T199T", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.1363, "cell_entry": 0.07707, "ferret_sera_escape": 0.238, "mature_H5_site": 195, "mouse_sera_escape": -0.05187, "mutant": "V", "mutation": "T199V", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.02299, "wildtype": "T"}, {"a26_usage": 0.2122, "cell_entry": -1.08, "ferret_sera_escape": null, "mature_H5_site": 195, "mouse_sera_escape": null, "mutant": "W", "mutation": "T199W", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0692, "ferret_sera_escape": 0.1576, "mature_H5_site": 195, "mouse_sera_escape": 0.07476, "mutant": "Y", "mutation": "T199Y", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.0252, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1451, "ferret_sera_escape": -0.1646, "mature_H5_site": -9, "mouse_sera_escape": 0.006281, "mutant": "A", "mutation": "L2A", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.07435, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7826, "ferret_sera_escape": -0.0211, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "C", "mutation": "L2C", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "D", "mutation": "L2D", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.661, "ferret_sera_escape": null, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "E", "mutation": "L2E", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5433, "ferret_sera_escape": -0.03409, "mature_H5_site": -9, "mouse_sera_escape": 0.026, "mutant": "F", "mutation": "L2F", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.0255, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4676, "ferret_sera_escape": -0.1523, "mature_H5_site": -9, "mouse_sera_escape": 0.02082, "mutant": "G", "mutation": "L2G", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.08135, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.057, "ferret_sera_escape": -0.1215, "mature_H5_site": -9, "mouse_sera_escape": -0.13, "mutant": "H", "mutation": "L2H", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.1877, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5281, "ferret_sera_escape": -0.01377, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "I", "mutation": "L2I", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.02734, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.977, "ferret_sera_escape": null, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "K", "mutation": "L2K", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -9, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L2L", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06773, "ferret_sera_escape": 0.03233, "mature_H5_site": -9, "mouse_sera_escape": -0.02664, "mutant": "M", "mutation": "L2M", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.04311, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.091, "ferret_sera_escape": null, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "P", "mutation": "L2P", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.256, "ferret_sera_escape": 0.07717, "mature_H5_site": -9, "mouse_sera_escape": 0.1939, "mutant": "Q", "mutation": "L2Q", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "R", "mutation": "L2R", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.01022, "ferret_sera_escape": -0.3156, "mature_H5_site": -9, "mouse_sera_escape": -0.1273, "mutant": "S", "mutation": "L2S", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.1044, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.0171, "ferret_sera_escape": null, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "T", "mutation": "L2T", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.608, "ferret_sera_escape": -0.1262, "mature_H5_site": -9, "mouse_sera_escape": 0.04939, "mutant": "V", "mutation": "L2V", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.04979, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2817, "ferret_sera_escape": -0.03422, "mature_H5_site": -9, "mouse_sera_escape": 0.03766, "mutant": "W", "mutation": "L2W", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.07587, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3166, "ferret_sera_escape": 0.1109, "mature_H5_site": -9, "mouse_sera_escape": 0.04438, "mutant": "Y", "mutation": "L2Y", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.08331, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.88, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "A", "mutation": "N20A", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.236, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "D", "mutation": "N20D", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "G", "mutation": "N20G", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "H", "mutation": "N20H", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "I", "mutation": "N20I", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.853, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "K", "mutation": "N20K", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "L", "mutation": "N20L", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.862, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "M", "mutation": "N20M", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 10, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N20N", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.751, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "P", "mutation": "N20P", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N20Q", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.276, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "R", "mutation": "N20R", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.403, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "S", "mutation": "N20S", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.053, "ferret_sera_escape": -0.206, "mature_H5_site": 10, "mouse_sera_escape": -0.05135, "mutant": "T", "mutation": "N20T", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": 0.1787, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "W", "mutation": "N20W", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N20Y", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1878, "ferret_sera_escape": 0.2083, "mature_H5_site": 196, "mouse_sera_escape": 0.1149, "mutant": "A", "mutation": "T200A", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": -0.08473, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5365, "ferret_sera_escape": -0.1272, "mature_H5_site": 196, "mouse_sera_escape": 0.1469, "mutant": "C", "mutation": "T200C", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": -0.2043, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.452, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "D", "mutation": "T200D", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "E", "mutation": "T200E", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "F", "mutation": "T200F", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.03888, "ferret_sera_escape": 0.05122, "mature_H5_site": 196, "mouse_sera_escape": 0.1415, "mutant": "G", "mutation": "T200G", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": -0.2006, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.628, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "H", "mutation": "T200H", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.131, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "I", "mutation": "T200I", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "K", "mutation": "T200K", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "L", "mutation": "T200L", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "M", "mutation": "T200M", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.848, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "N", "mutation": "T200N", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.07342, "ferret_sera_escape": 0.02109, "mature_H5_site": 196, "mouse_sera_escape": 0.05194, "mutant": "P", "mutation": "T200P", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": -0.2693, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.694, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T200Q", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.71, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "R", "mutation": "T200R", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2367, "ferret_sera_escape": -0.1489, "mature_H5_site": 196, "mouse_sera_escape": 0.07291, "mutant": "S", "mutation": "T200S", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": 0.1553, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 196, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T200T", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.01604, "ferret_sera_escape": -0.05412, "mature_H5_site": 196, "mouse_sera_escape": -0.1203, "mutant": "V", "mutation": "T200V", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": -0.2295, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "W", "mutation": "T200W", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T200Y", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.04903, "ferret_sera_escape": -0.1407, "mature_H5_site": 197, "mouse_sera_escape": -0.1168, "mutant": "A", "mutation": "Y201A", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.1668, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.773, "ferret_sera_escape": -0.3329, "mature_H5_site": 197, "mouse_sera_escape": -0.2085, "mutant": "C", "mutation": "Y201C", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.2277, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4882, "ferret_sera_escape": -0.4373, "mature_H5_site": 197, "mouse_sera_escape": -0.3363, "mutant": "D", "mutation": "Y201D", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.2351, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.04513, "ferret_sera_escape": -0.5301, "mature_H5_site": 197, "mouse_sera_escape": -0.2821, "mutant": "E", "mutation": "Y201E", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.2375, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1835, "ferret_sera_escape": -0.07776, "mature_H5_site": 197, "mouse_sera_escape": -0.06197, "mutant": "F", "mutation": "Y201F", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.04182, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4292, "ferret_sera_escape": -0.1551, "mature_H5_site": 197, "mouse_sera_escape": -0.2159, "mutant": "G", "mutation": "Y201G", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.1458, "wildtype": "Y"}, {"a26_usage": 0.1434, "cell_entry": -0.2328, "ferret_sera_escape": null, "mature_H5_site": 197, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y201H", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.923, "ferret_sera_escape": -0.3258, "mature_H5_site": 197, "mouse_sera_escape": -0.1761, "mutant": "I", "mutation": "Y201I", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.575, "ferret_sera_escape": -0.1775, "mature_H5_site": 197, "mouse_sera_escape": 0.09758, "mutant": "K", "mutation": "Y201K", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.01717, "ferret_sera_escape": -0.1888, "mature_H5_site": 197, "mouse_sera_escape": -0.06926, "mutant": "M", "mutation": "Y201M", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.1522, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.64, "ferret_sera_escape": -0.2887, "mature_H5_site": 197, "mouse_sera_escape": -0.1372, "mutant": "N", "mutation": "Y201N", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 197, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y201P", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.0749, "ferret_sera_escape": -0.1442, "mature_H5_site": 197, "mouse_sera_escape": -0.1126, "mutant": "R", "mutation": "Y201R", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.1231, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.07129, "ferret_sera_escape": -0.09344, "mature_H5_site": 197, "mouse_sera_escape": -0.2779, "mutant": "S", "mutation": "Y201S", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.0991, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3794, "ferret_sera_escape": -0.4735, "mature_H5_site": 197, "mouse_sera_escape": -0.2305, "mutant": "T", "mutation": "Y201T", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.4403, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.041, "ferret_sera_escape": null, "mature_H5_site": 197, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y201V", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.004945, "ferret_sera_escape": -0.1634, "mature_H5_site": 197, "mouse_sera_escape": -0.1536, "mutant": "W", "mutation": "Y201W", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.06318, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 197, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y201Y", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.325, "ferret_sera_escape": -0.09476, "mature_H5_site": 198, "mouse_sera_escape": 0.0637, "mutant": "C", "mutation": "I202C", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": -0.2826, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.907, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "D", "mutation": "I202D", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "E", "mutation": "I202E", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.998, "ferret_sera_escape": -0.1768, "mature_H5_site": 198, "mouse_sera_escape": 0.01593, "mutant": "F", "mutation": "I202F", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.455, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "G", "mutation": "I202G", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.661, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "H", "mutation": "I202H", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 198, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I202I", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "K", "mutation": "I202K", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4756, "ferret_sera_escape": 0.01978, "mature_H5_site": 198, "mouse_sera_escape": -0.08739, "mutant": "L", "mutation": "I202L", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": -0.2349, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03982, "ferret_sera_escape": -0.04557, "mature_H5_site": 198, "mouse_sera_escape": -0.09057, "mutant": "M", "mutation": "I202M", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": -0.3231, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.05, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "N", "mutation": "I202N", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "P", "mutation": "I202P", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "R", "mutation": "I202R", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.184, "ferret_sera_escape": -0.2552, "mature_H5_site": 198, "mouse_sera_escape": -0.1633, "mutant": "S", "mutation": "I202S", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.007615, "ferret_sera_escape": -0.07334, "mature_H5_site": 198, "mouse_sera_escape": 0.01249, "mutant": "T", "mutation": "I202T", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": -0.641, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.215, "ferret_sera_escape": -0.08365, "mature_H5_site": 198, "mouse_sera_escape": 3.875e-05, "mutant": "V", "mutation": "I202V", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": -0.1185, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "W", "mutation": "I202W", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I202Y", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.208, "ferret_sera_escape": -0.3182, "mature_H5_site": 199, "mouse_sera_escape": -0.02213, "mutant": "C", "mutation": "S203C", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 199, "mouse_sera_escape": null, "mutant": "E", "mutation": "S203E", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.02631, "ferret_sera_escape": -1.061, "mature_H5_site": 199, "mouse_sera_escape": -0.662, "mutant": "F", "mutation": "S203F", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": -0.1419, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.5688, "ferret_sera_escape": 0.08372, "mature_H5_site": 199, "mouse_sera_escape": -0.00678, "mutant": "G", "mutation": "S203G", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": -0.2965, "wildtype": "S"}, {"a26_usage": 0.3472, "cell_entry": -0.3072, "ferret_sera_escape": -0.4085, "mature_H5_site": 199, "mouse_sera_escape": -0.2393, "mutant": "H", "mutation": "S203H", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": 0.06095, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.499, "ferret_sera_escape": -0.6158, "mature_H5_site": 199, "mouse_sera_escape": -0.3182, "mutant": "I", "mutation": "S203I", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.796, "ferret_sera_escape": null, "mature_H5_site": 199, "mouse_sera_escape": null, "mutant": "K", "mutation": "S203K", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.05166, "ferret_sera_escape": -0.4077, "mature_H5_site": 199, "mouse_sera_escape": -0.2549, "mutant": "L", "mutation": "S203L", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": 0.1718, "wildtype": "S"}, {"a26_usage": 0.7484, "cell_entry": -0.4317, "ferret_sera_escape": -0.3333, "mature_H5_site": 199, "mouse_sera_escape": -0.2471, "mutant": "N", "mutation": "S203N", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 199, "mouse_sera_escape": null, "mutant": "P", "mutation": "S203P", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.09187, "ferret_sera_escape": -0.5438, "mature_H5_site": 199, "mouse_sera_escape": -0.3312, "mutant": "Q", "mutation": "S203Q", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": 0.4665, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.768, "ferret_sera_escape": null, "mature_H5_site": 199, "mouse_sera_escape": null, "mutant": "R", "mutation": "S203R", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 199, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S203S", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8307, "ferret_sera_escape": null, "mature_H5_site": 199, "mouse_sera_escape": null, "mutant": "T", "mutation": "S203T", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6649, "ferret_sera_escape": -0.4297, "mature_H5_site": 199, "mouse_sera_escape": -0.3018, "mutant": "V", "mutation": "S203V", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": -0.08441, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.995, "ferret_sera_escape": null, "mature_H5_site": 199, "mouse_sera_escape": null, "mutant": "W", "mutation": "S203W", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.02779, "ferret_sera_escape": -0.1286, "mature_H5_site": 200, "mouse_sera_escape": -0.2445, "mutant": "A", "mutation": "V204A", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": -0.1122, "wildtype": "V"}, {"a26_usage": 0.3008, "cell_entry": -0.9364, "ferret_sera_escape": 0.04848, "mature_H5_site": 200, "mouse_sera_escape": 0.06913, "mutant": "C", "mutation": "V204C", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": -0.1929, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "D", "mutation": "V204D", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "E", "mutation": "V204E", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.667, "ferret_sera_escape": -0.1316, "mature_H5_site": 200, "mouse_sera_escape": -0.167, "mutant": "F", "mutation": "V204F", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": -0.225, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.056, "ferret_sera_escape": -0.1201, "mature_H5_site": 200, "mouse_sera_escape": 0.03496, "mutant": "G", "mutation": "V204G", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": -0.2507, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "H", "mutation": "V204H", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "K", "mutation": "V204K", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.628, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "L", "mutation": "V204L", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.649, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "M", "mutation": "V204M", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "N", "mutation": "V204N", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "P", "mutation": "V204P", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.033, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V204Q", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "R", "mutation": "V204R", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3403, "ferret_sera_escape": 0.01786, "mature_H5_site": 200, "mouse_sera_escape": -0.09793, "mutant": "S", "mutation": "V204S", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": -0.2865, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.06503, "ferret_sera_escape": -0.1947, "mature_H5_site": 200, "mouse_sera_escape": -0.07021, "mutant": "T", "mutation": "V204T", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": -0.1817, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 200, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V204V", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.938, "ferret_sera_escape": -0.1872, "mature_H5_site": 200, "mouse_sera_escape": -0.1709, "mutant": "W", "mutation": "V204W", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": -0.2413, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.572, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V204Y", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.9708, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "A", "mutation": "G205A", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.07951, "cell_entry": -1.012, "ferret_sera_escape": -0.9203, "mature_H5_site": 201, "mouse_sera_escape": -0.625, "mutant": "C", "mutation": "G205C", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": -0.2158, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.837, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "E", "mutation": "G205E", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.004, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "F", "mutation": "G205F", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 201, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G205G", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "I", "mutation": "G205I", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "K", "mutation": "G205K", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.926, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "M", "mutation": "G205M", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.884, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "N", "mutation": "G205N", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "P", "mutation": "G205P", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8336, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G205Q", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "R", "mutation": "G205R", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.443, "ferret_sera_escape": -0.4773, "mature_H5_site": 201, "mouse_sera_escape": -0.4653, "mutant": "S", "mutation": "G205S", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": -0.2469, "wildtype": "G"}, {"a26_usage": 0.123, "cell_entry": -0.5742, "ferret_sera_escape": -0.5419, "mature_H5_site": 201, "mouse_sera_escape": -0.4582, "mutant": "T", "mutation": "G205T", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": 0.01387, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.404, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "V", "mutation": "G205V", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "W", "mutation": "G205W", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.907, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G205Y", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.1464, "cell_entry": -0.01796, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "A", "mutation": "T206A", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.1, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "C", "mutation": "T206C", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "E", "mutation": "T206E", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.745, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "F", "mutation": "T206F", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1915, "ferret_sera_escape": 0.2798, "mature_H5_site": 202, "mouse_sera_escape": 0.1541, "mutant": "G", "mutation": "T206G", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": -0.1614, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2482, "ferret_sera_escape": -0.02183, "mature_H5_site": 202, "mouse_sera_escape": -0.1166, "mutant": "H", "mutation": "T206H", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": -0.6223, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "I", "mutation": "T206I", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "K", "mutation": "T206K", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.774, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "L", "mutation": "T206L", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "M", "mutation": "T206M", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.994, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "N", "mutation": "T206N", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "P", "mutation": "T206P", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T206Q", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.824, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "R", "mutation": "T206R", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 202, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T206T", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "V", "mutation": "T206V", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "W", "mutation": "T206W", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T206Y", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7795, "ferret_sera_escape": 0.09651, "mature_H5_site": 203, "mouse_sera_escape": 0.06762, "mutant": "A", "mutation": "S207A", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": 0.2105, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.002705, "ferret_sera_escape": -0.1106, "mature_H5_site": 203, "mouse_sera_escape": 0.05027, "mutant": "C", "mutation": "S207C", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.2497, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1294, "ferret_sera_escape": 0.01857, "mature_H5_site": 203, "mouse_sera_escape": 0.0346, "mutant": "D", "mutation": "S207D", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.2327, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06497, "ferret_sera_escape": 0.04028, "mature_H5_site": 203, "mouse_sera_escape": 0.08865, "mutant": "E", "mutation": "S207E", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.2128, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3525, "ferret_sera_escape": -0.1754, "mature_H5_site": 203, "mouse_sera_escape": -0.1478, "mutant": "G", "mutation": "S207G", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.1085, "wildtype": "S"}, {"a26_usage": 0.06748, "cell_entry": -0.02117, "ferret_sera_escape": -0.07502, "mature_H5_site": 203, "mouse_sera_escape": 0.03052, "mutant": "I", "mutation": "S207I", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.275, "wildtype": "S"}, {"a26_usage": 0.01931, "cell_entry": 0.06246, "ferret_sera_escape": 0.1008, "mature_H5_site": 203, "mouse_sera_escape": 0.1268, "mutant": "K", "mutation": "S207K", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": 0.003042, "wildtype": "S"}, {"a26_usage": 0.1138, "cell_entry": -0.02478, "ferret_sera_escape": 0.1504, "mature_H5_site": 203, "mouse_sera_escape": -0.06857, "mutant": "N", "mutation": "S207N", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.2213, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.836, "ferret_sera_escape": null, "mature_H5_site": 203, "mouse_sera_escape": 0.06558, "mutant": "P", "mutation": "S207P", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2801, "ferret_sera_escape": 0.198, "mature_H5_site": 203, "mouse_sera_escape": 0.1212, "mutant": "Q", "mutation": "S207Q", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.02432, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 203, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S207S", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.2453, "cell_entry": -0.1829, "ferret_sera_escape": 0.2023, "mature_H5_site": 203, "mouse_sera_escape": 0.0546, "mutant": "T", "mutation": "S207T", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.3701, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.9663, "ferret_sera_escape": -0.1251, "mature_H5_site": 203, "mouse_sera_escape": -0.03154, "mutant": "W", "mutation": "S207W", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4106, "ferret_sera_escape": null, "mature_H5_site": 204, "mouse_sera_escape": null, "mutant": "A", "mutation": "T208A", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4845, "ferret_sera_escape": 0.1013, "mature_H5_site": 204, "mouse_sera_escape": -0.04432, "mutant": "C", "mutation": "T208C", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.2496, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.04, "ferret_sera_escape": -0.1051, "mature_H5_site": 204, "mouse_sera_escape": -0.1179, "mutant": "D", "mutation": "T208D", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.2982, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.07075, "ferret_sera_escape": -0.001634, "mature_H5_site": 204, "mouse_sera_escape": -0.09234, "mutant": "E", "mutation": "T208E", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.4408, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4355, "ferret_sera_escape": 0.01159, "mature_H5_site": 204, "mouse_sera_escape": null, "mutant": "F", "mutation": "T208F", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.03211, "ferret_sera_escape": -0.1036, "mature_H5_site": 204, "mouse_sera_escape": -0.06654, "mutant": "G", "mutation": "T208G", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.3017, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.05084, "ferret_sera_escape": 0.1363, "mature_H5_site": 204, "mouse_sera_escape": 0.07224, "mutant": "I", "mutation": "T208I", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.1458, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.00554, "ferret_sera_escape": 0.08899, "mature_H5_site": 204, "mouse_sera_escape": 0.07916, "mutant": "K", "mutation": "T208K", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.1308, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.0802, "ferret_sera_escape": -0.0915, "mature_H5_site": 204, "mouse_sera_escape": 0.0522, "mutant": "L", "mutation": "T208L", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.1567, "wildtype": "T"}, {"a26_usage": 0.3494, "cell_entry": -0.3923, "ferret_sera_escape": -0.07218, "mature_H5_site": 204, "mouse_sera_escape": 0.01846, "mutant": "M", "mutation": "T208M", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.08901, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5868, "ferret_sera_escape": null, "mature_H5_site": 204, "mouse_sera_escape": null, "mutant": "N", "mutation": "T208N", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 204, "mouse_sera_escape": null, "mutant": "P", "mutation": "T208P", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.04968, "ferret_sera_escape": 0.1154, "mature_H5_site": 204, "mouse_sera_escape": 0.03734, "mutant": "Q", "mutation": "T208Q", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.1804, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2482, "ferret_sera_escape": -0.009407, "mature_H5_site": 204, "mouse_sera_escape": 0.02496, "mutant": "R", "mutation": "T208R", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.2438, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2978, "ferret_sera_escape": -0.07459, "mature_H5_site": 204, "mouse_sera_escape": 0.002721, "mutant": "S", "mutation": "T208S", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.1938, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 204, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T208T", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5021, "ferret_sera_escape": 0.04161, "mature_H5_site": 204, "mouse_sera_escape": 0.08205, "mutant": "V", "mutation": "T208V", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": null, "wildtype": "T"}, {"a26_usage": 0.08724, "cell_entry": 0.0459, "ferret_sera_escape": 0.1716, "mature_H5_site": 204, "mouse_sera_escape": 0.04573, "mutant": "W", "mutation": "T208W", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.2331, "wildtype": "T"}, {"a26_usage": 0.4689, "cell_entry": -0.4254, "ferret_sera_escape": -0.05105, "mature_H5_site": 204, "mouse_sera_escape": -0.03363, "mutant": "Y", "mutation": "T208Y", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.1661, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.06468, "ferret_sera_escape": 0.02097, "mature_H5_site": 205, "mouse_sera_escape": 0.01013, "mutant": "C", "mutation": "L209C", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": 0.08321, "wildtype": "L"}, {"a26_usage": 0.01079, "cell_entry": -0.2622, "ferret_sera_escape": 0.01404, "mature_H5_site": 205, "mouse_sera_escape": 0.09776, "mutant": "E", "mutation": "L209E", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": 0.008546, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.991, "ferret_sera_escape": null, "mature_H5_site": 205, "mouse_sera_escape": null, "mutant": "F", "mutation": "L209F", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.869, "ferret_sera_escape": null, "mature_H5_site": 205, "mouse_sera_escape": null, "mutant": "G", "mutation": "L209G", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.696, "ferret_sera_escape": null, "mature_H5_site": 205, "mouse_sera_escape": null, "mutant": "K", "mutation": "L209K", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 205, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L209L", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1419, "ferret_sera_escape": -0.04456, "mature_H5_site": 205, "mouse_sera_escape": 0.05669, "mutant": "M", "mutation": "L209M", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": -0.1727, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 205, "mouse_sera_escape": null, "mutant": "P", "mutation": "L209P", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6816, "ferret_sera_escape": -0.3307, "mature_H5_site": 205, "mouse_sera_escape": -0.1644, "mutant": "Q", "mutation": "L209Q", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.728, "ferret_sera_escape": null, "mature_H5_site": 205, "mouse_sera_escape": null, "mutant": "R", "mutation": "L209R", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.821, "ferret_sera_escape": null, "mature_H5_site": 205, "mouse_sera_escape": null, "mutant": "S", "mutation": "L209S", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2147, "ferret_sera_escape": -0.1465, "mature_H5_site": 205, "mouse_sera_escape": -0.06417, "mutant": "T", "mutation": "L209T", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": -0.04456, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.382, "ferret_sera_escape": 0.129, "mature_H5_site": 205, "mouse_sera_escape": 0.03634, "mutant": "V", "mutation": "L209V", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": 0.4008, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.629, "ferret_sera_escape": null, "mature_H5_site": 205, "mouse_sera_escape": null, "mutant": "W", "mutation": "L209W", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.633, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "C", "mutation": "N21C", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.22, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "D", "mutation": "N21D", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6686, "ferret_sera_escape": -0.05557, "mature_H5_site": 11, "mouse_sera_escape": -0.03642, "mutant": "G", "mutation": "N21G", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": -0.05949, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.693, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "H", "mutation": "N21H", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.993, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "I", "mutation": "N21I", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.355, "ferret_sera_escape": 0.01568, "mature_H5_site": 11, "mouse_sera_escape": 0.1385, "mutant": "K", "mutation": "N21K", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": -0.04842, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05349, "ferret_sera_escape": -0.1143, "mature_H5_site": 11, "mouse_sera_escape": 0.1369, "mutant": "L", "mutation": "N21L", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": -0.1696, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.958, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "M", "mutation": "N21M", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 11, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N21N", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8727, "ferret_sera_escape": -0.1176, "mature_H5_site": 11, "mouse_sera_escape": 0.1049, "mutant": "Q", "mutation": "N21Q", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.184, "ferret_sera_escape": -0.01805, "mature_H5_site": 11, "mouse_sera_escape": 0.4196, "mutant": "R", "mutation": "N21R", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.204, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "S", "mutation": "N21S", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9196, "ferret_sera_escape": -0.0873, "mature_H5_site": 11, "mouse_sera_escape": 0.3256, "mutant": "T", "mutation": "N21T", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "V", "mutation": "N21V", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.732, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "W", "mutation": "N21W", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.398, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N21Y", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.794, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "A", "mutation": "N210A", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.659, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "D", "mutation": "N210D", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.76, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "E", "mutation": "N210E", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.798, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "F", "mutation": "N210F", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.665, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "H", "mutation": "N210H", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.511, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "I", "mutation": "N210I", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "K", "mutation": "N210K", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.708, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "L", "mutation": "N210L", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.263, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "M", "mutation": "N210M", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 206, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N210N", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.93, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "P", "mutation": "N210P", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.646, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N210Q", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "R", "mutation": "N210R", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.767, "ferret_sera_escape": -0.1756, "mature_H5_site": 206, "mouse_sera_escape": -0.02884, "mutant": "S", "mutation": "N210S", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.603, "ferret_sera_escape": -0.5212, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "T", "mutation": "N210T", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": -0.1609, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "V", "mutation": "N210V", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.175, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "W", "mutation": "N210W", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.693, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N210Y", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.5204, "cell_entry": -0.372, "ferret_sera_escape": null, "mature_H5_site": 207, "mouse_sera_escape": null, "mutant": "A", "mutation": "Q211A", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1783, "ferret_sera_escape": 0.119, "mature_H5_site": 207, "mouse_sera_escape": 0.03715, "mutant": "C", "mutation": "Q211C", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.111, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1263, "ferret_sera_escape": -0.02441, "mature_H5_site": 207, "mouse_sera_escape": 0.02827, "mutant": "D", "mutation": "Q211D", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.5599, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.06217, "ferret_sera_escape": 0.09265, "mature_H5_site": 207, "mouse_sera_escape": -0.05058, "mutant": "E", "mutation": "Q211E", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.3173, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.061, "ferret_sera_escape": -0.231, "mature_H5_site": 207, "mouse_sera_escape": -0.03894, "mutant": "F", "mutation": "Q211F", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.1603, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.219, "ferret_sera_escape": -0.01257, "mature_H5_site": 207, "mouse_sera_escape": 0.005562, "mutant": "G", "mutation": "Q211G", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.2506, "wildtype": "Q"}, {"a26_usage": 0.0197, "cell_entry": 0.06265, "ferret_sera_escape": 0.0845, "mature_H5_site": 207, "mouse_sera_escape": -0.01952, "mutant": "H", "mutation": "Q211H", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.4032, "wildtype": "Q"}, {"a26_usage": 0.001446, "cell_entry": -0.01455, "ferret_sera_escape": null, "mature_H5_site": 207, "mouse_sera_escape": null, "mutant": "I", "mutation": "Q211I", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.7477, "ferret_sera_escape": -0.08039, "mature_H5_site": 207, "mouse_sera_escape": -0.2052, "mutant": "K", "mutation": "Q211K", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.2086, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1064, "ferret_sera_escape": -0.095, "mature_H5_site": 207, "mouse_sera_escape": -0.1192, "mutant": "L", "mutation": "Q211L", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.1564, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.06665, "ferret_sera_escape": 0.02265, "mature_H5_site": 207, "mouse_sera_escape": -0.04052, "mutant": "N", "mutation": "Q211N", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.3773, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.669, "ferret_sera_escape": null, "mature_H5_site": 207, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q211P", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 207, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q211Q", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1399, "ferret_sera_escape": -0.1183, "mature_H5_site": 207, "mouse_sera_escape": -0.1399, "mutant": "R", "mutation": "Q211R", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.3531, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.04676, "ferret_sera_escape": -0.03933, "mature_H5_site": 207, "mouse_sera_escape": -0.09986, "mutant": "S", "mutation": "Q211S", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.354, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.475, "ferret_sera_escape": -0.3415, "mature_H5_site": 207, "mouse_sera_escape": -0.06318, "mutant": "T", "mutation": "Q211T", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.4775, "ferret_sera_escape": 0.065, "mature_H5_site": 207, "mouse_sera_escape": 0.03089, "mutant": "V", "mutation": "Q211V", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.2548, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.04648, "ferret_sera_escape": -0.249, "mature_H5_site": 207, "mouse_sera_escape": -0.09529, "mutant": "W", "mutation": "Q211W", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.06918, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1633, "ferret_sera_escape": -0.07702, "mature_H5_site": 207, "mouse_sera_escape": -0.06302, "mutant": "Y", "mutation": "Q211Y", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.1589, "wildtype": "Q"}, {"a26_usage": 0.00196, "cell_entry": 0.05157, "ferret_sera_escape": -0.1934, "mature_H5_site": 208, "mouse_sera_escape": -0.14, "mutant": "A", "mutation": "R212A", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": -0.158, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1094, "ferret_sera_escape": -0.3191, "mature_H5_site": 208, "mouse_sera_escape": -0.1618, "mutant": "C", "mutation": "R212C", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": -0.21, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.756, "ferret_sera_escape": null, "mature_H5_site": 208, "mouse_sera_escape": null, "mutant": "D", "mutation": "R212D", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.009905, "ferret_sera_escape": -0.3961, "mature_H5_site": 208, "mouse_sera_escape": -0.2991, "mutant": "F", "mutation": "R212F", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": -0.2355, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4338, "ferret_sera_escape": -0.2689, "mature_H5_site": 208, "mouse_sera_escape": null, "mutant": "H", "mutation": "R212H", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": null, "wildtype": "R"}, {"a26_usage": 0.01618, "cell_entry": 0.0764, "ferret_sera_escape": -0.1515, "mature_H5_site": 208, "mouse_sera_escape": -0.1688, "mutant": "I", "mutation": "R212I", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": 0.3405, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.351, "ferret_sera_escape": -0.2088, "mature_H5_site": 208, "mouse_sera_escape": -0.05484, "mutant": "K", "mutation": "R212K", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": 0.03514, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.001365, "ferret_sera_escape": -0.134, "mature_H5_site": 208, "mouse_sera_escape": -0.1827, "mutant": "N", "mutation": "R212N", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": -0.08621, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 208, "mouse_sera_escape": null, "mutant": "P", "mutation": "R212P", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3394, "ferret_sera_escape": -0.1911, "mature_H5_site": 208, "mouse_sera_escape": -0.04824, "mutant": "Q", "mutation": "R212Q", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": -0.03155, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 208, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R212R", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.86, "ferret_sera_escape": -0.1914, "mature_H5_site": 208, "mouse_sera_escape": -0.1391, "mutant": "S", "mutation": "R212S", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": -0.2268, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.745, "ferret_sera_escape": null, "mature_H5_site": 208, "mouse_sera_escape": null, "mutant": "T", "mutation": "R212T", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.8722, "ferret_sera_escape": null, "mature_H5_site": 208, "mouse_sera_escape": null, "mutant": "W", "mutation": "R212W", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.06514, "ferret_sera_escape": -0.4964, "mature_H5_site": 208, "mouse_sera_escape": -0.4613, "mutant": "Y", "mutation": "R212Y", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": -0.2718, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.01018, "ferret_sera_escape": null, "mature_H5_site": 209, "mouse_sera_escape": null, "mutant": "A", "mutation": "L213A", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": null, "wildtype": "L"}, {"a26_usage": 0.1463, "cell_entry": 0.03875, "ferret_sera_escape": -0.06493, "mature_H5_site": 209, "mouse_sera_escape": -0.03196, "mutant": "C", "mutation": "L213C", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.2067, "wildtype": "L"}, {"a26_usage": 0.2251, "cell_entry": -0.4933, "ferret_sera_escape": -0.09064, "mature_H5_site": 209, "mouse_sera_escape": null, "mutant": "D", "mutation": "L213D", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2292, "ferret_sera_escape": -0.2278, "mature_H5_site": 209, "mouse_sera_escape": -0.1614, "mutant": "E", "mutation": "L213E", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.2289, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.855, "ferret_sera_escape": -0.3583, "mature_H5_site": 209, "mouse_sera_escape": -0.2054, "mutant": "G", "mutation": "L213G", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.1579, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.006395, "ferret_sera_escape": -0.1397, "mature_H5_site": 209, "mouse_sera_escape": -0.1507, "mutant": "H", "mutation": "L213H", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.3982, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6634, "ferret_sera_escape": -0.2119, "mature_H5_site": 209, "mouse_sera_escape": -0.01093, "mutant": "I", "mutation": "L213I", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.07551, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9553, "ferret_sera_escape": -0.07762, "mature_H5_site": 209, "mouse_sera_escape": -0.03552, "mutant": "K", "mutation": "L213K", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 209, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L213L", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06624, "ferret_sera_escape": null, "mature_H5_site": 209, "mouse_sera_escape": null, "mutant": "M", "mutation": "L213M", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 209, "mouse_sera_escape": null, "mutant": "P", "mutation": "L213P", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1603, "ferret_sera_escape": -0.1891, "mature_H5_site": 209, "mouse_sera_escape": -0.09999, "mutant": "Q", "mutation": "L213Q", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.3292, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.638, "ferret_sera_escape": -0.02025, "mature_H5_site": 209, "mouse_sera_escape": 0.0131, "mutant": "R", "mutation": "L213R", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.2638, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1492, "ferret_sera_escape": -0.0989, "mature_H5_site": 209, "mouse_sera_escape": -0.1182, "mutant": "S", "mutation": "L213S", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.2729, "wildtype": "L"}, {"a26_usage": 0.376, "cell_entry": -1.061, "ferret_sera_escape": 0.02541, "mature_H5_site": 209, "mouse_sera_escape": null, "mutant": "T", "mutation": "L213T", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.03, "ferret_sera_escape": 0.07158, "mature_H5_site": 209, "mouse_sera_escape": -0.04966, "mutant": "V", "mutation": "L213V", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.1879, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.302, "ferret_sera_escape": -0.2164, "mature_H5_site": 209, "mouse_sera_escape": -0.1726, "mutant": "W", "mutation": "L213W", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.2252, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.002795, "ferret_sera_escape": -0.1371, "mature_H5_site": 209, "mouse_sera_escape": -0.07714, "mutant": "Y", "mutation": "L213Y", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.2108, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 210, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A214A", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.07426, "ferret_sera_escape": -0.01519, "mature_H5_site": 210, "mouse_sera_escape": -0.03486, "mutant": "C", "mutation": "A214C", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": -0.07378, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.02426, "ferret_sera_escape": -0.1886, "mature_H5_site": 210, "mouse_sera_escape": -0.07832, "mutant": "D", "mutation": "A214D", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": -0.1229, "wildtype": "A"}, {"a26_usage": 0.2028, "cell_entry": -0.01068, "ferret_sera_escape": 0.04924, "mature_H5_site": 210, "mouse_sera_escape": 0.1379, "mutant": "E", "mutation": "A214E", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": -0.01961, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.00549, "ferret_sera_escape": null, "mature_H5_site": 210, "mouse_sera_escape": null, "mutant": "F", "mutation": "A214F", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.003955, "ferret_sera_escape": -0.06434, "mature_H5_site": 210, "mouse_sera_escape": -0.03472, "mutant": "I", "mutation": "A214I", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": null, "wildtype": "A"}, {"a26_usage": 0.3148, "cell_entry": 0.05656, "ferret_sera_escape": 0.02207, "mature_H5_site": 210, "mouse_sera_escape": 0.1015, "mutant": "K", "mutation": "A214K", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": 0.184, "wildtype": "A"}, {"a26_usage": 0.04296, "cell_entry": 0.06172, "ferret_sera_escape": -0.08259, "mature_H5_site": 210, "mouse_sera_escape": -0.07201, "mutant": "L", "mutation": "A214L", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": -0.03536, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.02643, "ferret_sera_escape": -0.01686, "mature_H5_site": 210, "mouse_sera_escape": -0.03036, "mutant": "M", "mutation": "A214M", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": -0.0006739, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.01319, "ferret_sera_escape": 0.1016, "mature_H5_site": 210, "mouse_sera_escape": 0.1127, "mutant": "N", "mutation": "A214N", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": -0.0008743, "wildtype": "A"}, {"a26_usage": 0.3676, "cell_entry": -0.1523, "ferret_sera_escape": 0.08474, "mature_H5_site": 210, "mouse_sera_escape": 0.05708, "mutant": "Q", "mutation": "A214Q", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": 0.05546, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.6893, "ferret_sera_escape": 0.1919, "mature_H5_site": 210, "mouse_sera_escape": 0.00668, "mutant": "R", "mutation": "A214R", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": 0.06067, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3456, "ferret_sera_escape": 0.01961, "mature_H5_site": 210, "mouse_sera_escape": -0.1283, "mutant": "S", "mutation": "A214S", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": -0.02598, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.0005658, "ferret_sera_escape": -0.2371, "mature_H5_site": 210, "mouse_sera_escape": -0.02958, "mutant": "T", "mutation": "A214T", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": 0.1316, "wildtype": "A"}, {"a26_usage": 0.4213, "cell_entry": -0.1736, "ferret_sera_escape": -0.0642, "mature_H5_site": 210, "mouse_sera_escape": -0.1015, "mutant": "V", "mutation": "A214V", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": 0.07261, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.245, "ferret_sera_escape": null, "mature_H5_site": 210, "mouse_sera_escape": null, "mutant": "W", "mutation": "A214W", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.584, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "A", "mutation": "P215A", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.634, "ferret_sera_escape": -0.09007, "mature_H5_site": 211, "mouse_sera_escape": -0.04602, "mutant": "C", "mutation": "P215C", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": -0.2576, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "D", "mutation": "P215D", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "E", "mutation": "P215E", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "F", "mutation": "P215F", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "G", "mutation": "P215G", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "K", "mutation": "P215K", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.853, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "L", "mutation": "P215L", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "M", "mutation": "P215M", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.523, "ferret_sera_escape": -0.3085, "mature_H5_site": 211, "mouse_sera_escape": -0.1512, "mutant": "N", "mutation": "P215N", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 211, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P215P", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P215Q", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.881, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "R", "mutation": "P215R", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.959, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "S", "mutation": "P215S", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.431, "ferret_sera_escape": -0.5554, "mature_H5_site": 211, "mouse_sera_escape": -0.1376, "mutant": "V", "mutation": "P215V", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.88, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "W", "mutation": "P215W", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.409, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "Y", "mutation": "P215Y", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0329, "ferret_sera_escape": -0.2303, "mature_H5_site": 212, "mouse_sera_escape": -0.2051, "mutant": "C", "mutation": "K216C", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": -0.2786, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.749, "ferret_sera_escape": null, "mature_H5_site": 212, "mouse_sera_escape": null, "mutant": "E", "mutation": "K216E", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.08566, "ferret_sera_escape": -0.8109, "mature_H5_site": 212, "mouse_sera_escape": -0.589, "mutant": "F", "mutation": "K216F", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": -0.2543, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 212, "mouse_sera_escape": null, "mutant": "G", "mutation": "K216G", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03417, "ferret_sera_escape": -0.7372, "mature_H5_site": 212, "mouse_sera_escape": -0.5455, "mutant": "H", "mutation": "K216H", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": 0.09082, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 212, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K216K", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.1195, "cell_entry": 0.07761, "ferret_sera_escape": -0.2492, "mature_H5_site": 212, "mouse_sera_escape": -0.3991, "mutant": "L", "mutation": "K216L", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": 0.08161, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.02587, "ferret_sera_escape": -0.4992, "mature_H5_site": 212, "mouse_sera_escape": -0.3919, "mutant": "M", "mutation": "K216M", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": -0.2978, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.257, "ferret_sera_escape": -0.8952, "mature_H5_site": 212, "mouse_sera_escape": -0.5546, "mutant": "N", "mutation": "K216N", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": -0.01479, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 212, "mouse_sera_escape": null, "mutant": "P", "mutation": "K216P", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.06986, "ferret_sera_escape": -0.3744, "mature_H5_site": 212, "mouse_sera_escape": -0.2542, "mutant": "Q", "mutation": "K216Q", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.04816, "ferret_sera_escape": -0.08764, "mature_H5_site": 212, "mouse_sera_escape": 0.09474, "mutant": "R", "mutation": "K216R", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": -0.02283, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05051, "ferret_sera_escape": -0.5087, "mature_H5_site": 212, "mouse_sera_escape": -0.4646, "mutant": "S", "mutation": "K216S", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": -0.3009, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.366, "ferret_sera_escape": -0.08445, "mature_H5_site": 212, "mouse_sera_escape": 0.05237, "mutant": "T", "mutation": "K216T", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07996, "ferret_sera_escape": null, "mature_H5_site": 212, "mouse_sera_escape": null, "mutant": "V", "mutation": "K216V", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": null, "wildtype": "K"}, {"a26_usage": 0.03124, "cell_entry": 0.0742, "ferret_sera_escape": -0.6386, "mature_H5_site": 212, "mouse_sera_escape": -0.4792, "mutant": "Y", "mutation": "K216Y", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3187, "ferret_sera_escape": -0.5743, "mature_H5_site": 213, "mouse_sera_escape": -0.2584, "mutant": "A", "mutation": "I217A", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": 0.002562, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4126, "ferret_sera_escape": -0.1698, "mature_H5_site": 213, "mouse_sera_escape": -0.05478, "mutant": "C", "mutation": "I217C", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": -0.09418, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.181, "ferret_sera_escape": null, "mature_H5_site": 213, "mouse_sera_escape": null, "mutant": "D", "mutation": "I217D", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2592, "ferret_sera_escape": -0.1704, "mature_H5_site": 213, "mouse_sera_escape": -0.2555, "mutant": "E", "mutation": "I217E", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": 0.06025, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06098, "ferret_sera_escape": -0.2035, "mature_H5_site": 213, "mouse_sera_escape": -0.04748, "mutant": "F", "mutation": "I217F", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": 0.491, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.256, "ferret_sera_escape": null, "mature_H5_site": 213, "mouse_sera_escape": null, "mutant": "G", "mutation": "I217G", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1569, "ferret_sera_escape": -0.6872, "mature_H5_site": 213, "mouse_sera_escape": -0.4768, "mutant": "H", "mutation": "I217H", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": -0.02071, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 213, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I217I", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3126, "ferret_sera_escape": -0.5184, "mature_H5_site": 213, "mouse_sera_escape": -0.2505, "mutant": "K", "mutation": "I217K", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": 0.09923, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1902, "ferret_sera_escape": null, "mature_H5_site": 213, "mouse_sera_escape": null, "mutant": "L", "mutation": "I217L", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3976, "ferret_sera_escape": -0.09219, "mature_H5_site": 213, "mouse_sera_escape": -0.08106, "mutant": "M", "mutation": "I217M", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": 0.0574, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.245, "ferret_sera_escape": null, "mature_H5_site": 213, "mouse_sera_escape": null, "mutant": "N", "mutation": "I217N", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": null, "wildtype": "I"}, {"a26_usage": 0.03477, "cell_entry": -0.001815, "ferret_sera_escape": null, "mature_H5_site": 213, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I217Q", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6056, "ferret_sera_escape": -0.668, "mature_H5_site": 213, "mouse_sera_escape": -0.3882, "mutant": "R", "mutation": "I217R", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.04, "ferret_sera_escape": -0.4569, "mature_H5_site": 213, "mouse_sera_escape": null, "mutant": "S", "mutation": "I217S", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4957, "ferret_sera_escape": -0.167, "mature_H5_site": 213, "mouse_sera_escape": -0.3386, "mutant": "T", "mutation": "I217T", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": -0.08986, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.216, "ferret_sera_escape": 0.1014, "mature_H5_site": 213, "mouse_sera_escape": 0.02819, "mutant": "V", "mutation": "I217V", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": -0.1128, "wildtype": "I"}, {"a26_usage": 0.04316, "cell_entry": -0.0001195, "ferret_sera_escape": -0.8643, "mature_H5_site": 213, "mouse_sera_escape": -0.6126, "mutant": "W", "mutation": "I217W", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": 0.08844, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 214, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A218A", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2463, "ferret_sera_escape": 0.02494, "mature_H5_site": 214, "mouse_sera_escape": 0.08144, "mutant": "C", "mutation": "A218C", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": -0.2005, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 214, "mouse_sera_escape": null, "mutant": "D", "mutation": "A218D", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.795, "ferret_sera_escape": null, "mature_H5_site": 214, "mouse_sera_escape": null, "mutant": "E", "mutation": "A218E", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.0487, "ferret_sera_escape": -1.488, "mature_H5_site": 214, "mouse_sera_escape": -1.045, "mutant": "F", "mutation": "A218F", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": -0.2455, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2427, "ferret_sera_escape": -0.1297, "mature_H5_site": 214, "mouse_sera_escape": -0.1262, "mutant": "G", "mutation": "A218G", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": -0.2151, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.29, "ferret_sera_escape": -0.7139, "mature_H5_site": 214, "mouse_sera_escape": -0.3204, "mutant": "H", "mutation": "A218H", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": -0.08482, "wildtype": "A"}, {"a26_usage": 1.52, "cell_entry": -2.991, "ferret_sera_escape": -0.08003, "mature_H5_site": 214, "mouse_sera_escape": -0.002649, "mutant": "I", "mutation": "A218I", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.8935, "ferret_sera_escape": 0.2182, "mature_H5_site": 214, "mouse_sera_escape": 0.1224, "mutant": "L", "mutation": "A218L", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": 0.7351, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.8063, "ferret_sera_escape": -0.07864, "mature_H5_site": 214, "mouse_sera_escape": 0.02083, "mutant": "M", "mutation": "A218M", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": 0.4078, "wildtype": "A"}, {"a26_usage": 0.3516, "cell_entry": -0.03717, "ferret_sera_escape": -0.6349, "mature_H5_site": 214, "mouse_sera_escape": -0.1997, "mutant": "N", "mutation": "A218N", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": -0.1485, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.851, "ferret_sera_escape": null, "mature_H5_site": 214, "mouse_sera_escape": null, "mutant": "P", "mutation": "A218P", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": null, "wildtype": "A"}, {"a26_usage": 0.1369, "cell_entry": -0.1621, "ferret_sera_escape": null, "mature_H5_site": 214, "mouse_sera_escape": null, "mutant": "S", "mutation": "A218S", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3872, "ferret_sera_escape": -0.01529, "mature_H5_site": 214, "mouse_sera_escape": 0.07621, "mutant": "T", "mutation": "A218T", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": -0.01731, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.6792, "ferret_sera_escape": 0.3371, "mature_H5_site": 214, "mouse_sera_escape": 0.2002, "mutant": "V", "mutation": "A218V", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": 0.3192, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 214, "mouse_sera_escape": null, "mutant": "W", "mutation": "A218W", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.5, "ferret_sera_escape": null, "mature_H5_site": 214, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A218Y", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": null, "wildtype": "A"}, {"a26_usage": 0.1385, "cell_entry": 0.01311, "ferret_sera_escape": -0.5565, "mature_H5_site": 215, "mouse_sera_escape": -0.374, "mutant": "A", "mutation": "T219A", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.01521, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.02908, "ferret_sera_escape": -0.2806, "mature_H5_site": 215, "mouse_sera_escape": -0.2303, "mutant": "C", "mutation": "T219C", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.2097, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.07375, "ferret_sera_escape": -1.393, "mature_H5_site": 215, "mouse_sera_escape": -1.006, "mutant": "D", "mutation": "T219D", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.5488, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.06439, "ferret_sera_escape": -1.559, "mature_H5_site": 215, "mouse_sera_escape": -1.096, "mutant": "E", "mutation": "T219E", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.326, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0208, "ferret_sera_escape": -0.1344, "mature_H5_site": 215, "mouse_sera_escape": -0.05307, "mutant": "F", "mutation": "T219F", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.1963, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1026, "ferret_sera_escape": null, "mature_H5_site": 215, "mouse_sera_escape": null, "mutant": "G", "mutation": "T219G", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.298, "ferret_sera_escape": 0.05218, "mature_H5_site": 215, "mouse_sera_escape": -0.06727, "mutant": "I", "mutation": "T219I", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.6563, "ferret_sera_escape": -0.03793, "mature_H5_site": 215, "mouse_sera_escape": 0.108, "mutant": "K", "mutation": "T219K", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": 0.36, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.01552, "ferret_sera_escape": 0.2677, "mature_H5_site": 215, "mouse_sera_escape": 0.1019, "mutant": "L", "mutation": "T219L", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": 0.3671, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3844, "ferret_sera_escape": -0.182, "mature_H5_site": 215, "mouse_sera_escape": -0.01435, "mutant": "M", "mutation": "T219M", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": 0.05533, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.06996, "ferret_sera_escape": null, "mature_H5_site": 215, "mouse_sera_escape": null, "mutant": "N", "mutation": "T219N", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.01061, "ferret_sera_escape": null, "mature_H5_site": 215, "mouse_sera_escape": -0.237, "mutant": "P", "mutation": "T219P", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.09164, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1603, "ferret_sera_escape": -0.2141, "mature_H5_site": 215, "mouse_sera_escape": 0.2711, "mutant": "R", "mutation": "T219R", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": 0.3164, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1901, "ferret_sera_escape": -0.7719, "mature_H5_site": 215, "mouse_sera_escape": -0.3435, "mutant": "S", "mutation": "T219S", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 215, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T219T", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0449, "ferret_sera_escape": -0.3117, "mature_H5_site": 215, "mouse_sera_escape": -0.1514, "mutant": "W", "mutation": "T219W", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.1596, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.02245, "ferret_sera_escape": -0.1349, "mature_H5_site": 215, "mouse_sera_escape": -0.01025, "mutant": "Y", "mutation": "T219Y", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.05556, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7403, "ferret_sera_escape": -0.09005, "mature_H5_site": 12, "mouse_sera_escape": -0.07347, "mutant": "A", "mutation": "S22A", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.1412, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.473, "ferret_sera_escape": null, "mature_H5_site": 12, "mouse_sera_escape": null, "mutant": "C", "mutation": "S22C", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.298, "ferret_sera_escape": null, "mature_H5_site": 12, "mouse_sera_escape": null, "mutant": "D", "mutation": "S22D", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.261, "ferret_sera_escape": -0.1848, "mature_H5_site": 12, "mouse_sera_escape": null, "mutant": "E", "mutation": "S22E", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.06257, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.65, "ferret_sera_escape": null, "mature_H5_site": 12, "mouse_sera_escape": null, "mutant": "F", "mutation": "S22F", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.01645, "ferret_sera_escape": -0.04008, "mature_H5_site": 12, "mouse_sera_escape": 0.04432, "mutant": "G", "mutation": "S22G", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.2292, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.0678, "ferret_sera_escape": -0.1343, "mature_H5_site": 12, "mouse_sera_escape": -0.1169, "mutant": "H", "mutation": "S22H", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.1486, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.093, "ferret_sera_escape": -0.126, "mature_H5_site": 12, "mouse_sera_escape": 0.02657, "mutant": "K", "mutation": "S22K", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.2112, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.482, "ferret_sera_escape": 0.2402, "mature_H5_site": 12, "mouse_sera_escape": null, "mutant": "L", "mutation": "S22L", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3824, "ferret_sera_escape": 0.00546, "mature_H5_site": 12, "mouse_sera_escape": 0.02734, "mutant": "N", "mutation": "S22N", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.07566, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 12, "mouse_sera_escape": null, "mutant": "P", "mutation": "S22P", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2029, "ferret_sera_escape": 0.002535, "mature_H5_site": 12, "mouse_sera_escape": 0.05955, "mutant": "Q", "mutation": "S22Q", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.2415, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8081, "ferret_sera_escape": null, "mature_H5_site": 12, "mouse_sera_escape": -0.1007, "mutant": "R", "mutation": "S22R", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 12, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S22S", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6728, "ferret_sera_escape": -0.1396, "mature_H5_site": 12, "mouse_sera_escape": -0.06145, "mutant": "T", "mutation": "S22T", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.199, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1991, "ferret_sera_escape": -0.08009, "mature_H5_site": 12, "mouse_sera_escape": 0.1298, "mutant": "V", "mutation": "S22V", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.04232, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.66, "ferret_sera_escape": null, "mature_H5_site": 12, "mouse_sera_escape": null, "mutant": "W", "mutation": "S22W", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.365, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "C", "mutation": "R220C", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.886, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "E", "mutation": "R220E", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "F", "mutation": "R220F", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.991, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "G", "mutation": "R220G", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "H", "mutation": "R220H", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "I", "mutation": "R220I", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "K", "mutation": "R220K", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.077, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "L", "mutation": "R220L", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.733, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "M", "mutation": "R220M", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.753, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "N", "mutation": "R220N", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.048, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "Q", "mutation": "R220Q", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 216, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R220R", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "T", "mutation": "R220T", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "V", "mutation": "R220V", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "W", "mutation": "R220W", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4744, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "A", "mutation": "S221A", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": -0.1177, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "C", "mutation": "S221C", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.891, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "D", "mutation": "S221D", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.61, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "E", "mutation": "S221E", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "F", "mutation": "S221F", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06865, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "G", "mutation": "S221G", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.615, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "I", "mutation": "S221I", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "K", "mutation": "S221K", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.308, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "M", "mutation": "S221M", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3714, "ferret_sera_escape": 0.07971, "mature_H5_site": 217, "mouse_sera_escape": 0.0147, "mutant": "N", "mutation": "S221N", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": -0.5074, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.726, "ferret_sera_escape": -0.4027, "mature_H5_site": 217, "mouse_sera_escape": -0.1413, "mutant": "Q", "mutation": "S221Q", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "R", "mutation": "S221R", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 217, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S221S", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06572, "ferret_sera_escape": -0.04877, "mature_H5_site": 217, "mouse_sera_escape": 0.04643, "mutant": "T", "mutation": "S221T", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": -0.08297, "wildtype": "S"}, {"a26_usage": 0.09434, "cell_entry": -0.2128, "ferret_sera_escape": 0.1477, "mature_H5_site": 218, "mouse_sera_escape": 0.05529, "mutant": "A", "mutation": "Q222A", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.1939, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0449, "ferret_sera_escape": -0.6391, "mature_H5_site": 218, "mouse_sera_escape": -0.1862, "mutant": "C", "mutation": "Q222C", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.093, "wildtype": "Q"}, {"a26_usage": 0.3028, "cell_entry": -0.2266, "ferret_sera_escape": -0.9053, "mature_H5_site": 218, "mouse_sera_escape": -0.7421, "mutant": "D", "mutation": "Q222D", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.2898, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.052, "ferret_sera_escape": -0.437, "mature_H5_site": 218, "mouse_sera_escape": -0.3326, "mutant": "E", "mutation": "Q222E", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.05751, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.4377, "ferret_sera_escape": -0.403, "mature_H5_site": 218, "mouse_sera_escape": -0.2165, "mutant": "G", "mutation": "Q222G", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.158, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1208, "ferret_sera_escape": -0.2643, "mature_H5_site": 218, "mouse_sera_escape": -0.3418, "mutant": "I", "mutation": "Q222I", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.03094, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.164, "ferret_sera_escape": -0.2123, "mature_H5_site": 218, "mouse_sera_escape": -0.004055, "mutant": "K", "mutation": "Q222K", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.02896, "wildtype": "Q"}, {"a26_usage": 0.1462, "cell_entry": -0.3618, "ferret_sera_escape": -0.5265, "mature_H5_site": 218, "mouse_sera_escape": -0.3361, "mutant": "L", "mutation": "Q222L", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.01573, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.00794, "ferret_sera_escape": -0.1538, "mature_H5_site": 218, "mouse_sera_escape": -0.1007, "mutant": "M", "mutation": "Q222M", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.07025, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.7274, "ferret_sera_escape": -0.3954, "mature_H5_site": 218, "mouse_sera_escape": null, "mutant": "N", "mutation": "Q222N", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2373, "ferret_sera_escape": 0.1726, "mature_H5_site": 218, "mouse_sera_escape": 0.1333, "mutant": "P", "mutation": "Q222P", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.1116, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 218, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q222Q", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.6401, "ferret_sera_escape": -0.02869, "mature_H5_site": 218, "mouse_sera_escape": -0.0107, "mutant": "R", "mutation": "Q222R", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.03895, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.05038, "ferret_sera_escape": -0.06632, "mature_H5_site": 218, "mouse_sera_escape": -0.1312, "mutant": "S", "mutation": "Q222S", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.01621, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.3952, "ferret_sera_escape": -0.4742, "mature_H5_site": 218, "mouse_sera_escape": -0.1787, "mutant": "T", "mutation": "Q222T", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.1112, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.04258, "ferret_sera_escape": -0.1424, "mature_H5_site": 218, "mouse_sera_escape": -0.1701, "mutant": "V", "mutation": "Q222V", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.01724, "wildtype": "Q"}, {"a26_usage": 0.1996, "cell_entry": 0.07365, "ferret_sera_escape": -1.101, "mature_H5_site": 218, "mouse_sera_escape": -0.803, "mutant": "W", "mutation": "Q222W", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.2866, "wildtype": "Q"}, {"a26_usage": 0.3241, "cell_entry": -0.7141, "ferret_sera_escape": -0.3427, "mature_H5_site": 218, "mouse_sera_escape": -0.252, "mutant": "Y", "mutation": "Q222Y", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.1722, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5974, "ferret_sera_escape": null, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "A", "mutation": "V223A", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4831, "ferret_sera_escape": 0.0842, "mature_H5_site": 219, "mouse_sera_escape": 0.1618, "mutant": "C", "mutation": "V223C", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": -0.1575, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "D", "mutation": "V223D", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "E", "mutation": "V223E", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7263, "ferret_sera_escape": -0.1481, "mature_H5_site": 219, "mouse_sera_escape": 0.005881, "mutant": "F", "mutation": "V223F", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": -0.2377, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "G", "mutation": "V223G", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.585, "ferret_sera_escape": -0.06337, "mature_H5_site": 219, "mouse_sera_escape": 0.2251, "mutant": "H", "mutation": "V223H", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.31, "ferret_sera_escape": null, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "I", "mutation": "V223I", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.511, "ferret_sera_escape": 0.317, "mature_H5_site": 219, "mouse_sera_escape": 0.2829, "mutant": "K", "mutation": "V223K", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.119, "ferret_sera_escape": -0.1478, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "L", "mutation": "V223L", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6187, "ferret_sera_escape": 0.04259, "mature_H5_site": 219, "mouse_sera_escape": 0.04489, "mutant": "M", "mutation": "V223M", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": -0.2714, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.577, "ferret_sera_escape": -0.09891, "mature_H5_site": 219, "mouse_sera_escape": 0.06929, "mutant": "N", "mutation": "V223N", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": 0.003194, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "P", "mutation": "V223P", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5101, "ferret_sera_escape": -0.09471, "mature_H5_site": 219, "mouse_sera_escape": 0.08428, "mutant": "Q", "mutation": "V223Q", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": -0.2294, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2131, "ferret_sera_escape": 0.2835, "mature_H5_site": 219, "mouse_sera_escape": 0.1993, "mutant": "R", "mutation": "V223R", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": -0.2536, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.241, "ferret_sera_escape": 0.2733, "mature_H5_site": 219, "mouse_sera_escape": 0.0001, "mutant": "S", "mutation": "V223S", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 219, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V223V", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6693, "ferret_sera_escape": 0.2773, "mature_H5_site": 219, "mouse_sera_escape": 0.04137, "mutant": "W", "mutation": "V223W", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": -0.2484, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5668, "ferret_sera_escape": null, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V223Y", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.2415, "cell_entry": 0.02828, "ferret_sera_escape": -0.2993, "mature_H5_site": 220, "mouse_sera_escape": -0.1993, "mutant": "A", "mutation": "N224A", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.2993, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6787, "ferret_sera_escape": -0.474, "mature_H5_site": 220, "mouse_sera_escape": -0.202, "mutant": "C", "mutation": "N224C", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.2602, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.039, "ferret_sera_escape": -0.8281, "mature_H5_site": 220, "mouse_sera_escape": null, "mutant": "D", "mutation": "N224D", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.381, "ferret_sera_escape": null, "mature_H5_site": 220, "mouse_sera_escape": null, "mutant": "E", "mutation": "N224E", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6112, "ferret_sera_escape": -0.4127, "mature_H5_site": 220, "mouse_sera_escape": 0.1018, "mutant": "F", "mutation": "N224F", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.1275, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1535, "ferret_sera_escape": -0.6747, "mature_H5_site": 220, "mouse_sera_escape": -0.4148, "mutant": "G", "mutation": "N224G", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.2461, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02618, "ferret_sera_escape": null, "mature_H5_site": 220, "mouse_sera_escape": null, "mutant": "H", "mutation": "N224H", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.008507, "ferret_sera_escape": -0.1161, "mature_H5_site": 220, "mouse_sera_escape": -0.02828, "mutant": "K", "mutation": "N224K", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.2226, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0627, "ferret_sera_escape": -0.5809, "mature_H5_site": 220, "mouse_sera_escape": -0.3291, "mutant": "M", "mutation": "N224M", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.1597, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 220, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N224N", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9023, "ferret_sera_escape": 0.2657, "mature_H5_site": 220, "mouse_sera_escape": 0.1561, "mutant": "R", "mutation": "N224R", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": 0.1458, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1981, "ferret_sera_escape": 0.01102, "mature_H5_site": 220, "mouse_sera_escape": 0.0731, "mutant": "S", "mutation": "N224S", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.1863, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.689, "ferret_sera_escape": -0.2669, "mature_H5_site": 220, "mouse_sera_escape": -0.005915, "mutant": "T", "mutation": "N224T", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.811, "ferret_sera_escape": null, "mature_H5_site": 220, "mouse_sera_escape": null, "mutant": "V", "mutation": "N224V", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": null, "wildtype": "N"}, {"a26_usage": 0.5336, "cell_entry": -0.3341, "ferret_sera_escape": -0.3009, "mature_H5_site": 220, "mouse_sera_escape": -0.1131, "mutant": "Y", "mutation": "N224Y", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.2167, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5885, "ferret_sera_escape": -1.047, "mature_H5_site": 221, "mouse_sera_escape": -0.4954, "mutant": "A", "mutation": "G225A", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.1788, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7007, "ferret_sera_escape": null, "mature_H5_site": 221, "mouse_sera_escape": null, "mutant": "C", "mutation": "G225C", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.563, "ferret_sera_escape": -1.283, "mature_H5_site": 221, "mouse_sera_escape": -0.4694, "mutant": "E", "mutation": "G225E", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.2525, "wildtype": "G"}, {"a26_usage": 1.188, "cell_entry": -0.4221, "ferret_sera_escape": -1.01, "mature_H5_site": 221, "mouse_sera_escape": -0.7881, "mutant": "F", "mutation": "G225F", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.2722, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 221, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G225G", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.01002, "ferret_sera_escape": -0.8638, "mature_H5_site": 221, "mouse_sera_escape": -0.6327, "mutant": "H", "mutation": "G225H", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.291, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 221, "mouse_sera_escape": null, "mutant": "I", "mutation": "G225I", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8743, "ferret_sera_escape": null, "mature_H5_site": 221, "mouse_sera_escape": null, "mutant": "K", "mutation": "G225K", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": null, "wildtype": "G"}, {"a26_usage": 0.9447, "cell_entry": 0.00201, "ferret_sera_escape": null, "mature_H5_site": 221, "mouse_sera_escape": null, "mutant": "L", "mutation": "G225L", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": null, "wildtype": "G"}, {"a26_usage": 1.507, "cell_entry": -0.3914, "ferret_sera_escape": -0.8954, "mature_H5_site": 221, "mouse_sera_escape": -0.5696, "mutant": "N", "mutation": "G225N", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.2273, "wildtype": "G"}, {"a26_usage": 1.222, "cell_entry": -0.9766, "ferret_sera_escape": -0.9984, "mature_H5_site": 221, "mouse_sera_escape": -0.6598, "mutant": "Q", "mutation": "G225Q", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.1937, "wildtype": "G"}, {"a26_usage": 1.778, "cell_entry": -0.2233, "ferret_sera_escape": -0.5916, "mature_H5_site": 221, "mouse_sera_escape": -0.2428, "mutant": "R", "mutation": "G225R", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.09189, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2021, "ferret_sera_escape": -0.1947, "mature_H5_site": 221, "mouse_sera_escape": -0.08515, "mutant": "S", "mutation": "G225S", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.3339, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.603, "ferret_sera_escape": 0.08312, "mature_H5_site": 221, "mouse_sera_escape": null, "mutant": "T", "mutation": "G225T", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.655, "ferret_sera_escape": null, "mature_H5_site": 221, "mouse_sera_escape": null, "mutant": "V", "mutation": "G225V", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.234, "ferret_sera_escape": -0.929, "mature_H5_site": 221, "mouse_sera_escape": -0.7199, "mutant": "W", "mutation": "G225W", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.2183, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.221, "ferret_sera_escape": -1.213, "mature_H5_site": 221, "mouse_sera_escape": -0.8184, "mutant": "Y", "mutation": "G225Y", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.2603, "wildtype": "G"}, {"a26_usage": 2.071, "cell_entry": -1.655, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "A", "mutation": "Q226A", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.44, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "E", "mutation": "Q226E", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 4.2, "cell_entry": -3.1, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "F", "mutation": "Q226F", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "G", "mutation": "Q226G", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.691, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "H", "mutation": "Q226H", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.784, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "K", "mutation": "Q226K", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 5.592, "cell_entry": -3.317, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": 0.2132, "mutant": "L", "mutation": "Q226L", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 5.028, "cell_entry": -3.296, "ferret_sera_escape": -1.399, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "M", "mutation": "Q226M", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 3.59, "cell_entry": -3.575, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "N", "mutation": "Q226N", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -6.025, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q226P", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 222, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q226Q", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 4.155, "cell_entry": -2.333, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "R", "mutation": "Q226R", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.762, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "S", "mutation": "Q226S", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.026, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "T", "mutation": "Q226T", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 5.652, "cell_entry": -2.708, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "V", "mutation": "Q226V", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.331, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "W", "mutation": "Q226W", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 4.577, "cell_entry": -4.382, "ferret_sera_escape": -1.048, "mature_H5_site": 222, "mouse_sera_escape": -0.3304, "mutant": "Y", "mutation": "Q226Y", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.005089, "ferret_sera_escape": -0.4027, "mature_H5_site": 223, "mouse_sera_escape": -0.393, "mutant": "A", "mutation": "R227A", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.1938, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.438, "ferret_sera_escape": null, "mature_H5_site": 223, "mouse_sera_escape": null, "mutant": "D", "mutation": "R227D", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.914, "ferret_sera_escape": -0.7016, "mature_H5_site": 223, "mouse_sera_escape": -0.3125, "mutant": "E", "mutation": "R227E", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.2489, "wildtype": "R"}, {"a26_usage": 0.1427, "cell_entry": -0.062, "ferret_sera_escape": -1.357, "mature_H5_site": 223, "mouse_sera_escape": -1.056, "mutant": "G", "mutation": "R227G", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.3275, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.045, "ferret_sera_escape": null, "mature_H5_site": 223, "mouse_sera_escape": null, "mutant": "H", "mutation": "R227H", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.2877, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.934, "ferret_sera_escape": null, "mature_H5_site": 223, "mouse_sera_escape": null, "mutant": "I", "mutation": "R227I", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.08733, "ferret_sera_escape": -0.3162, "mature_H5_site": 223, "mouse_sera_escape": -0.329, "mutant": "K", "mutation": "R227K", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.1246, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.373, "ferret_sera_escape": null, "mature_H5_site": 223, "mouse_sera_escape": null, "mutant": "L", "mutation": "R227L", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.03078, "ferret_sera_escape": -1.377, "mature_H5_site": 223, "mouse_sera_escape": -0.8241, "mutant": "M", "mutation": "R227M", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.1655, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.07086, "ferret_sera_escape": -1.431, "mature_H5_site": 223, "mouse_sera_escape": -1.048, "mutant": "Q", "mutation": "R227Q", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.2402, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 223, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R227R", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3811, "ferret_sera_escape": -0.341, "mature_H5_site": 223, "mouse_sera_escape": -0.3463, "mutant": "S", "mutation": "R227S", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.2286, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.03982, "ferret_sera_escape": -1.296, "mature_H5_site": 223, "mouse_sera_escape": -1.073, "mutant": "T", "mutation": "R227T", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.3445, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.965, "ferret_sera_escape": null, "mature_H5_site": 223, "mouse_sera_escape": -0.2614, "mutant": "V", "mutation": "R227V", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.308, "ferret_sera_escape": -1.096, "mature_H5_site": 223, "mouse_sera_escape": -0.4979, "mutant": "W", "mutation": "R227W", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.02307, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.449, "ferret_sera_escape": null, "mature_H5_site": 223, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R227Y", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": null, "wildtype": "R"}, {"a26_usage": 3.058, "cell_entry": -0.7881, "ferret_sera_escape": -0.4738, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "A", "mutation": "G228A", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": -0.144, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.607, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "C", "mutation": "G228C", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.805, "ferret_sera_escape": -0.8486, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "D", "mutation": "G228D", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.438, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "E", "mutation": "G228E", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 224, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G228G", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.87, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "H", "mutation": "G228H", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.78, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "I", "mutation": "G228I", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.775, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "M", "mutation": "G228M", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "N", "mutation": "G228N", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.904, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "P", "mutation": "G228P", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.762, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G228Q", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.022, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "R", "mutation": "G228R", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.09, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "S", "mutation": "G228S", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.319, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "T", "mutation": "G228T", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.71, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "V", "mutation": "G228V", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "W", "mutation": "G228W", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G228Y", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.717, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "A", "mutation": "R229A", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "C", "mutation": "R229C", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.809, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "D", "mutation": "R229D", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "E", "mutation": "R229E", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "F", "mutation": "R229F", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "G", "mutation": "R229G", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "H", "mutation": "R229H", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "I", "mutation": "R229I", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "K", "mutation": "R229K", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "L", "mutation": "R229L", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -6.017, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "N", "mutation": "R229N", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "P", "mutation": "R229P", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 225, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R229R", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "S", "mutation": "R229S", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.752, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "T", "mutation": "R229T", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "V", "mutation": "R229V", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R229Y", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.447, "ferret_sera_escape": -0.0251, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "A", "mutation": "T23A", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.331, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "C", "mutation": "T23C", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.221, "ferret_sera_escape": -0.3885, "mature_H5_site": 13, "mouse_sera_escape": 0.03647, "mutant": "D", "mutation": "T23D", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": -0.1464, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.112, "ferret_sera_escape": -0.1245, "mature_H5_site": 13, "mouse_sera_escape": 0.05135, "mutant": "E", "mutation": "T23E", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": -0.1004, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.566, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "F", "mutation": "T23F", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.699, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "H", "mutation": "T23H", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.534, "ferret_sera_escape": -0.09034, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "I", "mutation": "T23I", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.042, "ferret_sera_escape": -0.1936, "mature_H5_site": 13, "mouse_sera_escape": 0.03777, "mutant": "K", "mutation": "T23K", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": -0.1018, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.558, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "L", "mutation": "T23L", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.851, "ferret_sera_escape": -0.05099, "mature_H5_site": 13, "mouse_sera_escape": 0.009154, "mutant": "N", "mutation": "T23N", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": -0.2389, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.673, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "P", "mutation": "T23P", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1549, "ferret_sera_escape": 0.1059, "mature_H5_site": 13, "mouse_sera_escape": 0.2046, "mutant": "Q", "mutation": "T23Q", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.788, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "R", "mutation": "T23R", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.02638, "ferret_sera_escape": -0.1816, "mature_H5_site": 13, "mouse_sera_escape": -0.1009, "mutant": "S", "mutation": "T23S", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": 0.05048, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 13, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T23T", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "W", "mutation": "T23W", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.892, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T23Y", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "D", "mutation": "M230D", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.858, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "E", "mutation": "M230E", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.867, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "G", "mutation": "M230G", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.3338, "ferret_sera_escape": -1.193, "mature_H5_site": 226, "mouse_sera_escape": -0.7731, "mutant": "H", "mutation": "M230H", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": -0.08124, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.6565, "ferret_sera_escape": 0.1029, "mature_H5_site": 226, "mouse_sera_escape": 0.06581, "mutant": "I", "mutation": "M230I", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": 0.9118, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "K", "mutation": "M230K", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.801, "ferret_sera_escape": -0.3903, "mature_H5_site": 226, "mouse_sera_escape": -0.2194, "mutant": "L", "mutation": "M230L", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 226, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M230M", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "P", "mutation": "M230P", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.9438, "ferret_sera_escape": -0.8504, "mature_H5_site": 226, "mouse_sera_escape": -0.5225, "mutant": "Q", "mutation": "M230Q", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "R", "mutation": "M230R", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.3396, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "T", "mutation": "M230T", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.02679, "cell_entry": 0.05557, "ferret_sera_escape": 0.1169, "mature_H5_site": 226, "mouse_sera_escape": 0.02995, "mutant": "V", "mutation": "M230V", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": 0.7284, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.688, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "W", "mutation": "M230W", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "Y", "mutation": "M230Y", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.441, "ferret_sera_escape": -0.4896, "mature_H5_site": 227, "mouse_sera_escape": -0.2077, "mutant": "A", "mutation": "D231A", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": -0.1728, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.9362, "ferret_sera_escape": -0.4671, "mature_H5_site": 227, "mouse_sera_escape": -0.4794, "mutant": "C", "mutation": "D231C", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 227, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D231D", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.05072, "ferret_sera_escape": -0.5872, "mature_H5_site": 227, "mouse_sera_escape": -0.5048, "mutant": "E", "mutation": "D231E", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": 0.3984, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.06255, "ferret_sera_escape": null, "mature_H5_site": 227, "mouse_sera_escape": null, "mutant": "F", "mutation": "D231F", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.178, "ferret_sera_escape": null, "mature_H5_site": 227, "mouse_sera_escape": null, "mutant": "I", "mutation": "D231I", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4206, "ferret_sera_escape": -0.2701, "mature_H5_site": 227, "mouse_sera_escape": -0.06516, "mutant": "K", "mutation": "D231K", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": 0.5584, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.748, "ferret_sera_escape": null, "mature_H5_site": 227, "mouse_sera_escape": -0.06413, "mutant": "L", "mutation": "D231L", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": -0.1471, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.682, "ferret_sera_escape": -0.4149, "mature_H5_site": 227, "mouse_sera_escape": null, "mutant": "M", "mutation": "D231M", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": -0.1751, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.03781, "ferret_sera_escape": -0.1009, "mature_H5_site": 227, "mouse_sera_escape": 0.02961, "mutant": "N", "mutation": "D231N", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": 0.04732, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1689, "ferret_sera_escape": -0.07624, "mature_H5_site": 227, "mouse_sera_escape": -0.08539, "mutant": "R", "mutation": "D231R", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": 0.06917, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.06307, "ferret_sera_escape": 0.03704, "mature_H5_site": 227, "mouse_sera_escape": 0.03003, "mutant": "S", "mutation": "D231S", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": -0.01518, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3806, "ferret_sera_escape": 0.3076, "mature_H5_site": 227, "mouse_sera_escape": 0.07347, "mutant": "T", "mutation": "D231T", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": -0.2266, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1447, "ferret_sera_escape": null, "mature_H5_site": 227, "mouse_sera_escape": null, "mutant": "V", "mutation": "D231V", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6277, "ferret_sera_escape": -0.4709, "mature_H5_site": 227, "mouse_sera_escape": -0.2271, "mutant": "W", "mutation": "D231W", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": -0.2304, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2985, "ferret_sera_escape": -0.7497, "mature_H5_site": 227, "mouse_sera_escape": -0.5486, "mutant": "Y", "mutation": "D231Y", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": -0.3001, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "A", "mutation": "F232A", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.737, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "C", "mutation": "F232C", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.712, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "D", "mutation": "F232D", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "E", "mutation": "F232E", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 228, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F232F", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.305, "ferret_sera_escape": -0.1843, "mature_H5_site": 228, "mouse_sera_escape": -0.1974, "mutant": "H", "mutation": "F232H", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.02291, "ferret_sera_escape": -0.098, "mature_H5_site": 228, "mouse_sera_escape": -0.03926, "mutant": "I", "mutation": "F232I", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": -0.06531, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "K", "mutation": "F232K", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.1306, "ferret_sera_escape": -0.2291, "mature_H5_site": 228, "mouse_sera_escape": -0.161, "mutant": "L", "mutation": "F232L", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": -0.3048, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F232Q", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "R", "mutation": "F232R", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.655, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "S", "mutation": "F232S", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.8159, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "V", "mutation": "F232V", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.01892, "ferret_sera_escape": -0.1706, "mature_H5_site": 228, "mouse_sera_escape": -0.06363, "mutant": "W", "mutation": "F232W", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": 0.4987, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.03671, "ferret_sera_escape": -0.1514, "mature_H5_site": 228, "mouse_sera_escape": -0.1662, "mutant": "Y", "mutation": "F232Y", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": -0.09844, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.3993, "ferret_sera_escape": -0.4083, "mature_H5_site": 229, "mouse_sera_escape": -0.1288, "mutant": "A", "mutation": "F233A", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.1559, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.809, "ferret_sera_escape": -0.03511, "mature_H5_site": 229, "mouse_sera_escape": 0.144, "mutant": "C", "mutation": "F233C", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.2944, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.486, "ferret_sera_escape": -0.6494, "mature_H5_site": 229, "mouse_sera_escape": -0.07992, "mutant": "D", "mutation": "F233D", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.2181, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.9423, "ferret_sera_escape": -0.3177, "mature_H5_site": 229, "mouse_sera_escape": -0.03266, "mutant": "E", "mutation": "F233E", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.3058, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 229, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F233F", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.196, "ferret_sera_escape": -0.2632, "mature_H5_site": 229, "mouse_sera_escape": -0.05426, "mutant": "G", "mutation": "F233G", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.06187, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.1909, "ferret_sera_escape": -0.2085, "mature_H5_site": 229, "mouse_sera_escape": -0.06913, "mutant": "H", "mutation": "F233H", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.06949, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.5708, "ferret_sera_escape": 0.004106, "mature_H5_site": 229, "mouse_sera_escape": -0.01993, "mutant": "I", "mutation": "F233I", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.075, "ferret_sera_escape": -0.1788, "mature_H5_site": 229, "mouse_sera_escape": -0.08002, "mutant": "K", "mutation": "F233K", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.2687, "ferret_sera_escape": -0.1036, "mature_H5_site": 229, "mouse_sera_escape": -0.03815, "mutant": "L", "mutation": "F233L", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.1407, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.07083, "ferret_sera_escape": -0.01039, "mature_H5_site": 229, "mouse_sera_escape": -0.06706, "mutant": "M", "mutation": "F233M", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.1548, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.857, "ferret_sera_escape": null, "mature_H5_site": 229, "mouse_sera_escape": null, "mutant": "N", "mutation": "F233N", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 229, "mouse_sera_escape": null, "mutant": "P", "mutation": "F233P", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.5644, "ferret_sera_escape": -0.1578, "mature_H5_site": 229, "mouse_sera_escape": 0.08844, "mutant": "Q", "mutation": "F233Q", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.2733, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.2455, "ferret_sera_escape": -0.2618, "mature_H5_site": 229, "mouse_sera_escape": -0.007862, "mutant": "R", "mutation": "F233R", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.183, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.9978, "ferret_sera_escape": -0.1373, "mature_H5_site": 229, "mouse_sera_escape": -0.09639, "mutant": "S", "mutation": "F233S", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.03267, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.6983, "ferret_sera_escape": -0.1967, "mature_H5_site": 229, "mouse_sera_escape": null, "mutant": "T", "mutation": "F233T", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": null, "wildtype": "F"}, {"a26_usage": 0.002745, "cell_entry": 0.07132, "ferret_sera_escape": null, "mature_H5_site": 229, "mouse_sera_escape": null, "mutant": "W", "mutation": "F233W", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": null, "wildtype": "F"}, {"a26_usage": 0.03024, "cell_entry": 0.01381, "ferret_sera_escape": -0.01718, "mature_H5_site": 229, "mouse_sera_escape": -0.004482, "mutant": "Y", "mutation": "F233Y", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.001134, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "A", "mutation": "W234A", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "C", "mutation": "W234C", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "E", "mutation": "W234E", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.4576, "ferret_sera_escape": -0.276, "mature_H5_site": 230, "mouse_sera_escape": -0.03125, "mutant": "F", "mutation": "W234F", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": -0.271, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.853, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "G", "mutation": "W234G", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.624, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "H", "mutation": "W234H", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "I", "mutation": "W234I", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.034, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "K", "mutation": "W234K", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.138, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "L", "mutation": "W234L", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.85, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "M", "mutation": "W234M", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "N", "mutation": "W234N", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.503, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "P", "mutation": "W234P", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.604, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W234Q", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "R", "mutation": "W234R", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.141, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "S", "mutation": "W234S", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.872, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "T", "mutation": "W234T", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 230, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W234W", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.05031, "ferret_sera_escape": null, "mature_H5_site": 231, "mouse_sera_escape": null, "mutant": "I", "mutation": "T235I", "reference_site": "235", "region": "HA1", "sequential_site": 247, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 231, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T235T", "reference_site": "235", "region": "HA1", "sequential_site": 247, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.6301, "ferret_sera_escape": -0.1662, "mature_H5_site": 232, "mouse_sera_escape": -0.1365, "mutant": "A", "mutation": "I236A", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": -0.2357, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.394, "ferret_sera_escape": 0.1031, "mature_H5_site": 232, "mouse_sera_escape": null, "mutant": "D", "mutation": "I236D", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 232, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I236I", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4227, "ferret_sera_escape": null, "mature_H5_site": 232, "mouse_sera_escape": null, "mutant": "K", "mutation": "I236K", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4466, "ferret_sera_escape": null, "mature_H5_site": 232, "mouse_sera_escape": null, "mutant": "M", "mutation": "I236M", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.7793, "ferret_sera_escape": null, "mature_H5_site": 232, "mouse_sera_escape": null, "mutant": "N", "mutation": "I236N", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.054, "ferret_sera_escape": -0.4124, "mature_H5_site": 232, "mouse_sera_escape": -0.08092, "mutant": "S", "mutation": "I236S", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": -0.2204, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.0821, "ferret_sera_escape": 0.02314, "mature_H5_site": 232, "mouse_sera_escape": 0.06088, "mutant": "T", "mutation": "I236T", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": -0.08194, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4451, "ferret_sera_escape": -0.03558, "mature_H5_site": 232, "mouse_sera_escape": -0.05706, "mutant": "V", "mutation": "I236V", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": -0.02245, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 233, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L237L", "reference_site": "237", "region": "HA1", "sequential_site": 249, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7486, "ferret_sera_escape": 0.009093, "mature_H5_site": 233, "mouse_sera_escape": 0.131, "mutant": "M", "mutation": "L237M", "reference_site": "237", "region": "HA1", "sequential_site": 249, "stability": -0.1185, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.749, "ferret_sera_escape": null, "mature_H5_site": 233, "mouse_sera_escape": null, "mutant": "P", "mutation": "L237P", "reference_site": "237", "region": "HA1", "sequential_site": 249, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.06227, "ferret_sera_escape": 0.1389, "mature_H5_site": 235, "mouse_sera_escape": -0.04479, "mutant": "A", "mutation": "P239A", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": -0.1802, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.00035, "ferret_sera_escape": 0.00119, "mature_H5_site": 235, "mouse_sera_escape": -0.1928, "mutant": "C", "mutation": "P239C", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": -0.4255, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.2724, "ferret_sera_escape": -0.2899, "mature_H5_site": 235, "mouse_sera_escape": -0.1454, "mutant": "F", "mutation": "P239F", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": -0.5479, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1624, "ferret_sera_escape": -0.02143, "mature_H5_site": 235, "mouse_sera_escape": -0.03389, "mutant": "G", "mutation": "P239G", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.03368, "ferret_sera_escape": 0.03143, "mature_H5_site": 235, "mouse_sera_escape": -0.1197, "mutant": "H", "mutation": "P239H", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": -0.161, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1499, "ferret_sera_escape": 0.1002, "mature_H5_site": 235, "mouse_sera_escape": 0.1417, "mutant": "I", "mutation": "P239I", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": 0.7125, "wildtype": "P"}, {"a26_usage": 0.131, "cell_entry": -0.07137, "ferret_sera_escape": 0.1694, "mature_H5_site": 235, "mouse_sera_escape": 0.02328, "mutant": "K", "mutation": "P239K", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": -0.03087, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.7714, "ferret_sera_escape": null, "mature_H5_site": 235, "mouse_sera_escape": null, "mutant": "L", "mutation": "P239L", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1981, "ferret_sera_escape": null, "mature_H5_site": 235, "mouse_sera_escape": null, "mutant": "M", "mutation": "P239M", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 235, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P239P", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.05611, "ferret_sera_escape": null, "mature_H5_site": 235, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P239Q", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1848, "ferret_sera_escape": 0.04513, "mature_H5_site": 235, "mouse_sera_escape": 0.06152, "mutant": "R", "mutation": "P239R", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": -0.026, "wildtype": "P"}, {"a26_usage": 0.4268, "cell_entry": -0.00894, "ferret_sera_escape": 0.05737, "mature_H5_site": 235, "mouse_sera_escape": -0.03652, "mutant": "S", "mutation": "P239S", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.03696, "ferret_sera_escape": 0.08648, "mature_H5_site": 235, "mouse_sera_escape": -0.0524, "mutant": "T", "mutation": "P239T", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": -0.04912, "wildtype": "P"}, {"a26_usage": 0.2209, "cell_entry": 0.02009, "ferret_sera_escape": 0.03009, "mature_H5_site": 235, "mouse_sera_escape": 0.06778, "mutant": "V", "mutation": "P239V", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": 0.3617, "wildtype": "P"}, {"a26_usage": 0.3302, "cell_entry": -0.3104, "ferret_sera_escape": 0.09226, "mature_H5_site": 14, "mouse_sera_escape": null, "mutant": "A", "mutation": "E24A", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.01662, "ferret_sera_escape": 0.05448, "mature_H5_site": 14, "mouse_sera_escape": 0.04583, "mutant": "C", "mutation": "E24C", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": 0.003614, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02677, "ferret_sera_escape": -0.1077, "mature_H5_site": 14, "mouse_sera_escape": -0.1688, "mutant": "D", "mutation": "E24D", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": -0.1131, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 14, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E24E", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.06868, "cell_entry": 0.06023, "ferret_sera_escape": null, "mature_H5_site": 14, "mouse_sera_escape": null, "mutant": "F", "mutation": "E24F", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4561, "ferret_sera_escape": null, "mature_H5_site": 14, "mouse_sera_escape": -0.07045, "mutant": "H", "mutation": "E24H", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.00755, "ferret_sera_escape": -0.01779, "mature_H5_site": 14, "mouse_sera_escape": 0.04133, "mutant": "I", "mutation": "E24I", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": 1.15, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07343, "ferret_sera_escape": 0.06065, "mature_H5_site": 14, "mouse_sera_escape": 0.01666, "mutant": "K", "mutation": "E24K", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": -0.05592, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0424, "ferret_sera_escape": 0.03603, "mature_H5_site": 14, "mouse_sera_escape": null, "mutant": "M", "mutation": "E24M", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": -0.1613, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1671, "ferret_sera_escape": 0.06741, "mature_H5_site": 14, "mouse_sera_escape": 0.1451, "mutant": "N", "mutation": "E24N", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": -0.1363, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.03681, "ferret_sera_escape": null, "mature_H5_site": 14, "mouse_sera_escape": null, "mutant": "Q", "mutation": "E24Q", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.952, "ferret_sera_escape": null, "mature_H5_site": 14, "mouse_sera_escape": null, "mutant": "R", "mutation": "E24R", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": null, "wildtype": "E"}, {"a26_usage": 0.1246, "cell_entry": 0.03423, "ferret_sera_escape": null, "mature_H5_site": 14, "mouse_sera_escape": null, "mutant": "S", "mutation": "E24S", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06496, "ferret_sera_escape": 0.06355, "mature_H5_site": 14, "mouse_sera_escape": 0.1321, "mutant": "T", "mutation": "E24T", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": 0.7043, "wildtype": "E"}, {"a26_usage": 0.03704, "cell_entry": -0.09474, "ferret_sera_escape": 0.04995, "mature_H5_site": 14, "mouse_sera_escape": 0.07178, "mutant": "V", "mutation": "E24V", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": 0.6342, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.02058, "ferret_sera_escape": -0.06466, "mature_H5_site": 14, "mouse_sera_escape": -0.02694, "mutant": "W", "mutation": "E24W", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": -0.2076, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.07234, "ferret_sera_escape": -0.06959, "mature_H5_site": 14, "mouse_sera_escape": 0.00568, "mutant": "Y", "mutation": "E24Y", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": -0.2595, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.05736, "ferret_sera_escape": 0.216, "mature_H5_site": 236, "mouse_sera_escape": 0.2058, "mutant": "A", "mutation": "D240A", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.002062, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.06234, "ferret_sera_escape": 0.1887, "mature_H5_site": 236, "mouse_sera_escape": 0.04144, "mutant": "C", "mutation": "D240C", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.04186, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 236, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D240D", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.00056, "ferret_sera_escape": 0.05763, "mature_H5_site": 236, "mouse_sera_escape": 0.04452, "mutant": "E", "mutation": "D240E", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.08076, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.713, "ferret_sera_escape": null, "mature_H5_site": 236, "mouse_sera_escape": null, "mutant": "F", "mutation": "D240F", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4038, "ferret_sera_escape": 0.1375, "mature_H5_site": 236, "mouse_sera_escape": 0.03998, "mutant": "H", "mutation": "D240H", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.1367, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.01827, "ferret_sera_escape": 0.01361, "mature_H5_site": 236, "mouse_sera_escape": 0.05204, "mutant": "I", "mutation": "D240I", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": -0.04009, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1773, "ferret_sera_escape": 0.1431, "mature_H5_site": 236, "mouse_sera_escape": 0.05483, "mutant": "K", "mutation": "D240K", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.1851, "wildtype": "D"}, {"a26_usage": 0.1471, "cell_entry": -0.162, "ferret_sera_escape": 0.232, "mature_H5_site": 236, "mouse_sera_escape": 0.00455, "mutant": "L", "mutation": "D240L", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.1543, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.06425, "ferret_sera_escape": -0.08253, "mature_H5_site": 236, "mouse_sera_escape": -0.04052, "mutant": "N", "mutation": "D240N", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.1642, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2, "ferret_sera_escape": 0.1305, "mature_H5_site": 236, "mouse_sera_escape": 0.09361, "mutant": "Q", "mutation": "D240Q", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.04812, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.375, "ferret_sera_escape": 0.1224, "mature_H5_site": 236, "mouse_sera_escape": 0.01792, "mutant": "S", "mutation": "D240S", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.05509, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.03591, "ferret_sera_escape": 0.1679, "mature_H5_site": 236, "mouse_sera_escape": 0.1279, "mutant": "T", "mutation": "D240T", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.1892, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2345, "ferret_sera_escape": 0.1354, "mature_H5_site": 236, "mouse_sera_escape": 0.04489, "mutant": "V", "mutation": "D240V", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": -0.005921, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2791, "ferret_sera_escape": 0.1395, "mature_H5_site": 236, "mouse_sera_escape": 0.02093, "mutant": "W", "mutation": "D240W", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.2244, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": 0.04017, "mature_H5_site": 236, "mouse_sera_escape": -0.04409, "mutant": "Y", "mutation": "D240Y", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": -0.008749, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.638, "ferret_sera_escape": 0.07179, "mature_H5_site": 237, "mouse_sera_escape": 0.437, "mutant": "A", "mutation": "D241A", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": -0.05809, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.736, "ferret_sera_escape": 0.04203, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "C", "mutation": "D241C", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 237, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D241D", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.06689, "ferret_sera_escape": -0.1001, "mature_H5_site": 237, "mouse_sera_escape": 0.02125, "mutant": "E", "mutation": "D241E", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": -0.3047, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.873, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "F", "mutation": "D241F", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.9867, "ferret_sera_escape": -0.02812, "mature_H5_site": 237, "mouse_sera_escape": 0.1093, "mutant": "G", "mutation": "D241G", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": -0.3476, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.079, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": 0.2262, "mutant": "H", "mutation": "D241H", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.161, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "K", "mutation": "D241K", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.324, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "L", "mutation": "D241L", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.777, "ferret_sera_escape": 0.1632, "mature_H5_site": 237, "mouse_sera_escape": 0.3649, "mutant": "N", "mutation": "D241N", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "P", "mutation": "D241P", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.401, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "R", "mutation": "D241R", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.91, "ferret_sera_escape": -0.1153, "mature_H5_site": 237, "mouse_sera_escape": 0.04219, "mutant": "S", "mutation": "D241S", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "T", "mutation": "D241T", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.544, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "V", "mutation": "D241V", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.602, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D241Y", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 238, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A242A", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.1163, "cell_entry": -0.127, "ferret_sera_escape": -0.02698, "mature_H5_site": 238, "mouse_sera_escape": 0.05726, "mutant": "C", "mutation": "A242C", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": 0.09766, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.00228, "ferret_sera_escape": -0.3542, "mature_H5_site": 238, "mouse_sera_escape": -0.3824, "mutant": "D", "mutation": "A242D", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": -0.2282, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.06975, "ferret_sera_escape": -0.1704, "mature_H5_site": 238, "mouse_sera_escape": -0.3469, "mutant": "E", "mutation": "A242E", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": -0.0114, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3154, "ferret_sera_escape": 0.0869, "mature_H5_site": 238, "mouse_sera_escape": 0.2935, "mutant": "F", "mutation": "A242F", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": -0.2098, "wildtype": "A"}, {"a26_usage": 0.07632, "cell_entry": 0.05014, "ferret_sera_escape": -0.5408, "mature_H5_site": 238, "mouse_sera_escape": -0.3704, "mutant": "G", "mutation": "A242G", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": -0.1516, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7801, "ferret_sera_escape": 0.0669, "mature_H5_site": 238, "mouse_sera_escape": 0.1303, "mutant": "H", "mutation": "A242H", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": -0.2035, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3109, "ferret_sera_escape": -0.2727, "mature_H5_site": 238, "mouse_sera_escape": 0.09171, "mutant": "K", "mutation": "A242K", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.898, "ferret_sera_escape": -0.4984, "mature_H5_site": 238, "mouse_sera_escape": -0.1485, "mutant": "N", "mutation": "A242N", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": -0.2723, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5513, "ferret_sera_escape": -0.4171, "mature_H5_site": 238, "mouse_sera_escape": 0.06911, "mutant": "P", "mutation": "A242P", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2068, "ferret_sera_escape": -0.4169, "mature_H5_site": 238, "mouse_sera_escape": 0.07131, "mutant": "R", "mutation": "A242R", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": 0.001137, "wildtype": "A"}, {"a26_usage": 0.1668, "cell_entry": 0.02188, "ferret_sera_escape": -0.1314, "mature_H5_site": 238, "mouse_sera_escape": -0.07154, "mutant": "S", "mutation": "A242S", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": -0.00523, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.03773, "ferret_sera_escape": -0.07625, "mature_H5_site": 238, "mouse_sera_escape": -0.09673, "mutant": "T", "mutation": "A242T", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": 0.0627, "wildtype": "A"}, {"a26_usage": 0.2991, "cell_entry": 0.01979, "ferret_sera_escape": -0.293, "mature_H5_site": 238, "mouse_sera_escape": 0.05035, "mutant": "V", "mutation": "A242V", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": 0.04462, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.447, "ferret_sera_escape": null, "mature_H5_site": 238, "mouse_sera_escape": null, "mutant": "W", "mutation": "A242W", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.23, "ferret_sera_escape": -0.1379, "mature_H5_site": 238, "mouse_sera_escape": 0.2621, "mutant": "Y", "mutation": "A242Y", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.6236, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "A", "mutation": "I243A", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.368, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "C", "mutation": "I243C", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.845, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "D", "mutation": "I243D", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "E", "mutation": "I243E", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.596, "ferret_sera_escape": -0.2647, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "F", "mutation": "I243F", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "G", "mutation": "I243G", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 239, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I243I", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.964, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "K", "mutation": "I243K", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.04473, "ferret_sera_escape": -0.4844, "mature_H5_site": 239, "mouse_sera_escape": -0.1419, "mutant": "L", "mutation": "I243L", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": -0.2257, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06378, "ferret_sera_escape": -0.0733, "mature_H5_site": 239, "mouse_sera_escape": -0.1851, "mutant": "M", "mutation": "I243M", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": -0.256, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "N", "mutation": "I243N", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.994, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "P", "mutation": "I243P", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.975, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I243Q", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "R", "mutation": "I243R", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.79, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "T", "mutation": "I243T", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1009, "ferret_sera_escape": -0.08271, "mature_H5_site": 239, "mouse_sera_escape": -0.02461, "mutant": "V", "mutation": "I243V", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": -0.08073, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.034, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "W", "mutation": "I243W", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I243Y", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2284, "ferret_sera_escape": null, "mature_H5_site": 240, "mouse_sera_escape": null, "mutant": "D", "mutation": "H244D", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.352, "ferret_sera_escape": -0.5213, "mature_H5_site": 240, "mouse_sera_escape": -0.368, "mutant": "E", "mutation": "H244E", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": -0.1212, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.005, "ferret_sera_escape": -0.2408, "mature_H5_site": 240, "mouse_sera_escape": -0.07896, "mutant": "F", "mutation": "H244F", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": 0.1406, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.223, "ferret_sera_escape": null, "mature_H5_site": 240, "mouse_sera_escape": null, "mutant": "G", "mutation": "H244G", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 240, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H244H", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.03123, "ferret_sera_escape": -0.4985, "mature_H5_site": 240, "mouse_sera_escape": -0.4556, "mutant": "I", "mutation": "H244I", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": -0.1149, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.975, "ferret_sera_escape": null, "mature_H5_site": 240, "mouse_sera_escape": null, "mutant": "K", "mutation": "H244K", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1735, "ferret_sera_escape": -0.885, "mature_H5_site": 240, "mouse_sera_escape": -0.691, "mutant": "L", "mutation": "H244L", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": -0.2299, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.21, "ferret_sera_escape": -0.06246, "mature_H5_site": 240, "mouse_sera_escape": -0.1529, "mutant": "N", "mutation": "H244N", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5471, "ferret_sera_escape": -0.4883, "mature_H5_site": 240, "mouse_sera_escape": -0.3926, "mutant": "Q", "mutation": "H244Q", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": -0.2293, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 240, "mouse_sera_escape": null, "mutant": "R", "mutation": "H244R", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.8379, "ferret_sera_escape": null, "mature_H5_site": 240, "mouse_sera_escape": null, "mutant": "S", "mutation": "H244S", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4743, "ferret_sera_escape": -0.1897, "mature_H5_site": 240, "mouse_sera_escape": -0.1471, "mutant": "T", "mutation": "H244T", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": -0.06742, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5613, "ferret_sera_escape": -0.7372, "mature_H5_site": 240, "mouse_sera_escape": -0.7262, "mutant": "V", "mutation": "H244V", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.02739, "ferret_sera_escape": -0.4389, "mature_H5_site": 240, "mouse_sera_escape": -0.1231, "mutant": "Y", "mutation": "H244Y", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": 0.1168, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.7, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "A", "mutation": "F245A", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "D", "mutation": "F245D", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 241, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F245F", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "G", "mutation": "F245G", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "H", "mutation": "F245H", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.107, "ferret_sera_escape": -0.1245, "mature_H5_site": 241, "mouse_sera_escape": -0.1252, "mutant": "I", "mutation": "F245I", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "K", "mutation": "F245K", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.1846, "ferret_sera_escape": -0.1816, "mature_H5_site": 241, "mouse_sera_escape": -0.1254, "mutant": "L", "mutation": "F245L", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": -0.1906, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "N", "mutation": "F245N", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "P", "mutation": "F245P", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F245Q", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "R", "mutation": "F245R", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "S", "mutation": "F245S", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "T", "mutation": "F245T", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.06792, "ferret_sera_escape": -0.01378, "mature_H5_site": 241, "mouse_sera_escape": -0.1283, "mutant": "V", "mutation": "F245V", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": -0.2019, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.2588, "ferret_sera_escape": 0.2052, "mature_H5_site": 241, "mouse_sera_escape": 0.03014, "mutant": "W", "mutation": "F245W", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": -0.0936, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.05965, "ferret_sera_escape": -0.0269, "mature_H5_site": 241, "mouse_sera_escape": 0.04218, "mutant": "Y", "mutation": "F245Y", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": -0.2329, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.4036, "ferret_sera_escape": 0.0423, "mature_H5_site": 242, "mouse_sera_escape": 0.02874, "mutant": "A", "mutation": "E246A", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.1928, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2044, "ferret_sera_escape": 0.1265, "mature_H5_site": 242, "mouse_sera_escape": 0.134, "mutant": "C", "mutation": "E246C", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.1816, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.8272, "ferret_sera_escape": 0.4246, "mature_H5_site": 242, "mouse_sera_escape": 0.07429, "mutant": "D", "mutation": "E246D", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.2427, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 242, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E246E", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 242, "mouse_sera_escape": null, "mutant": "F", "mutation": "E246F", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.01, "ferret_sera_escape": null, "mature_H5_site": 242, "mouse_sera_escape": null, "mutant": "G", "mutation": "E246G", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07021, "ferret_sera_escape": 0.1577, "mature_H5_site": 242, "mouse_sera_escape": 0.3386, "mutant": "H", "mutation": "E246H", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.2088, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1924, "ferret_sera_escape": 0.2655, "mature_H5_site": 242, "mouse_sera_escape": 0.3416, "mutant": "I", "mutation": "E246I", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.228, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.639, "ferret_sera_escape": 0.304, "mature_H5_site": 242, "mouse_sera_escape": 0.537, "mutant": "K", "mutation": "E246K", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.1059, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5186, "ferret_sera_escape": 0.4351, "mature_H5_site": 242, "mouse_sera_escape": 0.4095, "mutant": "L", "mutation": "E246L", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.2192, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.03527, "ferret_sera_escape": 0.1542, "mature_H5_site": 242, "mouse_sera_escape": 0.1125, "mutant": "M", "mutation": "E246M", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.09783, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1961, "ferret_sera_escape": 0.2623, "mature_H5_site": 242, "mouse_sera_escape": 0.2574, "mutant": "N", "mutation": "E246N", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.729, "ferret_sera_escape": null, "mature_H5_site": 242, "mouse_sera_escape": null, "mutant": "P", "mutation": "E246P", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.953, "ferret_sera_escape": 0.2545, "mature_H5_site": 242, "mouse_sera_escape": 0.2084, "mutant": "R", "mutation": "E246R", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.1849, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.02232, "ferret_sera_escape": 0.08748, "mature_H5_site": 242, "mouse_sera_escape": 0.1166, "mutant": "S", "mutation": "E246S", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.2049, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4647, "ferret_sera_escape": 0.246, "mature_H5_site": 242, "mouse_sera_escape": 0.2403, "mutant": "V", "mutation": "E246V", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.3154, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1823, "ferret_sera_escape": 0.1499, "mature_H5_site": 242, "mouse_sera_escape": 0.3093, "mutant": "W", "mutation": "E246W", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.2856, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9304, "ferret_sera_escape": -0.08033, "mature_H5_site": 242, "mouse_sera_escape": 0.1512, "mutant": "Y", "mutation": "E246Y", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.04611, "ferret_sera_escape": -0.1512, "mature_H5_site": 243, "mouse_sera_escape": -0.05387, "mutant": "A", "mutation": "S247A", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": -0.1075, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.822, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "D", "mutation": "S247D", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.998, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "E", "mutation": "S247E", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.9194, "ferret_sera_escape": -0.2277, "mature_H5_site": 243, "mouse_sera_escape": -0.0722, "mutant": "F", "mutation": "S247F", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.05672, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "G", "mutation": "S247G", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -6.01, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "I", "mutation": "S247I", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "K", "mutation": "S247K", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.05, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "M", "mutation": "S247M", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "P", "mutation": "S247P", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.497, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "Q", "mutation": "S247Q", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 243, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S247S", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.2745, "cell_entry": -0.5357, "ferret_sera_escape": 0.007003, "mature_H5_site": 243, "mouse_sera_escape": 0.146, "mutant": "T", "mutation": "S247T", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S247Y", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.5594, "cell_entry": 0.07866, "ferret_sera_escape": -0.4604, "mature_H5_site": 244, "mouse_sera_escape": -0.2813, "mutant": "A", "mutation": "N248A", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": -0.2432, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.775, "ferret_sera_escape": null, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "C", "mutation": "N248C", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": -0.2445, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02962, "ferret_sera_escape": -0.1505, "mature_H5_site": 244, "mouse_sera_escape": -0.1077, "mutant": "D", "mutation": "N248D", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": -0.1704, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4819, "ferret_sera_escape": -0.07821, "mature_H5_site": 244, "mouse_sera_escape": -0.1357, "mutant": "E", "mutation": "N248E", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": -0.1397, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.632, "ferret_sera_escape": null, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "H", "mutation": "N248H", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.067, "ferret_sera_escape": 0.1096, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "I", "mutation": "N248I", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": -0.1088, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7208, "ferret_sera_escape": -0.2551, "mature_H5_site": 244, "mouse_sera_escape": -0.1105, "mutant": "K", "mutation": "N248K", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.151, "ferret_sera_escape": null, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "L", "mutation": "N248L", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9711, "ferret_sera_escape": null, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "M", "mutation": "N248M", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 244, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N248N", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.55, "ferret_sera_escape": -0.08175, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "P", "mutation": "N248P", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.0659, "ferret_sera_escape": -0.2364, "mature_H5_site": 244, "mouse_sera_escape": -0.2122, "mutant": "Q", "mutation": "N248Q", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": -0.2157, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.615, "ferret_sera_escape": -0.5953, "mature_H5_site": 244, "mouse_sera_escape": -0.09622, "mutant": "R", "mutation": "N248R", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.1766, "cell_entry": -0.04235, "ferret_sera_escape": -0.2726, "mature_H5_site": 244, "mouse_sera_escape": -0.1428, "mutant": "S", "mutation": "N248S", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1701, "ferret_sera_escape": -0.08497, "mature_H5_site": 244, "mouse_sera_escape": -0.04253, "mutant": "T", "mutation": "N248T", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.119, "ferret_sera_escape": null, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "V", "mutation": "N248V", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.289, "ferret_sera_escape": null, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "W", "mutation": "N248W", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.128, "ferret_sera_escape": null, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N248Y", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.997, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "D", "mutation": "G249D", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.986, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "E", "mutation": "G249E", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 245, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G249G", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "H", "mutation": "G249H", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "K", "mutation": "G249K", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "L", "mutation": "G249L", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.255, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "M", "mutation": "G249M", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "N", "mutation": "G249N", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.047, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "P", "mutation": "G249P", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G249Q", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "R", "mutation": "G249R", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "S", "mutation": "G249S", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.073, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "T", "mutation": "G249T", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.646, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "V", "mutation": "G249V", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "W", "mutation": "G249W", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G249Y", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.07544, "ferret_sera_escape": null, "mature_H5_site": 15, "mouse_sera_escape": null, "mutant": "A", "mutation": "Q25A", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1791, "ferret_sera_escape": -0.09862, "mature_H5_site": 15, "mouse_sera_escape": -0.04204, "mutant": "C", "mutation": "Q25C", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": -0.2701, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2037, "ferret_sera_escape": -0.05114, "mature_H5_site": 15, "mouse_sera_escape": 0.01503, "mutant": "E", "mutation": "Q25E", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": -0.05458, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2308, "ferret_sera_escape": -0.08462, "mature_H5_site": 15, "mouse_sera_escape": 0.02062, "mutant": "F", "mutation": "Q25F", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.639, "ferret_sera_escape": -0.04697, "mature_H5_site": 15, "mouse_sera_escape": -0.07533, "mutant": "H", "mutation": "Q25H", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.02609, "cell_entry": 0.05322, "ferret_sera_escape": -0.01323, "mature_H5_site": 15, "mouse_sera_escape": 0.07796, "mutant": "K", "mutation": "Q25K", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": 0.03919, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.4802, "ferret_sera_escape": 0.0494, "mature_H5_site": 15, "mouse_sera_escape": null, "mutant": "L", "mutation": "Q25L", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": 0.0473, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.0263, "ferret_sera_escape": 0.1439, "mature_H5_site": 15, "mouse_sera_escape": 0.06586, "mutant": "N", "mutation": "Q25N", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.15, "ferret_sera_escape": null, "mature_H5_site": 15, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q25P", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 15, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q25Q", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2161, "ferret_sera_escape": -0.06133, "mature_H5_site": 15, "mouse_sera_escape": -0.06627, "mutant": "R", "mutation": "Q25R", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": 0.05167, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.28, "ferret_sera_escape": null, "mature_H5_site": 15, "mouse_sera_escape": null, "mutant": "S", "mutation": "Q25S", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.04558, "ferret_sera_escape": -0.06248, "mature_H5_site": 15, "mouse_sera_escape": 0.02389, "mutant": "T", "mutation": "Q25T", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": -0.2598, "wildtype": "Q"}, {"a26_usage": 0.001975, "cell_entry": -0.06474, "ferret_sera_escape": null, "mature_H5_site": 15, "mouse_sera_escape": -0.04064, "mutant": "V", "mutation": "Q25V", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": -0.06342, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.05477, "ferret_sera_escape": -0.2498, "mature_H5_site": 15, "mouse_sera_escape": -0.0885, "mutant": "W", "mutation": "Q25W", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": 1.069, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5637, "ferret_sera_escape": 0.06546, "mature_H5_site": 15, "mouse_sera_escape": 0.0702, "mutant": "Y", "mutation": "Q25Y", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": 0.1322, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.4829, "ferret_sera_escape": 0.03767, "mature_H5_site": 246, "mouse_sera_escape": -0.04664, "mutant": "A", "mutation": "N250A", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.236, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "C", "mutation": "N250C", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "D", "mutation": "N250D", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.991, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "F", "mutation": "N250F", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3624, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "G", "mutation": "N250G", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "H", "mutation": "N250H", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "I", "mutation": "N250I", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -6.058, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "K", "mutation": "N250K", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.73, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "M", "mutation": "N250M", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 246, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N250N", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N250Q", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "R", "mutation": "N250R", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2077, "ferret_sera_escape": 0.4757, "mature_H5_site": 246, "mouse_sera_escape": -0.09096, "mutant": "S", "mutation": "N250S", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": -0.2198, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "V", "mutation": "N250V", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.157, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "A", "mutation": "F251A", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "D", "mutation": "F251D", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "E", "mutation": "F251E", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 247, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F251F", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.008, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "G", "mutation": "F251G", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "H", "mutation": "F251H", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.04736, "ferret_sera_escape": 0.0954, "mature_H5_site": 247, "mouse_sera_escape": 0.02678, "mutant": "I", "mutation": "F251I", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": -0.0836, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "K", "mutation": "F251K", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.03755, "cell_entry": -0.3646, "ferret_sera_escape": 0.1421, "mature_H5_site": 247, "mouse_sera_escape": -0.05454, "mutant": "L", "mutation": "F251L", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": -0.1824, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.06907, "ferret_sera_escape": -0.07375, "mature_H5_site": 247, "mouse_sera_escape": -0.0694, "mutant": "M", "mutation": "F251M", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": -0.1653, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "N", "mutation": "F251N", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F251Q", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.973, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "R", "mutation": "F251R", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "S", "mutation": "F251S", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "T", "mutation": "F251T", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.595, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "V", "mutation": "F251V", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.2702, "ferret_sera_escape": 0.02749, "mature_H5_site": 247, "mouse_sera_escape": 0.1186, "mutant": "W", "mutation": "F251W", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": 0.02186, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.917, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "Y", "mutation": "F251Y", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.291, "ferret_sera_escape": -0.1503, "mature_H5_site": 248, "mouse_sera_escape": -0.01071, "mutant": "A", "mutation": "I252A", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "C", "mutation": "I252C", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "D", "mutation": "I252D", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "E", "mutation": "I252E", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.771, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "F", "mutation": "I252F", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.558, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "G", "mutation": "I252G", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "H", "mutation": "I252H", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 248, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I252I", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1505, "ferret_sera_escape": -0.3759, "mature_H5_site": 248, "mouse_sera_escape": -0.2856, "mutant": "L", "mutation": "I252L", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": -0.2731, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2476, "ferret_sera_escape": -0.6723, "mature_H5_site": 248, "mouse_sera_escape": -0.6913, "mutant": "M", "mutation": "I252M", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": -0.25, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.898, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "N", "mutation": "I252N", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.141, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I252Q", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "R", "mutation": "I252R", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "S", "mutation": "I252S", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "T", "mutation": "I252T", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1272, "ferret_sera_escape": 0.07598, "mature_H5_site": 248, "mouse_sera_escape": 0.03064, "mutant": "V", "mutation": "I252V", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": -0.05327, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "W", "mutation": "I252W", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I252Y", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 249, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A253A", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.02496, "ferret_sera_escape": 0.3854, "mature_H5_site": 249, "mouse_sera_escape": -0.0416, "mutant": "C", "mutation": "A253C", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": -0.05824, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.659, "ferret_sera_escape": null, "mature_H5_site": 249, "mouse_sera_escape": null, "mutant": "D", "mutation": "A253D", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.831, "ferret_sera_escape": null, "mature_H5_site": 249, "mouse_sera_escape": null, "mutant": "E", "mutation": "A253E", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.832, "ferret_sera_escape": 0.1293, "mature_H5_site": 249, "mouse_sera_escape": -0.3473, "mutant": "F", "mutation": "A253F", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.00855, "ferret_sera_escape": -0.2506, "mature_H5_site": 249, "mouse_sera_escape": 0.000635, "mutant": "G", "mutation": "A253G", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.9725, "ferret_sera_escape": 0.6793, "mature_H5_site": 249, "mouse_sera_escape": 0.2404, "mutant": "I", "mutation": "A253I", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": -0.08341, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 249, "mouse_sera_escape": null, "mutant": "K", "mutation": "A253K", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7596, "ferret_sera_escape": 0.3332, "mature_H5_site": 249, "mouse_sera_escape": 0.08721, "mutant": "L", "mutation": "A253L", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": 0.08129, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.121, "ferret_sera_escape": null, "mature_H5_site": 249, "mouse_sera_escape": null, "mutant": "M", "mutation": "A253M", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 249, "mouse_sera_escape": null, "mutant": "N", "mutation": "A253N", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.0624, "ferret_sera_escape": 0.1094, "mature_H5_site": 249, "mouse_sera_escape": 0.09268, "mutant": "P", "mutation": "A253P", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": -0.1698, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.873, "ferret_sera_escape": null, "mature_H5_site": 249, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A253Q", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.004725, "cell_entry": -0.1116, "ferret_sera_escape": 0.2776, "mature_H5_site": 249, "mouse_sera_escape": 0.03513, "mutant": "S", "mutation": "A253S", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": -0.00916, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3065, "ferret_sera_escape": 0.1346, "mature_H5_site": 249, "mouse_sera_escape": -0.2323, "mutant": "T", "mutation": "A253T", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": -0.1918, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.08648, "ferret_sera_escape": 0.3043, "mature_H5_site": 249, "mouse_sera_escape": 0.03359, "mutant": "V", "mutation": "A253V", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": 0.0555, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 249, "mouse_sera_escape": null, "mutant": "W", "mutation": "A253W", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.442, "ferret_sera_escape": -0.1442, "mature_H5_site": 250, "mouse_sera_escape": 0.06816, "mutant": "A", "mutation": "P254A", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": -0.08427, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.29, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "C", "mutation": "P254C", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "D", "mutation": "P254D", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "E", "mutation": "P254E", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "G", "mutation": "P254G", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.046, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "H", "mutation": "P254H", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "K", "mutation": "P254K", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.007, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "L", "mutation": "P254L", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.607, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "M", "mutation": "P254M", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "N", "mutation": "P254N", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 250, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P254P", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.718, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P254Q", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.032, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "R", "mutation": "P254R", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.545, "ferret_sera_escape": -0.0874, "mature_H5_site": 250, "mouse_sera_escape": -0.03787, "mutant": "S", "mutation": "P254S", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": 0.01251, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.219, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "T", "mutation": "P254T", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.056, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "W", "mutation": "P254W", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "Y", "mutation": "P254Y", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.08652, "ferret_sera_escape": -0.1015, "mature_H5_site": 251, "mouse_sera_escape": 0.467, "mutant": "A", "mutation": "E255A", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.06867, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.707, "ferret_sera_escape": 0.247, "mature_H5_site": 251, "mouse_sera_escape": 0.4594, "mutant": "D", "mutation": "E255D", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.1846, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 251, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E255E", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.06212, "cell_entry": -0.05388, "ferret_sera_escape": 0.3503, "mature_H5_site": 251, "mouse_sera_escape": 1.022, "mutant": "F", "mutation": "E255F", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.06339, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.03479, "ferret_sera_escape": null, "mature_H5_site": 251, "mouse_sera_escape": null, "mutant": "G", "mutation": "E255G", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.114, "ferret_sera_escape": -0.07302, "mature_H5_site": 251, "mouse_sera_escape": 0.6545, "mutant": "H", "mutation": "E255H", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.195, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.057, "ferret_sera_escape": -0.08771, "mature_H5_site": 251, "mouse_sera_escape": 0.4395, "mutant": "I", "mutation": "E255I", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": 0.3155, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4098, "ferret_sera_escape": 0.09833, "mature_H5_site": 251, "mouse_sera_escape": 1.047, "mutant": "K", "mutation": "E255K", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.1786, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01654, "ferret_sera_escape": 0.1057, "mature_H5_site": 251, "mouse_sera_escape": 1.044, "mutant": "M", "mutation": "E255M", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.3627, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0449, "ferret_sera_escape": -0.01985, "mature_H5_site": 251, "mouse_sera_escape": 0.5439, "mutant": "Q", "mutation": "E255Q", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.07128, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.04152, "ferret_sera_escape": 0.0009233, "mature_H5_site": 251, "mouse_sera_escape": 1.079, "mutant": "R", "mutation": "E255R", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.2459, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07055, "ferret_sera_escape": -0.02589, "mature_H5_site": 251, "mouse_sera_escape": null, "mutant": "S", "mutation": "E255S", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2516, "ferret_sera_escape": -0.245, "mature_H5_site": 251, "mouse_sera_escape": 0.4315, "mutant": "T", "mutation": "E255T", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": 0.0482, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.05987, "ferret_sera_escape": -0.013, "mature_H5_site": 251, "mouse_sera_escape": 0.5909, "mutant": "V", "mutation": "E255V", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.04528, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.03663, "ferret_sera_escape": 0.2831, "mature_H5_site": 251, "mouse_sera_escape": 0.9031, "mutant": "W", "mutation": "E255W", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.06046, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02599, "ferret_sera_escape": 0.2873, "mature_H5_site": 251, "mouse_sera_escape": 0.7836, "mutant": "Y", "mutation": "E255Y", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.1072, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1794, "ferret_sera_escape": 0.1892, "mature_H5_site": 252, "mouse_sera_escape": 0.2842, "mutant": "A", "mutation": "Y256A", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.03823, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7673, "ferret_sera_escape": 0.2567, "mature_H5_site": 252, "mouse_sera_escape": 0.3809, "mutant": "C", "mutation": "Y256C", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.1592, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.649, "ferret_sera_escape": null, "mature_H5_site": 252, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y256D", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.645, "ferret_sera_escape": 0.2082, "mature_H5_site": 252, "mouse_sera_escape": 0.4523, "mutant": "E", "mutation": "Y256E", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.2013, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3248, "ferret_sera_escape": 0.09901, "mature_H5_site": 252, "mouse_sera_escape": -0.01165, "mutant": "F", "mutation": "Y256F", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": 0.0184, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1096, "ferret_sera_escape": 0.1346, "mature_H5_site": 252, "mouse_sera_escape": 0.2227, "mutant": "H", "mutation": "Y256H", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.158, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.2811, "ferret_sera_escape": 0.2879, "mature_H5_site": 252, "mouse_sera_escape": 0.01939, "mutant": "I", "mutation": "Y256I", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.3211, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.5509, "ferret_sera_escape": 0.198, "mature_H5_site": 252, "mouse_sera_escape": 0.4509, "mutant": "K", "mutation": "Y256K", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.08562, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1837, "ferret_sera_escape": -0.05464, "mature_H5_site": 252, "mouse_sera_escape": -0.02275, "mutant": "L", "mutation": "Y256L", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.2543, "wildtype": "Y"}, {"a26_usage": 0.6918, "cell_entry": -0.8669, "ferret_sera_escape": 0.07145, "mature_H5_site": 252, "mouse_sera_escape": 0.2994, "mutant": "N", "mutation": "Y256N", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.128, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 252, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y256P", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.07612, "ferret_sera_escape": 0.1773, "mature_H5_site": 252, "mouse_sera_escape": 0.3632, "mutant": "Q", "mutation": "Y256Q", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.1919, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.052, "ferret_sera_escape": null, "mature_H5_site": 252, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y256R", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.04036, "ferret_sera_escape": 0.2159, "mature_H5_site": 252, "mouse_sera_escape": 0.2444, "mutant": "S", "mutation": "Y256S", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.268, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7166, "ferret_sera_escape": 0.04814, "mature_H5_site": 252, "mouse_sera_escape": 0.05686, "mutant": "T", "mutation": "Y256T", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.2306, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.03938, "ferret_sera_escape": 0.3626, "mature_H5_site": 252, "mouse_sera_escape": 0.07486, "mutant": "V", "mutation": "Y256V", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.1821, "wildtype": "Y"}, {"a26_usage": 0.03293, "cell_entry": 0.0641, "ferret_sera_escape": 0.1762, "mature_H5_site": 252, "mouse_sera_escape": 0.5, "mutant": "W", "mutation": "Y256W", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.296, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 252, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y256Y", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 253, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A257A", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.8768, "ferret_sera_escape": 0.008647, "mature_H5_site": 253, "mouse_sera_escape": 0.2867, "mutant": "C", "mutation": "A257C", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": -0.2924, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "D", "mutation": "A257D", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.849, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "E", "mutation": "A257E", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.787, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "F", "mutation": "A257F", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.735, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "H", "mutation": "A257H", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.337, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "I", "mutation": "A257I", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "K", "mutation": "A257K", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "L", "mutation": "A257L", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.378, "ferret_sera_escape": 0.05713, "mature_H5_site": 253, "mouse_sera_escape": 0.2777, "mutant": "M", "mutation": "A257M", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.021, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "N", "mutation": "A257N", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "P", "mutation": "A257P", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A257Q", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.88, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "R", "mutation": "A257R", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4608, "ferret_sera_escape": -0.1845, "mature_H5_site": 253, "mouse_sera_escape": 0.1016, "mutant": "S", "mutation": "A257S", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": -0.1716, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "T", "mutation": "A257T", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7475, "ferret_sera_escape": 0.06482, "mature_H5_site": 253, "mouse_sera_escape": 0.1677, "mutant": "V", "mutation": "A257V", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": -0.2181, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "W", "mutation": "A257W", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.765, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A257Y", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.768, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y258C", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y258D", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.989, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y258E", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.191, "ferret_sera_escape": 0.02218, "mature_H5_site": 254, "mouse_sera_escape": 0.02426, "mutant": "F", "mutation": "Y258F", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": 0.6354, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.011, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y258G", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.466, "ferret_sera_escape": -0.4243, "mature_H5_site": 254, "mouse_sera_escape": 0.1736, "mutant": "H", "mutation": "Y258H", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.2232, "ferret_sera_escape": -0.0429, "mature_H5_site": 254, "mouse_sera_escape": 0.06653, "mutant": "I", "mutation": "Y258I", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": 1.452, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y258K", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.03454, "ferret_sera_escape": -0.01583, "mature_H5_site": 254, "mouse_sera_escape": -0.08054, "mutant": "M", "mutation": "Y258M", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": -0.2858, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.687, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y258N", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.876, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y258Q", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y258R", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.287, "ferret_sera_escape": -0.14, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y258S", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.772, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y258T", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.331, "ferret_sera_escape": 0.006823, "mature_H5_site": 254, "mouse_sera_escape": 0.1353, "mutant": "V", "mutation": "Y258V", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": 2.246, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.625, "ferret_sera_escape": 0.1288, "mature_H5_site": 254, "mouse_sera_escape": 0.129, "mutant": "W", "mutation": "Y258W", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 254, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y258Y", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.07852, "ferret_sera_escape": -0.06888, "mature_H5_site": 255, "mouse_sera_escape": 0.2156, "mutant": "A", "mutation": "K259A", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": -0.1745, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.766, "ferret_sera_escape": 0.01057, "mature_H5_site": 255, "mouse_sera_escape": 0.4015, "mutant": "C", "mutation": "K259C", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 255, "mouse_sera_escape": null, "mutant": "D", "mutation": "K259D", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.027, "ferret_sera_escape": 0.001104, "mature_H5_site": 255, "mouse_sera_escape": 0.4122, "mutant": "E", "mutation": "K259E", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 0.8847, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.286, "ferret_sera_escape": -0.05196, "mature_H5_site": 255, "mouse_sera_escape": -0.2445, "mutant": "F", "mutation": "K259F", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 0.9224, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.102, "ferret_sera_escape": 0.03456, "mature_H5_site": 255, "mouse_sera_escape": 0.6524, "mutant": "G", "mutation": "K259G", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 0.6986, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6033, "ferret_sera_escape": 0.3681, "mature_H5_site": 255, "mouse_sera_escape": 0.1407, "mutant": "H", "mutation": "K259H", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": -0.1431, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 255, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K259K", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.07437, "cell_entry": -0.3481, "ferret_sera_escape": 0.05584, "mature_H5_site": 255, "mouse_sera_escape": 0.09044, "mutant": "L", "mutation": "K259L", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2186, "ferret_sera_escape": 0.1455, "mature_H5_site": 255, "mouse_sera_escape": 0.2921, "mutant": "M", "mutation": "K259M", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 0.2436, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.324, "ferret_sera_escape": null, "mature_H5_site": 255, "mouse_sera_escape": null, "mutant": "N", "mutation": "K259N", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.929, "ferret_sera_escape": null, "mature_H5_site": 255, "mouse_sera_escape": null, "mutant": "P", "mutation": "K259P", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.182, "ferret_sera_escape": -0.03091, "mature_H5_site": 255, "mouse_sera_escape": 0.3285, "mutant": "Q", "mutation": "K259Q", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 0.01785, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3963, "ferret_sera_escape": -0.05077, "mature_H5_site": 255, "mouse_sera_escape": 0.08262, "mutant": "R", "mutation": "K259R", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": -0.3385, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03081, "ferret_sera_escape": 0.03872, "mature_H5_site": 255, "mouse_sera_escape": 0.2492, "mutant": "S", "mutation": "K259S", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 0.191, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.098, "ferret_sera_escape": -0.1222, "mature_H5_site": 255, "mouse_sera_escape": 0.6, "mutant": "T", "mutation": "K259T", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2181, "ferret_sera_escape": 0.08231, "mature_H5_site": 255, "mouse_sera_escape": 0.1779, "mutant": "V", "mutation": "K259V", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 1.291, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.004, "ferret_sera_escape": null, "mature_H5_site": 255, "mouse_sera_escape": null, "mutant": "W", "mutation": "K259W", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6905, "ferret_sera_escape": null, "mature_H5_site": 255, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K259Y", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.595, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "A", "mutation": "V26A", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.604, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "D", "mutation": "V26D", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -6.043, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "E", "mutation": "V26E", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "G", "mutation": "V26G", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "H", "mutation": "V26H", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5995, "ferret_sera_escape": 0.02191, "mature_H5_site": 16, "mouse_sera_escape": -0.003472, "mutant": "I", "mutation": "V26I", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": 0.02324, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.209, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "L", "mutation": "V26L", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.986, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "M", "mutation": "V26M", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "N", "mutation": "V26N", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.562, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "S", "mutation": "V26S", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "T", "mutation": "V26T", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 16, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V26V", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "W", "mutation": "V26W", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.279, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V26Y", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.3343, "cell_entry": 0.07074, "ferret_sera_escape": -0.05312, "mature_H5_site": 256, "mouse_sera_escape": 0.01897, "mutant": "A", "mutation": "I260A", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": -0.2199, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "D", "mutation": "I260D", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.562, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "E", "mutation": "I260E", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.88, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "F", "mutation": "I260F", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 256, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I260I", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.488, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "K", "mutation": "I260K", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.07275, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "L", "mutation": "I260L", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.361, "ferret_sera_escape": -0.2378, "mature_H5_site": 256, "mouse_sera_escape": 0.7909, "mutant": "M", "mutation": "I260M", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.716, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "N", "mutation": "I260N", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.804, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I260Q", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.726, "ferret_sera_escape": -0.3145, "mature_H5_site": 256, "mouse_sera_escape": 0.06047, "mutant": "S", "mutation": "I260S", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": -0.0895, "wildtype": "I"}, {"a26_usage": 0.007265, "cell_entry": -0.1632, "ferret_sera_escape": -0.02395, "mature_H5_site": 256, "mouse_sera_escape": -0.05158, "mutant": "V", "mutation": "I260V", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": 0.7054, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.751, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "W", "mutation": "I260W", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I260Y", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.8537, "ferret_sera_escape": 0.0358, "mature_H5_site": 257, "mouse_sera_escape": 0.03377, "mutant": "A", "mutation": "V261A", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.04576, "ferret_sera_escape": 0.2122, "mature_H5_site": 257, "mouse_sera_escape": 0.1037, "mutant": "C", "mutation": "V261C", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": -0.1032, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3668, "ferret_sera_escape": null, "mature_H5_site": 257, "mouse_sera_escape": null, "mutant": "D", "mutation": "V261D", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8042, "ferret_sera_escape": 0.01995, "mature_H5_site": 257, "mouse_sera_escape": 0.2383, "mutant": "E", "mutation": "V261E", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": 1.719, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7212, "ferret_sera_escape": -0.02336, "mature_H5_site": 257, "mouse_sera_escape": 0.2025, "mutant": "F", "mutation": "V261F", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": 0.3216, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.09323, "ferret_sera_escape": null, "mature_H5_site": 257, "mouse_sera_escape": null, "mutant": "I", "mutation": "V261I", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4881, "ferret_sera_escape": 0.04454, "mature_H5_site": 257, "mouse_sera_escape": 0.1707, "mutant": "K", "mutation": "V261K", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": -0.08384, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.01508, "ferret_sera_escape": 0.2457, "mature_H5_site": 257, "mouse_sera_escape": 0.06511, "mutant": "M", "mutation": "V261M", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": -0.7935, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.05874, "ferret_sera_escape": -0.1593, "mature_H5_site": 257, "mouse_sera_escape": 0.01018, "mutant": "N", "mutation": "V261N", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": 0.2352, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 257, "mouse_sera_escape": null, "mutant": "P", "mutation": "V261P", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.04909, "ferret_sera_escape": null, "mature_H5_site": 257, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V261Q", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3833, "ferret_sera_escape": 0.09215, "mature_H5_site": 257, "mouse_sera_escape": 0.1564, "mutant": "S", "mutation": "V261S", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": 0.4557, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.06115, "ferret_sera_escape": -0.2332, "mature_H5_site": 257, "mouse_sera_escape": -0.1587, "mutant": "T", "mutation": "V261T", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": -0.2244, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 257, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V261V", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.533, "ferret_sera_escape": -0.5013, "mature_H5_site": 257, "mouse_sera_escape": 0.2012, "mutant": "W", "mutation": "V261W", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": 0.4339, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7603, "ferret_sera_escape": -0.09924, "mature_H5_site": 257, "mouse_sera_escape": 0.1107, "mutant": "Y", "mutation": "V261Y", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": 0.4908, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.901, "ferret_sera_escape": -0.09232, "mature_H5_site": 258, "mouse_sera_escape": 0.1812, "mutant": "A", "mutation": "K262A", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 1.947, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.608, "ferret_sera_escape": 0.1036, "mature_H5_site": 258, "mouse_sera_escape": 0.01458, "mutant": "C", "mutation": "K262C", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.151, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -6.012, "ferret_sera_escape": null, "mature_H5_site": 258, "mouse_sera_escape": null, "mutant": "D", "mutation": "K262D", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.525, "ferret_sera_escape": -0.121, "mature_H5_site": 258, "mouse_sera_escape": null, "mutant": "E", "mutation": "K262E", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.27, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 258, "mouse_sera_escape": null, "mutant": "F", "mutation": "K262F", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.677, "ferret_sera_escape": null, "mature_H5_site": 258, "mouse_sera_escape": null, "mutant": "G", "mutation": "K262G", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.688, "ferret_sera_escape": -0.2173, "mature_H5_site": 258, "mouse_sera_escape": 0.1194, "mutant": "I", "mutation": "K262I", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.377, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 258, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K262K", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.933, "ferret_sera_escape": 0.0376, "mature_H5_site": 258, "mouse_sera_escape": -0.005449, "mutant": "L", "mutation": "K262L", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.085, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.799, "ferret_sera_escape": -0.1374, "mature_H5_site": 258, "mouse_sera_escape": 0.1407, "mutant": "M", "mutation": "K262M", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.165, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.393, "ferret_sera_escape": -0.0407, "mature_H5_site": 258, "mouse_sera_escape": 0.1942, "mutant": "N", "mutation": "K262N", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.135, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.766, "ferret_sera_escape": null, "mature_H5_site": 258, "mouse_sera_escape": null, "mutant": "P", "mutation": "K262P", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.325, "ferret_sera_escape": -0.1007, "mature_H5_site": 258, "mouse_sera_escape": 0.03139, "mutant": "Q", "mutation": "K262Q", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.9813, "ferret_sera_escape": -0.03578, "mature_H5_site": 258, "mouse_sera_escape": 0.02821, "mutant": "R", "mutation": "K262R", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 0.8004, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.583, "ferret_sera_escape": 0.08168, "mature_H5_site": 258, "mouse_sera_escape": 0.3504, "mutant": "T", "mutation": "K262T", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.204, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.643, "ferret_sera_escape": -0.02572, "mature_H5_site": 258, "mouse_sera_escape": 0.3371, "mutant": "V", "mutation": "K262V", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.25, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.121, "ferret_sera_escape": null, "mature_H5_site": 258, "mouse_sera_escape": null, "mutant": "W", "mutation": "K262W", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.858, "ferret_sera_escape": -0.1091, "mature_H5_site": 258, "mouse_sera_escape": 0.06184, "mutant": "Y", "mutation": "K262Y", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": null, "wildtype": "K"}, {"a26_usage": 0.00515, "cell_entry": -0.9504, "ferret_sera_escape": -0.383, "mature_H5_site": 259, "mouse_sera_escape": -0.01416, "mutant": "A", "mutation": "K262aA", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": 1.106, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5241, "ferret_sera_escape": 0.02116, "mature_H5_site": 259, "mouse_sera_escape": 0.04064, "mutant": "C", "mutation": "K262aC", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": -0.03637, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.638, "ferret_sera_escape": null, "mature_H5_site": 259, "mouse_sera_escape": null, "mutant": "D", "mutation": "K262aD", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.08961, "ferret_sera_escape": -0.1146, "mature_H5_site": 259, "mouse_sera_escape": 0.01892, "mutant": "E", "mutation": "K262aE", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": 0.4741, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7404, "ferret_sera_escape": -0.116, "mature_H5_site": 259, "mouse_sera_escape": 0.1355, "mutant": "F", "mutation": "K262aF", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": -0.1989, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.624, "ferret_sera_escape": null, "mature_H5_site": 259, "mouse_sera_escape": null, "mutant": "G", "mutation": "K262aG", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3484, "ferret_sera_escape": -0.02185, "mature_H5_site": 259, "mouse_sera_escape": null, "mutant": "H", "mutation": "K262aH", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.779, "ferret_sera_escape": -0.06106, "mature_H5_site": 259, "mouse_sera_escape": -0.02779, "mutant": "I", "mutation": "K262aI", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": -0.04011, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 259, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K262aK", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.05808, "cell_entry": -0.601, "ferret_sera_escape": -0.08929, "mature_H5_site": 259, "mouse_sera_escape": -0.03224, "mutant": "L", "mutation": "K262aL", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": 0.06836, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1283, "ferret_sera_escape": -0.1787, "mature_H5_site": 259, "mouse_sera_escape": -0.1108, "mutant": "M", "mutation": "K262aM", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": -0.1775, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5621, "ferret_sera_escape": -0.06674, "mature_H5_site": 259, "mouse_sera_escape": 0.2158, "mutant": "N", "mutation": "K262aN", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": 1.468, "wildtype": "K"}, {"a26_usage": 0.1842, "cell_entry": -0.08908, "ferret_sera_escape": -0.1144, "mature_H5_site": 259, "mouse_sera_escape": -0.001779, "mutant": "P", "mutation": "K262aP", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": -0.1915, "wildtype": "K"}, {"a26_usage": 0.2778, "cell_entry": -0.1121, "ferret_sera_escape": -0.00797, "mature_H5_site": 259, "mouse_sera_escape": -0.004093, "mutant": "Q", "mutation": "K262aQ", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": 0.05337, "wildtype": "K"}, {"a26_usage": 0.2227, "cell_entry": -0.06869, "ferret_sera_escape": 0.0413, "mature_H5_site": 259, "mouse_sera_escape": -0.02132, "mutant": "R", "mutation": "K262aR", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": -0.2976, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7108, "ferret_sera_escape": null, "mature_H5_site": 259, "mouse_sera_escape": null, "mutant": "S", "mutation": "K262aS", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3274, "ferret_sera_escape": 0.05512, "mature_H5_site": 259, "mouse_sera_escape": 0.08803, "mutant": "T", "mutation": "K262aT", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": 0.5546, "wildtype": "K"}, {"a26_usage": 0.03311, "cell_entry": -0.05537, "ferret_sera_escape": 0.008367, "mature_H5_site": 259, "mouse_sera_escape": -0.01474, "mutant": "V", "mutation": "K262aV", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": -0.1082, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.379, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "A", "mutation": "G263A", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "C", "mutation": "G263C", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.787, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "D", "mutation": "G263D", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.167, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "E", "mutation": "G263E", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.845, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "F", "mutation": "G263F", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 260, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G263G", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.227, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "H", "mutation": "G263H", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8941, "ferret_sera_escape": 0.1993, "mature_H5_site": 260, "mouse_sera_escape": 0.2731, "mutant": "K", "mutation": "G263K", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": 1.478, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.857, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "L", "mutation": "G263L", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.641, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": 1.132, "mutant": "M", "mutation": "G263M", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": 0.6156, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4806, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "N", "mutation": "G263N", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.038, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "P", "mutation": "G263P", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.971, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G263Q", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.737, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "S", "mutation": "G263S", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.476, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "T", "mutation": "G263T", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.199, "ferret_sera_escape": -0.1036, "mature_H5_site": 260, "mouse_sera_escape": 0.628, "mutant": "V", "mutation": "G263V", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": 1.351, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5123, "ferret_sera_escape": -0.09823, "mature_H5_site": 261, "mouse_sera_escape": -0.05711, "mutant": "A", "mutation": "D264A", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.345, "ferret_sera_escape": -0.488, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "C", "mutation": "D264C", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 261, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D264D", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.3426, "cell_entry": -0.04274, "ferret_sera_escape": -0.1211, "mature_H5_site": 261, "mouse_sera_escape": -0.128, "mutant": "E", "mutation": "D264E", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": -0.2822, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.05635, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "F", "mutation": "D264F", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.207, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "H", "mutation": "D264H", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "I", "mutation": "D264I", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "K", "mutation": "D264K", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "N", "mutation": "D264N", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.258, "ferret_sera_escape": -0.0922, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "P", "mutation": "D264P", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.678, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "Q", "mutation": "D264Q", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "R", "mutation": "D264R", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4896, "ferret_sera_escape": -0.04748, "mature_H5_site": 261, "mouse_sera_escape": -0.1166, "mutant": "S", "mutation": "D264S", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": -0.1568, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.99, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "V", "mutation": "D264V", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.4098, "cell_entry": -0.04174, "ferret_sera_escape": -0.1047, "mature_H5_site": 261, "mouse_sera_escape": -0.07178, "mutant": "W", "mutation": "D264W", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": -0.2757, "wildtype": "D"}, {"a26_usage": 0.1675, "cell_entry": 0.07162, "ferret_sera_escape": -0.01084, "mature_H5_site": 261, "mouse_sera_escape": 0.03811, "mutant": "Y", "mutation": "D264Y", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": -0.2313, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1721, "ferret_sera_escape": -0.1197, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "C", "mutation": "S265C", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "E", "mutation": "S265E", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.129, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "H", "mutation": "S265H", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "I", "mutation": "S265I", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "L", "mutation": "S265L", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "M", "mutation": "S265M", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "N", "mutation": "S265N", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "R", "mutation": "S265R", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 262, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S265S", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.004765, "ferret_sera_escape": -0.01864, "mature_H5_site": 262, "mouse_sera_escape": -0.04802, "mutant": "T", "mutation": "S265T", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": -0.05784, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "V", "mutation": "S265V", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "W", "mutation": "S265W", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S265Y", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1485, "ferret_sera_escape": -0.09588, "mature_H5_site": 263, "mouse_sera_escape": 0.1406, "mutant": "A", "mutation": "T266A", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": 0.1355, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.704, "ferret_sera_escape": -0.08942, "mature_H5_site": 263, "mouse_sera_escape": 0.1003, "mutant": "D", "mutation": "T266D", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": 0.2438, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.08722, "ferret_sera_escape": -0.154, "mature_H5_site": 263, "mouse_sera_escape": -0.02452, "mutant": "E", "mutation": "T266E", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": 0.02018, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.817, "ferret_sera_escape": -0.117, "mature_H5_site": 263, "mouse_sera_escape": 0.5276, "mutant": "G", "mutation": "T266G", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": 1.117, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.965, "ferret_sera_escape": null, "mature_H5_site": 263, "mouse_sera_escape": null, "mutant": "I", "mutation": "T266I", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.729, "ferret_sera_escape": null, "mature_H5_site": 263, "mouse_sera_escape": null, "mutant": "L", "mutation": "T266L", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.275, "ferret_sera_escape": null, "mature_H5_site": 263, "mouse_sera_escape": null, "mutant": "M", "mutation": "T266M", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.09486, "ferret_sera_escape": 0.1062, "mature_H5_site": 263, "mouse_sera_escape": -0.0005669, "mutant": "N", "mutation": "T266N", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": 0.04793, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 263, "mouse_sera_escape": null, "mutant": "R", "mutation": "T266R", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.989, "ferret_sera_escape": -0.1128, "mature_H5_site": 263, "mouse_sera_escape": 0.2256, "mutant": "S", "mutation": "T266S", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": 1.675, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 263, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T266T", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2074, "ferret_sera_escape": -0.2811, "mature_H5_site": 263, "mouse_sera_escape": -0.2288, "mutant": "V", "mutation": "T266V", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": -0.2479, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 263, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T266Y", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "A", "mutation": "I267A", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.235, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "C", "mutation": "I267C", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.516, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "E", "mutation": "I267E", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "G", "mutation": "I267G", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 264, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I267I", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.151, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "L", "mutation": "I267L", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.7231, "ferret_sera_escape": -0.1472, "mature_H5_site": 264, "mouse_sera_escape": -0.1038, "mutant": "M", "mutation": "I267M", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": -0.03202, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.219, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "N", "mutation": "I267N", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.787, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "P", "mutation": "I267P", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "R", "mutation": "I267R", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.265, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "S", "mutation": "I267S", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.305, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "T", "mutation": "I267T", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3549, "ferret_sera_escape": -0.1571, "mature_H5_site": 264, "mouse_sera_escape": 0.1085, "mutant": "V", "mutation": "I267V", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": 1.597, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0026, "ferret_sera_escape": -0.2024, "mature_H5_site": 264, "mouse_sera_escape": -0.08939, "mutant": "Y", "mutation": "I267Y", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": 0.883, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.715, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "A", "mutation": "M268A", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.739, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "C", "mutation": "M268C", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -6.024, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "D", "mutation": "M268D", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.671, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "E", "mutation": "M268E", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.9476, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "F", "mutation": "M268F", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -6.019, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "G", "mutation": "M268G", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.814, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "H", "mutation": "M268H", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.04886, "ferret_sera_escape": 0.08174, "mature_H5_site": 265, "mouse_sera_escape": 0.1201, "mutant": "I", "mutation": "M268I", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": 0.1481, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "K", "mutation": "M268K", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.6561, "ferret_sera_escape": 0.1577, "mature_H5_site": 265, "mouse_sera_escape": 0.09768, "mutant": "L", "mutation": "M268L", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": 0.3783, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 265, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M268M", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "N", "mutation": "M268N", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "P", "mutation": "M268P", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "R", "mutation": "M268R", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.888, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "T", "mutation": "M268T", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.809, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "W", "mutation": "M268W", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.97, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": -0.04414, "mutant": "Y", "mutation": "M268Y", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": -0.1465, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.06521, "ferret_sera_escape": -0.1155, "mature_H5_site": 266, "mouse_sera_escape": -0.03005, "mutant": "A", "mutation": "K269A", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 1.476, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.05252, "ferret_sera_escape": -0.1879, "mature_H5_site": 266, "mouse_sera_escape": -0.004454, "mutant": "E", "mutation": "K269E", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 1.579, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1037, "ferret_sera_escape": -0.2299, "mature_H5_site": 266, "mouse_sera_escape": -0.1134, "mutant": "F", "mutation": "K269F", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 0.863, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1979, "ferret_sera_escape": -0.1978, "mature_H5_site": 266, "mouse_sera_escape": -0.04479, "mutant": "G", "mutation": "K269G", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 0.5144, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7659, "ferret_sera_escape": null, "mature_H5_site": 266, "mouse_sera_escape": null, "mutant": "H", "mutation": "K269H", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0247, "cell_entry": -0.2601, "ferret_sera_escape": -0.02281, "mature_H5_site": 266, "mouse_sera_escape": 0.02381, "mutant": "I", "mutation": "K269I", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 2.055, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 266, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K269K", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3771, "ferret_sera_escape": null, "mature_H5_site": 266, "mouse_sera_escape": null, "mutant": "L", "mutation": "K269L", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05869, "ferret_sera_escape": -0.1596, "mature_H5_site": 266, "mouse_sera_escape": 0.06044, "mutant": "N", "mutation": "K269N", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 1.689, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3809, "ferret_sera_escape": -0.2953, "mature_H5_site": 266, "mouse_sera_escape": 0.0712, "mutant": "P", "mutation": "K269P", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": -0.09833, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.0735, "ferret_sera_escape": 0.02423, "mature_H5_site": 266, "mouse_sera_escape": 0.03181, "mutant": "Q", "mutation": "K269Q", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2058, "ferret_sera_escape": 0.07617, "mature_H5_site": 266, "mouse_sera_escape": -0.05208, "mutant": "R", "mutation": "K269R", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": -0.06978, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.548, "ferret_sera_escape": -0.1296, "mature_H5_site": 266, "mouse_sera_escape": -0.01991, "mutant": "S", "mutation": "K269S", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 0.8763, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2104, "ferret_sera_escape": -0.007491, "mature_H5_site": 266, "mouse_sera_escape": 0.1075, "mutant": "W", "mutation": "K269W", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 0.9908, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03421, "ferret_sera_escape": -0.1937, "mature_H5_site": 266, "mouse_sera_escape": -0.08209, "mutant": "Y", "mutation": "K269Y", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": -0.009141, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.163, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "A", "mutation": "D27A", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "C", "mutation": "D27C", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 17, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D27D", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3213, "ferret_sera_escape": -0.04761, "mature_H5_site": 17, "mouse_sera_escape": -0.08281, "mutant": "E", "mutation": "D27E", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": -0.05211, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "F", "mutation": "D27F", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.476, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "G", "mutation": "D27G", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7211, "ferret_sera_escape": -0.2459, "mature_H5_site": 17, "mouse_sera_escape": -0.1303, "mutant": "H", "mutation": "D27H", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": 0.1139, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.829, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "I", "mutation": "D27I", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "K", "mutation": "D27K", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.794, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "M", "mutation": "D27M", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.124, "ferret_sera_escape": -0.2566, "mature_H5_site": 17, "mouse_sera_escape": 0.06368, "mutant": "N", "mutation": "D27N", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": 0.3326, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "R", "mutation": "D27R", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.137, "ferret_sera_escape": -0.00492, "mature_H5_site": 17, "mouse_sera_escape": 0.1627, "mutant": "S", "mutation": "D27S", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": -0.02505, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.863, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "V", "mutation": "D27V", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "W", "mutation": "D27W", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D27Y", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.01864, "ferret_sera_escape": 0.02026, "mature_H5_site": 267, "mouse_sera_escape": 0.2078, "mutant": "A", "mutation": "S270A", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": 0.2899, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.03212, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "C", "mutation": "S270C", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.997, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "D", "mutation": "S270D", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.444, "ferret_sera_escape": -0.1633, "mature_H5_site": 267, "mouse_sera_escape": 0.3259, "mutant": "E", "mutation": "S270E", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": 0.3675, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.636, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "F", "mutation": "S270F", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8488, "ferret_sera_escape": -0.1488, "mature_H5_site": 267, "mouse_sera_escape": 0.2435, "mutant": "G", "mutation": "S270G", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": 0.2279, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.365, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "H", "mutation": "S270H", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.128, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "L", "mutation": "S270L", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2355, "ferret_sera_escape": -0.05635, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "M", "mutation": "S270M", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.827, "ferret_sera_escape": -0.1365, "mature_H5_site": 267, "mouse_sera_escape": 0.3303, "mutant": "N", "mutation": "S270N", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": 0.5994, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.244, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "P", "mutation": "S270P", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "R", "mutation": "S270R", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 267, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S270S", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.04222, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "T", "mutation": "S270T", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.998, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "W", "mutation": "S270W", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.09, "ferret_sera_escape": -0.4258, "mature_H5_site": 267, "mouse_sera_escape": -0.02105, "mutant": "Y", "mutation": "S270Y", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": -0.01774, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1557, "ferret_sera_escape": 0.007901, "mature_H5_site": 268, "mouse_sera_escape": 0.08481, "mutant": "C", "mutation": "G271C", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.0001654, "wildtype": "G"}, {"a26_usage": 0.1521, "cell_entry": -0.1137, "ferret_sera_escape": 0.03679, "mature_H5_site": 268, "mouse_sera_escape": 0.06421, "mutant": "D", "mutation": "G271D", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": -0.1425, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.01537, "ferret_sera_escape": -0.03559, "mature_H5_site": 268, "mouse_sera_escape": 0.1023, "mutant": "E", "mutation": "G271E", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.09551, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 268, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G271G", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4224, "ferret_sera_escape": -0.054, "mature_H5_site": 268, "mouse_sera_escape": 0.1655, "mutant": "H", "mutation": "G271H", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1898, "ferret_sera_escape": -0.07203, "mature_H5_site": 268, "mouse_sera_escape": 0.01507, "mutant": "I", "mutation": "G271I", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": -0.01489, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 268, "mouse_sera_escape": null, "mutant": "K", "mutation": "G271K", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": null, "wildtype": "G"}, {"a26_usage": 0.05401, "cell_entry": -0.07054, "ferret_sera_escape": 0.05085, "mature_H5_site": 268, "mouse_sera_escape": 0.2087, "mutant": "L", "mutation": "G271L", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.349, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.009605, "ferret_sera_escape": -0.1802, "mature_H5_site": 268, "mouse_sera_escape": 0.03843, "mutant": "M", "mutation": "G271M", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.105, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2581, "ferret_sera_escape": -0.04592, "mature_H5_site": 268, "mouse_sera_escape": 0.02322, "mutant": "N", "mutation": "G271N", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": -0.2279, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.03999, "ferret_sera_escape": -0.1406, "mature_H5_site": 268, "mouse_sera_escape": 0.04004, "mutant": "Q", "mutation": "G271Q", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.02278, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1469, "ferret_sera_escape": 0.0332, "mature_H5_site": 268, "mouse_sera_escape": 0.0978, "mutant": "R", "mutation": "G271R", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.1376, "wildtype": "G"}, {"a26_usage": 0.02778, "cell_entry": -0.02725, "ferret_sera_escape": 0.1186, "mature_H5_site": 268, "mouse_sera_escape": 0.1136, "mutant": "S", "mutation": "G271S", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": -0.00492, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0728, "ferret_sera_escape": 0.04292, "mature_H5_site": 268, "mouse_sera_escape": 0.07658, "mutant": "T", "mutation": "G271T", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.2334, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.07468, "ferret_sera_escape": -0.02198, "mature_H5_site": 268, "mouse_sera_escape": null, "mutant": "V", "mutation": "G271V", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8843, "ferret_sera_escape": -0.02638, "mature_H5_site": 268, "mouse_sera_escape": 0.03788, "mutant": "Y", "mutation": "G271Y", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.1104, "wildtype": "G"}, {"a26_usage": 0.1393, "cell_entry": -0.2633, "ferret_sera_escape": -0.05949, "mature_H5_site": 269, "mouse_sera_escape": 0.1077, "mutant": "A", "mutation": "V272A", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": -0.1205, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.08906, "ferret_sera_escape": 0.01119, "mature_H5_site": 269, "mouse_sera_escape": 0.08193, "mutant": "C", "mutation": "V272C", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": -0.08458, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3006, "ferret_sera_escape": 0.0987, "mature_H5_site": 269, "mouse_sera_escape": 0.3021, "mutant": "E", "mutation": "V272E", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": 0.4036, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.05965, "ferret_sera_escape": 0.01044, "mature_H5_site": 269, "mouse_sera_escape": -0.04419, "mutant": "L", "mutation": "V272L", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": 0.6907, "wildtype": "V"}, {"a26_usage": 0.3021, "cell_entry": -0.8292, "ferret_sera_escape": 0.07857, "mature_H5_site": 269, "mouse_sera_escape": 0.09085, "mutant": "M", "mutation": "V272M", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": 0.3187, "wildtype": "V"}, {"a26_usage": 0.3462, "cell_entry": -0.8411, "ferret_sera_escape": 0.1119, "mature_H5_site": 269, "mouse_sera_escape": 0.09782, "mutant": "N", "mutation": "V272N", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": 0.02924, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.227, "ferret_sera_escape": null, "mature_H5_site": 269, "mouse_sera_escape": null, "mutant": "P", "mutation": "V272P", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.07754, "ferret_sera_escape": -0.1082, "mature_H5_site": 269, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V272Q", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3126, "ferret_sera_escape": null, "mature_H5_site": 269, "mouse_sera_escape": null, "mutant": "R", "mutation": "V272R", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.01186, "ferret_sera_escape": 0.05093, "mature_H5_site": 269, "mouse_sera_escape": 0.1503, "mutant": "S", "mutation": "V272S", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": -0.1195, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2572, "ferret_sera_escape": -0.01784, "mature_H5_site": 269, "mouse_sera_escape": 0.08651, "mutant": "T", "mutation": "V272T", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": -0.1437, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 269, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V272V", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.896, "ferret_sera_escape": null, "mature_H5_site": 269, "mouse_sera_escape": null, "mutant": "W", "mutation": "V272W", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.205, "ferret_sera_escape": -0.1297, "mature_H5_site": 269, "mouse_sera_escape": 0.1203, "mutant": "Y", "mutation": "V272Y", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": 0.05758, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.04307, "ferret_sera_escape": -0.01675, "mature_H5_site": 270, "mouse_sera_escape": 0.06675, "mutant": "D", "mutation": "E273D", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": 0.03856, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 270, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E273E", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.008185, "ferret_sera_escape": 0.2729, "mature_H5_site": 270, "mouse_sera_escape": 0.1976, "mutant": "F", "mutation": "E273F", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.1247, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7489, "ferret_sera_escape": 0.09807, "mature_H5_site": 270, "mouse_sera_escape": null, "mutant": "G", "mutation": "E273G", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.003823, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.89, "ferret_sera_escape": 0.06296, "mature_H5_site": 270, "mouse_sera_escape": 0.09128, "mutant": "H", "mutation": "E273H", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.1138, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.09874, "ferret_sera_escape": 0.09984, "mature_H5_site": 270, "mouse_sera_escape": 0.2181, "mutant": "I", "mutation": "E273I", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.05892, "ferret_sera_escape": 0.159, "mature_H5_site": 270, "mouse_sera_escape": 0.1807, "mutant": "K", "mutation": "E273K", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.579, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07617, "ferret_sera_escape": -0.07928, "mature_H5_site": 270, "mouse_sera_escape": 0.1341, "mutant": "L", "mutation": "E273L", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.1249, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5956, "ferret_sera_escape": -0.01489, "mature_H5_site": 270, "mouse_sera_escape": 0.06254, "mutant": "N", "mutation": "E273N", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.04821, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.05613, "ferret_sera_escape": 0.05113, "mature_H5_site": 270, "mouse_sera_escape": 0.02606, "mutant": "P", "mutation": "E273P", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.06852, "wildtype": "E"}, {"a26_usage": 0.02691, "cell_entry": -0.1911, "ferret_sera_escape": null, "mature_H5_site": 270, "mouse_sera_escape": null, "mutant": "Q", "mutation": "E273Q", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4189, "ferret_sera_escape": 0.08283, "mature_H5_site": 270, "mouse_sera_escape": 0.1385, "mutant": "R", "mutation": "E273R", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.2215, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.264, "ferret_sera_escape": 0.07872, "mature_H5_site": 270, "mouse_sera_escape": 0.1337, "mutant": "S", "mutation": "E273S", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.02958, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07145, "ferret_sera_escape": 0.1031, "mature_H5_site": 270, "mouse_sera_escape": 0.1236, "mutant": "V", "mutation": "E273V", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.04884, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.213, "ferret_sera_escape": 0.1005, "mature_H5_site": 270, "mouse_sera_escape": 0.1506, "mutant": "W", "mutation": "E273W", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.2233, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1791, "ferret_sera_escape": -0.04212, "mature_H5_site": 270, "mouse_sera_escape": 0.1404, "mutant": "Y", "mutation": "E273Y", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.1853, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 271, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y274C", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.233, "ferret_sera_escape": null, "mature_H5_site": 271, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y274D", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6571, "ferret_sera_escape": null, "mature_H5_site": 271, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y274E", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1473, "ferret_sera_escape": -0.1678, "mature_H5_site": 271, "mouse_sera_escape": 0.03334, "mutant": "F", "mutation": "Y274F", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.2171, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.9315, "ferret_sera_escape": -0.06037, "mature_H5_site": 271, "mouse_sera_escape": 0.07831, "mutant": "H", "mutation": "Y274H", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.1531, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.004, "ferret_sera_escape": -0.2251, "mature_H5_site": 271, "mouse_sera_escape": 0.02939, "mutant": "I", "mutation": "Y274I", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7471, "ferret_sera_escape": -0.1415, "mature_H5_site": 271, "mouse_sera_escape": -0.09017, "mutant": "K", "mutation": "Y274K", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.1608, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.5867, "ferret_sera_escape": -0.06246, "mature_H5_site": 271, "mouse_sera_escape": 0.2086, "mutant": "L", "mutation": "Y274L", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.03466, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3086, "ferret_sera_escape": -0.2127, "mature_H5_site": 271, "mouse_sera_escape": -0.0169, "mutant": "M", "mutation": "Y274M", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.05645, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.674, "ferret_sera_escape": null, "mature_H5_site": 271, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y274N", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.9213, "ferret_sera_escape": -0.2864, "mature_H5_site": 271, "mouse_sera_escape": 0.1884, "mutant": "P", "mutation": "Y274P", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.5091, "ferret_sera_escape": -0.1276, "mature_H5_site": 271, "mouse_sera_escape": 0.08142, "mutant": "Q", "mutation": "Y274Q", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.03969, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3517, "ferret_sera_escape": -0.1047, "mature_H5_site": 271, "mouse_sera_escape": -0.06496, "mutant": "R", "mutation": "Y274R", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.1542, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.553, "ferret_sera_escape": null, "mature_H5_site": 271, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y274S", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.342, "ferret_sera_escape": -0.06022, "mature_H5_site": 271, "mouse_sera_escape": 0.1688, "mutant": "V", "mutation": "Y274V", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.1482, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.374, "ferret_sera_escape": -0.05142, "mature_H5_site": 271, "mouse_sera_escape": 0.1065, "mutant": "W", "mutation": "Y274W", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.1287, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 271, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y274Y", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3067, "ferret_sera_escape": 0.2261, "mature_H5_site": 272, "mouse_sera_escape": -0.01942, "mutant": "A", "mutation": "G275A", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.1921, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2103, "ferret_sera_escape": 0.1345, "mature_H5_site": 272, "mouse_sera_escape": 0.1888, "mutant": "C", "mutation": "G275C", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.3552, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1904, "ferret_sera_escape": -0.06979, "mature_H5_site": 272, "mouse_sera_escape": 0.04526, "mutant": "D", "mutation": "G275D", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.1064, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.00481, "ferret_sera_escape": 0.07898, "mature_H5_site": 272, "mouse_sera_escape": 0.08696, "mutant": "E", "mutation": "G275E", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.208, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.07922, "ferret_sera_escape": -0.0372, "mature_H5_site": 272, "mouse_sera_escape": -0.03573, "mutant": "F", "mutation": "G275F", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.2527, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 272, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G275G", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.05633, "ferret_sera_escape": 0.007223, "mature_H5_site": 272, "mouse_sera_escape": 0.09607, "mutant": "I", "mutation": "G275I", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.1721, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5344, "ferret_sera_escape": -0.1786, "mature_H5_site": 272, "mouse_sera_escape": 0.03781, "mutant": "L", "mutation": "G275L", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.2881, "wildtype": "G"}, {"a26_usage": 0.8435, "cell_entry": null, "ferret_sera_escape": -0.09921, "mature_H5_site": 272, "mouse_sera_escape": -0.03481, "mutant": "M", "mutation": "G275M", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.1821, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1075, "ferret_sera_escape": 0.02666, "mature_H5_site": 272, "mouse_sera_escape": 0.1796, "mutant": "N", "mutation": "G275N", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.2779, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3611, "ferret_sera_escape": 0.0508, "mature_H5_site": 272, "mouse_sera_escape": 0.08306, "mutant": "Q", "mutation": "G275Q", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.1939, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.05761, "ferret_sera_escape": -0.004873, "mature_H5_site": 272, "mouse_sera_escape": 0.04978, "mutant": "R", "mutation": "G275R", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.4089, "wildtype": "G"}, {"a26_usage": 0.129, "cell_entry": 0.04569, "ferret_sera_escape": -0.07198, "mature_H5_site": 272, "mouse_sera_escape": -0.08362, "mutant": "S", "mutation": "G275S", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.1898, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.356, "ferret_sera_escape": 0.02419, "mature_H5_site": 272, "mouse_sera_escape": -0.01981, "mutant": "T", "mutation": "G275T", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.2316, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7538, "ferret_sera_escape": -0.001287, "mature_H5_site": 272, "mouse_sera_escape": 0.07425, "mutant": "V", "mutation": "G275V", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.4038, "wildtype": "G"}, {"a26_usage": 0.1788, "cell_entry": -0.06164, "ferret_sera_escape": 0.07118, "mature_H5_site": 272, "mouse_sera_escape": 0.1524, "mutant": "Y", "mutation": "G275Y", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.2143, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.04673, "ferret_sera_escape": -0.0237, "mature_H5_site": 273, "mouse_sera_escape": -0.0707, "mutant": "A", "mutation": "H276A", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.0003186, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.639, "ferret_sera_escape": 0.05069, "mature_H5_site": 273, "mouse_sera_escape": -0.01411, "mutant": "C", "mutation": "H276C", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.1807, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.03909, "ferret_sera_escape": -0.2438, "mature_H5_site": 273, "mouse_sera_escape": 0.02956, "mutant": "D", "mutation": "H276D", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.004831, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0575, "ferret_sera_escape": 0.08248, "mature_H5_site": 273, "mouse_sera_escape": 0.08209, "mutant": "E", "mutation": "H276E", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": 0.04955, "wildtype": "H"}, {"a26_usage": 0.01294, "cell_entry": -0.2528, "ferret_sera_escape": 0.02124, "mature_H5_site": 273, "mouse_sera_escape": 0.05663, "mutant": "F", "mutation": "H276F", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": 0.08427, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1948, "ferret_sera_escape": 0.1025, "mature_H5_site": 273, "mouse_sera_escape": 0.1527, "mutant": "G", "mutation": "H276G", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.04804, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 273, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H276H", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1161, "ferret_sera_escape": 0.1067, "mature_H5_site": 273, "mouse_sera_escape": 0.07931, "mutant": "I", "mutation": "H276I", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.003913, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.03018, "ferret_sera_escape": 0.03347, "mature_H5_site": 273, "mouse_sera_escape": 0.03368, "mutant": "L", "mutation": "H276L", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.00786, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4396, "ferret_sera_escape": 0.09672, "mature_H5_site": 273, "mouse_sera_escape": 0.0305, "mutant": "M", "mutation": "H276M", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": null, "wildtype": "H"}, {"a26_usage": 0.004055, "cell_entry": 0.06345, "ferret_sera_escape": 0.1041, "mature_H5_site": 273, "mouse_sera_escape": 0.03018, "mutant": "N", "mutation": "H276N", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": 0.04685, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.09073, "ferret_sera_escape": 0.02695, "mature_H5_site": 273, "mouse_sera_escape": 0.1123, "mutant": "P", "mutation": "H276P", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.07781, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.05824, "ferret_sera_escape": 0.09006, "mature_H5_site": 273, "mouse_sera_escape": 0.03579, "mutant": "Q", "mutation": "H276Q", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.004703, "wildtype": "H"}, {"a26_usage": 0.09592, "cell_entry": -0.2119, "ferret_sera_escape": 0.03128, "mature_H5_site": 273, "mouse_sera_escape": 0.004824, "mutant": "R", "mutation": "H276R", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.00706, "wildtype": "H"}, {"a26_usage": 0.3178, "cell_entry": -0.01836, "ferret_sera_escape": 0.06423, "mature_H5_site": 273, "mouse_sera_escape": -0.01813, "mutant": "V", "mutation": "H276V", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": 0.004314, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.05123, "ferret_sera_escape": 0.183, "mature_H5_site": 273, "mouse_sera_escape": 0.04031, "mutant": "Y", "mutation": "H276Y", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.02631, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 274, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C277C", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.105, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "D", "mutation": "C277D", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "E", "mutation": "C277E", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "F", "mutation": "C277F", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.945, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "G", "mutation": "C277G", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.887, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "H", "mutation": "C277H", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "I", "mutation": "C277I", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "K", "mutation": "C277K", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.029, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "L", "mutation": "C277L", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.059, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "M", "mutation": "C277M", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.091, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "N", "mutation": "C277N", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "P", "mutation": "C277P", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C277Q", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.683, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "R", "mutation": "C277R", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.897, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "T", "mutation": "C277T", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "V", "mutation": "C277V", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.861, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "W", "mutation": "C277W", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C277Y", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.6703, "ferret_sera_escape": 0.03723, "mature_H5_site": 275, "mouse_sera_escape": 0.03367, "mutant": "A", "mutation": "N278A", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": 0.0613, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05209, "ferret_sera_escape": -0.04938, "mature_H5_site": 275, "mouse_sera_escape": 0.0549, "mutant": "C", "mutation": "N278C", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": null, "wildtype": "N"}, {"a26_usage": 0.02136, "cell_entry": -0.06275, "ferret_sera_escape": 0.01667, "mature_H5_site": 275, "mouse_sera_escape": 0.04618, "mutant": "D", "mutation": "N278D", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": 0.01978, "wildtype": "N"}, {"a26_usage": 0.003791, "cell_entry": -0.06308, "ferret_sera_escape": 0.02454, "mature_H5_site": 275, "mouse_sera_escape": 0.1046, "mutant": "E", "mutation": "N278E", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": -0.08861, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.03093, "ferret_sera_escape": -0.09605, "mature_H5_site": 275, "mouse_sera_escape": -0.04555, "mutant": "G", "mutation": "N278G", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": -0.06749, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07623, "ferret_sera_escape": null, "mature_H5_site": 275, "mouse_sera_escape": null, "mutant": "H", "mutation": "N278H", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.08326, "ferret_sera_escape": -0.07798, "mature_H5_site": 275, "mouse_sera_escape": 0.05913, "mutant": "I", "mutation": "N278I", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": -0.1164, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3997, "ferret_sera_escape": 0.04424, "mature_H5_site": 275, "mouse_sera_escape": 0.06751, "mutant": "K", "mutation": "N278K", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.117, "ferret_sera_escape": null, "mature_H5_site": 275, "mouse_sera_escape": null, "mutant": "L", "mutation": "N278L", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 275, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N278N", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.2, "ferret_sera_escape": -0.4398, "mature_H5_site": 275, "mouse_sera_escape": -0.0287, "mutant": "P", "mutation": "N278P", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": -0.2614, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04685, "ferret_sera_escape": -0.1211, "mature_H5_site": 275, "mouse_sera_escape": 0.01027, "mutant": "Q", "mutation": "N278Q", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": -0.05117, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.28, "ferret_sera_escape": null, "mature_H5_site": 275, "mouse_sera_escape": null, "mutant": "R", "mutation": "N278R", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": 0.06451, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.06859, "ferret_sera_escape": 0.01815, "mature_H5_site": 275, "mouse_sera_escape": -0.02269, "mutant": "V", "mutation": "N278V", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": -0.206, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1673, "ferret_sera_escape": -0.04927, "mature_H5_site": 275, "mouse_sera_escape": 0.03777, "mutant": "W", "mutation": "N278W", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": 0.01606, "wildtype": "N"}, {"a26_usage": 0.5753, "cell_entry": 0.02635, "ferret_sera_escape": null, "mature_H5_site": 275, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N278Y", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": -0.1064, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.04979, "ferret_sera_escape": -0.1855, "mature_H5_site": 276, "mouse_sera_escape": -0.0147, "mutant": "A", "mutation": "T279A", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": 0.3921, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "D", "mutation": "T279D", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.6106, "ferret_sera_escape": -0.3421, "mature_H5_site": 276, "mouse_sera_escape": -0.1182, "mutant": "E", "mutation": "T279E", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": -0.2691, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7477, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "F", "mutation": "T279F", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.607, "ferret_sera_escape": -0.04797, "mature_H5_site": 276, "mouse_sera_escape": 0.2028, "mutant": "G", "mutation": "T279G", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": 0.5787, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3263, "ferret_sera_escape": -0.08865, "mature_H5_site": 276, "mouse_sera_escape": -0.01454, "mutant": "H", "mutation": "T279H", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.076, "ferret_sera_escape": -0.4149, "mature_H5_site": 276, "mouse_sera_escape": -0.1102, "mutant": "I", "mutation": "T279I", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": -0.1804, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.309, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "K", "mutation": "T279K", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.208, "ferret_sera_escape": -0.01019, "mature_H5_site": 276, "mouse_sera_escape": 0.03875, "mutant": "L", "mutation": "T279L", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": -0.2033, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1254, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "M", "mutation": "T279M", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.536, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "N", "mutation": "T279N", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.964, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "P", "mutation": "T279P", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.149, "ferret_sera_escape": 0.2241, "mature_H5_site": 276, "mouse_sera_escape": 0.1271, "mutant": "Q", "mutation": "T279Q", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": -0.2481, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.256, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "R", "mutation": "T279R", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.3247, "cell_entry": -0.1961, "ferret_sera_escape": -0.02985, "mature_H5_site": 276, "mouse_sera_escape": 0.104, "mutant": "S", "mutation": "T279S", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": 0.5185, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 276, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T279T", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.494, "ferret_sera_escape": 0.03353, "mature_H5_site": 276, "mouse_sera_escape": -0.0119, "mutant": "V", "mutation": "T279V", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": 0.5448, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "W", "mutation": "T279W", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2367, "ferret_sera_escape": -0.1101, "mature_H5_site": 276, "mouse_sera_escape": 0.06911, "mutant": "Y", "mutation": "T279Y", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": -0.05642, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.081, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "A", "mutation": "T28A", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.056, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "D", "mutation": "T28D", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.159, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "E", "mutation": "T28E", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.952, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "G", "mutation": "T28G", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "H", "mutation": "T28H", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -6.058, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "I", "mutation": "T28I", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.172, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "L", "mutation": "T28L", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "M", "mutation": "T28M", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "N", "mutation": "T28N", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.35, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T28Q", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "R", "mutation": "T28R", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.918, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "S", "mutation": "T28S", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 18, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T28T", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "V", "mutation": "T28V", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "W", "mutation": "T28W", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2911, "ferret_sera_escape": -0.02672, "mature_H5_site": 277, "mouse_sera_escape": 0.0735, "mutant": "A", "mutation": "K280A", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.07781, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4976, "ferret_sera_escape": 0.08109, "mature_H5_site": 277, "mouse_sera_escape": 0.04654, "mutant": "D", "mutation": "K280D", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.2803, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1043, "ferret_sera_escape": -0.1165, "mature_H5_site": 277, "mouse_sera_escape": -0.09801, "mutant": "E", "mutation": "K280E", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.957, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1471, "ferret_sera_escape": 0.02984, "mature_H5_site": 277, "mouse_sera_escape": 0.06815, "mutant": "F", "mutation": "K280F", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.2949, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.329, "ferret_sera_escape": null, "mature_H5_site": 277, "mouse_sera_escape": null, "mutant": "G", "mutation": "K280G", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2482, "ferret_sera_escape": 0.1476, "mature_H5_site": 277, "mouse_sera_escape": -0.1055, "mutant": "H", "mutation": "K280H", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.2088, "wildtype": "K"}, {"a26_usage": 0.4376, "cell_entry": -0.04782, "ferret_sera_escape": -0.1488, "mature_H5_site": 277, "mouse_sera_escape": -0.1339, "mutant": "I", "mutation": "K280I", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.1719, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 277, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K280K", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1948, "ferret_sera_escape": -0.2223, "mature_H5_site": 277, "mouse_sera_escape": -0.038, "mutant": "M", "mutation": "K280M", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.1558, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03372, "ferret_sera_escape": 0.07396, "mature_H5_site": 277, "mouse_sera_escape": -0.001291, "mutant": "N", "mutation": "K280N", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.3328, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 277, "mouse_sera_escape": null, "mutant": "P", "mutation": "K280P", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3246, "ferret_sera_escape": -0.036, "mature_H5_site": 277, "mouse_sera_escape": 0.03633, "mutant": "R", "mutation": "K280R", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": 0.1622, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.008765, "ferret_sera_escape": -0.2168, "mature_H5_site": 277, "mouse_sera_escape": -0.05076, "mutant": "S", "mutation": "K280S", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.2159, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.239, "ferret_sera_escape": -0.1969, "mature_H5_site": 277, "mouse_sera_escape": null, "mutant": "T", "mutation": "K280T", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": null, "wildtype": "K"}, {"a26_usage": 0.2644, "cell_entry": 0.07706, "ferret_sera_escape": -0.01675, "mature_H5_site": 277, "mouse_sera_escape": -0.04124, "mutant": "V", "mutation": "K280V", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.336, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1321, "ferret_sera_escape": 0.05216, "mature_H5_site": 277, "mouse_sera_escape": 0.1124, "mutant": "W", "mutation": "K280W", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.2677, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "A", "mutation": "C281A", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 278, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C281C", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "D", "mutation": "C281D", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "E", "mutation": "C281E", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.692, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "F", "mutation": "C281F", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "G", "mutation": "C281G", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "H", "mutation": "C281H", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "I", "mutation": "C281I", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "K", "mutation": "C281K", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "M", "mutation": "C281M", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "N", "mutation": "C281N", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "P", "mutation": "C281P", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.632, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C281Q", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "S", "mutation": "C281S", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.786, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "T", "mutation": "C281T", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.299, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "V", "mutation": "C281V", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "W", "mutation": "C281W", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.731, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C281Y", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.711, "ferret_sera_escape": -0.08184, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "A", "mutation": "Q282A", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.01, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "C", "mutation": "Q282C", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "D", "mutation": "Q282D", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "E", "mutation": "Q282E", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "F", "mutation": "Q282F", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.838, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "G", "mutation": "Q282G", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "H", "mutation": "Q282H", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "I", "mutation": "Q282I", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "K", "mutation": "Q282K", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "L", "mutation": "Q282L", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "N", "mutation": "Q282N", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q282P", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 279, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q282Q", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "R", "mutation": "Q282R", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.654, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "S", "mutation": "Q282S", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.691, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "T", "mutation": "Q282T", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.761, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "V", "mutation": "Q282V", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "W", "mutation": "Q282W", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.873, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "Y", "mutation": "Q282Y", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.7026, "ferret_sera_escape": 0.08027, "mature_H5_site": 280, "mouse_sera_escape": 0.08478, "mutant": "A", "mutation": "T283A", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": 1.31, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.281, "ferret_sera_escape": 0.03785, "mature_H5_site": 280, "mouse_sera_escape": 0.05719, "mutant": "C", "mutation": "T283C", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": 0.06446, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.72, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "D", "mutation": "T283D", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -6.007, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "E", "mutation": "T283E", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "F", "mutation": "T283F", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.595, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "G", "mutation": "T283G", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "I", "mutation": "T283I", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "K", "mutation": "T283K", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.871, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "L", "mutation": "T283L", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "N", "mutation": "T283N", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "P", "mutation": "T283P", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T283Q", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.997, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "R", "mutation": "T283R", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.00089, "ferret_sera_escape": -0.03912, "mature_H5_site": 280, "mouse_sera_escape": 0.04799, "mutant": "S", "mutation": "T283S", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": 0.2691, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 280, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T283T", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "W", "mutation": "T283W", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.769, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T283Y", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.361, "ferret_sera_escape": -0.2317, "mature_H5_site": 281, "mouse_sera_escape": -0.01105, "mutant": "C", "mutation": "P284C", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.275, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.187, "ferret_sera_escape": -0.09688, "mature_H5_site": 281, "mouse_sera_escape": -0.05137, "mutant": "E", "mutation": "P284E", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.09062, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.564, "ferret_sera_escape": null, "mature_H5_site": 281, "mouse_sera_escape": null, "mutant": "F", "mutation": "P284F", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.044, "ferret_sera_escape": -0.3871, "mature_H5_site": 281, "mouse_sera_escape": -0.1486, "mutant": "G", "mutation": "P284G", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.925, "ferret_sera_escape": null, "mature_H5_site": 281, "mouse_sera_escape": null, "mutant": "H", "mutation": "P284H", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.278, "ferret_sera_escape": -0.07369, "mature_H5_site": 281, "mouse_sera_escape": 0.007541, "mutant": "I", "mutation": "P284I", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.07686, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.218, "ferret_sera_escape": -0.247, "mature_H5_site": 281, "mouse_sera_escape": 0.0447, "mutant": "K", "mutation": "P284K", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.0127, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.144, "ferret_sera_escape": -0.2048, "mature_H5_site": 281, "mouse_sera_escape": 0.02513, "mutant": "L", "mutation": "P284L", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.2265, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.03431, "ferret_sera_escape": null, "mature_H5_site": 281, "mouse_sera_escape": null, "mutant": "M", "mutation": "P284M", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.138, "ferret_sera_escape": -0.1696, "mature_H5_site": 281, "mouse_sera_escape": 0.02392, "mutant": "N", "mutation": "P284N", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.1878, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 281, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P284P", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3004, "ferret_sera_escape": -0.01239, "mature_H5_site": 281, "mouse_sera_escape": 0.02441, "mutant": "Q", "mutation": "P284Q", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.3203, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.617, "ferret_sera_escape": null, "mature_H5_site": 281, "mouse_sera_escape": null, "mutant": "R", "mutation": "P284R", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.8283, "ferret_sera_escape": -0.1357, "mature_H5_site": 281, "mouse_sera_escape": 0.004321, "mutant": "S", "mutation": "P284S", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.136, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.564, "ferret_sera_escape": 0.01739, "mature_H5_site": 281, "mouse_sera_escape": 0.1632, "mutant": "T", "mutation": "P284T", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.9163, "ferret_sera_escape": null, "mature_H5_site": 281, "mouse_sera_escape": null, "mutant": "V", "mutation": "P284V", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.185, "ferret_sera_escape": -0.1377, "mature_H5_site": 281, "mouse_sera_escape": 0.03857, "mutant": "W", "mutation": "P284W", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.2216, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.066, "ferret_sera_escape": null, "mature_H5_site": 281, "mouse_sera_escape": null, "mutant": "Y", "mutation": "P284Y", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.04041, "ferret_sera_escape": 0.1049, "mature_H5_site": 282, "mouse_sera_escape": 0.05688, "mutant": "D", "mutation": "V285D", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.07515, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.134, "ferret_sera_escape": -0.04315, "mature_H5_site": 282, "mouse_sera_escape": 0.1699, "mutant": "E", "mutation": "V285E", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.2222, "wildtype": "V"}, {"a26_usage": 0.1619, "cell_entry": 0.04734, "ferret_sera_escape": 0.02198, "mature_H5_site": 282, "mouse_sera_escape": -0.1538, "mutant": "F", "mutation": "V285F", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.09773, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.849, "ferret_sera_escape": null, "mature_H5_site": 282, "mouse_sera_escape": null, "mutant": "G", "mutation": "V285G", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4318, "ferret_sera_escape": -0.01397, "mature_H5_site": 282, "mouse_sera_escape": -0.02244, "mutant": "H", "mutation": "V285H", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.2805, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5692, "ferret_sera_escape": 0.06895, "mature_H5_site": 282, "mouse_sera_escape": 0.06946, "mutant": "K", "mutation": "V285K", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.2427, "wildtype": "V"}, {"a26_usage": 0.1949, "cell_entry": 0.05529, "ferret_sera_escape": -0.03714, "mature_H5_site": 282, "mouse_sera_escape": -0.001371, "mutant": "L", "mutation": "V285L", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": 0.07216, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.02511, "ferret_sera_escape": 0.04114, "mature_H5_site": 282, "mouse_sera_escape": 0.01273, "mutant": "M", "mutation": "V285M", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.3497, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.03936, "ferret_sera_escape": 0.1164, "mature_H5_site": 282, "mouse_sera_escape": 0.06024, "mutant": "R", "mutation": "V285R", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.3218, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.141, "ferret_sera_escape": -0.002717, "mature_H5_site": 282, "mouse_sera_escape": 0.0113, "mutant": "T", "mutation": "V285T", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.2205, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 282, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V285V", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1219, "ferret_sera_escape": -0.07078, "mature_H5_site": 282, "mouse_sera_escape": -0.2958, "mutant": "Y", "mutation": "V285Y", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.3088, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.723, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "A", "mutation": "G286A", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.988, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "C", "mutation": "G286C", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.693, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "D", "mutation": "G286D", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.875, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "E", "mutation": "G286E", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.53, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "F", "mutation": "G286F", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 283, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G286G", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "H", "mutation": "G286H", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "I", "mutation": "G286I", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.645, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "K", "mutation": "G286K", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.112, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "L", "mutation": "G286L", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.897, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "M", "mutation": "G286M", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "N", "mutation": "G286N", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.454, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "P", "mutation": "G286P", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G286Q", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.878, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "R", "mutation": "G286R", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.566, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "S", "mutation": "G286S", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "T", "mutation": "G286T", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "V", "mutation": "G286V", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "W", "mutation": "G286W", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.89, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G286Y", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 284, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A287A", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.212, "ferret_sera_escape": -0.08981, "mature_H5_site": 284, "mouse_sera_escape": -0.03762, "mutant": "C", "mutation": "A287C", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": -0.2597, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.336, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "D", "mutation": "A287D", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.703, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "E", "mutation": "A287E", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.993, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "F", "mutation": "A287F", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.5327, "cell_entry": -0.03492, "ferret_sera_escape": -0.2037, "mature_H5_site": 284, "mouse_sera_escape": 0.1083, "mutant": "G", "mutation": "A287G", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": -0.1851, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "H", "mutation": "A287H", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.976, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "I", "mutation": "A287I", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.845, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "K", "mutation": "A287K", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.803, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "L", "mutation": "A287L", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.854, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "M", "mutation": "A287M", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "N", "mutation": "A287N", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "P", "mutation": "A287P", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A287Q", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.788, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "R", "mutation": "A287R", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3706, "ferret_sera_escape": -0.04319, "mature_H5_site": 284, "mouse_sera_escape": -0.01286, "mutant": "S", "mutation": "A287S", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": -0.1533, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.235, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "T", "mutation": "A287T", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "V", "mutation": "A287V", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.72, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "W", "mutation": "A287W", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.389, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A287Y", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "A", "mutation": "I288A", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.709, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "C", "mutation": "I288C", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "D", "mutation": "I288D", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.87, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "E", "mutation": "I288E", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1064, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "F", "mutation": "I288F", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "G", "mutation": "I288G", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.51, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "H", "mutation": "I288H", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 285, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I288I", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "K", "mutation": "I288K", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6565, "ferret_sera_escape": 0.07987, "mature_H5_site": 285, "mouse_sera_escape": 0.1212, "mutant": "L", "mutation": "I288L", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": 0.6465, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "N", "mutation": "I288N", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "P", "mutation": "I288P", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.891, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "R", "mutation": "I288R", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "S", "mutation": "I288S", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3081, "ferret_sera_escape": -0.3497, "mature_H5_site": 285, "mouse_sera_escape": 0.02295, "mutant": "T", "mutation": "I288T", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": 0.108, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.07299, "ferret_sera_escape": -0.09063, "mature_H5_site": 285, "mouse_sera_escape": -0.08816, "mutant": "V", "mutation": "I288V", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": 0.06439, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.008, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "W", "mutation": "I288W", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I288Y", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2427, "ferret_sera_escape": -0.3116, "mature_H5_site": 286, "mouse_sera_escape": 0.02149, "mutant": "C", "mutation": "N289C", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.9475, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02386, "ferret_sera_escape": -0.254, "mature_H5_site": 286, "mouse_sera_escape": -0.1347, "mutant": "D", "mutation": "N289D", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.3916, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6729, "ferret_sera_escape": -0.2093, "mature_H5_site": 286, "mouse_sera_escape": -0.01829, "mutant": "E", "mutation": "N289E", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.2215, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5121, "ferret_sera_escape": -0.3577, "mature_H5_site": 286, "mouse_sera_escape": -0.05332, "mutant": "F", "mutation": "N289F", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.04747, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.476, "ferret_sera_escape": -0.05161, "mature_H5_site": 286, "mouse_sera_escape": 0.1958, "mutant": "H", "mutation": "N289H", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.5718, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8409, "ferret_sera_escape": 0.01423, "mature_H5_site": 286, "mouse_sera_escape": 0.1062, "mutant": "K", "mutation": "N289K", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.4782, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2793, "ferret_sera_escape": -0.2268, "mature_H5_site": 286, "mouse_sera_escape": 0.1043, "mutant": "L", "mutation": "N289L", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 1.692, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3157, "ferret_sera_escape": -0.3014, "mature_H5_site": 286, "mouse_sera_escape": 0.06817, "mutant": "M", "mutation": "N289M", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 1.621, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 286, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N289N", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7309, "ferret_sera_escape": -0.4279, "mature_H5_site": 286, "mouse_sera_escape": 0.06188, "mutant": "P", "mutation": "N289P", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 1.692, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05491, "ferret_sera_escape": -0.127, "mature_H5_site": 286, "mouse_sera_escape": 0.08962, "mutant": "Q", "mutation": "N289Q", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 1.451, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5173, "ferret_sera_escape": -0.3925, "mature_H5_site": 286, "mouse_sera_escape": -0.0874, "mutant": "R", "mutation": "N289R", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.6255, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2118, "ferret_sera_escape": -0.265, "mature_H5_site": 286, "mouse_sera_escape": -0.08385, "mutant": "S", "mutation": "N289S", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.415, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7815, "ferret_sera_escape": -0.1617, "mature_H5_site": 286, "mouse_sera_escape": 0.034, "mutant": "T", "mutation": "N289T", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.606, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.64, "ferret_sera_escape": -0.369, "mature_H5_site": 286, "mouse_sera_escape": -0.1767, "mutant": "V", "mutation": "N289V", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.9676, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.375, "ferret_sera_escape": -0.2062, "mature_H5_site": 286, "mouse_sera_escape": -0.003586, "mutant": "Y", "mutation": "N289Y", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": -0.1141, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.885, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "D", "mutation": "I29D", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "E", "mutation": "I29E", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.212, "ferret_sera_escape": 0.1104, "mature_H5_site": 19, "mouse_sera_escape": 0.1014, "mutant": "F", "mutation": "I29F", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": 0.3511, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.755, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "G", "mutation": "I29G", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.48, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "H", "mutation": "I29H", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 19, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I29I", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "K", "mutation": "I29K", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.556, "ferret_sera_escape": -0.346, "mature_H5_site": 19, "mouse_sera_escape": 0.2848, "mutant": "M", "mutation": "I29M", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": 2.168, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.404, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "N", "mutation": "I29N", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.274, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "P", "mutation": "I29P", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.142, "ferret_sera_escape": 0.1979, "mature_H5_site": 19, "mouse_sera_escape": 0.1473, "mutant": "Q", "mutation": "I29Q", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": 1.485, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.906, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "R", "mutation": "I29R", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.179, "ferret_sera_escape": -0.247, "mature_H5_site": 19, "mouse_sera_escape": 0.3462, "mutant": "S", "mutation": "I29S", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": 1.945, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.814, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "T", "mutation": "I29T", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3447, "ferret_sera_escape": -0.185, "mature_H5_site": 19, "mouse_sera_escape": 0.1044, "mutant": "V", "mutation": "I29V", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": -0.2337, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.062, "ferret_sera_escape": 0.2559, "mature_H5_site": 19, "mouse_sera_escape": 0.3026, "mutant": "W", "mutation": "I29W", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": 1.932, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.589, "ferret_sera_escape": -0.1007, "mature_H5_site": 19, "mouse_sera_escape": 0.5179, "mutant": "Y", "mutation": "I29Y", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4521, "ferret_sera_escape": -0.1772, "mature_H5_site": 287, "mouse_sera_escape": 0.4033, "mutant": "A", "mutation": "S290A", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 1.99, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4881, "ferret_sera_escape": null, "mature_H5_site": 287, "mouse_sera_escape": null, "mutant": "C", "mutation": "S290C", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.79, "ferret_sera_escape": -0.1167, "mature_H5_site": 287, "mouse_sera_escape": 0.07669, "mutant": "D", "mutation": "S290D", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 0.9916, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8632, "ferret_sera_escape": -0.1507, "mature_H5_site": 287, "mouse_sera_escape": null, "mutant": "E", "mutation": "S290E", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4681, "ferret_sera_escape": -0.1415, "mature_H5_site": 287, "mouse_sera_escape": -0.01076, "mutant": "F", "mutation": "S290F", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": -0.0682, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4433, "ferret_sera_escape": -0.06069, "mature_H5_site": 287, "mouse_sera_escape": 0.1903, "mutant": "H", "mutation": "S290H", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 1.249, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8901, "ferret_sera_escape": -0.1132, "mature_H5_site": 287, "mouse_sera_escape": 0.06578, "mutant": "I", "mutation": "S290I", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 0.1345, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.301, "ferret_sera_escape": 0.1277, "mature_H5_site": 287, "mouse_sera_escape": 0.07307, "mutant": "K", "mutation": "S290K", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.141, "ferret_sera_escape": null, "mature_H5_site": 287, "mouse_sera_escape": null, "mutant": "L", "mutation": "S290L", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 0.3945, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.687, "ferret_sera_escape": -0.1385, "mature_H5_site": 287, "mouse_sera_escape": 0.05307, "mutant": "M", "mutation": "S290M", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 0.5899, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.02721, "ferret_sera_escape": 0.008297, "mature_H5_site": 287, "mouse_sera_escape": 0.13, "mutant": "N", "mutation": "S290N", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 1.486, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.9476, "ferret_sera_escape": -0.8405, "mature_H5_site": 287, "mouse_sera_escape": -0.1753, "mutant": "P", "mutation": "S290P", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 287, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S290S", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1778, "ferret_sera_escape": 0.05753, "mature_H5_site": 287, "mouse_sera_escape": 0.06155, "mutant": "T", "mutation": "S290T", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 0.3642, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4178, "ferret_sera_escape": -0.09534, "mature_H5_site": 287, "mouse_sera_escape": 0.01692, "mutant": "V", "mutation": "S290V", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 1.57, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.708, "ferret_sera_escape": -0.425, "mature_H5_site": 287, "mouse_sera_escape": 0.6464, "mutant": "W", "mutation": "S290W", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 1.29, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.034, "ferret_sera_escape": -0.1641, "mature_H5_site": 287, "mouse_sera_escape": 0.09876, "mutant": "Y", "mutation": "S290Y", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": -0.01852, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.512, "ferret_sera_escape": -0.4569, "mature_H5_site": 288, "mouse_sera_escape": -0.07216, "mutant": "D", "mutation": "S291D", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 0.4098, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.01435, "ferret_sera_escape": -0.3295, "mature_H5_site": 288, "mouse_sera_escape": -0.06144, "mutant": "E", "mutation": "S291E", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 0.6591, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3417, "ferret_sera_escape": -0.0554, "mature_H5_site": 288, "mouse_sera_escape": 0.1591, "mutant": "F", "mutation": "S291F", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.656, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1044, "ferret_sera_escape": -0.2727, "mature_H5_site": 288, "mouse_sera_escape": -0.0624, "mutant": "G", "mutation": "S291G", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.887, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3105, "ferret_sera_escape": -0.0951, "mature_H5_site": 288, "mouse_sera_escape": 0.05407, "mutant": "I", "mutation": "S291I", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.831, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.9585, "ferret_sera_escape": -0.1788, "mature_H5_site": 288, "mouse_sera_escape": 0.2094, "mutant": "K", "mutation": "S291K", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.669, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.112, "ferret_sera_escape": -0.3014, "mature_H5_site": 288, "mouse_sera_escape": -0.03817, "mutant": "L", "mutation": "S291L", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.159, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1897, "ferret_sera_escape": -0.2697, "mature_H5_site": 288, "mouse_sera_escape": 0.03793, "mutant": "N", "mutation": "S291N", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.462, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4923, "ferret_sera_escape": -0.1806, "mature_H5_site": 288, "mouse_sera_escape": 0.1206, "mutant": "P", "mutation": "S291P", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.746, "wildtype": "S"}, {"a26_usage": 0.2896, "cell_entry": -0.2441, "ferret_sera_escape": -0.319, "mature_H5_site": 288, "mouse_sera_escape": -0.03134, "mutant": "Q", "mutation": "S291Q", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.345, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.539, "ferret_sera_escape": null, "mature_H5_site": 288, "mouse_sera_escape": null, "mutant": "R", "mutation": "S291R", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.627, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 288, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S291S", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.04824, "ferret_sera_escape": -0.0715, "mature_H5_site": 288, "mouse_sera_escape": -0.07146, "mutant": "T", "mutation": "S291T", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": -0.0677, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.512, "ferret_sera_escape": -0.3226, "mature_H5_site": 288, "mouse_sera_escape": 0.05679, "mutant": "W", "mutation": "S291W", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.724, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.921, "ferret_sera_escape": -0.3863, "mature_H5_site": 288, "mouse_sera_escape": -0.05003, "mutant": "Y", "mutation": "S291Y", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.93, "wildtype": "S"}, {"a26_usage": 0.2752, "cell_entry": -0.07493, "ferret_sera_escape": 0.03373, "mature_H5_site": 289, "mouse_sera_escape": -0.05005, "mutant": "A", "mutation": "M292A", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.1716, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.104, "ferret_sera_escape": -0.1082, "mature_H5_site": 289, "mouse_sera_escape": 0.01239, "mutant": "C", "mutation": "M292C", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.04196, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.468, "ferret_sera_escape": -0.0087, "mature_H5_site": 289, "mouse_sera_escape": -0.2808, "mutant": "D", "mutation": "M292D", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.4671, "ferret_sera_escape": -0.09103, "mature_H5_site": 289, "mouse_sera_escape": -0.08058, "mutant": "E", "mutation": "M292E", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.2931, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.3826, "ferret_sera_escape": 0.1501, "mature_H5_site": 289, "mouse_sera_escape": 0.01976, "mutant": "F", "mutation": "M292F", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": 1.627, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.628, "ferret_sera_escape": -0.1605, "mature_H5_site": 289, "mouse_sera_escape": -0.0507, "mutant": "G", "mutation": "M292G", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": 0.4799, "wildtype": "M"}, {"a26_usage": 0.5847, "cell_entry": -0.9509, "ferret_sera_escape": -0.2025, "mature_H5_site": 289, "mouse_sera_escape": -0.09097, "mutant": "H", "mutation": "M292H", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.3246, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.5777, "ferret_sera_escape": -0.05682, "mature_H5_site": 289, "mouse_sera_escape": 0.08203, "mutant": "I", "mutation": "M292I", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.7501, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.5759, "ferret_sera_escape": 0.09828, "mature_H5_site": 289, "mouse_sera_escape": -0.02135, "mutant": "K", "mutation": "M292K", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.2898, "wildtype": "M"}, {"a26_usage": 0.1227, "cell_entry": -0.1714, "ferret_sera_escape": 0.1847, "mature_H5_site": 289, "mouse_sera_escape": 0.1741, "mutant": "L", "mutation": "M292L", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": 1.161, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 289, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M292M", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.1027, "cell_entry": -0.2639, "ferret_sera_escape": -0.03065, "mature_H5_site": 289, "mouse_sera_escape": 0.06161, "mutant": "N", "mutation": "M292N", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": 1.817, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.4293, "ferret_sera_escape": -0.1141, "mature_H5_site": 289, "mouse_sera_escape": -0.0863, "mutant": "Q", "mutation": "M292Q", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.201, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.195, "ferret_sera_escape": -0.1076, "mature_H5_site": 289, "mouse_sera_escape": -0.04571, "mutant": "R", "mutation": "M292R", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.2516, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.9998, "ferret_sera_escape": null, "mature_H5_site": 289, "mouse_sera_escape": null, "mutant": "T", "mutation": "M292T", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.03645, "ferret_sera_escape": 0.006273, "mature_H5_site": 289, "mouse_sera_escape": 0.06246, "mutant": "V", "mutation": "M292V", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.05052, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.593, "ferret_sera_escape": -0.2546, "mature_H5_site": 289, "mouse_sera_escape": 0.6581, "mutant": "W", "mutation": "M292W", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": 1.017, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.5862, "ferret_sera_escape": null, "mature_H5_site": 289, "mouse_sera_escape": null, "mutant": "Y", "mutation": "M292Y", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.9639, "ferret_sera_escape": 0.00997, "mature_H5_site": 290, "mouse_sera_escape": -0.108, "mutant": "A", "mutation": "P293A", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": -0.248, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.275, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "C", "mutation": "P293C", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "D", "mutation": "P293D", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.808, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "E", "mutation": "P293E", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "F", "mutation": "P293F", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.669, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "G", "mutation": "P293G", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "H", "mutation": "P293H", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.288, "ferret_sera_escape": -0.105, "mature_H5_site": 290, "mouse_sera_escape": 0.2322, "mutant": "I", "mutation": "P293I", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.587, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "K", "mutation": "P293K", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "L", "mutation": "P293L", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "N", "mutation": "P293N", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 290, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P293P", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P293Q", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "R", "mutation": "P293R", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.104, "ferret_sera_escape": -0.1009, "mature_H5_site": 290, "mouse_sera_escape": -0.04982, "mutant": "S", "mutation": "P293S", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": -0.2894, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "T", "mutation": "P293T", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.036, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "V", "mutation": "P293V", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.997, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "W", "mutation": "P293W", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.686, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "A", "mutation": "F294A", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.527, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "C", "mutation": "F294C", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "D", "mutation": "F294D", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "E", "mutation": "F294E", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 291, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F294F", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "G", "mutation": "F294G", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -4.228, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "H", "mutation": "F294H", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.756, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "I", "mutation": "F294I", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "K", "mutation": "F294K", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "L", "mutation": "F294L", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.223, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "M", "mutation": "F294M", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "N", "mutation": "F294N", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "P", "mutation": "F294P", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F294Q", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "R", "mutation": "F294R", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "S", "mutation": "F294S", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "T", "mutation": "F294T", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.56, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "V", "mutation": "F294V", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.006, "ferret_sera_escape": 0.03403, "mature_H5_site": 291, "mouse_sera_escape": -0.05495, "mutant": "W", "mutation": "F294W", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": 0.2094, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.904, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "A", "mutation": "H295A", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "D", "mutation": "H295D", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.033, "ferret_sera_escape": 0.032, "mature_H5_site": 292, "mouse_sera_escape": 0.0319, "mutant": "E", "mutation": "H295E", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": -0.2013, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.009, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "F", "mutation": "H295F", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "G", "mutation": "H295G", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 292, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H295H", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.704, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "I", "mutation": "H295I", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "K", "mutation": "H295K", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -6.05, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "L", "mutation": "H295L", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1798, "ferret_sera_escape": 0.00771, "mature_H5_site": 292, "mouse_sera_escape": 0.08517, "mutant": "M", "mutation": "H295M", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": 0.8931, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.243, "ferret_sera_escape": -0.2186, "mature_H5_site": 292, "mouse_sera_escape": -0.1426, "mutant": "N", "mutation": "H295N", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "P", "mutation": "H295P", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5552, "ferret_sera_escape": 0.04153, "mature_H5_site": 292, "mouse_sera_escape": 0.06, "mutant": "Q", "mutation": "H295Q", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": 0.8473, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "R", "mutation": "H295R", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.692, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "S", "mutation": "H295S", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "V", "mutation": "H295V", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "W", "mutation": "H295W", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "Y", "mutation": "H295Y", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.2204, "ferret_sera_escape": 0.04048, "mature_H5_site": 293, "mouse_sera_escape": 0.06466, "mutant": "C", "mutation": "N296C", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": 0.06613, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.787, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "D", "mutation": "N296D", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.178, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "E", "mutation": "N296E", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.482, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "F", "mutation": "N296F", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.482, "ferret_sera_escape": -0.237, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "G", "mutation": "N296G", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.011, "ferret_sera_escape": -0.2419, "mature_H5_site": 293, "mouse_sera_escape": 0.009677, "mutant": "H", "mutation": "N296H", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": 0.8781, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9063, "ferret_sera_escape": -0.1602, "mature_H5_site": 293, "mouse_sera_escape": 0.1787, "mutant": "K", "mutation": "N296K", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": 0.8286, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "L", "mutation": "N296L", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.267, "ferret_sera_escape": -0.3433, "mature_H5_site": 293, "mouse_sera_escape": -0.1083, "mutant": "M", "mutation": "N296M", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 293, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N296N", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "P", "mutation": "N296P", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2041, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "S", "mutation": "N296S", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.678, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "V", "mutation": "N296V", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "W", "mutation": "N296W", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.692, "ferret_sera_escape": 0.2293, "mature_H5_site": 294, "mouse_sera_escape": 0.214, "mutant": "A", "mutation": "I297A", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.356, "ferret_sera_escape": 0.01811, "mature_H5_site": 294, "mouse_sera_escape": 0.3164, "mutant": "C", "mutation": "I297C", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.545, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "D", "mutation": "I297D", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "E", "mutation": "I297E", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "F", "mutation": "I297F", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.046, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "G", "mutation": "I297G", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "H", "mutation": "I297H", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 294, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I297I", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "K", "mutation": "I297K", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.307, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "M", "mutation": "I297M", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.418, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "N", "mutation": "I297N", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "P", "mutation": "I297P", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.755, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I297Q", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "R", "mutation": "I297R", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "S", "mutation": "I297S", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5858, "ferret_sera_escape": 0.09975, "mature_H5_site": 294, "mouse_sera_escape": 0.1556, "mutant": "V", "mutation": "I297V", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": 1.038, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "W", "mutation": "I297W", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I297Y", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4859, "ferret_sera_escape": -0.08316, "mature_H5_site": 295, "mouse_sera_escape": 0.01797, "mutant": "A", "mutation": "H298A", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.1329, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1668, "ferret_sera_escape": -0.05349, "mature_H5_site": 295, "mouse_sera_escape": 0.1306, "mutant": "C", "mutation": "H298C", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": 0.0445, "wildtype": "H"}, {"a26_usage": 0.09162, "cell_entry": -0.3435, "ferret_sera_escape": null, "mature_H5_site": 295, "mouse_sera_escape": null, "mutant": "D", "mutation": "H298D", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.268, "ferret_sera_escape": -0.2734, "mature_H5_site": 295, "mouse_sera_escape": -0.04252, "mutant": "E", "mutation": "H298E", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.06522, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.212, "ferret_sera_escape": 0.02434, "mature_H5_site": 295, "mouse_sera_escape": 0.06479, "mutant": "F", "mutation": "H298F", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.242, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.829, "ferret_sera_escape": -0.1937, "mature_H5_site": 295, "mouse_sera_escape": 0.2928, "mutant": "G", "mutation": "H298G", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": 1.314, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 295, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H298H", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3204, "ferret_sera_escape": -0.07648, "mature_H5_site": 295, "mouse_sera_escape": -0.05537, "mutant": "I", "mutation": "H298I", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.1046, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 295, "mouse_sera_escape": null, "mutant": "K", "mutation": "H298K", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.464, "ferret_sera_escape": null, "mature_H5_site": 295, "mouse_sera_escape": null, "mutant": "L", "mutation": "H298L", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4391, "ferret_sera_escape": -0.06916, "mature_H5_site": 295, "mouse_sera_escape": -0.1563, "mutant": "M", "mutation": "H298M", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.08075, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.04058, "ferret_sera_escape": 0.08779, "mature_H5_site": 295, "mouse_sera_escape": 0.06207, "mutant": "N", "mutation": "H298N", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": 1.422, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.808, "ferret_sera_escape": null, "mature_H5_site": 295, "mouse_sera_escape": null, "mutant": "P", "mutation": "H298P", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.335, "ferret_sera_escape": null, "mature_H5_site": 295, "mouse_sera_escape": null, "mutant": "Q", "mutation": "H298Q", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.01038, "ferret_sera_escape": -0.06034, "mature_H5_site": 295, "mouse_sera_escape": 0.05529, "mutant": "S", "mutation": "H298S", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": 2.005, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.587, "ferret_sera_escape": null, "mature_H5_site": 295, "mouse_sera_escape": null, "mutant": "T", "mutation": "H298T", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5103, "ferret_sera_escape": -0.05852, "mature_H5_site": 295, "mouse_sera_escape": 0.05549, "mutant": "V", "mutation": "H298V", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.175, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.174, "ferret_sera_escape": 0.09348, "mature_H5_site": 295, "mouse_sera_escape": 0.06699, "mutant": "W", "mutation": "H298W", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.2662, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.371, "ferret_sera_escape": -0.1719, "mature_H5_site": 295, "mouse_sera_escape": 0.03531, "mutant": "Y", "mutation": "H298Y", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.69, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3082, "ferret_sera_escape": -0.01727, "mature_H5_site": 296, "mouse_sera_escape": 0.06702, "mutant": "A", "mutation": "P299A", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 0.8046, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.211, "ferret_sera_escape": null, "mature_H5_site": 296, "mouse_sera_escape": null, "mutant": "C", "mutation": "P299C", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.869, "ferret_sera_escape": null, "mature_H5_site": 296, "mouse_sera_escape": null, "mutant": "D", "mutation": "P299D", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 0.843, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.05282, "ferret_sera_escape": 0.05213, "mature_H5_site": 296, "mouse_sera_escape": 0.005645, "mutant": "E", "mutation": "P299E", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 0.6164, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5805, "ferret_sera_escape": 0.1922, "mature_H5_site": 296, "mouse_sera_escape": 0.1151, "mutant": "F", "mutation": "P299F", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": -0.1112, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.632, "ferret_sera_escape": null, "mature_H5_site": 296, "mouse_sera_escape": null, "mutant": "G", "mutation": "P299G", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.298, "ferret_sera_escape": 0.07482, "mature_H5_site": 296, "mouse_sera_escape": 0.03595, "mutant": "H", "mutation": "P299H", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 0.2025, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.895, "ferret_sera_escape": -0.5101, "mature_H5_site": 296, "mouse_sera_escape": null, "mutant": "I", "mutation": "P299I", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 1.071, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.6738, "ferret_sera_escape": 0.02725, "mature_H5_site": 296, "mouse_sera_escape": 0.05692, "mutant": "K", "mutation": "P299K", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": -0.2263, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.341, "ferret_sera_escape": -0.09982, "mature_H5_site": 296, "mouse_sera_escape": 0.3111, "mutant": "L", "mutation": "P299L", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 1.209, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1411, "ferret_sera_escape": -0.1128, "mature_H5_site": 296, "mouse_sera_escape": 0.09314, "mutant": "M", "mutation": "P299M", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 1.748, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.85, "ferret_sera_escape": 0.2721, "mature_H5_site": 296, "mouse_sera_escape": 0.3497, "mutant": "N", "mutation": "P299N", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 1.161, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 296, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P299P", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.006735, "ferret_sera_escape": 0.03192, "mature_H5_site": 296, "mouse_sera_escape": 0.2768, "mutant": "Q", "mutation": "P299Q", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 2.004, "wildtype": "P"}, {"a26_usage": 0.03544, "cell_entry": 0.02747, "ferret_sera_escape": -0.00777, "mature_H5_site": 296, "mouse_sera_escape": 0.07723, "mutant": "R", "mutation": "P299R", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": -0.1451, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3645, "ferret_sera_escape": -0.08346, "mature_H5_site": 296, "mouse_sera_escape": -0.004101, "mutant": "S", "mutation": "P299S", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 0.2178, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.923, "ferret_sera_escape": -0.1047, "mature_H5_site": 296, "mouse_sera_escape": 0.1181, "mutant": "T", "mutation": "P299T", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3982, "ferret_sera_escape": -0.1651, "mature_H5_site": 296, "mouse_sera_escape": 0.2796, "mutant": "V", "mutation": "P299V", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 1.512, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.009955, "ferret_sera_escape": -0.005387, "mature_H5_site": 296, "mouse_sera_escape": 0.06501, "mutant": "W", "mutation": "P299W", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": -0.08597, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.274, "ferret_sera_escape": -0.01951, "mature_H5_site": 296, "mouse_sera_escape": 0.03394, "mutant": "Y", "mutation": "P299Y", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": -0.226, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -8, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A3A", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.09102, "ferret_sera_escape": 0.05602, "mature_H5_site": -8, "mouse_sera_escape": 0.01006, "mutant": "C", "mutation": "A3C", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": -0.06029, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.952, "ferret_sera_escape": null, "mature_H5_site": -8, "mouse_sera_escape": null, "mutant": "D", "mutation": "A3D", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.523, "ferret_sera_escape": null, "mature_H5_site": -8, "mouse_sera_escape": null, "mutant": "E", "mutation": "A3E", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.04236, "ferret_sera_escape": -0.02124, "mature_H5_site": -8, "mouse_sera_escape": -0.08931, "mutant": "F", "mutation": "A3F", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": 0.01015, "wildtype": "A"}, {"a26_usage": 0.05199, "cell_entry": -0.115, "ferret_sera_escape": 0.1043, "mature_H5_site": -8, "mouse_sera_escape": -0.03008, "mutant": "G", "mutation": "A3G", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": -0.04024, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.638, "ferret_sera_escape": 0.123, "mature_H5_site": -8, "mouse_sera_escape": null, "mutant": "H", "mutation": "A3H", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1002, "ferret_sera_escape": -0.04215, "mature_H5_site": -8, "mouse_sera_escape": -0.02035, "mutant": "I", "mutation": "A3I", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": -0.04222, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.239, "ferret_sera_escape": null, "mature_H5_site": -8, "mouse_sera_escape": null, "mutant": "K", "mutation": "A3K", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.02632, "cell_entry": 0.01363, "ferret_sera_escape": 0.04169, "mature_H5_site": -8, "mouse_sera_escape": -0.04435, "mutant": "M", "mutation": "A3M", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": -0.007856, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1904, "ferret_sera_escape": null, "mature_H5_site": -8, "mouse_sera_escape": -0.2718, "mutant": "N", "mutation": "A3N", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.024, "ferret_sera_escape": -0.2432, "mature_H5_site": -8, "mouse_sera_escape": -0.1966, "mutant": "P", "mutation": "A3P", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": -0.1826, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": -8, "mouse_sera_escape": null, "mutant": "R", "mutation": "A3R", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.291, "ferret_sera_escape": null, "mature_H5_site": -8, "mouse_sera_escape": null, "mutant": "S", "mutation": "A3S", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.04197, "cell_entry": -0.1812, "ferret_sera_escape": 0.1271, "mature_H5_site": -8, "mouse_sera_escape": -0.001172, "mutant": "T", "mutation": "A3T", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": -0.008903, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2082, "ferret_sera_escape": 0.1009, "mature_H5_site": -8, "mouse_sera_escape": -0.1276, "mutant": "V", "mutation": "A3V", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1149, "ferret_sera_escape": 0.03544, "mature_H5_site": -8, "mouse_sera_escape": 0.007356, "mutant": "W", "mutation": "A3W", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": 0.05242, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.0315, "ferret_sera_escape": -0.04392, "mature_H5_site": -8, "mouse_sera_escape": -0.03145, "mutant": "Y", "mutation": "A3Y", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": -0.03384, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.53, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "A", "mutation": "M30A", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.017, "ferret_sera_escape": -0.05731, "mature_H5_site": 20, "mouse_sera_escape": 0.05386, "mutant": "C", "mutation": "M30C", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "D", "mutation": "M30D", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -6.007, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "E", "mutation": "M30E", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.582, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "F", "mutation": "M30F", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.71, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "G", "mutation": "M30G", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.86, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "H", "mutation": "M30H", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.3399, "cell_entry": -0.3339, "ferret_sera_escape": -0.03065, "mature_H5_site": 20, "mouse_sera_escape": 0.02768, "mutant": "I", "mutation": "M30I", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": 1.069, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.547, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": 0.09687, "mutant": "K", "mutation": "M30K", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.05798, "ferret_sera_escape": 0.01288, "mature_H5_site": 20, "mouse_sera_escape": 0.06532, "mutant": "L", "mutation": "M30L", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": 1.769, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 20, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M30M", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "P", "mutation": "M30P", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.603, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "Q", "mutation": "M30Q", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.01377, "ferret_sera_escape": -0.0774, "mature_H5_site": 20, "mouse_sera_escape": -0.06243, "mutant": "R", "mutation": "M30R", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": 0.2733, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.258, "ferret_sera_escape": -0.07364, "mature_H5_site": 20, "mouse_sera_escape": -0.01392, "mutant": "T", "mutation": "M30T", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": -0.1525, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.516, "ferret_sera_escape": -0.1263, "mature_H5_site": 20, "mouse_sera_escape": 0.02833, "mutant": "V", "mutation": "M30V", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": -0.07247, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.746, "ferret_sera_escape": -0.1262, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "W", "mutation": "M30W", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.02554, "ferret_sera_escape": -0.07232, "mature_H5_site": 20, "mouse_sera_escape": 0.09304, "mutant": "Y", "mutation": "M30Y", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": 1.4, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.2448, "ferret_sera_escape": -0.1122, "mature_H5_site": 297, "mouse_sera_escape": -0.04789, "mutant": "C", "mutation": "L300C", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.2636, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.7, "ferret_sera_escape": -0.151, "mature_H5_site": 297, "mouse_sera_escape": null, "mutant": "D", "mutation": "L300D", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.8145, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.087, "ferret_sera_escape": -0.1872, "mature_H5_site": 297, "mouse_sera_escape": 0.3159, "mutant": "E", "mutation": "L300E", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.7471, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.11, "ferret_sera_escape": 0.01205, "mature_H5_site": 297, "mouse_sera_escape": 0.2456, "mutant": "F", "mutation": "L300F", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.05542, "ferret_sera_escape": -0.3168, "mature_H5_site": 297, "mouse_sera_escape": 0.002527, "mutant": "G", "mutation": "L300G", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5598, "ferret_sera_escape": -0.0665, "mature_H5_site": 297, "mouse_sera_escape": -0.07754, "mutant": "H", "mutation": "L300H", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": -0.2875, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.324, "ferret_sera_escape": 0.04262, "mature_H5_site": 297, "mouse_sera_escape": 0.06093, "mutant": "I", "mutation": "L300I", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.2358, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6996, "ferret_sera_escape": null, "mature_H5_site": 297, "mouse_sera_escape": null, "mutant": "K", "mutation": "L300K", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 297, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L300L", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3473, "ferret_sera_escape": 0.08441, "mature_H5_site": 297, "mouse_sera_escape": 0.03404, "mutant": "M", "mutation": "L300M", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.01447, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06018, "ferret_sera_escape": 0.00878, "mature_H5_site": 297, "mouse_sera_escape": -0.01437, "mutant": "N", "mutation": "L300N", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": -0.2299, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.824, "ferret_sera_escape": null, "mature_H5_site": 297, "mouse_sera_escape": null, "mutant": "P", "mutation": "L300P", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.00903, "ferret_sera_escape": null, "mature_H5_site": 297, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L300Q", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5619, "ferret_sera_escape": 0.01152, "mature_H5_site": 297, "mouse_sera_escape": 0.1278, "mutant": "R", "mutation": "L300R", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2622, "ferret_sera_escape": -0.1623, "mature_H5_site": 297, "mouse_sera_escape": -0.001735, "mutant": "S", "mutation": "L300S", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.0909, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6339, "ferret_sera_escape": 0.1049, "mature_H5_site": 297, "mouse_sera_escape": 0.1896, "mutant": "T", "mutation": "L300T", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.5398, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9497, "ferret_sera_escape": null, "mature_H5_site": 297, "mouse_sera_escape": null, "mutant": "V", "mutation": "L300V", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.679, "ferret_sera_escape": -0.1296, "mature_H5_site": 297, "mouse_sera_escape": null, "mutant": "W", "mutation": "L300W", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 1.038, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.8056, "ferret_sera_escape": 0.2096, "mature_H5_site": 297, "mouse_sera_escape": 0.1057, "mutant": "Y", "mutation": "L300Y", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.4549, "wildtype": "L"}, {"a26_usage": 0.8482, "cell_entry": -1.639, "ferret_sera_escape": null, "mature_H5_site": 298, "mouse_sera_escape": null, "mutant": "A", "mutation": "T301A", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.6266, "ferret_sera_escape": null, "mature_H5_site": 298, "mouse_sera_escape": null, "mutant": "C", "mutation": "T301C", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": -0.06737, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.8886, "ferret_sera_escape": null, "mature_H5_site": 298, "mouse_sera_escape": null, "mutant": "E", "mutation": "T301E", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2488, "ferret_sera_escape": 0.09106, "mature_H5_site": 298, "mouse_sera_escape": 0.01404, "mutant": "G", "mutation": "T301G", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.264, "ferret_sera_escape": 0.1525, "mature_H5_site": 298, "mouse_sera_escape": null, "mutant": "H", "mutation": "T301H", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.795, "ferret_sera_escape": -0.1399, "mature_H5_site": 298, "mouse_sera_escape": 0.2562, "mutant": "I", "mutation": "T301I", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": 1.611, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.0938, "ferret_sera_escape": 0.2155, "mature_H5_site": 298, "mouse_sera_escape": 0.2235, "mutant": "L", "mutation": "T301L", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": 0.3446, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5401, "ferret_sera_escape": 0.002423, "mature_H5_site": 298, "mouse_sera_escape": 0.03477, "mutant": "M", "mutation": "T301M", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": -0.08384, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2265, "ferret_sera_escape": -0.0537, "mature_H5_site": 298, "mouse_sera_escape": 0.03904, "mutant": "N", "mutation": "T301N", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": -0.2728, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.01294, "ferret_sera_escape": -0.09327, "mature_H5_site": 298, "mouse_sera_escape": -0.06196, "mutant": "Q", "mutation": "T301Q", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": -0.152, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.787, "ferret_sera_escape": null, "mature_H5_site": 298, "mouse_sera_escape": null, "mutant": "R", "mutation": "T301R", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 298, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T301T", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3608, "ferret_sera_escape": 0.02167, "mature_H5_site": 298, "mouse_sera_escape": 0.03234, "mutant": "V", "mutation": "T301V", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": 0.9135, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3641, "ferret_sera_escape": 0.1982, "mature_H5_site": 298, "mouse_sera_escape": 0.1925, "mutant": "W", "mutation": "T301W", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": 0.7569, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1224, "ferret_sera_escape": 0.2993, "mature_H5_site": 298, "mouse_sera_escape": 0.1383, "mutant": "Y", "mutation": "T301Y", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": 0.1093, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.574, "ferret_sera_escape": -0.102, "mature_H5_site": 299, "mouse_sera_escape": 0.0927, "mutant": "A", "mutation": "I302A", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": -0.4837, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "D", "mutation": "I302D", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.339, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "G", "mutation": "I302G", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "H", "mutation": "I302H", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 299, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I302I", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.884, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "K", "mutation": "I302K", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.05906, "ferret_sera_escape": -0.1131, "mature_H5_site": 299, "mouse_sera_escape": 0.1913, "mutant": "L", "mutation": "I302L", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": 0.5065, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.7368, "ferret_sera_escape": -0.02313, "mature_H5_site": 299, "mouse_sera_escape": -0.09599, "mutant": "M", "mutation": "I302M", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": -0.232, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "N", "mutation": "I302N", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I302Q", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.822, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "R", "mutation": "I302R", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.85, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "S", "mutation": "I302S", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.171, "ferret_sera_escape": 0.213, "mature_H5_site": 299, "mouse_sera_escape": 0.1199, "mutant": "T", "mutation": "I302T", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": -0.1797, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.432, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "W", "mutation": "I302W", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I302Y", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.584, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "A", "mutation": "G303A", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "C", "mutation": "G303C", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "D", "mutation": "G303D", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "F", "mutation": "G303F", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 300, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G303G", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.826, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "H", "mutation": "G303H", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "I", "mutation": "G303I", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.069, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "K", "mutation": "G303K", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.004, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "L", "mutation": "G303L", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "M", "mutation": "G303M", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "N", "mutation": "G303N", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "P", "mutation": "G303P", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G303Q", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "R", "mutation": "G303R", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "S", "mutation": "G303S", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.026, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "V", "mutation": "G303V", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "W", "mutation": "G303W", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G303Y", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4521, "ferret_sera_escape": -0.1288, "mature_H5_site": 301, "mouse_sera_escape": null, "mutant": "A", "mutation": "E304A", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.0295, "ferret_sera_escape": null, "mature_H5_site": 301, "mouse_sera_escape": null, "mutant": "C", "mutation": "E304C", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.556, "ferret_sera_escape": -0.03166, "mature_H5_site": 301, "mouse_sera_escape": -0.03509, "mutant": "D", "mutation": "E304D", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": -0.2694, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 301, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E304E", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.296, "ferret_sera_escape": -0.2596, "mature_H5_site": 301, "mouse_sera_escape": 0.4468, "mutant": "F", "mutation": "E304F", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": 1.828, "wildtype": "E"}, {"a26_usage": 0.473, "cell_entry": -0.7993, "ferret_sera_escape": 0.0176, "mature_H5_site": 301, "mouse_sera_escape": 0.05528, "mutant": "G", "mutation": "E304G", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": -0.1977, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7413, "ferret_sera_escape": -0.02141, "mature_H5_site": 301, "mouse_sera_escape": 0.1133, "mutant": "H", "mutation": "E304H", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": 0.5496, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.001, "ferret_sera_escape": 0.02007, "mature_H5_site": 301, "mouse_sera_escape": 0.1223, "mutant": "I", "mutation": "E304I", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": 0.5649, "wildtype": "E"}, {"a26_usage": 0.0858, "cell_entry": -0.052, "ferret_sera_escape": 0.01642, "mature_H5_site": 301, "mouse_sera_escape": -0.01441, "mutant": "K", "mutation": "E304K", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": -0.1366, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7932, "ferret_sera_escape": null, "mature_H5_site": 301, "mouse_sera_escape": null, "mutant": "L", "mutation": "E304L", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2023, "ferret_sera_escape": -0.04407, "mature_H5_site": 301, "mouse_sera_escape": -0.01882, "mutant": "M", "mutation": "E304M", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": 0.175, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.968, "ferret_sera_escape": null, "mature_H5_site": 301, "mouse_sera_escape": null, "mutant": "P", "mutation": "E304P", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": null, "wildtype": "E"}, {"a26_usage": 0.4645, "cell_entry": -0.965, "ferret_sera_escape": -0.03268, "mature_H5_site": 301, "mouse_sera_escape": 0.201, "mutant": "R", "mutation": "E304R", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": 0.03259, "wildtype": "E"}, {"a26_usage": 0.1685, "cell_entry": -0.08097, "ferret_sera_escape": -0.1145, "mature_H5_site": 301, "mouse_sera_escape": -0.02002, "mutant": "S", "mutation": "E304S", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": -0.2115, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7158, "ferret_sera_escape": null, "mature_H5_site": 301, "mouse_sera_escape": null, "mutant": "T", "mutation": "E304T", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06391, "ferret_sera_escape": -0.08525, "mature_H5_site": 301, "mouse_sera_escape": -0.03307, "mutant": "V", "mutation": "E304V", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": 0.5197, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.094, "ferret_sera_escape": -0.07135, "mature_H5_site": 301, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E304Y", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "A", "mutation": "C305A", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 302, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C305C", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "D", "mutation": "C305D", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.898, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "E", "mutation": "C305E", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "F", "mutation": "C305F", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.249, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "G", "mutation": "C305G", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.988, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "H", "mutation": "C305H", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "K", "mutation": "C305K", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "L", "mutation": "C305L", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "N", "mutation": "C305N", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C305Q", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "R", "mutation": "C305R", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "S", "mutation": "C305S", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "T", "mutation": "C305T", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "V", "mutation": "C305V", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "W", "mutation": "C305W", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C305Y", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.1275, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "A", "mutation": "P306A", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "C", "mutation": "P306C", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.136, "ferret_sera_escape": -0.08925, "mature_H5_site": 303, "mouse_sera_escape": 0.1051, "mutant": "G", "mutation": "P306G", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": 1.03, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "H", "mutation": "P306H", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "I", "mutation": "P306I", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "K", "mutation": "P306K", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.377, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "L", "mutation": "P306L", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.627, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "M", "mutation": "P306M", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "N", "mutation": "P306N", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 303, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P306P", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P306Q", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.7, "ferret_sera_escape": -0.7422, "mature_H5_site": 303, "mouse_sera_escape": -0.1354, "mutant": "S", "mutation": "P306S", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "T", "mutation": "P306T", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "V", "mutation": "P306V", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.012, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "W", "mutation": "P306W", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.838, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "A", "mutation": "K307A", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.274, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "D", "mutation": "K307D", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.445, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "E", "mutation": "K307E", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.323, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "F", "mutation": "K307F", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "G", "mutation": "K307G", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.498, "ferret_sera_escape": 0.05923, "mature_H5_site": 304, "mouse_sera_escape": 0.0958, "mutant": "H", "mutation": "K307H", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": -0.09664, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.333, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "I", "mutation": "K307I", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 304, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K307K", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "L", "mutation": "K307L", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.267, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "M", "mutation": "K307M", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "N", "mutation": "K307N", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "P", "mutation": "K307P", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.316, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "Q", "mutation": "K307Q", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.319, "ferret_sera_escape": 0.1917, "mature_H5_site": 304, "mouse_sera_escape": 0.4336, "mutant": "R", "mutation": "K307R", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.821, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "S", "mutation": "K307S", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.845, "ferret_sera_escape": -0.03604, "mature_H5_site": 304, "mouse_sera_escape": 0.1009, "mutant": "T", "mutation": "K307T", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.49, "ferret_sera_escape": -0.09891, "mature_H5_site": 304, "mouse_sera_escape": -0.1293, "mutant": "V", "mutation": "K307V", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": -0.2164, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "W", "mutation": "K307W", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y308C", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y308D", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y308E", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y308G", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y308I", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y308L", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y308N", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.785, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y308Q", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y308R", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y308T", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y308V", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.585, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y308W", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 305, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y308Y", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.094, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "A", "mutation": "V309A", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.817, "ferret_sera_escape": -0.1326, "mature_H5_site": 306, "mouse_sera_escape": 0.07488, "mutant": "C", "mutation": "V309C", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": -0.2218, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "D", "mutation": "V309D", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "E", "mutation": "V309E", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "F", "mutation": "V309F", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.007, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "G", "mutation": "V309G", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "H", "mutation": "V309H", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.689, "ferret_sera_escape": -0.1444, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "I", "mutation": "V309I", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.897, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "K", "mutation": "V309K", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.686, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "L", "mutation": "V309L", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "M", "mutation": "V309M", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V309Q", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.843, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "R", "mutation": "V309R", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.359, "ferret_sera_escape": 0.04204, "mature_H5_site": 306, "mouse_sera_escape": -0.04377, "mutant": "T", "mutation": "V309T", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": -0.2404, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 306, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V309V", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "W", "mutation": "V309W", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.587, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V309Y", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2336, "ferret_sera_escape": 0.04488, "mature_H5_site": 21, "mouse_sera_escape": 0.09133, "mutant": "A", "mutation": "E31A", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.2127, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7526, "ferret_sera_escape": 0.02106, "mature_H5_site": 21, "mouse_sera_escape": 0.01635, "mutant": "C", "mutation": "E31C", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.1909, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.013, "ferret_sera_escape": -0.1675, "mature_H5_site": 21, "mouse_sera_escape": -0.07694, "mutant": "D", "mutation": "E31D", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": -0.2157, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 21, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E31E", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.279, "ferret_sera_escape": null, "mature_H5_site": 21, "mouse_sera_escape": null, "mutant": "F", "mutation": "E31F", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.533, "ferret_sera_escape": -0.07743, "mature_H5_site": 21, "mouse_sera_escape": 0.08016, "mutant": "G", "mutation": "E31G", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.2024, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.007725, "ferret_sera_escape": 0.1091, "mature_H5_site": 21, "mouse_sera_escape": -0.06131, "mutant": "H", "mutation": "E31H", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.216, "ferret_sera_escape": null, "mature_H5_site": 21, "mouse_sera_escape": null, "mutant": "I", "mutation": "E31I", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2315, "ferret_sera_escape": 0.01244, "mature_H5_site": 21, "mouse_sera_escape": 0.07375, "mutant": "K", "mutation": "E31K", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.6966, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.094, "ferret_sera_escape": -0.1522, "mature_H5_site": 21, "mouse_sera_escape": 0.04931, "mutant": "L", "mutation": "E31L", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": -0.09359, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.06906, "ferret_sera_escape": null, "mature_H5_site": 21, "mouse_sera_escape": null, "mutant": "M", "mutation": "E31M", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3974, "ferret_sera_escape": -0.1918, "mature_H5_site": 21, "mouse_sera_escape": 0.1181, "mutant": "N", "mutation": "E31N", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": -0.03575, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6577, "ferret_sera_escape": null, "mature_H5_site": 21, "mouse_sera_escape": null, "mutant": "P", "mutation": "E31P", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.07231, "ferret_sera_escape": 0.04775, "mature_H5_site": 21, "mouse_sera_escape": 0.02129, "mutant": "Q", "mutation": "E31Q", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.5868, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6499, "ferret_sera_escape": -0.07666, "mature_H5_site": 21, "mouse_sera_escape": 0.0497, "mutant": "R", "mutation": "E31R", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 1.009, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2634, "ferret_sera_escape": -0.0305, "mature_H5_site": 21, "mouse_sera_escape": 0.04438, "mutant": "S", "mutation": "E31S", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 1.315, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5679, "ferret_sera_escape": 0.02685, "mature_H5_site": 21, "mouse_sera_escape": -0.01402, "mutant": "V", "mutation": "E31V", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.2562, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.377, "ferret_sera_escape": 0.1159, "mature_H5_site": 21, "mouse_sera_escape": 0.2443, "mutant": "W", "mutation": "E31W", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.2738, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.498, "ferret_sera_escape": 0.0443, "mature_H5_site": 21, "mouse_sera_escape": 0.05803, "mutant": "Y", "mutation": "E31Y", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": -0.0005835, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.163, "ferret_sera_escape": null, "mature_H5_site": 307, "mouse_sera_escape": null, "mutant": "A", "mutation": "K310A", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.508, "ferret_sera_escape": -0.2333, "mature_H5_site": 307, "mouse_sera_escape": 0.2745, "mutant": "C", "mutation": "K310C", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 1.339, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.008, "ferret_sera_escape": -0.3682, "mature_H5_site": 307, "mouse_sera_escape": 0.1686, "mutant": "D", "mutation": "K310D", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 0.8751, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.348, "ferret_sera_escape": -0.1226, "mature_H5_site": 307, "mouse_sera_escape": 0.1048, "mutant": "E", "mutation": "K310E", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 0.7171, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.009, "ferret_sera_escape": -0.1037, "mature_H5_site": 307, "mouse_sera_escape": 0.2614, "mutant": "F", "mutation": "K310F", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 1.137, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.408, "ferret_sera_escape": -0.1626, "mature_H5_site": 307, "mouse_sera_escape": -0.08859, "mutant": "G", "mutation": "K310G", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 1.804, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3301, "ferret_sera_escape": -0.008974, "mature_H5_site": 307, "mouse_sera_escape": 0.05169, "mutant": "H", "mutation": "K310H", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 0.8882, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 307, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K310K", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.196, "ferret_sera_escape": null, "mature_H5_site": 307, "mouse_sera_escape": null, "mutant": "M", "mutation": "K310M", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7102, "ferret_sera_escape": -0.07383, "mature_H5_site": 307, "mouse_sera_escape": 0.09006, "mutant": "N", "mutation": "K310N", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 1.707, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.914, "ferret_sera_escape": null, "mature_H5_site": 307, "mouse_sera_escape": null, "mutant": "P", "mutation": "K310P", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7229, "ferret_sera_escape": -0.001727, "mature_H5_site": 307, "mouse_sera_escape": 0.1969, "mutant": "Q", "mutation": "K310Q", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 1.542, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2898, "ferret_sera_escape": -0.02549, "mature_H5_site": 307, "mouse_sera_escape": 0.03226, "mutant": "R", "mutation": "K310R", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 0.6794, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.9836, "ferret_sera_escape": -0.07804, "mature_H5_site": 307, "mouse_sera_escape": null, "mutant": "S", "mutation": "K310S", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 0.9266, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.69, "ferret_sera_escape": null, "mature_H5_site": 307, "mouse_sera_escape": null, "mutant": "V", "mutation": "K310V", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.931, "ferret_sera_escape": null, "mature_H5_site": 307, "mouse_sera_escape": null, "mutant": "W", "mutation": "K310W", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03533, "ferret_sera_escape": -0.1011, "mature_H5_site": 308, "mouse_sera_escape": -0.07366, "mutant": "A", "mutation": "S311A", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": 0.149, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.05619, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "C", "mutation": "S311C", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "D", "mutation": "S311D", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "F", "mutation": "S311F", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.629, "ferret_sera_escape": -0.08104, "mature_H5_site": 308, "mouse_sera_escape": 0.01017, "mutant": "G", "mutation": "S311G", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": 0.1301, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3355, "ferret_sera_escape": -0.07642, "mature_H5_site": 308, "mouse_sera_escape": 0.0375, "mutant": "I", "mutation": "S311I", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": -0.04661, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "K", "mutation": "S311K", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6445, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "L", "mutation": "S311L", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.985, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": 0.02298, "mutant": "M", "mutation": "S311M", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.167, "ferret_sera_escape": -0.05085, "mature_H5_site": 308, "mouse_sera_escape": 0.05174, "mutant": "N", "mutation": "S311N", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": 0.1765, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "P", "mutation": "S311P", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.777, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "R", "mutation": "S311R", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 308, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S311S", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1297, "ferret_sera_escape": -0.05758, "mature_H5_site": 308, "mouse_sera_escape": 0.03364, "mutant": "T", "mutation": "S311T", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": -0.2401, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1737, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "V", "mutation": "S311V", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S311Y", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4553, "ferret_sera_escape": 0.01017, "mature_H5_site": 309, "mouse_sera_escape": 0.02464, "mutant": "A", "mutation": "N312A", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.1042, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07363, "ferret_sera_escape": 0.01935, "mature_H5_site": 309, "mouse_sera_escape": 0.02883, "mutant": "C", "mutation": "N312C", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.07742, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.03951, "ferret_sera_escape": -0.1365, "mature_H5_site": 309, "mouse_sera_escape": -0.0001547, "mutant": "D", "mutation": "N312D", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": 0.1691, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.09834, "ferret_sera_escape": 0.01523, "mature_H5_site": 309, "mouse_sera_escape": -0.02071, "mutant": "E", "mutation": "N312E", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": 0.1491, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.004592, "ferret_sera_escape": -0.04139, "mature_H5_site": 309, "mouse_sera_escape": 0.004021, "mutant": "F", "mutation": "N312F", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.09747, "wildtype": "N"}, {"a26_usage": 0.07573, "cell_entry": -0.01632, "ferret_sera_escape": -0.04675, "mature_H5_site": 309, "mouse_sera_escape": 0.01963, "mutant": "H", "mutation": "N312H", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.09312, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1411, "ferret_sera_escape": -0.03112, "mature_H5_site": 309, "mouse_sera_escape": -0.01409, "mutant": "I", "mutation": "N312I", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.05172, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.116, "ferret_sera_escape": 0.1264, "mature_H5_site": 309, "mouse_sera_escape": 0.07565, "mutant": "K", "mutation": "N312K", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3112, "ferret_sera_escape": -0.04619, "mature_H5_site": 309, "mouse_sera_escape": -0.04928, "mutant": "L", "mutation": "N312L", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.1558, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2403, "ferret_sera_escape": 0.1637, "mature_H5_site": 309, "mouse_sera_escape": -0.04495, "mutant": "M", "mutation": "N312M", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.07116, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 309, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N312N", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3483, "ferret_sera_escape": -0.1424, "mature_H5_site": 309, "mouse_sera_escape": -0.02319, "mutant": "P", "mutation": "N312P", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.1758, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.03838, "ferret_sera_escape": 0.117, "mature_H5_site": 309, "mouse_sera_escape": 0.06004, "mutant": "R", "mutation": "N312R", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.1425, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.06465, "ferret_sera_escape": -0.05422, "mature_H5_site": 309, "mouse_sera_escape": 0.004641, "mutant": "S", "mutation": "N312S", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.01558, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.00225, "ferret_sera_escape": 0.01824, "mature_H5_site": 309, "mouse_sera_escape": 0.02196, "mutant": "T", "mutation": "N312T", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": 0.1184, "wildtype": "N"}, {"a26_usage": 0.2638, "cell_entry": -0.05144, "ferret_sera_escape": 0.04071, "mature_H5_site": 309, "mouse_sera_escape": -0.04032, "mutant": "V", "mutation": "N312V", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.04081, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04393, "ferret_sera_escape": -0.03603, "mature_H5_site": 310, "mouse_sera_escape": -0.05499, "mutant": "A", "mutation": "K313A", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.01465, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5039, "ferret_sera_escape": 0.04006, "mature_H5_site": 310, "mouse_sera_escape": 0.004066, "mutant": "C", "mutation": "K313C", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.09299, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7088, "ferret_sera_escape": 0.161, "mature_H5_site": 310, "mouse_sera_escape": -0.01477, "mutant": "E", "mutation": "K313E", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.2162, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2309, "ferret_sera_escape": -0.04088, "mature_H5_site": 310, "mouse_sera_escape": -0.08302, "mutant": "F", "mutation": "K313F", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.1402, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8627, "ferret_sera_escape": -0.03016, "mature_H5_site": 310, "mouse_sera_escape": -0.0711, "mutant": "G", "mutation": "K313G", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": 0.4163, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.544, "ferret_sera_escape": null, "mature_H5_site": 310, "mouse_sera_escape": null, "mutant": "I", "mutation": "K313I", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 310, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K313K", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.121, "ferret_sera_escape": -0.1464, "mature_H5_site": 310, "mouse_sera_escape": null, "mutant": "L", "mutation": "K313L", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5647, "ferret_sera_escape": 0.04259, "mature_H5_site": 310, "mouse_sera_escape": null, "mutant": "M", "mutation": "K313M", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3387, "ferret_sera_escape": -0.1522, "mature_H5_site": 310, "mouse_sera_escape": -0.08061, "mutant": "N", "mutation": "K313N", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.2754, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.808, "ferret_sera_escape": null, "mature_H5_site": 310, "mouse_sera_escape": null, "mutant": "P", "mutation": "K313P", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6448, "ferret_sera_escape": 0.02885, "mature_H5_site": 310, "mouse_sera_escape": 0.07202, "mutant": "Q", "mutation": "K313Q", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.07274, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2134, "ferret_sera_escape": 0.05527, "mature_H5_site": 310, "mouse_sera_escape": 0.04203, "mutant": "R", "mutation": "K313R", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.03834, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.788, "ferret_sera_escape": 0.4327, "mature_H5_site": 310, "mouse_sera_escape": 0.02673, "mutant": "S", "mutation": "K313S", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.069, "ferret_sera_escape": -0.3476, "mature_H5_site": 310, "mouse_sera_escape": -0.1104, "mutant": "V", "mutation": "K313V", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.281, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.006, "ferret_sera_escape": 0.05184, "mature_H5_site": 310, "mouse_sera_escape": -0.04403, "mutant": "W", "mutation": "K313W", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.2285, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8353, "ferret_sera_escape": -0.0154, "mature_H5_site": 310, "mouse_sera_escape": -0.0233, "mutant": "Y", "mutation": "K313Y", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.1658, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "A", "mutation": "L314A", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.46, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "C", "mutation": "L314C", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.952, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "E", "mutation": "L314E", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.817, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "F", "mutation": "L314F", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.605, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "G", "mutation": "L314G", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "H", "mutation": "L314H", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.427, "ferret_sera_escape": -0.1216, "mature_H5_site": 311, "mouse_sera_escape": 0.09845, "mutant": "I", "mutation": "L314I", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": -0.05791, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "K", "mutation": "L314K", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 311, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L314L", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.601, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "M", "mutation": "L314M", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.013, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "N", "mutation": "L314N", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "P", "mutation": "L314P", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L314Q", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "R", "mutation": "L314R", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "S", "mutation": "L314S", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.01, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "T", "mutation": "L314T", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "V", "mutation": "L314V", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "W", "mutation": "L314W", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L314Y", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06373, "ferret_sera_escape": -0.001787, "mature_H5_site": 312, "mouse_sera_escape": 0.0879, "mutant": "A", "mutation": "V315A", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 1.567, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2216, "ferret_sera_escape": 0.09106, "mature_H5_site": 312, "mouse_sera_escape": 0.06085, "mutant": "C", "mutation": "V315C", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 0.9585, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 312, "mouse_sera_escape": null, "mutant": "D", "mutation": "V315D", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.498, "ferret_sera_escape": null, "mature_H5_site": 312, "mouse_sera_escape": null, "mutant": "E", "mutation": "V315E", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.312, "ferret_sera_escape": 0.01326, "mature_H5_site": 312, "mouse_sera_escape": 0.03647, "mutant": "F", "mutation": "V315F", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 0.1866, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.472, "ferret_sera_escape": -0.1711, "mature_H5_site": 312, "mouse_sera_escape": 0.6132, "mutant": "G", "mutation": "V315G", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6726, "ferret_sera_escape": null, "mature_H5_site": 312, "mouse_sera_escape": null, "mutant": "H", "mutation": "V315H", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.008165, "ferret_sera_escape": 0.08123, "mature_H5_site": 312, "mouse_sera_escape": 0.03878, "mutant": "I", "mutation": "V315I", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": -0.1062, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5023, "ferret_sera_escape": -0.05331, "mature_H5_site": 312, "mouse_sera_escape": 0.01706, "mutant": "K", "mutation": "V315K", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 0.776, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3479, "ferret_sera_escape": -0.07235, "mature_H5_site": 312, "mouse_sera_escape": -0.009075, "mutant": "L", "mutation": "V315L", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 1.331, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.003785, "ferret_sera_escape": -0.06027, "mature_H5_site": 312, "mouse_sera_escape": 0.04433, "mutant": "M", "mutation": "V315M", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 1.075, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5965, "ferret_sera_escape": -0.1175, "mature_H5_site": 312, "mouse_sera_escape": 0.3837, "mutant": "N", "mutation": "V315N", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 1.716, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4559, "ferret_sera_escape": 0.08028, "mature_H5_site": 312, "mouse_sera_escape": 0.006346, "mutant": "Q", "mutation": "V315Q", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 0.4132, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.05245, "ferret_sera_escape": -0.002237, "mature_H5_site": 312, "mouse_sera_escape": 0.1699, "mutant": "R", "mutation": "V315R", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 1.862, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.829, "ferret_sera_escape": 0.019, "mature_H5_site": 312, "mouse_sera_escape": null, "mutant": "S", "mutation": "V315S", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 312, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V315V", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.159, "ferret_sera_escape": -0.04555, "mature_H5_site": 312, "mouse_sera_escape": 0.06865, "mutant": "Y", "mutation": "V315Y", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 1.117, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "A", "mutation": "L316A", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "E", "mutation": "L316E", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "G", "mutation": "L316G", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "H", "mutation": "L316H", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 313, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L316L", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.05, "ferret_sera_escape": -0.06383, "mature_H5_site": 313, "mouse_sera_escape": -0.02965, "mutant": "M", "mutation": "L316M", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": 1.243, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "N", "mutation": "L316N", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.84, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "P", "mutation": "L316P", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L316Q", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.574, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "R", "mutation": "L316R", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "S", "mutation": "L316S", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.8901, "ferret_sera_escape": -0.01726, "mature_H5_site": 313, "mouse_sera_escape": 0.01028, "mutant": "V", "mutation": "L316V", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": -0.192, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L316Y", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 314, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A317A", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5285, "ferret_sera_escape": -0.03775, "mature_H5_site": 314, "mouse_sera_escape": 0.2172, "mutant": "C", "mutation": "A317C", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": -0.1234, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "D", "mutation": "A317D", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.215, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "E", "mutation": "A317E", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "F", "mutation": "A317F", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5958, "ferret_sera_escape": -0.1028, "mature_H5_site": 314, "mouse_sera_escape": 0.03157, "mutant": "G", "mutation": "A317G", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": -0.2257, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "K", "mutation": "A317K", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.823, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "L", "mutation": "A317L", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.295, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "M", "mutation": "A317M", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "N", "mutation": "A317N", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "P", "mutation": "A317P", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A317Q", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "R", "mutation": "A317R", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.859, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "S", "mutation": "A317S", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.553, "ferret_sera_escape": -0.1325, "mature_H5_site": 314, "mouse_sera_escape": 0.06712, "mutant": "T", "mutation": "A317T", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": 0.1442, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4158, "ferret_sera_escape": -0.01401, "mature_H5_site": 314, "mouse_sera_escape": 0.02533, "mutant": "V", "mutation": "A317V", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": 0.8405, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "W", "mutation": "A317W", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A317Y", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.618, "ferret_sera_escape": null, "mature_H5_site": 315, "mouse_sera_escape": null, "mutant": "A", "mutation": "T318A", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 315, "mouse_sera_escape": null, "mutant": "D", "mutation": "T318D", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.136, "ferret_sera_escape": null, "mature_H5_site": 315, "mouse_sera_escape": -0.05116, "mutant": "E", "mutation": "T318E", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 315, "mouse_sera_escape": null, "mutant": "G", "mutation": "T318G", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.169, "ferret_sera_escape": null, "mature_H5_site": 315, "mouse_sera_escape": null, "mutant": "H", "mutation": "T318H", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.735, "ferret_sera_escape": 0.05462, "mature_H5_site": 315, "mouse_sera_escape": 0.08398, "mutant": "I", "mutation": "T318I", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": 0.5462, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1585, "ferret_sera_escape": 0.05474, "mature_H5_site": 315, "mouse_sera_escape": -0.06191, "mutant": "K", "mutation": "T318K", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2562, "ferret_sera_escape": -0.0149, "mature_H5_site": 315, "mouse_sera_escape": 0.06052, "mutant": "L", "mutation": "T318L", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": 0.02013, "wildtype": "T"}, {"a26_usage": 0.1335, "cell_entry": -0.3248, "ferret_sera_escape": 0.04584, "mature_H5_site": 315, "mouse_sera_escape": 0.08109, "mutant": "M", "mutation": "T318M", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": 0.0842, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.857, "ferret_sera_escape": null, "mature_H5_site": 315, "mouse_sera_escape": null, "mutant": "N", "mutation": "T318N", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3703, "ferret_sera_escape": 0.04758, "mature_H5_site": 315, "mouse_sera_escape": -0.02641, "mutant": "Q", "mutation": "T318Q", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": -0.1943, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5656, "ferret_sera_escape": null, "mature_H5_site": 315, "mouse_sera_escape": null, "mutant": "R", "mutation": "T318R", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 315, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T318T", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.23, "ferret_sera_escape": -0.01436, "mature_H5_site": 315, "mouse_sera_escape": 0.06197, "mutant": "V", "mutation": "T318V", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": -0.03366, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.446, "ferret_sera_escape": 0.07379, "mature_H5_site": 315, "mouse_sera_escape": 0.1702, "mutant": "W", "mutation": "T318W", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": -0.8588, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.894, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "C", "mutation": "G319C", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.353, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "D", "mutation": "G319D", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "E", "mutation": "G319E", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "F", "mutation": "G319F", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 316, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G319G", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.101, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "H", "mutation": "G319H", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "I", "mutation": "G319I", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "K", "mutation": "G319K", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.007, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "L", "mutation": "G319L", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "M", "mutation": "G319M", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "N", "mutation": "G319N", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "P", "mutation": "G319P", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "S", "mutation": "G319S", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.873, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "T", "mutation": "G319T", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "V", "mutation": "G319V", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.863, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "W", "mutation": "G319W", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.926, "ferret_sera_escape": -0.3679, "mature_H5_site": 22, "mouse_sera_escape": -0.1191, "mutant": "A", "mutation": "K32A", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": -0.1999, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.9328, "ferret_sera_escape": -0.2761, "mature_H5_site": 22, "mouse_sera_escape": null, "mutant": "C", "mutation": "K32C", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.363, "ferret_sera_escape": null, "mature_H5_site": 22, "mouse_sera_escape": null, "mutant": "D", "mutation": "K32D", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3666, "ferret_sera_escape": -0.07898, "mature_H5_site": 22, "mouse_sera_escape": 0.01565, "mutant": "H", "mutation": "K32H", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": 0.9802, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2186, "ferret_sera_escape": 0.001288, "mature_H5_site": 22, "mouse_sera_escape": -0.04851, "mutant": "I", "mutation": "K32I", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": -0.7656, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 22, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K32K", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.8645, "cell_entry": -0.3318, "ferret_sera_escape": null, "mature_H5_site": 22, "mouse_sera_escape": null, "mutant": "L", "mutation": "K32L", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4696, "ferret_sera_escape": -0.04662, "mature_H5_site": 22, "mouse_sera_escape": -0.1602, "mutant": "M", "mutation": "K32M", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": 0.0243, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4788, "ferret_sera_escape": -0.002157, "mature_H5_site": 22, "mouse_sera_escape": 0.07026, "mutant": "N", "mutation": "K32N", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": -0.1458, "wildtype": "K"}, {"a26_usage": 0.004918, "cell_entry": -0.03636, "ferret_sera_escape": 0.03815, "mature_H5_site": 22, "mouse_sera_escape": -0.0232, "mutant": "P", "mutation": "K32P", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": 0.5621, "wildtype": "K"}, {"a26_usage": 0.1331, "cell_entry": 0.03646, "ferret_sera_escape": -0.05831, "mature_H5_site": 22, "mouse_sera_escape": -0.1632, "mutant": "Q", "mutation": "K32Q", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": -0.205, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7013, "ferret_sera_escape": -0.003793, "mature_H5_site": 22, "mouse_sera_escape": 0.05935, "mutant": "R", "mutation": "K32R", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": 1.414, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03918, "ferret_sera_escape": -0.04683, "mature_H5_site": 22, "mouse_sera_escape": -0.1386, "mutant": "S", "mutation": "K32S", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": -0.1656, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.144, "ferret_sera_escape": -0.0163, "mature_H5_site": 22, "mouse_sera_escape": 0.1153, "mutant": "T", "mutation": "K32T", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": -0.1746, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.857, "ferret_sera_escape": null, "mature_H5_site": 22, "mouse_sera_escape": null, "mutant": "V", "mutation": "K32V", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": -0.09428, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.371, "ferret_sera_escape": -0.31, "mature_H5_site": 22, "mouse_sera_escape": null, "mutant": "W", "mutation": "K32W", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.007195, "ferret_sera_escape": -0.02407, "mature_H5_site": 22, "mouse_sera_escape": -0.08414, "mutant": "Y", "mutation": "K32Y", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": 0.4681, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.906, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "C", "mutation": "L320C", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.874, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "D", "mutation": "L320D", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "E", "mutation": "L320E", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.038, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "F", "mutation": "L320F", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4321, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "I", "mutation": "L320I", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "K", "mutation": "L320K", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 317, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L320L", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06974, "ferret_sera_escape": -0.005233, "mature_H5_site": 317, "mouse_sera_escape": 0.04991, "mutant": "M", "mutation": "L320M", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": -0.2516, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "N", "mutation": "L320N", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.698, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "P", "mutation": "L320P", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.814, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "R", "mutation": "L320R", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "S", "mutation": "L320S", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.066, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "W", "mutation": "L320W", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.653, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L320Y", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.828, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "A", "mutation": "R321A", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "E", "mutation": "R321E", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.229, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "F", "mutation": "R321F", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.745, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "G", "mutation": "R321G", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.82, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "H", "mutation": "R321H", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.885, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "I", "mutation": "R321I", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.267, "ferret_sera_escape": 0.02098, "mature_H5_site": 318, "mouse_sera_escape": -0.03141, "mutant": "K", "mutation": "R321K", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": -0.003753, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.806, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "L", "mutation": "R321L", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.129, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "M", "mutation": "R321M", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.675, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "N", "mutation": "R321N", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.947, "ferret_sera_escape": -0.2337, "mature_H5_site": 318, "mouse_sera_escape": 0.2891, "mutant": "P", "mutation": "R321P", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.271, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "Q", "mutation": "R321Q", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 318, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R321R", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.777, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "S", "mutation": "R321S", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.754, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "T", "mutation": "R321T", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.776, "ferret_sera_escape": -0.4193, "mature_H5_site": 318, "mouse_sera_escape": 0.1627, "mutant": "V", "mutation": "R321V", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.826, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "W", "mutation": "R321W", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.142, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R321Y", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.992, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "A", "mutation": "N322A", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.62, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "C", "mutation": "N322C", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.746, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "D", "mutation": "N322D", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.845, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "E", "mutation": "N322E", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.055, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "F", "mutation": "N322F", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5156, "ferret_sera_escape": -0.4511, "mature_H5_site": 319, "mouse_sera_escape": -0.06753, "mutant": "G", "mutation": "N322G", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.868, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "H", "mutation": "N322H", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.06028, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "I", "mutation": "N322I", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7166, "ferret_sera_escape": -0.2848, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "K", "mutation": "N322K", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4512, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "L", "mutation": "N322L", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8267, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "M", "mutation": "N322M", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 319, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N322N", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.947, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "P", "mutation": "N322P", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.094, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N322Q", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.764, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "R", "mutation": "N322R", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.63, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "S", "mutation": "N322S", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.95, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "T", "mutation": "N322T", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8907, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "V", "mutation": "N322V", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.133, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N322Y", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.09105, "cell_entry": -0.04155, "ferret_sera_escape": 0.056, "mature_H5_site": 320, "mouse_sera_escape": 0.04428, "mutant": "A", "mutation": "S323A", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.1325, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.29, "ferret_sera_escape": 0.1063, "mature_H5_site": 320, "mouse_sera_escape": 0.2006, "mutant": "C", "mutation": "S323C", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": 0.4671, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2743, "ferret_sera_escape": null, "mature_H5_site": 320, "mouse_sera_escape": null, "mutant": "E", "mutation": "S323E", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.003295, "ferret_sera_escape": 0.05552, "mature_H5_site": 320, "mouse_sera_escape": 0.0221, "mutant": "G", "mutation": "S323G", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": 0.07725, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.07157, "ferret_sera_escape": -0.09933, "mature_H5_site": 320, "mouse_sera_escape": -0.02394, "mutant": "H", "mutation": "S323H", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.2636, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.707, "ferret_sera_escape": 0.1534, "mature_H5_site": 320, "mouse_sera_escape": null, "mutant": "I", "mutation": "S323I", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": 1.15, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.06501, "ferret_sera_escape": -0.03692, "mature_H5_site": 320, "mouse_sera_escape": -0.0823, "mutant": "K", "mutation": "S323K", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.1293, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.485, "ferret_sera_escape": 0.151, "mature_H5_site": 320, "mouse_sera_escape": 0.1512, "mutant": "L", "mutation": "S323L", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": 1.116, "wildtype": "S"}, {"a26_usage": 1.135, "cell_entry": -2.617, "ferret_sera_escape": -0.09504, "mature_H5_site": 320, "mouse_sera_escape": 0.01132, "mutant": "M", "mutation": "S323M", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.5236, "ferret_sera_escape": -0.2572, "mature_H5_site": 320, "mouse_sera_escape": -0.04369, "mutant": "N", "mutation": "S323N", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.06875, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1952, "ferret_sera_escape": -0.0992, "mature_H5_site": 320, "mouse_sera_escape": 0.05117, "mutant": "P", "mutation": "S323P", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.1665, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.05623, "ferret_sera_escape": 0.004659, "mature_H5_site": 320, "mouse_sera_escape": 0.1283, "mutant": "Q", "mutation": "S323Q", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.1413, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 320, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S323S", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.102, "ferret_sera_escape": 0.1104, "mature_H5_site": 320, "mouse_sera_escape": 0.2331, "mutant": "V", "mutation": "S323V", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": 1.35, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.01485, "ferret_sera_escape": 0.06559, "mature_H5_site": 320, "mouse_sera_escape": 0.07776, "mutant": "W", "mutation": "S323W", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.2148, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.07295, "ferret_sera_escape": 0.01007, "mature_H5_site": 320, "mouse_sera_escape": -0.073, "mutant": "Y", "mutation": "S323Y", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.1613, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6343, "ferret_sera_escape": 0.03484, "mature_H5_site": 321, "mouse_sera_escape": -0.03664, "mutant": "A", "mutation": "P324A", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": 0.09317, "wildtype": "P"}, {"a26_usage": 0.5084, "cell_entry": -0.2232, "ferret_sera_escape": -0.01089, "mature_H5_site": 321, "mouse_sera_escape": null, "mutant": "C", "mutation": "P324C", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": 0.01863, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1866, "ferret_sera_escape": 0.1407, "mature_H5_site": 321, "mouse_sera_escape": 0.08088, "mutant": "E", "mutation": "P324E", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": 0.03475, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.6168, "ferret_sera_escape": -0.05367, "mature_H5_site": 321, "mouse_sera_escape": null, "mutant": "G", "mutation": "P324G", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.09831, "ferret_sera_escape": 0.08385, "mature_H5_site": 321, "mouse_sera_escape": 0.04461, "mutant": "H", "mutation": "P324H", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": -0.01276, "wildtype": "P"}, {"a26_usage": 0.07059, "cell_entry": -0.1055, "ferret_sera_escape": 0.002548, "mature_H5_site": 321, "mouse_sera_escape": 0.01616, "mutant": "I", "mutation": "P324I", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": -0.04046, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.03263, "ferret_sera_escape": null, "mature_H5_site": 321, "mouse_sera_escape": null, "mutant": "L", "mutation": "P324L", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1588, "ferret_sera_escape": 0.04224, "mature_H5_site": 321, "mouse_sera_escape": -0.006322, "mutant": "N", "mutation": "P324N", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": -0.00212, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 321, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P324P", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.07755, "ferret_sera_escape": -0.02852, "mature_H5_site": 321, "mouse_sera_escape": -0.0002475, "mutant": "Q", "mutation": "P324Q", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": -0.04908, "wildtype": "P"}, {"a26_usage": 0.003017, "cell_entry": 0.04963, "ferret_sera_escape": -0.1812, "mature_H5_site": 321, "mouse_sera_escape": -0.1439, "mutant": "R", "mutation": "P324R", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": -0.01751, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.07107, "ferret_sera_escape": 0.06216, "mature_H5_site": 321, "mouse_sera_escape": 0.03853, "mutant": "S", "mutation": "P324S", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": 0.01193, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.7241, "ferret_sera_escape": -0.07936, "mature_H5_site": 321, "mouse_sera_escape": 0.1871, "mutant": "T", "mutation": "P324T", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": 0.0148, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1532, "ferret_sera_escape": 0.00142, "mature_H5_site": 321, "mouse_sera_escape": -0.0288, "mutant": "V", "mutation": "P324V", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": -0.03472, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.4194, "ferret_sera_escape": -0.07306, "mature_H5_site": 321, "mouse_sera_escape": -0.01007, "mutant": "W", "mutation": "P324W", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": -0.003264, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.7439, "ferret_sera_escape": 0.2359, "mature_H5_site": 321, "mouse_sera_escape": 0.02928, "mutant": "Y", "mutation": "P324Y", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.01924, "ferret_sera_escape": 0.03486, "mature_H5_site": 322, "mouse_sera_escape": 0.07308, "mutant": "A", "mutation": "L325A", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.02499, "wildtype": "L"}, {"a26_usage": 0.05557, "cell_entry": -0.1827, "ferret_sera_escape": -0.09581, "mature_H5_site": 322, "mouse_sera_escape": -0.08414, "mutant": "C", "mutation": "L325C", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": -0.08614, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.03556, "ferret_sera_escape": -0.1458, "mature_H5_site": 322, "mouse_sera_escape": 0.003765, "mutant": "D", "mutation": "L325D", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.1011, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2797, "ferret_sera_escape": 0.0442, "mature_H5_site": 322, "mouse_sera_escape": 0.01784, "mutant": "E", "mutation": "L325E", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": -0.0005663, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1614, "ferret_sera_escape": 9.967e-05, "mature_H5_site": 322, "mouse_sera_escape": 0.03865, "mutant": "G", "mutation": "L325G", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.02644, "wildtype": "L"}, {"a26_usage": 0.08608, "cell_entry": -0.6185, "ferret_sera_escape": 0.006943, "mature_H5_site": 322, "mouse_sera_escape": -0.08262, "mutant": "H", "mutation": "L325H", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.1473, "wildtype": "L"}, {"a26_usage": 0.06831, "cell_entry": 0.07276, "ferret_sera_escape": 0.005307, "mature_H5_site": 322, "mouse_sera_escape": -0.03623, "mutant": "I", "mutation": "L325I", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.0591, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1546, "ferret_sera_escape": 0.00845, "mature_H5_site": 322, "mouse_sera_escape": 0.003069, "mutant": "K", "mutation": "L325K", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.06644, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 322, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L325L", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.04496, "cell_entry": -0.3378, "ferret_sera_escape": 0.03101, "mature_H5_site": 322, "mouse_sera_escape": 0.02512, "mutant": "M", "mutation": "L325M", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.08026, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.07551, "ferret_sera_escape": -0.1557, "mature_H5_site": 322, "mouse_sera_escape": -0.1487, "mutant": "N", "mutation": "L325N", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.006605, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06666, "ferret_sera_escape": 0.11, "mature_H5_site": 322, "mouse_sera_escape": -0.04144, "mutant": "Q", "mutation": "L325Q", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.0728, "wildtype": "L"}, {"a26_usage": 0.04182, "cell_entry": 0.07336, "ferret_sera_escape": 0.03848, "mature_H5_site": 322, "mouse_sera_escape": -0.1567, "mutant": "R", "mutation": "L325R", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.04254, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5357, "ferret_sera_escape": null, "mature_H5_site": 322, "mouse_sera_escape": null, "mutant": "T", "mutation": "L325T", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.00195, "ferret_sera_escape": -0.04594, "mature_H5_site": 322, "mouse_sera_escape": 0.01632, "mutant": "V", "mutation": "L325V", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.08033, "wildtype": "L"}, {"a26_usage": 0.1194, "cell_entry": -0.02877, "ferret_sera_escape": -0.08493, "mature_H5_site": 322, "mouse_sera_escape": -0.01965, "mutant": "W", "mutation": "L325W", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.0107, "wildtype": "L"}, {"a26_usage": 0.1136, "cell_entry": 0.05221, "ferret_sera_escape": -0.0402, "mature_H5_site": 322, "mouse_sera_escape": -0.06625, "mutant": "Y", "mutation": "L325Y", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.04685, "ferret_sera_escape": 0.08457, "mature_H5_site": 323, "mouse_sera_escape": -0.133, "mutant": "A", "mutation": "R326A", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.002554, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.08008, "ferret_sera_escape": 0.07326, "mature_H5_site": 323, "mouse_sera_escape": 0.04311, "mutant": "C", "mutation": "R326C", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.0233, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.562, "ferret_sera_escape": null, "mature_H5_site": 323, "mouse_sera_escape": null, "mutant": "D", "mutation": "R326D", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.266, "ferret_sera_escape": -5.733e-05, "mature_H5_site": 323, "mouse_sera_escape": 0.2913, "mutant": "E", "mutation": "R326E", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": -0.004059, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1051, "ferret_sera_escape": -0.03911, "mature_H5_site": 323, "mouse_sera_escape": 0.08853, "mutant": "F", "mutation": "R326F", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.01245, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.05941, "ferret_sera_escape": -0.07091, "mature_H5_site": 323, "mouse_sera_escape": -0.05245, "mutant": "G", "mutation": "R326G", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": -0.0007344, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.003475, "ferret_sera_escape": -0.03973, "mature_H5_site": 323, "mouse_sera_escape": -0.05467, "mutant": "H", "mutation": "R326H", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.1275, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.05031, "ferret_sera_escape": null, "mature_H5_site": 323, "mouse_sera_escape": null, "mutant": "I", "mutation": "R326I", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4284, "ferret_sera_escape": 0.134, "mature_H5_site": 323, "mouse_sera_escape": 0.05584, "mutant": "K", "mutation": "R326K", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.07274, "wildtype": "R"}, {"a26_usage": 0.1083, "cell_entry": -0.2477, "ferret_sera_escape": 0.01236, "mature_H5_site": 323, "mouse_sera_escape": 0.01751, "mutant": "L", "mutation": "R326L", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.07376, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.02796, "ferret_sera_escape": 0.04513, "mature_H5_site": 323, "mouse_sera_escape": -0.04777, "mutant": "M", "mutation": "R326M", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.05109, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4669, "ferret_sera_escape": null, "mature_H5_site": 323, "mouse_sera_escape": null, "mutant": "N", "mutation": "R326N", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": null, "wildtype": "R"}, {"a26_usage": 0.1352, "cell_entry": 0.04852, "ferret_sera_escape": 0.06783, "mature_H5_site": 323, "mouse_sera_escape": -0.01094, "mutant": "Q", "mutation": "R326Q", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.05486, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 323, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R326R", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2349, "ferret_sera_escape": -0.0906, "mature_H5_site": 323, "mouse_sera_escape": 0.01443, "mutant": "S", "mutation": "R326S", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.03201, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2323, "ferret_sera_escape": null, "mature_H5_site": 323, "mouse_sera_escape": null, "mutant": "T", "mutation": "R326T", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1277, "ferret_sera_escape": 0.1225, "mature_H5_site": 323, "mouse_sera_escape": 0.05792, "mutant": "V", "mutation": "R326V", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.2303, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3319, "ferret_sera_escape": -0.07635, "mature_H5_site": 323, "mouse_sera_escape": 0.08009, "mutant": "W", "mutation": "R326W", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": -0.02386, "wildtype": "R"}, {"a26_usage": 0.09865, "cell_entry": 0.03368, "ferret_sera_escape": 0.05436, "mature_H5_site": 323, "mouse_sera_escape": 0.02116, "mutant": "Y", "mutation": "R326Y", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.01071, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3196, "ferret_sera_escape": 0.04839, "mature_H5_site": 324, "mouse_sera_escape": -0.005777, "mutant": "A", "mutation": "E327A", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.1072, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2663, "ferret_sera_escape": 0.08306, "mature_H5_site": 324, "mouse_sera_escape": -0.1518, "mutant": "C", "mutation": "E327C", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.181, "wildtype": "E"}, {"a26_usage": 0.4887, "cell_entry": -0.1089, "ferret_sera_escape": -0.1186, "mature_H5_site": 324, "mouse_sera_escape": -0.01733, "mutant": "D", "mutation": "E327D", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.1223, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 324, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E327E", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.002401, "ferret_sera_escape": -0.06851, "mature_H5_site": 324, "mouse_sera_escape": -0.03692, "mutant": "F", "mutation": "E327F", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.08354, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06116, "ferret_sera_escape": -0.07034, "mature_H5_site": 324, "mouse_sera_escape": -0.04397, "mutant": "G", "mutation": "E327G", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.02445, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1623, "ferret_sera_escape": -0.1472, "mature_H5_site": 324, "mouse_sera_escape": -0.1769, "mutant": "H", "mutation": "E327H", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.06898, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1583, "ferret_sera_escape": -0.03867, "mature_H5_site": 324, "mouse_sera_escape": -0.07667, "mutant": "I", "mutation": "E327I", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.09918, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.744, "ferret_sera_escape": -0.06336, "mature_H5_site": 324, "mouse_sera_escape": -0.0548, "mutant": "K", "mutation": "E327K", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.08692, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06317, "ferret_sera_escape": 0.01454, "mature_H5_site": 324, "mouse_sera_escape": 0.03804, "mutant": "L", "mutation": "E327L", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.09755, "wildtype": "E"}, {"a26_usage": 0.1755, "cell_entry": -0.07594, "ferret_sera_escape": -0.08662, "mature_H5_site": 324, "mouse_sera_escape": -0.01727, "mutant": "Q", "mutation": "E327Q", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.0232, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2668, "ferret_sera_escape": 0.03827, "mature_H5_site": 324, "mouse_sera_escape": -0.03549, "mutant": "R", "mutation": "E327R", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.09135, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4871, "ferret_sera_escape": 0.101, "mature_H5_site": 324, "mouse_sera_escape": -0.02106, "mutant": "S", "mutation": "E327S", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.09222, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 324, "mouse_sera_escape": null, "mutant": "T", "mutation": "E327T", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2793, "ferret_sera_escape": 0.01881, "mature_H5_site": 324, "mouse_sera_escape": -0.03494, "mutant": "V", "mutation": "E327V", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.05991, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.04419, "ferret_sera_escape": -0.09317, "mature_H5_site": 324, "mouse_sera_escape": 0.03545, "mutant": "W", "mutation": "E327W", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.1164, "wildtype": "E"}, {"a26_usage": 0.008215, "cell_entry": 0.03971, "ferret_sera_escape": 0.07341, "mature_H5_site": 324, "mouse_sera_escape": -0.07968, "mutant": "Y", "mutation": "E327Y", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.0942, "wildtype": "E"}, {"a26_usage": 0.1512, "cell_entry": 0.04226, "ferret_sera_escape": 0.07889, "mature_H5_site": 325, "mouse_sera_escape": null, "mutant": "A", "mutation": "K328A", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.1318, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7532, "ferret_sera_escape": -0.0417, "mature_H5_site": 325, "mouse_sera_escape": -0.1602, "mutant": "C", "mutation": "K328C", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": -0.1135, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.056, "ferret_sera_escape": null, "mature_H5_site": 325, "mouse_sera_escape": null, "mutant": "D", "mutation": "K328D", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.877, "ferret_sera_escape": 0.05958, "mature_H5_site": 325, "mouse_sera_escape": 0.1716, "mutant": "E", "mutation": "K328E", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": -0.03997, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1584, "ferret_sera_escape": 0.03472, "mature_H5_site": 325, "mouse_sera_escape": 0.003367, "mutant": "F", "mutation": "K328F", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.09508, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03592, "ferret_sera_escape": 0.03283, "mature_H5_site": 325, "mouse_sera_escape": 0.07289, "mutant": "G", "mutation": "K328G", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.06623, "wildtype": "K"}, {"a26_usage": 0.04962, "cell_entry": 0.00832, "ferret_sera_escape": -0.03733, "mature_H5_site": 325, "mouse_sera_escape": -0.0141, "mutant": "H", "mutation": "K328H", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": -0.0273, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03372, "ferret_sera_escape": 0.03102, "mature_H5_site": 325, "mouse_sera_escape": -0.06957, "mutant": "I", "mutation": "K328I", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.013, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 325, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K328K", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.213, "ferret_sera_escape": 0.1471, "mature_H5_site": 325, "mouse_sera_escape": 0.03706, "mutant": "N", "mutation": "K328N", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.07229, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07345, "ferret_sera_escape": 0.03618, "mature_H5_site": 325, "mouse_sera_escape": -0.04863, "mutant": "R", "mutation": "K328R", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": -0.06764, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3032, "ferret_sera_escape": 0.06543, "mature_H5_site": 325, "mouse_sera_escape": 0.1136, "mutant": "S", "mutation": "K328S", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.01921, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05675, "ferret_sera_escape": 0.05679, "mature_H5_site": 325, "mouse_sera_escape": -0.05843, "mutant": "V", "mutation": "K328V", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.06224, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8701, "ferret_sera_escape": 0.03892, "mature_H5_site": 325, "mouse_sera_escape": 0.08765, "mutant": "W", "mutation": "K328W", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.02936, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "D", "mutation": "R328aD", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.841, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "E", "mutation": "R328aE", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.652, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "F", "mutation": "R328aF", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.86, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "G", "mutation": "R328aG", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.795, "ferret_sera_escape": 0.671, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "H", "mutation": "R328aH", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.114, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "I", "mutation": "R328aI", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.84, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "K", "mutation": "R328aK", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "L", "mutation": "R328aL", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "M", "mutation": "R328aM", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.482, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": -0.1289, "mutant": "P", "mutation": "R328aP", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.083, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "Q", "mutation": "R328aQ", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 326, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R328aR", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "S", "mutation": "R328aS", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.763, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "T", "mutation": "R328aT", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.512, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "V", "mutation": "R328aV", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.663, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "W", "mutation": "R328aW", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.732, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R328aY", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.06475, "ferret_sera_escape": -0.09224, "mature_H5_site": 327, "mouse_sera_escape": -0.0898, "mutant": "A", "mutation": "R328bA", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": 0.009548, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.08059, "ferret_sera_escape": -0.439, "mature_H5_site": 327, "mouse_sera_escape": -0.4603, "mutant": "C", "mutation": "R328bC", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": -0.1023, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.08, "ferret_sera_escape": null, "mature_H5_site": 327, "mouse_sera_escape": null, "mutant": "D", "mutation": "R328bD", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4824, "ferret_sera_escape": null, "mature_H5_site": 327, "mouse_sera_escape": null, "mutant": "E", "mutation": "R328bE", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.06731, "ferret_sera_escape": null, "mature_H5_site": 327, "mouse_sera_escape": null, "mutant": "F", "mutation": "R328bF", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.25, "ferret_sera_escape": 0.07936, "mature_H5_site": 327, "mouse_sera_escape": 0.1731, "mutant": "G", "mutation": "R328bG", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": -0.04324, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1409, "ferret_sera_escape": 0.08366, "mature_H5_site": 327, "mouse_sera_escape": -0.09088, "mutant": "I", "mutation": "R328bI", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": 0.0003689, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0356, "ferret_sera_escape": -0.1096, "mature_H5_site": 327, "mouse_sera_escape": -0.1058, "mutant": "K", "mutation": "R328bK", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": -0.02507, "wildtype": "R"}, {"a26_usage": 0.09562, "cell_entry": -0.003765, "ferret_sera_escape": 0.002133, "mature_H5_site": 327, "mouse_sera_escape": -0.09729, "mutant": "L", "mutation": "R328bL", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": -0.04653, "wildtype": "R"}, {"a26_usage": 0.09677, "cell_entry": 0.02313, "ferret_sera_escape": -0.09024, "mature_H5_site": 327, "mouse_sera_escape": -0.02739, "mutant": "M", "mutation": "R328bM", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": -0.04391, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3905, "ferret_sera_escape": null, "mature_H5_site": 327, "mouse_sera_escape": null, "mutant": "N", "mutation": "R328bN", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.09431, "ferret_sera_escape": -0.05577, "mature_H5_site": 327, "mouse_sera_escape": 0.01034, "mutant": "P", "mutation": "R328bP", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": 0.0797, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 327, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R328bR", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.943, "ferret_sera_escape": 0.05939, "mature_H5_site": 327, "mouse_sera_escape": 0.02469, "mutant": "S", "mutation": "R328bS", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": 0.07773, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3589, "ferret_sera_escape": 0.04622, "mature_H5_site": 327, "mouse_sera_escape": 0.01632, "mutant": "T", "mutation": "R328bT", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": 0.01398, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1196, "ferret_sera_escape": 0.06344, "mature_H5_site": 327, "mouse_sera_escape": -0.07169, "mutant": "Y", "mutation": "R328bY", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": -0.008973, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.514, "ferret_sera_escape": -0.06687, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "A", "mutation": "K328cA", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": 0.01605, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.159, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "C", "mutation": "K328cC", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "D", "mutation": "K328cD", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "E", "mutation": "K328cE", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.712, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "F", "mutation": "K328cF", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.824, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "G", "mutation": "K328cG", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.063, "ferret_sera_escape": 0.1342, "mature_H5_site": 328, "mouse_sera_escape": 0.1771, "mutant": "I", "mutation": "K328cI", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 328, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K328cK", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "M", "mutation": "K328cM", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.732, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "N", "mutation": "K328cN", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.857, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "P", "mutation": "K328cP", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.713, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "Q", "mutation": "K328cQ", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.09191, "ferret_sera_escape": -0.09746, "mature_H5_site": 328, "mouse_sera_escape": -0.01855, "mutant": "R", "mutation": "K328cR", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": -0.008006, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.352, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "S", "mutation": "K328cS", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.197, "ferret_sera_escape": 0.2915, "mature_H5_site": 328, "mouse_sera_escape": 0.1912, "mutant": "T", "mutation": "K328cT", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": 0.02119, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.001, "ferret_sera_escape": 0.1448, "mature_H5_site": 328, "mouse_sera_escape": 0.2306, "mutant": "V", "mutation": "K328cV", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": 0.02245, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.551, "ferret_sera_escape": -0.05989, "mature_H5_site": 328, "mouse_sera_escape": 0.008904, "mutant": "Y", "mutation": "K328cY", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "A", "mutation": "R329A", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.431, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "C", "mutation": "R329C", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "D", "mutation": "R329D", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "E", "mutation": "R329E", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.633, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "F", "mutation": "R329F", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "G", "mutation": "R329G", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "H", "mutation": "R329H", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.832, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "I", "mutation": "R329I", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.291, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "K", "mutation": "R329K", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.822, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "M", "mutation": "R329M", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "N", "mutation": "R329N", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.903, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "P", "mutation": "R329P", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "Q", "mutation": "R329Q", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 329, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R329R", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.735, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "S", "mutation": "R329S", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.731, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "T", "mutation": "R329T", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.837, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "V", "mutation": "R329V", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "W", "mutation": "R329W", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.811, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R329Y", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7969, "ferret_sera_escape": -0.09333, "mature_H5_site": 23, "mouse_sera_escape": -0.02656, "mutant": "A", "mutation": "N33A", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.3272, "wildtype": "N"}, {"a26_usage": 1.304, "cell_entry": -0.1255, "ferret_sera_escape": -0.0541, "mature_H5_site": 23, "mouse_sera_escape": null, "mutant": "C", "mutation": "N33C", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.35, "ferret_sera_escape": 0.02909, "mature_H5_site": 23, "mouse_sera_escape": -0.01962, "mutant": "D", "mutation": "N33D", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7246, "ferret_sera_escape": -0.1071, "mature_H5_site": 23, "mouse_sera_escape": -0.05998, "mutant": "E", "mutation": "N33E", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.034, "ferret_sera_escape": -0.2497, "mature_H5_site": 23, "mouse_sera_escape": -0.03433, "mutant": "F", "mutation": "N33F", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": -0.04192, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1855, "ferret_sera_escape": -0.2066, "mature_H5_site": 23, "mouse_sera_escape": -0.1343, "mutant": "H", "mutation": "N33H", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.6506, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.683, "ferret_sera_escape": -0.04788, "mature_H5_site": 23, "mouse_sera_escape": 0.053, "mutant": "K", "mutation": "N33K", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.5282, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.45, "ferret_sera_escape": null, "mature_H5_site": 23, "mouse_sera_escape": null, "mutant": "L", "mutation": "N33L", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.027, "ferret_sera_escape": -0.2635, "mature_H5_site": 23, "mouse_sera_escape": 0.00373, "mutant": "M", "mutation": "N33M", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.2038, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 23, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N33N", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6412, "ferret_sera_escape": -0.1612, "mature_H5_site": 23, "mouse_sera_escape": -0.05566, "mutant": "Q", "mutation": "N33Q", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.4517, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2287, "ferret_sera_escape": -0.006357, "mature_H5_site": 23, "mouse_sera_escape": 0.06192, "mutant": "R", "mutation": "N33R", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.9194, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.217, "ferret_sera_escape": -0.1169, "mature_H5_site": 23, "mouse_sera_escape": -0.03528, "mutant": "S", "mutation": "N33S", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.2066, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 23, "mouse_sera_escape": null, "mutant": "V", "mutation": "N33V", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 23, "mouse_sera_escape": null, "mutant": "W", "mutation": "N33W", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.46, "ferret_sera_escape": -0.07743, "mature_H5_site": 330, "mouse_sera_escape": 0.532, "mutant": "A", "mutation": "G330A", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.756, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "C", "mutation": "G330C", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.518, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "D", "mutation": "G330D", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.554, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "E", "mutation": "G330E", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.403, "ferret_sera_escape": -0.0635, "mature_H5_site": 330, "mouse_sera_escape": 0.3959, "mutant": "F", "mutation": "G330F", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": 1.009, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 330, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G330G", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.335, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "H", "mutation": "G330H", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "I", "mutation": "G330I", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.515, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "K", "mutation": "G330K", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "L", "mutation": "G330L", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.848, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "M", "mutation": "G330M", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.855, "ferret_sera_escape": 0.2101, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "N", "mutation": "G330N", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.88, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "P", "mutation": "G330P", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.548, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G330Q", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.628, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "R", "mutation": "G330R", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.118, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "S", "mutation": "G330S", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.691, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "T", "mutation": "G330T", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.448, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "V", "mutation": "G330V", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1889, "ferret_sera_escape": -0.05713, "mature_H5_site": 330, "mouse_sera_escape": -0.0154, "mutant": "W", "mutation": "G330W", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": 0.4056, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.474, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G330Y", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.439, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "C", "mutation": "L331C", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.862, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "D", "mutation": "L331D", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "E", "mutation": "L331E", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.11, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "F", "mutation": "L331F", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "G", "mutation": "L331G", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.861, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "H", "mutation": "L331H", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7486, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "I", "mutation": "L331I", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.793, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "K", "mutation": "L331K", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 331, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L331L", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.83, "ferret_sera_escape": -0.0941, "mature_H5_site": 331, "mouse_sera_escape": 0.04818, "mutant": "M", "mutation": "L331M", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": 0.5362, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "P", "mutation": "L331P", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.678, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L331Q", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.833, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "R", "mutation": "L331R", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "S", "mutation": "L331S", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.895, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "T", "mutation": "L331T", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.362, "ferret_sera_escape": -0.2245, "mature_H5_site": 331, "mouse_sera_escape": 0.6048, "mutant": "V", "mutation": "L331V", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": 0.8239, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.846, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "W", "mutation": "L331W", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L331Y", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.856, "ferret_sera_escape": -0.1123, "mature_H5_site": 332, "mouse_sera_escape": 0.3842, "mutant": "A", "mutation": "F332A", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": 0.8835, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "C", "mutation": "F332C", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "D", "mutation": "F332D", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.454, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "E", "mutation": "F332E", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 332, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F332F", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.601, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "G", "mutation": "F332G", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "H", "mutation": "F332H", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.329, "ferret_sera_escape": -0.1003, "mature_H5_site": 332, "mouse_sera_escape": 0.4064, "mutant": "I", "mutation": "F332I", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": 1.592, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.822, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "K", "mutation": "F332K", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.181, "ferret_sera_escape": -0.1054, "mature_H5_site": 332, "mouse_sera_escape": 0.385, "mutant": "L", "mutation": "F332L", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": 1.38, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.221, "ferret_sera_escape": -0.1519, "mature_H5_site": 332, "mouse_sera_escape": 0.4544, "mutant": "M", "mutation": "F332M", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": 1.181, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.018, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "P", "mutation": "F332P", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.869, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F332Q", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "R", "mutation": "F332R", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "S", "mutation": "F332S", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "T", "mutation": "F332T", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.939, "ferret_sera_escape": -0.1829, "mature_H5_site": 332, "mouse_sera_escape": 0.2684, "mutant": "V", "mutation": "F332V", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": 1.479, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.699, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "W", "mutation": "F332W", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.636, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "Y", "mutation": "F332Y", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.035, "ferret_sera_escape": -0.1124, "mature_H5_site": 333, "mouse_sera_escape": 0.3503, "mutant": "A", "mutation": "G333A", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 1.241, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.842, "ferret_sera_escape": null, "mature_H5_site": 333, "mouse_sera_escape": null, "mutant": "C", "mutation": "G333C", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.678, "ferret_sera_escape": null, "mature_H5_site": 333, "mouse_sera_escape": null, "mutant": "D", "mutation": "G333D", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.63, "ferret_sera_escape": null, "mature_H5_site": 333, "mouse_sera_escape": null, "mutant": "E", "mutation": "G333E", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.189, "ferret_sera_escape": -0.1415, "mature_H5_site": 333, "mouse_sera_escape": 0.1984, "mutant": "F", "mutation": "G333F", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 1.295, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 333, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G333G", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.604, "ferret_sera_escape": -0.1355, "mature_H5_site": 333, "mouse_sera_escape": 0.5327, "mutant": "H", "mutation": "G333H", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 0.5796, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.65, "ferret_sera_escape": -0.1925, "mature_H5_site": 333, "mouse_sera_escape": null, "mutant": "K", "mutation": "G333K", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 0.9927, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.6009, "ferret_sera_escape": -0.1541, "mature_H5_site": 333, "mouse_sera_escape": 0.2912, "mutant": "L", "mutation": "G333L", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 1.363, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2621, "ferret_sera_escape": -0.1237, "mature_H5_site": 333, "mouse_sera_escape": 0.2083, "mutant": "M", "mutation": "G333M", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 1.773, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 333, "mouse_sera_escape": null, "mutant": "P", "mutation": "G333P", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.191, "ferret_sera_escape": 0.00674, "mature_H5_site": 333, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G333Q", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.603, "ferret_sera_escape": -0.1827, "mature_H5_site": 333, "mouse_sera_escape": 0.3784, "mutant": "R", "mutation": "G333R", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 0.9795, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7004, "ferret_sera_escape": -0.1172, "mature_H5_site": 333, "mouse_sera_escape": 0.4115, "mutant": "S", "mutation": "G333S", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 1.286, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.585, "ferret_sera_escape": -0.2927, "mature_H5_site": 333, "mouse_sera_escape": 0.12, "mutant": "V", "mutation": "G333V", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 1.485, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.516, "ferret_sera_escape": null, "mature_H5_site": 333, "mouse_sera_escape": null, "mutant": "W", "mutation": "G333W", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.925, "ferret_sera_escape": -0.2494, "mature_H5_site": 333, "mouse_sera_escape": 0.1799, "mutant": "Y", "mutation": "G333Y", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 1.11, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 334, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A334A", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.603, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "C", "mutation": "A334C", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "D", "mutation": "A334D", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.508, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "E", "mutation": "A334E", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.953, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "F", "mutation": "A334F", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.414, "ferret_sera_escape": -0.1556, "mature_H5_site": 334, "mouse_sera_escape": 0.445, "mutant": "G", "mutation": "A334G", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.491, "ferret_sera_escape": -0.1861, "mature_H5_site": 334, "mouse_sera_escape": 0.2083, "mutant": "I", "mutation": "A334I", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": 1.259, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "K", "mutation": "A334K", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.422, "ferret_sera_escape": -0.1446, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "L", "mutation": "A334L", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.235, "ferret_sera_escape": -0.1677, "mature_H5_site": 334, "mouse_sera_escape": 0.2144, "mutant": "M", "mutation": "A334M", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": 2.225, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.79, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A334Q", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "R", "mutation": "A334R", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.266, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "S", "mutation": "A334S", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.7, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "T", "mutation": "A334T", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.957, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": -0.1384, "mutant": "V", "mutation": "A334V", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.661, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "W", "mutation": "A334W", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A334Y", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 2.489, "cell_entry": -1.958, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "A", "mutation": "I335A", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.631, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "C", "mutation": "I335C", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.588, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "D", "mutation": "I335D", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.701, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "E", "mutation": "I335E", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "G", "mutation": "I335G", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.816, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "H", "mutation": "I335H", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 335, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I335I", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "K", "mutation": "I335K", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3644, "ferret_sera_escape": -0.07554, "mature_H5_site": 335, "mouse_sera_escape": 0.2042, "mutant": "L", "mutation": "I335L", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": 1.293, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.7006, "ferret_sera_escape": -0.1176, "mature_H5_site": 335, "mouse_sera_escape": 0.09558, "mutant": "M", "mutation": "I335M", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": 1.549, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "N", "mutation": "I335N", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.678, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "P", "mutation": "I335P", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I335Q", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.809, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "R", "mutation": "I335R", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "S", "mutation": "I335S", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.782, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "T", "mutation": "I335T", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.05497, "ferret_sera_escape": -0.118, "mature_H5_site": 335, "mouse_sera_escape": 0.02733, "mutant": "V", "mutation": "I335V", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": 1.062, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.497, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "W", "mutation": "I335W", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.752, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I335Y", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 336, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A336A", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.803, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "C", "mutation": "A336C", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "E", "mutation": "A336E", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.301, "ferret_sera_escape": 0.2453, "mature_H5_site": 336, "mouse_sera_escape": 0.3167, "mutant": "G", "mutation": "A336G", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.391, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "H", "mutation": "A336H", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.886, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "K", "mutation": "A336K", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.581, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "M", "mutation": "A336M", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "N", "mutation": "A336N", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A336Q", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.872, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "R", "mutation": "A336R", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.913, "ferret_sera_escape": -0.05082, "mature_H5_site": 336, "mouse_sera_escape": 0.06822, "mutant": "S", "mutation": "A336S", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": -0.1591, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.642, "ferret_sera_escape": 0.08096, "mature_H5_site": 336, "mouse_sera_escape": 0.4128, "mutant": "T", "mutation": "A336T", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": 0.01279, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.758, "ferret_sera_escape": -0.4007, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "V", "mutation": "A336V", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.99, "ferret_sera_escape": 0.2316, "mature_H5_site": 336, "mouse_sera_escape": 0.2424, "mutant": "W", "mutation": "A336W", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": 0.9507, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.385, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A336Y", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.369, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "C", "mutation": "G337C", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.774, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "D", "mutation": "G337D", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.746, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "E", "mutation": "G337E", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "F", "mutation": "G337F", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 337, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G337G", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "H", "mutation": "G337H", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "I", "mutation": "G337I", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "K", "mutation": "G337K", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.042, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "L", "mutation": "G337L", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.841, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "P", "mutation": "G337P", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.559, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G337Q", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "R", "mutation": "G337R", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.576, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "S", "mutation": "G337S", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.611, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "V", "mutation": "G337V", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.841, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "W", "mutation": "G337W", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "D", "mutation": "F338D", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.875, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "E", "mutation": "F338E", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 338, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F338F", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.824, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "G", "mutation": "F338G", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "H", "mutation": "F338H", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.553, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "I", "mutation": "F338I", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "K", "mutation": "F338K", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.095, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "L", "mutation": "F338L", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.803, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "N", "mutation": "F338N", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.806, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F338Q", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "R", "mutation": "F338R", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "S", "mutation": "F338S", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.745, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "T", "mutation": "F338T", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.764, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "V", "mutation": "F338V", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.463, "ferret_sera_escape": -0.09663, "mature_H5_site": 338, "mouse_sera_escape": 0.04159, "mutant": "W", "mutation": "F338W", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": 0.9281, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.254, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "Y", "mutation": "F338Y", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.835, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "A", "mutation": "I339A", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.829, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "C", "mutation": "I339C", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.525, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "D", "mutation": "I339D", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.119, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "E", "mutation": "I339E", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.436, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "H", "mutation": "I339H", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 339, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I339I", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.744, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "K", "mutation": "I339K", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.511, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "N", "mutation": "I339N", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.73, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "P", "mutation": "I339P", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.888, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I339Q", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "R", "mutation": "I339R", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.729, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "S", "mutation": "I339S", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "T", "mutation": "I339T", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": -0.1444, "mature_H5_site": 339, "mouse_sera_escape": 0.1228, "mutant": "V", "mutation": "I339V", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.98, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I339Y", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.025, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "A", "mutation": "V34A", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.482, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "C", "mutation": "V34C", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "D", "mutation": "V34D", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "E", "mutation": "V34E", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.888, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "F", "mutation": "V34F", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.314, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "G", "mutation": "V34G", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "H", "mutation": "V34H", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.235, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "I", "mutation": "V34I", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "K", "mutation": "V34K", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8625, "ferret_sera_escape": -0.0934, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "L", "mutation": "V34L", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.611, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "M", "mutation": "V34M", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "N", "mutation": "V34N", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.855, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V34Q", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "R", "mutation": "V34R", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "S", "mutation": "V34S", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.604, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "T", "mutation": "V34T", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 24, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V34V", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V34Y", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.435, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "A", "mutation": "E340A", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.753, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "C", "mutation": "E340C", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.192, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "D", "mutation": "E340D", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 340, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E340E", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.061, "ferret_sera_escape": 0.4853, "mature_H5_site": 340, "mouse_sera_escape": 0.1923, "mutant": "F", "mutation": "E340F", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.924, "ferret_sera_escape": -0.07067, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "G", "mutation": "E340G", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.706, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "H", "mutation": "E340H", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.38, "ferret_sera_escape": 0.1439, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "I", "mutation": "E340I", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": -0.005454, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.698, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "K", "mutation": "E340K", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.12, "ferret_sera_escape": 0.13, "mature_H5_site": 340, "mouse_sera_escape": 0.3031, "mutant": "M", "mutation": "E340M", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.635, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "N", "mutation": "E340N", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.501, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "Q", "mutation": "E340Q", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -6.054, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "R", "mutation": "E340R", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.396, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "S", "mutation": "E340S", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.524, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "V", "mutation": "E340V", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.847, "ferret_sera_escape": 0.007779, "mature_H5_site": 340, "mouse_sera_escape": 0.3888, "mutant": "W", "mutation": "E340W", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": 0.4343, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.565, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E340Y", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.162, "ferret_sera_escape": -0.04935, "mature_H5_site": 341, "mouse_sera_escape": -0.09464, "mutant": "A", "mutation": "G341A", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": -0.4084, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.905, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "C", "mutation": "G341C", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.554, "ferret_sera_escape": -0.2516, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "D", "mutation": "G341D", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.993, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "E", "mutation": "G341E", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.284, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "F", "mutation": "G341F", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 341, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G341G", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.468, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "H", "mutation": "G341H", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.237, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "I", "mutation": "G341I", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.848, "ferret_sera_escape": 0.3152, "mature_H5_site": 341, "mouse_sera_escape": 0.146, "mutant": "K", "mutation": "G341K", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": 0.02166, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.448, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "L", "mutation": "G341L", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.082, "ferret_sera_escape": -0.07914, "mature_H5_site": 341, "mouse_sera_escape": 0.01542, "mutant": "M", "mutation": "G341M", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "P", "mutation": "G341P", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.494, "ferret_sera_escape": -0.1037, "mature_H5_site": 341, "mouse_sera_escape": 0.02115, "mutant": "Q", "mutation": "G341Q", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": -0.07671, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.26, "ferret_sera_escape": 0.3108, "mature_H5_site": 341, "mouse_sera_escape": 0.354, "mutant": "R", "mutation": "G341R", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.226, "ferret_sera_escape": -0.2333, "mature_H5_site": 341, "mouse_sera_escape": -0.2146, "mutant": "S", "mutation": "G341S", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": 0.1229, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.311, "ferret_sera_escape": 0.3481, "mature_H5_site": 341, "mouse_sera_escape": 0.03644, "mutant": "T", "mutation": "G341T", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.096, "ferret_sera_escape": -0.2008, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "V", "mutation": "G341V", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": -0.0138, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.687, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "W", "mutation": "G341W", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.299, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "A", "mutation": "G342A", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "D", "mutation": "G342D", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.268, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "E", "mutation": "G342E", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "F", "mutation": "G342F", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 342, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G342G", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.596, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "H", "mutation": "G342H", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "I", "mutation": "G342I", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "L", "mutation": "G342L", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "M", "mutation": "G342M", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "P", "mutation": "G342P", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G342Q", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": -0.298, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "R", "mutation": "G342R", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "T", "mutation": "G342T", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.399, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "V", "mutation": "G342V", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.806, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "W", "mutation": "G342W", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G342Y", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.795, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "C", "mutation": "W343C", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.772, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "D", "mutation": "W343D", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.993, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "E", "mutation": "W343E", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.279, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "F", "mutation": "W343F", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.754, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "G", "mutation": "W343G", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.454, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "I", "mutation": "W343I", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.258, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "K", "mutation": "W343K", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "L", "mutation": "W343L", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.931, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "M", "mutation": "W343M", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "N", "mutation": "W343N", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.711, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "P", "mutation": "W343P", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W343Q", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.762, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "S", "mutation": "W343S", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.73, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "T", "mutation": "W343T", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "V", "mutation": "W343V", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 343, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W343W", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.603, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "Y", "mutation": "W343Y", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.3003, "ferret_sera_escape": 0.04032, "mature_H5_site": 344, "mouse_sera_escape": 0.0634, "mutant": "A", "mutation": "Q344A", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.01962, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.3258, "ferret_sera_escape": -0.04957, "mature_H5_site": 344, "mouse_sera_escape": 0.003724, "mutant": "C", "mutation": "Q344C", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.0446, "wildtype": "Q"}, {"a26_usage": 0.01972, "cell_entry": 0.008405, "ferret_sera_escape": 0.1325, "mature_H5_site": 344, "mouse_sera_escape": -0.03507, "mutant": "D", "mutation": "Q344D", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": -0.04501, "wildtype": "Q"}, {"a26_usage": 0.06465, "cell_entry": 0.05667, "ferret_sera_escape": 0.02244, "mature_H5_site": 344, "mouse_sera_escape": -0.03372, "mutant": "E", "mutation": "Q344E", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": -0.03283, "wildtype": "Q"}, {"a26_usage": 0.6251, "cell_entry": -0.07407, "ferret_sera_escape": -0.07382, "mature_H5_site": 344, "mouse_sera_escape": 0.08231, "mutant": "H", "mutation": "Q344H", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.4754, "wildtype": "Q"}, {"a26_usage": 0.06965, "cell_entry": -1.02, "ferret_sera_escape": -0.0462, "mature_H5_site": 344, "mouse_sera_escape": -0.0316, "mutant": "I", "mutation": "Q344I", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.6092, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.7721, "ferret_sera_escape": -0.1716, "mature_H5_site": 344, "mouse_sera_escape": -0.05693, "mutant": "K", "mutation": "Q344K", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": -0.05818, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.051, "ferret_sera_escape": 0.04744, "mature_H5_site": 344, "mouse_sera_escape": -0.03979, "mutant": "L", "mutation": "Q344L", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.4721, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.316, "ferret_sera_escape": -0.2422, "mature_H5_site": 344, "mouse_sera_escape": -0.1867, "mutant": "M", "mutation": "Q344M", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.08878, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.0657, "ferret_sera_escape": -0.0664, "mature_H5_site": 344, "mouse_sera_escape": 0.007667, "mutant": "N", "mutation": "Q344N", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": -0.08229, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.06274, "ferret_sera_escape": 0.04883, "mature_H5_site": 344, "mouse_sera_escape": -0.007899, "mutant": "P", "mutation": "Q344P", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.04412, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 344, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q344Q", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.141, "ferret_sera_escape": 0.03072, "mature_H5_site": 344, "mouse_sera_escape": 0.1437, "mutant": "R", "mutation": "Q344R", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.1315, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.3437, "ferret_sera_escape": 0.03401, "mature_H5_site": 344, "mouse_sera_escape": -0.04086, "mutant": "S", "mutation": "Q344S", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": -0.01223, "wildtype": "Q"}, {"a26_usage": 0.004325, "cell_entry": -0.5702, "ferret_sera_escape": 0.0533, "mature_H5_site": 344, "mouse_sera_escape": 0.03138, "mutant": "T", "mutation": "Q344T", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.1767, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.9498, "ferret_sera_escape": -0.03442, "mature_H5_site": 344, "mouse_sera_escape": 0.05206, "mutant": "V", "mutation": "Q344V", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.3606, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1852, "ferret_sera_escape": -0.06349, "mature_H5_site": 344, "mouse_sera_escape": -0.1168, "mutant": "W", "mutation": "Q344W", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": -0.02302, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.884, "ferret_sera_escape": 0.003507, "mature_H5_site": 345, "mouse_sera_escape": -0.0888, "mutant": "A", "mutation": "G345A", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.799, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "C", "mutation": "G345C", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.486, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "D", "mutation": "G345D", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": 0.07467, "mature_H5_site": 345, "mouse_sera_escape": -0.2059, "mutant": "E", "mutation": "G345E", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.53, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": 0.1204, "mutant": "F", "mutation": "G345F", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 345, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G345G", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.366, "ferret_sera_escape": 0.02444, "mature_H5_site": 345, "mouse_sera_escape": -0.00273, "mutant": "H", "mutation": "G345H", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": -0.08184, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "I", "mutation": "G345I", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.68, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": -0.1309, "mutant": "L", "mutation": "G345L", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.797, "ferret_sera_escape": 0.03496, "mature_H5_site": 345, "mouse_sera_escape": 0.2806, "mutant": "M", "mutation": "G345M", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": -0.03682, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.389, "ferret_sera_escape": 0.09393, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "P", "mutation": "G345P", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.92, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G345Q", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.069, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "R", "mutation": "G345R", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.144, "ferret_sera_escape": -0.07298, "mature_H5_site": 345, "mouse_sera_escape": 0.004074, "mutant": "S", "mutation": "G345S", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": -0.06669, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.675, "ferret_sera_escape": 0.1557, "mature_H5_site": 345, "mouse_sera_escape": 0.09029, "mutant": "T", "mutation": "G345T", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": -0.161, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.836, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "V", "mutation": "G345V", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.42, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "W", "mutation": "G345W", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.405, "ferret_sera_escape": 0.4383, "mature_H5_site": 345, "mouse_sera_escape": 0.2752, "mutant": "Y", "mutation": "G345Y", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": -0.08898, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "C", "mutation": "M346C", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "D", "mutation": "M346D", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.05502, "ferret_sera_escape": -0.3012, "mature_H5_site": 346, "mouse_sera_escape": -0.246, "mutant": "F", "mutation": "M346F", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": -0.08419, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.719, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "G", "mutation": "M346G", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "H", "mutation": "M346H", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.894, "ferret_sera_escape": -0.09775, "mature_H5_site": 346, "mouse_sera_escape": 0.1406, "mutant": "I", "mutation": "M346I", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": -0.1314, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.867, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "K", "mutation": "M346K", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.5736, "ferret_sera_escape": -0.01951, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "L", "mutation": "M346L", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 346, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M346M", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "N", "mutation": "M346N", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "P", "mutation": "M346P", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "R", "mutation": "M346R", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "S", "mutation": "M346S", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.173, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "V", "mutation": "M346V", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.795, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "W", "mutation": "M346W", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.847, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "Y", "mutation": "M346Y", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.7103, "ferret_sera_escape": -0.00316, "mature_H5_site": 347, "mouse_sera_escape": -0.008063, "mutant": "A", "mutation": "V347A", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.09931, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5873, "ferret_sera_escape": 0.02776, "mature_H5_site": 347, "mouse_sera_escape": 0.09978, "mutant": "C", "mutation": "V347C", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.1522, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.319, "ferret_sera_escape": 0.1219, "mature_H5_site": 347, "mouse_sera_escape": 0.06536, "mutant": "E", "mutation": "V347E", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.102, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.121, "ferret_sera_escape": -0.04243, "mature_H5_site": 347, "mouse_sera_escape": -0.02175, "mutant": "F", "mutation": "V347F", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.1276, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.654, "ferret_sera_escape": -0.00862, "mature_H5_site": 347, "mouse_sera_escape": -0.01634, "mutant": "G", "mutation": "V347G", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.0614, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.218, "ferret_sera_escape": 0.04256, "mature_H5_site": 347, "mouse_sera_escape": 0.3304, "mutant": "H", "mutation": "V347H", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2599, "ferret_sera_escape": -0.0008267, "mature_H5_site": 347, "mouse_sera_escape": -0.02686, "mutant": "I", "mutation": "V347I", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.09652, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.03992, "ferret_sera_escape": 0.002308, "mature_H5_site": 347, "mouse_sera_escape": -0.07904, "mutant": "L", "mutation": "V347L", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.0734, "wildtype": "V"}, {"a26_usage": 0.04177, "cell_entry": -0.05824, "ferret_sera_escape": -0.03132, "mature_H5_site": 347, "mouse_sera_escape": -0.09917, "mutant": "M", "mutation": "V347M", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.1081, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.916, "ferret_sera_escape": null, "mature_H5_site": 347, "mouse_sera_escape": null, "mutant": "N", "mutation": "V347N", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.001, "ferret_sera_escape": -0.05155, "mature_H5_site": 347, "mouse_sera_escape": 0.1135, "mutant": "Q", "mutation": "V347Q", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.04444, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7611, "ferret_sera_escape": -0.04555, "mature_H5_site": 347, "mouse_sera_escape": 0.2706, "mutant": "R", "mutation": "V347R", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.1073, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.125, "ferret_sera_escape": -0.1129, "mature_H5_site": 347, "mouse_sera_escape": 0.1962, "mutant": "S", "mutation": "V347S", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.1244, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 347, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V347V", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.07599, "cell_entry": 0.07594, "ferret_sera_escape": -0.04964, "mature_H5_site": 347, "mouse_sera_escape": 0.0109, "mutant": "Y", "mutation": "V347Y", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.1012, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.844, "ferret_sera_escape": -0.07237, "mature_H5_site": 348, "mouse_sera_escape": null, "mutant": "C", "mutation": "D348C", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 348, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D348D", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2697, "ferret_sera_escape": -0.1348, "mature_H5_site": 348, "mouse_sera_escape": -0.08247, "mutant": "E", "mutation": "D348E", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.1455, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.615, "ferret_sera_escape": null, "mature_H5_site": 348, "mouse_sera_escape": null, "mutant": "F", "mutation": "D348F", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5736, "ferret_sera_escape": -0.2358, "mature_H5_site": 348, "mouse_sera_escape": -0.1141, "mutant": "H", "mutation": "D348H", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.1281, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.937, "ferret_sera_escape": null, "mature_H5_site": 348, "mouse_sera_escape": null, "mutant": "K", "mutation": "D348K", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.591, "ferret_sera_escape": null, "mature_H5_site": 348, "mouse_sera_escape": null, "mutant": "L", "mutation": "D348L", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2994, "ferret_sera_escape": -0.09225, "mature_H5_site": 348, "mouse_sera_escape": -0.05296, "mutant": "N", "mutation": "D348N", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.1644, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7125, "ferret_sera_escape": -0.1426, "mature_H5_site": 348, "mouse_sera_escape": -0.08404, "mutant": "Q", "mutation": "D348Q", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.2715, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.107, "ferret_sera_escape": null, "mature_H5_site": 348, "mouse_sera_escape": null, "mutant": "R", "mutation": "D348R", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": null, "wildtype": "D"}, {"a26_usage": 0.4373, "cell_entry": -0.1254, "ferret_sera_escape": -0.05222, "mature_H5_site": 348, "mouse_sera_escape": -0.06899, "mutant": "S", "mutation": "D348S", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.1579, "wildtype": "D"}, {"a26_usage": 0.8325, "cell_entry": -0.9481, "ferret_sera_escape": null, "mature_H5_site": 348, "mouse_sera_escape": null, "mutant": "T", "mutation": "D348T", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5348, "ferret_sera_escape": -0.2215, "mature_H5_site": 348, "mouse_sera_escape": -0.2842, "mutant": "V", "mutation": "D348V", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.2119, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.868, "ferret_sera_escape": -0.1861, "mature_H5_site": 348, "mouse_sera_escape": -0.3, "mutant": "W", "mutation": "D348W", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.5426, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4447, "ferret_sera_escape": -0.1825, "mature_H5_site": 348, "mouse_sera_escape": -0.2062, "mutant": "Y", "mutation": "D348Y", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.1488, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.431, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "C", "mutation": "G349C", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.795, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "D", "mutation": "G349D", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.857, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "F", "mutation": "G349F", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 349, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G349G", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "H", "mutation": "G349H", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "I", "mutation": "G349I", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "L", "mutation": "G349L", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "M", "mutation": "G349M", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "N", "mutation": "G349N", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "P", "mutation": "G349P", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G349Q", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.876, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "R", "mutation": "G349R", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.931, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "S", "mutation": "G349S", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.832, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "T", "mutation": "G349T", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.44, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "V", "mutation": "G349V", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "W", "mutation": "G349W", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G349Y", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.05959, "ferret_sera_escape": -0.2141, "mature_H5_site": 25, "mouse_sera_escape": -0.09439, "mutant": "A", "mutation": "T35A", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": 0.03848, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.6734, "ferret_sera_escape": -0.08631, "mature_H5_site": 25, "mouse_sera_escape": 0.1133, "mutant": "D", "mutation": "T35D", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": -0.05123, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1543, "ferret_sera_escape": null, "mature_H5_site": 25, "mouse_sera_escape": null, "mutant": "E", "mutation": "T35E", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.06106, "ferret_sera_escape": -0.1429, "mature_H5_site": 25, "mouse_sera_escape": -0.04143, "mutant": "F", "mutation": "T35F", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": 0.1075, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4002, "ferret_sera_escape": -0.2636, "mature_H5_site": 25, "mouse_sera_escape": -0.09406, "mutant": "H", "mutation": "T35H", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": 0.0008317, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.8224, "ferret_sera_escape": 0.08765, "mature_H5_site": 25, "mouse_sera_escape": 0.1151, "mutant": "I", "mutation": "T35I", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": -0.131, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.05531, "ferret_sera_escape": -0.2425, "mature_H5_site": 25, "mouse_sera_escape": -0.03897, "mutant": "K", "mutation": "T35K", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": -0.1219, "wildtype": "T"}, {"a26_usage": 0.2467, "cell_entry": 0.06399, "ferret_sera_escape": -0.2636, "mature_H5_site": 25, "mouse_sera_escape": -0.03045, "mutant": "L", "mutation": "T35L", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": -0.00703, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.303, "ferret_sera_escape": -0.2418, "mature_H5_site": 25, "mouse_sera_escape": -0.08086, "mutant": "M", "mutation": "T35M", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": 0.09216, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.04879, "ferret_sera_escape": -0.2115, "mature_H5_site": 25, "mouse_sera_escape": -0.05638, "mutant": "N", "mutation": "T35N", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": -0.04686, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.03163, "ferret_sera_escape": -0.02862, "mature_H5_site": 25, "mouse_sera_escape": 0.07289, "mutant": "P", "mutation": "T35P", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": 0.1894, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.01751, "ferret_sera_escape": 0.131, "mature_H5_site": 25, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T35Q", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.63, "ferret_sera_escape": -0.2127, "mature_H5_site": 25, "mouse_sera_escape": -0.02464, "mutant": "R", "mutation": "T35R", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3758, "ferret_sera_escape": -0.1744, "mature_H5_site": 25, "mouse_sera_escape": 0.08441, "mutant": "S", "mutation": "T35S", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": -0.01182, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 25, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T35T", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.04975, "ferret_sera_escape": -0.1472, "mature_H5_site": 25, "mouse_sera_escape": -0.03642, "mutant": "W", "mutation": "T35W", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.07353, "ferret_sera_escape": -0.2289, "mature_H5_site": 25, "mouse_sera_escape": -0.04406, "mutant": "Y", "mutation": "T35Y", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": 0.1005, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.705, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "C", "mutation": "W350C", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "D", "mutation": "W350D", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "E", "mutation": "W350E", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.746, "ferret_sera_escape": -0.05273, "mature_H5_site": 350, "mouse_sera_escape": -0.04606, "mutant": "F", "mutation": "W350F", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": -0.09743, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "G", "mutation": "W350G", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "H", "mutation": "W350H", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.03, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "I", "mutation": "W350I", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "K", "mutation": "W350K", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.012, "ferret_sera_escape": 0.2162, "mature_H5_site": 350, "mouse_sera_escape": 0.1321, "mutant": "L", "mutation": "W350L", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.088, "ferret_sera_escape": -0.288, "mature_H5_site": 350, "mouse_sera_escape": -0.06406, "mutant": "M", "mutation": "W350M", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.888, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "P", "mutation": "W350P", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W350Q", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "R", "mutation": "W350R", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "S", "mutation": "W350S", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "T", "mutation": "W350T", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.062, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "V", "mutation": "W350V", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 350, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W350W", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.606, "ferret_sera_escape": 0.3015, "mature_H5_site": 350, "mouse_sera_escape": 0.3279, "mutant": "Y", "mutation": "W350Y", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": -0.2603, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y351C", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y351D", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.34, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "F", "mutation": "Y351F", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.004, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y351G", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y351H", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.937, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y351I", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y351K", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y351L", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.981, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y351M", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.015, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y351N", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y351P", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y351Q", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y351R", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y351S", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y351T", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y351W", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 351, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y351Y", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "A", "mutation": "G352A", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "C", "mutation": "G352C", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "D", "mutation": "G352D", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "E", "mutation": "G352E", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "F", "mutation": "G352F", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 352, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G352G", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "H", "mutation": "G352H", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "I", "mutation": "G352I", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "K", "mutation": "G352K", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "L", "mutation": "G352L", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.305, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "M", "mutation": "G352M", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "N", "mutation": "G352N", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G352Q", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.842, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "R", "mutation": "G352R", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "S", "mutation": "G352S", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.174, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "T", "mutation": "G352T", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.861, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "V", "mutation": "G352V", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.464, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "W", "mutation": "G352W", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y353A", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.809, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y353C", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.84, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y353D", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y353E", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3944, "ferret_sera_escape": -0.1563, "mature_H5_site": 353, "mouse_sera_escape": 0.06587, "mutant": "F", "mutation": "Y353F", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": 0.07773, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.879, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y353G", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y353H", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.011, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y353I", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.796, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y353K", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.842, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y353L", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.008, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y353N", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y353P", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.021, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y353Q", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y353R", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.123, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y353T", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y353V", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.5176, "ferret_sera_escape": -0.1742, "mature_H5_site": 353, "mouse_sera_escape": -0.1603, "mutant": "W", "mutation": "Y353W", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": 0.09595, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 353, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y353Y", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.073, "ferret_sera_escape": null, "mature_H5_site": 354, "mouse_sera_escape": null, "mutant": "D", "mutation": "H354D", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.112, "ferret_sera_escape": null, "mature_H5_site": 354, "mouse_sera_escape": null, "mutant": "E", "mutation": "H354E", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.611, "ferret_sera_escape": -0.02329, "mature_H5_site": 354, "mouse_sera_escape": -0.07132, "mutant": "F", "mutation": "H354F", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": 0.05642, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.708, "ferret_sera_escape": null, "mature_H5_site": 354, "mouse_sera_escape": null, "mutant": "G", "mutation": "H354G", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 354, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H354H", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 354, "mouse_sera_escape": null, "mutant": "I", "mutation": "H354I", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": null, "wildtype": "H"}, {"a26_usage": 0.2113, "cell_entry": -0.2202, "ferret_sera_escape": -0.1071, "mature_H5_site": 354, "mouse_sera_escape": 0.03737, "mutant": "K", "mutation": "H354K", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": 0.01965, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.059, "ferret_sera_escape": 0.01448, "mature_H5_site": 354, "mouse_sera_escape": -0.1834, "mutant": "L", "mutation": "H354L", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": -0.1188, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1193, "ferret_sera_escape": -0.0501, "mature_H5_site": 354, "mouse_sera_escape": -0.06029, "mutant": "M", "mutation": "H354M", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": -0.1061, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.111, "ferret_sera_escape": null, "mature_H5_site": 354, "mouse_sera_escape": null, "mutant": "N", "mutation": "H354N", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1964, "ferret_sera_escape": 0.03885, "mature_H5_site": 354, "mouse_sera_escape": -0.0295, "mutant": "R", "mutation": "H354R", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": -0.03999, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.000995, "ferret_sera_escape": 0.1017, "mature_H5_site": 354, "mouse_sera_escape": -0.01624, "mutant": "S", "mutation": "H354S", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": 0.05372, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.219, "ferret_sera_escape": null, "mature_H5_site": 354, "mouse_sera_escape": null, "mutant": "T", "mutation": "H354T", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.499, "ferret_sera_escape": null, "mature_H5_site": 354, "mouse_sera_escape": null, "mutant": "V", "mutation": "H354V", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.544, "ferret_sera_escape": -0.0024, "mature_H5_site": 354, "mouse_sera_escape": 0.05739, "mutant": "W", "mutation": "H354W", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": 0.3456, "wildtype": "H"}, {"a26_usage": 0.5957, "cell_entry": -1.301, "ferret_sera_escape": -0.1255, "mature_H5_site": 354, "mouse_sera_escape": 0.08556, "mutant": "Y", "mutation": "H354Y", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": 0.3825, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3039, "ferret_sera_escape": 0.08185, "mature_H5_site": 355, "mouse_sera_escape": 0.0981, "mutant": "A", "mutation": "H355A", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.01466, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.96, "ferret_sera_escape": null, "mature_H5_site": 355, "mouse_sera_escape": null, "mutant": "D", "mutation": "H355D", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.841, "ferret_sera_escape": 0.01615, "mature_H5_site": 355, "mouse_sera_escape": null, "mutant": "E", "mutation": "H355E", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.263, "ferret_sera_escape": -0.07255, "mature_H5_site": 355, "mouse_sera_escape": 0.02947, "mutant": "F", "mutation": "H355F", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.2703, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.36, "ferret_sera_escape": null, "mature_H5_site": 355, "mouse_sera_escape": null, "mutant": "G", "mutation": "H355G", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 355, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H355H", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.333, "ferret_sera_escape": null, "mature_H5_site": 355, "mouse_sera_escape": null, "mutant": "I", "mutation": "H355I", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1826, "ferret_sera_escape": -0.06984, "mature_H5_site": 355, "mouse_sera_escape": -0.002164, "mutant": "L", "mutation": "H355L", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.003531, "wildtype": "H"}, {"a26_usage": 0.3416, "cell_entry": -0.6519, "ferret_sera_escape": -0.06324, "mature_H5_site": 355, "mouse_sera_escape": -0.02043, "mutant": "M", "mutation": "H355M", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.3372, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.829, "ferret_sera_escape": null, "mature_H5_site": 355, "mouse_sera_escape": null, "mutant": "N", "mutation": "H355N", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5116, "ferret_sera_escape": null, "mature_H5_site": 355, "mouse_sera_escape": null, "mutant": "Q", "mutation": "H355Q", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.856, "ferret_sera_escape": null, "mature_H5_site": 355, "mouse_sera_escape": null, "mutant": "R", "mutation": "H355R", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.2482, "ferret_sera_escape": 0.01786, "mature_H5_site": 355, "mouse_sera_escape": -0.1041, "mutant": "S", "mutation": "H355S", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.006645, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3129, "ferret_sera_escape": 0.07551, "mature_H5_site": 355, "mouse_sera_escape": 0.2832, "mutant": "V", "mutation": "H355V", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.1214, "wildtype": "H"}, {"a26_usage": 0.4866, "cell_entry": -1.204, "ferret_sera_escape": -0.03437, "mature_H5_site": 355, "mouse_sera_escape": -0.06402, "mutant": "Y", "mutation": "H355Y", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.3516, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.06263, "ferret_sera_escape": 0.01766, "mature_H5_site": 356, "mouse_sera_escape": -0.06233, "mutant": "C", "mutation": "S356C", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": 0.03091, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1314, "ferret_sera_escape": 0.1128, "mature_H5_site": 356, "mouse_sera_escape": 0.02575, "mutant": "D", "mutation": "S356D", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.01744, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1531, "ferret_sera_escape": -0.1091, "mature_H5_site": 356, "mouse_sera_escape": -0.08542, "mutant": "E", "mutation": "S356E", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": 0.01262, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.07867, "ferret_sera_escape": -0.1223, "mature_H5_site": 356, "mouse_sera_escape": -0.02076, "mutant": "F", "mutation": "S356F", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.04711, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.046, "ferret_sera_escape": null, "mature_H5_site": 356, "mouse_sera_escape": null, "mutant": "G", "mutation": "S356G", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6692, "ferret_sera_escape": 0.07158, "mature_H5_site": 356, "mouse_sera_escape": -0.05984, "mutant": "H", "mutation": "S356H", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.1201, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1908, "ferret_sera_escape": 0.1265, "mature_H5_site": 356, "mouse_sera_escape": 0.1201, "mutant": "I", "mutation": "S356I", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.05106, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2403, "ferret_sera_escape": -0.0182, "mature_H5_site": 356, "mouse_sera_escape": -0.06309, "mutant": "K", "mutation": "S356K", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.0792, "wildtype": "S"}, {"a26_usage": 0.06793, "cell_entry": 0.07318, "ferret_sera_escape": -0.08667, "mature_H5_site": 356, "mouse_sera_escape": -0.09902, "mutant": "L", "mutation": "S356L", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.05135, "wildtype": "S"}, {"a26_usage": 0.6651, "cell_entry": -0.1524, "ferret_sera_escape": 0.07735, "mature_H5_site": 356, "mouse_sera_escape": 0.08511, "mutant": "M", "mutation": "S356M", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.008623, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3316, "ferret_sera_escape": -0.02389, "mature_H5_site": 356, "mouse_sera_escape": 0.01859, "mutant": "N", "mutation": "S356N", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.04972, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.877, "ferret_sera_escape": null, "mature_H5_site": 356, "mouse_sera_escape": null, "mutant": "P", "mutation": "S356P", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": null, "wildtype": "S"}, {"a26_usage": 0.02285, "cell_entry": 0.07727, "ferret_sera_escape": 5.933e-05, "mature_H5_site": 356, "mouse_sera_escape": null, "mutant": "Q", "mutation": "S356Q", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": 0.04096, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1829, "ferret_sera_escape": -0.02246, "mature_H5_site": 356, "mouse_sera_escape": 0.06302, "mutant": "R", "mutation": "S356R", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.08338, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 356, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S356S", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.04664, "ferret_sera_escape": 0.07652, "mature_H5_site": 356, "mouse_sera_escape": null, "mutant": "T", "mutation": "S356T", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.04194, "ferret_sera_escape": 0.01321, "mature_H5_site": 356, "mouse_sera_escape": -0.02344, "mutant": "V", "mutation": "S356V", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.02199, "wildtype": "S"}, {"a26_usage": 0.02423, "cell_entry": -0.5616, "ferret_sera_escape": -0.02143, "mature_H5_site": 356, "mouse_sera_escape": 0.05127, "mutant": "W", "mutation": "S356W", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.06401, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.416, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "C", "mutation": "N357C", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "D", "mutation": "N357D", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.045, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "E", "mutation": "N357E", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "F", "mutation": "N357F", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -6.034, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "G", "mutation": "N357G", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "H", "mutation": "N357H", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "K", "mutation": "N357K", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "M", "mutation": "N357M", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 357, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N357N", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.83, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "P", "mutation": "N357P", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N357Q", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "R", "mutation": "N357R", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.835, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "V", "mutation": "N357V", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "W", "mutation": "N357W", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1878, "ferret_sera_escape": -0.03242, "mature_H5_site": 358, "mouse_sera_escape": 0.07868, "mutant": "C", "mutation": "E358C", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.08506, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01101, "ferret_sera_escape": 0.1111, "mature_H5_site": 358, "mouse_sera_escape": 0.003017, "mutant": "D", "mutation": "E358D", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": 0.04012, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 358, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E358E", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.04931, "cell_entry": -0.3746, "ferret_sera_escape": -0.1836, "mature_H5_site": 358, "mouse_sera_escape": -0.05146, "mutant": "G", "mutation": "E358G", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.01586, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3734, "ferret_sera_escape": 0.05369, "mature_H5_site": 358, "mouse_sera_escape": 0.02814, "mutant": "I", "mutation": "E358I", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.07273, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.208, "ferret_sera_escape": -0.05264, "mature_H5_site": 358, "mouse_sera_escape": 0.1705, "mutant": "K", "mutation": "E358K", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2666, "ferret_sera_escape": -0.0159, "mature_H5_site": 358, "mouse_sera_escape": 0.025, "mutant": "L", "mutation": "E358L", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.06603, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07484, "ferret_sera_escape": 0.006067, "mature_H5_site": 358, "mouse_sera_escape": 0.029, "mutant": "N", "mutation": "E358N", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.0468, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.448, "ferret_sera_escape": null, "mature_H5_site": 358, "mouse_sera_escape": null, "mutant": "P", "mutation": "E358P", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": null, "wildtype": "E"}, {"a26_usage": 0.2992, "cell_entry": -0.2098, "ferret_sera_escape": 0.0355, "mature_H5_site": 358, "mouse_sera_escape": 0.09162, "mutant": "Q", "mutation": "E358Q", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.05344, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7569, "ferret_sera_escape": 0.001853, "mature_H5_site": 358, "mouse_sera_escape": 0.08439, "mutant": "S", "mutation": "E358S", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": 0.03684, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07576, "ferret_sera_escape": -0.02942, "mature_H5_site": 358, "mouse_sera_escape": 0.08005, "mutant": "T", "mutation": "E358T", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.07702, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07242, "ferret_sera_escape": 0.2163, "mature_H5_site": 358, "mouse_sera_escape": 0.05785, "mutant": "V", "mutation": "E358V", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.03558, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.351, "ferret_sera_escape": -0.3226, "mature_H5_site": 358, "mouse_sera_escape": 0.03627, "mutant": "W", "mutation": "E358W", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.068, "ferret_sera_escape": -0.1213, "mature_H5_site": 358, "mouse_sera_escape": -0.05259, "mutant": "Y", "mutation": "E358Y", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.569, "ferret_sera_escape": -0.1038, "mature_H5_site": 359, "mouse_sera_escape": -0.06223, "mutant": "A", "mutation": "Q359A", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.04351, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.4672, "ferret_sera_escape": -0.08185, "mature_H5_site": 359, "mouse_sera_escape": 0.08863, "mutant": "D", "mutation": "Q359D", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.0729, "wildtype": "Q"}, {"a26_usage": 0.2017, "cell_entry": -0.04854, "ferret_sera_escape": -0.1104, "mature_H5_site": 359, "mouse_sera_escape": -0.04317, "mutant": "E", "mutation": "Q359E", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.06327, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.08376, "ferret_sera_escape": null, "mature_H5_site": 359, "mouse_sera_escape": null, "mutant": "F", "mutation": "Q359F", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1041, "ferret_sera_escape": null, "mature_H5_site": 359, "mouse_sera_escape": null, "mutant": "H", "mutation": "Q359H", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.04396, "ferret_sera_escape": -0.1358, "mature_H5_site": 359, "mouse_sera_escape": -0.06619, "mutant": "I", "mutation": "Q359I", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.08213, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.583, "ferret_sera_escape": 0.01606, "mature_H5_site": 359, "mouse_sera_escape": 0.2214, "mutant": "K", "mutation": "Q359K", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.07239, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.03834, "ferret_sera_escape": -0.02199, "mature_H5_site": 359, "mouse_sera_escape": -0.008382, "mutant": "L", "mutation": "Q359L", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.006579, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5241, "ferret_sera_escape": -0.03912, "mature_H5_site": 359, "mouse_sera_escape": -0.03865, "mutant": "M", "mutation": "Q359M", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.04058, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.733, "ferret_sera_escape": -0.1989, "mature_H5_site": 359, "mouse_sera_escape": 0.05975, "mutant": "N", "mutation": "Q359N", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.07098, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.212, "ferret_sera_escape": null, "mature_H5_site": 359, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q359P", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 359, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q359Q", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.8552, "ferret_sera_escape": -0.06253, "mature_H5_site": 359, "mouse_sera_escape": 0.1742, "mutant": "R", "mutation": "Q359R", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.1211, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 359, "mouse_sera_escape": null, "mutant": "S", "mutation": "Q359S", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 359, "mouse_sera_escape": null, "mutant": "T", "mutation": "Q359T", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.4509, "ferret_sera_escape": -0.1446, "mature_H5_site": 359, "mouse_sera_escape": 0.07644, "mutant": "V", "mutation": "Q359V", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.1256, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.05101, "ferret_sera_escape": -0.05613, "mature_H5_site": 359, "mouse_sera_escape": -0.0453, "mutant": "W", "mutation": "Q359W", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.006867, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.861, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "A", "mutation": "V36A", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.057, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "C", "mutation": "V36C", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -6.01, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "D", "mutation": "V36D", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "E", "mutation": "V36E", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "F", "mutation": "V36F", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "G", "mutation": "V36G", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2526, "ferret_sera_escape": 0.0471, "mature_H5_site": 26, "mouse_sera_escape": 0.06256, "mutant": "I", "mutation": "V36I", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": 0.0839, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.037, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "L", "mutation": "V36L", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.097, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "M", "mutation": "V36M", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.656, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "N", "mutation": "V36N", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.698, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "P", "mutation": "V36P", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V36Q", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.013, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "R", "mutation": "V36R", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "S", "mutation": "V36S", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "T", "mutation": "V36T", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 26, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V36V", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.054, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "W", "mutation": "V36W", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.439, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "C", "mutation": "G360C", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "D", "mutation": "G360D", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.736, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "E", "mutation": "G360E", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 360, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G360G", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.819, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "H", "mutation": "G360H", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.426, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "I", "mutation": "G360I", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "K", "mutation": "G360K", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "L", "mutation": "G360L", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.671, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "N", "mutation": "G360N", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "P", "mutation": "G360P", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.399, "ferret_sera_escape": 0.0826, "mature_H5_site": 360, "mouse_sera_escape": 0.1499, "mutant": "S", "mutation": "G360S", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": -0.1955, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.579, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "T", "mutation": "G360T", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.821, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "V", "mutation": "G360V", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.355, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "W", "mutation": "G360W", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.644, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G360Y", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.023, "ferret_sera_escape": -0.07388, "mature_H5_site": 361, "mouse_sera_escape": 0.2368, "mutant": "C", "mutation": "S361C", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4424, "ferret_sera_escape": -0.1076, "mature_H5_site": 361, "mouse_sera_escape": -0.07331, "mutant": "D", "mutation": "S361D", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.1099, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3236, "ferret_sera_escape": -0.05186, "mature_H5_site": 361, "mouse_sera_escape": -0.02692, "mutant": "F", "mutation": "S361F", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.08057, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06629, "ferret_sera_escape": -0.07656, "mature_H5_site": 361, "mouse_sera_escape": 0.06053, "mutant": "H", "mutation": "S361H", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.0749, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2004, "ferret_sera_escape": 0.08013, "mature_H5_site": 361, "mouse_sera_escape": 0.0446, "mutant": "I", "mutation": "S361I", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.081, "ferret_sera_escape": 0.1506, "mature_H5_site": 361, "mouse_sera_escape": 0.202, "mutant": "K", "mutation": "S361K", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.01333, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.347, "ferret_sera_escape": -0.2355, "mature_H5_site": 361, "mouse_sera_escape": 0.09728, "mutant": "L", "mutation": "S361L", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.2056, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.05795, "ferret_sera_escape": 0.02898, "mature_H5_site": 361, "mouse_sera_escape": -0.0422, "mutant": "M", "mutation": "S361M", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.1828, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.828, "ferret_sera_escape": -0.009977, "mature_H5_site": 361, "mouse_sera_escape": 0.07156, "mutant": "N", "mutation": "S361N", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.838, "ferret_sera_escape": null, "mature_H5_site": 361, "mouse_sera_escape": null, "mutant": "P", "mutation": "S361P", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2279, "ferret_sera_escape": 0.05282, "mature_H5_site": 361, "mouse_sera_escape": 0.02891, "mutant": "Q", "mutation": "S361Q", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.03773, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1748, "ferret_sera_escape": -0.01043, "mature_H5_site": 361, "mouse_sera_escape": 0.1473, "mutant": "R", "mutation": "S361R", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.1152, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 361, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S361S", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.0247, "ferret_sera_escape": -0.02651, "mature_H5_site": 361, "mouse_sera_escape": 0.005695, "mutant": "T", "mutation": "S361T", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.05898, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06492, "ferret_sera_escape": -0.09316, "mature_H5_site": 361, "mouse_sera_escape": -0.001487, "mutant": "V", "mutation": "S361V", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.07866, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.05194, "ferret_sera_escape": 0.121, "mature_H5_site": 361, "mouse_sera_escape": -0.01399, "mutant": "W", "mutation": "S361W", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.06712, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1629, "ferret_sera_escape": -0.02559, "mature_H5_site": 361, "mouse_sera_escape": 0.03064, "mutant": "Y", "mutation": "S361Y", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.1157, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.02103, "ferret_sera_escape": null, "mature_H5_site": 362, "mouse_sera_escape": null, "mutant": "A", "mutation": "G362A", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.9292, "ferret_sera_escape": -0.1088, "mature_H5_site": 362, "mouse_sera_escape": 0.06967, "mutant": "C", "mutation": "G362C", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": -0.01388, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7029, "ferret_sera_escape": -0.06603, "mature_H5_site": 362, "mouse_sera_escape": -0.1159, "mutant": "D", "mutation": "G362D", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": -0.1153, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.182, "ferret_sera_escape": -0.05039, "mature_H5_site": 362, "mouse_sera_escape": 0.2541, "mutant": "E", "mutation": "G362E", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": -0.005209, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.253, "ferret_sera_escape": -0.184, "mature_H5_site": 362, "mouse_sera_escape": 0.2772, "mutant": "F", "mutation": "G362F", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.02233, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 362, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G362G", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5714, "ferret_sera_escape": -0.3031, "mature_H5_site": 362, "mouse_sera_escape": 0.1726, "mutant": "H", "mutation": "G362H", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": -0.03617, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.314, "ferret_sera_escape": 0.05769, "mature_H5_site": 362, "mouse_sera_escape": 0.353, "mutant": "I", "mutation": "G362I", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.04043, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.322, "ferret_sera_escape": -0.0817, "mature_H5_site": 362, "mouse_sera_escape": 0.1892, "mutant": "K", "mutation": "G362K", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.03723, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3178, "ferret_sera_escape": -0.2008, "mature_H5_site": 362, "mouse_sera_escape": 0.09079, "mutant": "M", "mutation": "G362M", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.09489, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.336, "ferret_sera_escape": -0.1296, "mature_H5_site": 362, "mouse_sera_escape": 0.178, "mutant": "N", "mutation": "G362N", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": -0.02992, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.598, "ferret_sera_escape": null, "mature_H5_site": 362, "mouse_sera_escape": null, "mutant": "P", "mutation": "G362P", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7936, "ferret_sera_escape": -0.01014, "mature_H5_site": 362, "mouse_sera_escape": 0.2009, "mutant": "Q", "mutation": "G362Q", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.1408, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7424, "ferret_sera_escape": -0.02258, "mature_H5_site": 362, "mouse_sera_escape": 0.1859, "mutant": "R", "mutation": "G362R", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.1115, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.03737, "ferret_sera_escape": 0.04514, "mature_H5_site": 362, "mouse_sera_escape": 0.134, "mutant": "S", "mutation": "G362S", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.0009184, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.261, "ferret_sera_escape": null, "mature_H5_site": 362, "mouse_sera_escape": null, "mutant": "T", "mutation": "G362T", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.421, "ferret_sera_escape": -0.215, "mature_H5_site": 362, "mouse_sera_escape": 0.2141, "mutant": "V", "mutation": "G362V", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.04874, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.339, "ferret_sera_escape": -0.2891, "mature_H5_site": 362, "mouse_sera_escape": 0.02598, "mutant": "W", "mutation": "G362W", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": -0.03231, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.841, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y363D", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.009, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y363G", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.171, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y363H", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.616, "ferret_sera_escape": 0.02437, "mature_H5_site": 363, "mouse_sera_escape": 0.2549, "mutant": "I", "mutation": "Y363I", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": -0.1759, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y363K", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.219, "ferret_sera_escape": -0.02104, "mature_H5_site": 363, "mouse_sera_escape": 0.1856, "mutant": "M", "mutation": "Y363M", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": -0.2342, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.654, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y363N", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y363P", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.357, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y363Q", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y363R", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y363S", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y363T", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.777, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y363V", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6294, "ferret_sera_escape": -0.2013, "mature_H5_site": 363, "mouse_sera_escape": -0.08164, "mutant": "W", "mutation": "Y363W", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": -0.2114, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 363, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y363Y", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 364, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A364A", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.161, "ferret_sera_escape": -0.08006, "mature_H5_site": 364, "mouse_sera_escape": -0.085, "mutant": "C", "mutation": "A364C", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.418, "ferret_sera_escape": null, "mature_H5_site": 364, "mouse_sera_escape": null, "mutant": "D", "mutation": "A364D", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.728, "ferret_sera_escape": null, "mature_H5_site": 364, "mouse_sera_escape": null, "mutant": "E", "mutation": "A364E", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.474, "ferret_sera_escape": null, "mature_H5_site": 364, "mouse_sera_escape": null, "mutant": "F", "mutation": "A364F", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.33, "ferret_sera_escape": -0.02686, "mature_H5_site": 364, "mouse_sera_escape": 0.1658, "mutant": "G", "mutation": "A364G", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": -0.07853, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.359, "ferret_sera_escape": -0.3084, "mature_H5_site": 364, "mouse_sera_escape": 0.1401, "mutant": "I", "mutation": "A364I", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": 0.1392, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.564, "ferret_sera_escape": null, "mature_H5_site": 364, "mouse_sera_escape": null, "mutant": "K", "mutation": "A364K", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.9535, "ferret_sera_escape": -0.05472, "mature_H5_site": 364, "mouse_sera_escape": 0.2242, "mutant": "M", "mutation": "A364M", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": 0.003595, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.87, "ferret_sera_escape": null, "mature_H5_site": 364, "mouse_sera_escape": null, "mutant": "N", "mutation": "A364N", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 364, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A364Q", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.06152, "cell_entry": -0.1324, "ferret_sera_escape": 0.2671, "mature_H5_site": 364, "mouse_sera_escape": 0.06395, "mutant": "S", "mutation": "A364S", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": 0.00583, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.18, "ferret_sera_escape": -0.122, "mature_H5_site": 364, "mouse_sera_escape": 0.05024, "mutant": "T", "mutation": "A364T", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": 0.2339, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.008, "ferret_sera_escape": 0.01409, "mature_H5_site": 364, "mouse_sera_escape": -0.005255, "mutant": "V", "mutation": "A364V", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": 0.05338, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.627, "ferret_sera_escape": null, "mature_H5_site": 364, "mouse_sera_escape": null, "mutant": "W", "mutation": "A364W", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 365, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A365A", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.926, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "D", "mutation": "A365D", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "E", "mutation": "A365E", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.954, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "F", "mutation": "A365F", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.907, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "H", "mutation": "A365H", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.735, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "I", "mutation": "A365I", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.827, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "K", "mutation": "A365K", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.529, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "L", "mutation": "A365L", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.362, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "M", "mutation": "A365M", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.832, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "N", "mutation": "A365N", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.975, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A365Q", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.757, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "R", "mutation": "A365R", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.295, "cell_entry": -0.1733, "ferret_sera_escape": 0.07661, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "S", "mutation": "A365S", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.175, "ferret_sera_escape": 0.2766, "mature_H5_site": 365, "mouse_sera_escape": 0.6934, "mutant": "T", "mutation": "A365T", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": -0.2564, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.354, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "V", "mutation": "A365V", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "W", "mutation": "A365W", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1232, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "A", "mutation": "D366A", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1671, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "C", "mutation": "D366C", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 366, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D366D", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.955, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "F", "mutation": "D366F", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.06, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "G", "mutation": "D366G", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.1073, "cell_entry": 0.00462, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "H", "mutation": "D366H", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.09276, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "N", "mutation": "D366N", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.944, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "P", "mutation": "D366P", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.1562, "cell_entry": -0.1119, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "R", "mutation": "D366R", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.9413, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "S", "mutation": "D366S", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.288, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "T", "mutation": "D366T", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.009, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "V", "mutation": "D366V", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.442, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D366Y", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.1684, "cell_entry": -0.876, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "A", "mutation": "K367A", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.06172, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "E", "mutation": "K367E", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 367, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K367K", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.298, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "L", "mutation": "K367L", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.9462, "cell_entry": -0.2492, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "M", "mutation": "K367M", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2832, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "N", "mutation": "K367N", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.248, "ferret_sera_escape": -0.2695, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "P", "mutation": "K367P", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03098, "ferret_sera_escape": 0.1326, "mature_H5_site": 367, "mouse_sera_escape": 0.02126, "mutant": "Q", "mutation": "K367Q", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3132, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "R", "mutation": "K367R", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.7208, "cell_entry": -4.048, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "S", "mutation": "K367S", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.23, "cell_entry": -0.8258, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "T", "mutation": "K367T", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.00256, "ferret_sera_escape": null, "mature_H5_site": 368, "mouse_sera_escape": null, "mutant": "D", "mutation": "E368D", "reference_site": "368", "region": "HA2", "sequential_site": 384, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 368, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E368E", "reference_site": "368", "region": "HA2", "sequential_site": 384, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2061, "ferret_sera_escape": -0.01226, "mature_H5_site": 368, "mouse_sera_escape": -0.06088, "mutant": "G", "mutation": "E368G", "reference_site": "368", "region": "HA2", "sequential_site": 384, "stability": -0.03281, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.00354, "ferret_sera_escape": -0.004617, "mature_H5_site": 368, "mouse_sera_escape": -0.03037, "mutant": "K", "mutation": "E368K", "reference_site": "368", "region": "HA2", "sequential_site": 384, "stability": -0.1331, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1272, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "A", "mutation": "S369A", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1512, "ferret_sera_escape": -0.03363, "mature_H5_site": 369, "mouse_sera_escape": -0.07967, "mutant": "C", "mutation": "S369C", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": -0.02221, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.613, "ferret_sera_escape": -0.191, "mature_H5_site": 369, "mouse_sera_escape": -0.0338, "mutant": "D", "mutation": "S369D", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.01033, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "E", "mutation": "S369E", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 1.814, "cell_entry": -1.502, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "F", "mutation": "S369F", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.06606, "ferret_sera_escape": -0.1719, "mature_H5_site": 369, "mouse_sera_escape": 0.03938, "mutant": "G", "mutation": "S369G", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": -0.1264, "wildtype": "S"}, {"a26_usage": 0.1978, "cell_entry": -1.536, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "I", "mutation": "S369I", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4442, "ferret_sera_escape": 0.02305, "mature_H5_site": 369, "mouse_sera_escape": 0.414, "mutant": "L", "mutation": "S369L", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.18, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "N", "mutation": "S369N", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.577, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "P", "mutation": "S369P", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4384, "ferret_sera_escape": 0.01371, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "R", "mutation": "S369R", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 369, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S369S", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.963, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "T", "mutation": "S369T", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.653, "ferret_sera_escape": 0.3821, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "V", "mutation": "S369V", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.721, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "W", "mutation": "S369W", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4119, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S369Y", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "A", "mutation": "T37A", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.748, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "C", "mutation": "T37C", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "D", "mutation": "T37D", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "E", "mutation": "T37E", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "F", "mutation": "T37F", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.325, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "G", "mutation": "T37G", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "H", "mutation": "T37H", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.867, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "I", "mutation": "T37I", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "K", "mutation": "T37K", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "L", "mutation": "T37L", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.034, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "M", "mutation": "T37M", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.72, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "P", "mutation": "T37P", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.575, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "S", "mutation": "T37S", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 27, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T37T", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.158, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "W", "mutation": "T37W", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.802, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "A", "mutation": "T370A", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.494, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "C", "mutation": "T370C", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "D", "mutation": "T370D", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.726, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "E", "mutation": "T370E", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "F", "mutation": "T370F", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "G", "mutation": "T370G", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.121, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "H", "mutation": "T370H", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "I", "mutation": "T370I", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.483, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "K", "mutation": "T370K", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "L", "mutation": "T370L", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.871, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "M", "mutation": "T370M", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "N", "mutation": "T370N", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "P", "mutation": "T370P", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.848, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T370Q", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.879, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "R", "mutation": "T370R", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.01304, "ferret_sera_escape": -0.03962, "mature_H5_site": 370, "mouse_sera_escape": -0.00353, "mutant": "S", "mutation": "T370S", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": -0.2099, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 370, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T370T", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.667, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "V", "mutation": "T370V", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "W", "mutation": "T370W", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.849, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T370Y", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.07425, "ferret_sera_escape": -0.08653, "mature_H5_site": 371, "mouse_sera_escape": 0.1046, "mutant": "A", "mutation": "Q371A", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.1655, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.419, "ferret_sera_escape": null, "mature_H5_site": 371, "mouse_sera_escape": null, "mutant": "C", "mutation": "Q371C", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.769, "ferret_sera_escape": -0.08981, "mature_H5_site": 371, "mouse_sera_escape": 0.1489, "mutant": "D", "mutation": "Q371D", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.1421, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2286, "ferret_sera_escape": -0.1642, "mature_H5_site": 371, "mouse_sera_escape": 0.03427, "mutant": "E", "mutation": "Q371E", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.06881, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 371, "mouse_sera_escape": null, "mutant": "F", "mutation": "Q371F", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5295, "ferret_sera_escape": -0.2519, "mature_H5_site": 371, "mouse_sera_escape": 0.02748, "mutant": "G", "mutation": "Q371G", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.023, "ferret_sera_escape": null, "mature_H5_site": 371, "mouse_sera_escape": null, "mutant": "H", "mutation": "Q371H", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.143, "ferret_sera_escape": -0.02396, "mature_H5_site": 371, "mouse_sera_escape": 0.3547, "mutant": "I", "mutation": "Q371I", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.1476, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.69, "ferret_sera_escape": -0.02867, "mature_H5_site": 371, "mouse_sera_escape": 0.1413, "mutant": "K", "mutation": "Q371K", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.008556, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.734, "ferret_sera_escape": null, "mature_H5_site": 371, "mouse_sera_escape": null, "mutant": "L", "mutation": "Q371L", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.7269, "ferret_sera_escape": 0.05508, "mature_H5_site": 371, "mouse_sera_escape": 0.1042, "mutant": "M", "mutation": "Q371M", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.07456, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.01187, "ferret_sera_escape": 0.005164, "mature_H5_site": 371, "mouse_sera_escape": 0.04116, "mutant": "N", "mutation": "Q371N", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.09053, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 371, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q371P", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 371, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q371Q", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.411, "ferret_sera_escape": 0.1985, "mature_H5_site": 371, "mouse_sera_escape": 0.2459, "mutant": "R", "mutation": "Q371R", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2476, "ferret_sera_escape": -0.08532, "mature_H5_site": 371, "mouse_sera_escape": 0.04861, "mutant": "S", "mutation": "Q371S", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.1918, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.9552, "ferret_sera_escape": -0.03909, "mature_H5_site": 371, "mouse_sera_escape": 0.05093, "mutant": "T", "mutation": "Q371T", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.149, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.256, "ferret_sera_escape": null, "mature_H5_site": 371, "mouse_sera_escape": null, "mutant": "V", "mutation": "Q371V", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.589, "ferret_sera_escape": null, "mature_H5_site": 371, "mouse_sera_escape": null, "mutant": "Y", "mutation": "Q371Y", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.05935, "ferret_sera_escape": -0.09079, "mature_H5_site": 372, "mouse_sera_escape": -0.0709, "mutant": "A", "mutation": "K372A", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1635, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.06388, "ferret_sera_escape": -0.05973, "mature_H5_site": 372, "mouse_sera_escape": -0.0147, "mutant": "C", "mutation": "K372C", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1796, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.725, "ferret_sera_escape": null, "mature_H5_site": 372, "mouse_sera_escape": -0.1707, "mutant": "D", "mutation": "K372D", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.147, "ferret_sera_escape": -0.1683, "mature_H5_site": 372, "mouse_sera_escape": 0.04285, "mutant": "E", "mutation": "K372E", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1876, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5297, "ferret_sera_escape": -0.1184, "mature_H5_site": 372, "mouse_sera_escape": -0.03781, "mutant": "F", "mutation": "K372F", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1076, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4995, "ferret_sera_escape": -0.2319, "mature_H5_site": 372, "mouse_sera_escape": -0.09209, "mutant": "G", "mutation": "K372G", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1013, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3715, "ferret_sera_escape": 0.03925, "mature_H5_site": 372, "mouse_sera_escape": -0.05646, "mutant": "H", "mutation": "K372H", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1184, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2627, "ferret_sera_escape": null, "mature_H5_site": 372, "mouse_sera_escape": -0.05502, "mutant": "I", "mutation": "K372I", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 372, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K372K", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03692, "ferret_sera_escape": -0.03942, "mature_H5_site": 372, "mouse_sera_escape": -0.1493, "mutant": "L", "mutation": "K372L", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.2929, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5105, "ferret_sera_escape": -0.1472, "mature_H5_site": 372, "mouse_sera_escape": -0.03143, "mutant": "M", "mutation": "K372M", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.0184, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.04168, "ferret_sera_escape": -0.1502, "mature_H5_site": 372, "mouse_sera_escape": 0.0007795, "mutant": "N", "mutation": "K372N", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.3352, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.421, "ferret_sera_escape": null, "mature_H5_site": 372, "mouse_sera_escape": null, "mutant": "P", "mutation": "K372P", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.002069, "ferret_sera_escape": -0.09448, "mature_H5_site": 372, "mouse_sera_escape": -0.08272, "mutant": "Q", "mutation": "K372Q", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1763, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.02441, "ferret_sera_escape": -0.05219, "mature_H5_site": 372, "mouse_sera_escape": 0.01597, "mutant": "R", "mutation": "K372R", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1229, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.02657, "ferret_sera_escape": null, "mature_H5_site": 372, "mouse_sera_escape": null, "mutant": "S", "mutation": "K372S", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1544, "ferret_sera_escape": 0.02241, "mature_H5_site": 372, "mouse_sera_escape": 0.03536, "mutant": "T", "mutation": "K372T", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.238, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5793, "ferret_sera_escape": null, "mature_H5_site": 372, "mouse_sera_escape": null, "mutant": "V", "mutation": "K372V", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2627, "ferret_sera_escape": 0.01271, "mature_H5_site": 372, "mouse_sera_escape": 0.02299, "mutant": "W", "mutation": "K372W", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": 0.7202, "wildtype": "K"}, {"a26_usage": 0.07052, "cell_entry": -0.1247, "ferret_sera_escape": -0.05016, "mature_H5_site": 372, "mouse_sera_escape": -0.05639, "mutant": "Y", "mutation": "K372Y", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.2332, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 373, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A373A", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.848, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "C", "mutation": "A373C", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "D", "mutation": "A373D", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.892, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "E", "mutation": "A373E", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "F", "mutation": "A373F", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.01648, "ferret_sera_escape": 0.01838, "mature_H5_site": 373, "mouse_sera_escape": 0.006231, "mutant": "G", "mutation": "A373G", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": 0.8378, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "H", "mutation": "A373H", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "K", "mutation": "A373K", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "L", "mutation": "A373L", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.367, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "M", "mutation": "A373M", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "N", "mutation": "A373N", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "P", "mutation": "A373P", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.87, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A373Q", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.806, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "R", "mutation": "A373R", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.542, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "S", "mutation": "A373S", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.028, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "T", "mutation": "A373T", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "V", "mutation": "A373V", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.594, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "W", "mutation": "A373W", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.059, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "C", "mutation": "I374C", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.318, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "D", "mutation": "I374D", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.02657, "cell_entry": -0.2379, "ferret_sera_escape": -0.02611, "mature_H5_site": 374, "mouse_sera_escape": 0.04862, "mutant": "F", "mutation": "I374F", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": -0.2311, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.904, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "G", "mutation": "I374G", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.44, "ferret_sera_escape": -0.09267, "mature_H5_site": 374, "mouse_sera_escape": 0.02047, "mutant": "H", "mutation": "I374H", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": -0.334, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 374, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I374I", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.875, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "K", "mutation": "I374K", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.05206, "ferret_sera_escape": 0.03999, "mature_H5_site": 374, "mouse_sera_escape": 0.02229, "mutant": "L", "mutation": "I374L", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": -0.2401, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.213, "ferret_sera_escape": -0.1007, "mature_H5_site": 374, "mouse_sera_escape": 0.2308, "mutant": "N", "mutation": "I374N", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": -0.3011, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.258, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "P", "mutation": "I374P", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1133, "ferret_sera_escape": 0.001767, "mature_H5_site": 374, "mouse_sera_escape": 0.01013, "mutant": "Q", "mutation": "I374Q", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": -0.1075, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.87, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "R", "mutation": "I374R", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.072, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "S", "mutation": "I374S", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03099, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "T", "mutation": "I374T", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03036, "ferret_sera_escape": -0.0136, "mature_H5_site": 374, "mouse_sera_escape": -0.07489, "mutant": "V", "mutation": "I374V", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": -0.08675, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.412, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "W", "mutation": "I374W", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.169, "ferret_sera_escape": null, "mature_H5_site": 375, "mouse_sera_escape": null, "mutant": "A", "mutation": "D375A", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.064, "ferret_sera_escape": 0.02573, "mature_H5_site": 375, "mouse_sera_escape": 0.1217, "mutant": "C", "mutation": "D375C", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.1075, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 375, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D375D", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7386, "ferret_sera_escape": 0.002568, "mature_H5_site": 375, "mouse_sera_escape": -0.002979, "mutant": "E", "mutation": "D375E", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.07786, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7592, "ferret_sera_escape": -0.00759, "mature_H5_site": 375, "mouse_sera_escape": 0.1265, "mutant": "F", "mutation": "D375F", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.2911, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.01165, "ferret_sera_escape": -0.1019, "mature_H5_site": 375, "mouse_sera_escape": 0.03899, "mutant": "G", "mutation": "D375G", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.2, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3345, "ferret_sera_escape": -0.05913, "mature_H5_site": 375, "mouse_sera_escape": 0.06578, "mutant": "H", "mutation": "D375H", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.2788, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.9873, "ferret_sera_escape": 0.1535, "mature_H5_site": 375, "mouse_sera_escape": 0.2372, "mutant": "I", "mutation": "D375I", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.09736, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.27, "ferret_sera_escape": 0.2369, "mature_H5_site": 375, "mouse_sera_escape": 0.375, "mutant": "K", "mutation": "D375K", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.001408, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2831, "ferret_sera_escape": 0.2526, "mature_H5_site": 375, "mouse_sera_escape": 0.2816, "mutant": "L", "mutation": "D375L", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.03567, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8669, "ferret_sera_escape": 0.09393, "mature_H5_site": 375, "mouse_sera_escape": 0.01292, "mutant": "M", "mutation": "D375M", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.02772, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.01528, "ferret_sera_escape": 0.03182, "mature_H5_site": 375, "mouse_sera_escape": 0.02313, "mutant": "N", "mutation": "D375N", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.01576, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 375, "mouse_sera_escape": null, "mutant": "P", "mutation": "D375P", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.195, "ferret_sera_escape": 0.02062, "mature_H5_site": 375, "mouse_sera_escape": 0.1925, "mutant": "Q", "mutation": "D375Q", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.008504, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.206, "ferret_sera_escape": -0.0846, "mature_H5_site": 375, "mouse_sera_escape": 0.05213, "mutant": "R", "mutation": "D375R", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.02674, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1904, "ferret_sera_escape": -0.06669, "mature_H5_site": 375, "mouse_sera_escape": 0.0708, "mutant": "S", "mutation": "D375S", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.02383, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.289, "ferret_sera_escape": -0.02912, "mature_H5_site": 375, "mouse_sera_escape": -0.03268, "mutant": "T", "mutation": "D375T", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.2327, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.016, "ferret_sera_escape": -0.0354, "mature_H5_site": 375, "mouse_sera_escape": 0.1954, "mutant": "V", "mutation": "D375V", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.2796, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6915, "ferret_sera_escape": -0.01154, "mature_H5_site": 375, "mouse_sera_escape": -0.00228, "mutant": "W", "mutation": "D375W", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.298, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3159, "ferret_sera_escape": -0.1244, "mature_H5_site": 375, "mouse_sera_escape": -0.06397, "mutant": "Y", "mutation": "D375Y", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.2985, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.79, "ferret_sera_escape": 0.1893, "mature_H5_site": 376, "mouse_sera_escape": 0.1427, "mutant": "A", "mutation": "G376A", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": 0.04071, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3486, "ferret_sera_escape": 0.07596, "mature_H5_site": 376, "mouse_sera_escape": 0.05537, "mutant": "C", "mutation": "G376C", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": 0.1669, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.25, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "D", "mutation": "G376D", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.518, "ferret_sera_escape": -0.2168, "mature_H5_site": 376, "mouse_sera_escape": -0.01929, "mutant": "E", "mutation": "G376E", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": -0.3255, "wildtype": "G"}, {"a26_usage": 0.7482, "cell_entry": -1.242, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "F", "mutation": "G376F", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 376, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G376G", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8924, "ferret_sera_escape": 0.07721, "mature_H5_site": 376, "mouse_sera_escape": -0.08169, "mutant": "H", "mutation": "G376H", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": -0.1958, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "I", "mutation": "G376I", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7905, "ferret_sera_escape": 0.0526, "mature_H5_site": 376, "mouse_sera_escape": 0.02403, "mutant": "K", "mutation": "G376K", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": -0.1519, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.813, "ferret_sera_escape": 0.07487, "mature_H5_site": 376, "mouse_sera_escape": 0.188, "mutant": "L", "mutation": "G376L", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": 0.003357, "wildtype": "G"}, {"a26_usage": 2.006, "cell_entry": -2.567, "ferret_sera_escape": 0.1019, "mature_H5_site": 376, "mouse_sera_escape": -0.005341, "mutant": "M", "mutation": "G376M", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": 0.9232, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.184, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "N", "mutation": "G376N", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": -0.1205, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "P", "mutation": "G376P", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8916, "ferret_sera_escape": 0.0329, "mature_H5_site": 376, "mouse_sera_escape": 0.002529, "mutant": "Q", "mutation": "G376Q", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.103, "ferret_sera_escape": 0.08245, "mature_H5_site": 376, "mouse_sera_escape": -0.05001, "mutant": "R", "mutation": "G376R", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": -0.3027, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1824, "ferret_sera_escape": 0.03099, "mature_H5_site": 376, "mouse_sera_escape": 0.005389, "mutant": "S", "mutation": "G376S", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": -0.2601, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.009, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "T", "mutation": "G376T", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.988, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "V", "mutation": "G376V", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.891, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "W", "mutation": "G376W", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.738, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G376Y", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "A", "mutation": "V377A", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.938, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "C", "mutation": "V377C", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "D", "mutation": "V377D", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "E", "mutation": "V377E", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "F", "mutation": "V377F", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "G", "mutation": "V377G", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "H", "mutation": "V377H", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.735, "ferret_sera_escape": 0.08221, "mature_H5_site": 377, "mouse_sera_escape": 0.1457, "mutant": "I", "mutation": "V377I", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": 0.1484, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "K", "mutation": "V377K", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3085, "ferret_sera_escape": -0.04969, "mature_H5_site": 377, "mouse_sera_escape": -0.0641, "mutant": "L", "mutation": "V377L", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": -0.1373, "wildtype": "V"}, {"a26_usage": 0.0105, "cell_entry": 0.06978, "ferret_sera_escape": -0.04816, "mature_H5_site": 377, "mouse_sera_escape": -0.1009, "mutant": "M", "mutation": "V377M", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": -0.003665, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.991, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "N", "mutation": "V377N", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.047, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "P", "mutation": "V377P", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.435, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V377Q", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "R", "mutation": "V377R", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "S", "mutation": "V377S", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1386, "ferret_sera_escape": -0.07684, "mature_H5_site": 377, "mouse_sera_escape": -0.1912, "mutant": "T", "mutation": "V377T", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": 0.2277, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 377, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V377V", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "W", "mutation": "V377W", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V377Y", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1649, "ferret_sera_escape": -0.05614, "mature_H5_site": 378, "mouse_sera_escape": -0.05191, "mutant": "A", "mutation": "T378A", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.2339, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7997, "ferret_sera_escape": 0.1745, "mature_H5_site": 378, "mouse_sera_escape": 0.1387, "mutant": "C", "mutation": "T378C", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": 0.08122, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4491, "ferret_sera_escape": null, "mature_H5_site": 378, "mouse_sera_escape": null, "mutant": "D", "mutation": "T378D", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3271, "ferret_sera_escape": -0.07807, "mature_H5_site": 378, "mouse_sera_escape": -0.1958, "mutant": "E", "mutation": "T378E", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.1998, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.282, "ferret_sera_escape": -0.2605, "mature_H5_site": 378, "mouse_sera_escape": null, "mutant": "F", "mutation": "T378F", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3682, "ferret_sera_escape": 0.03124, "mature_H5_site": 378, "mouse_sera_escape": -0.01197, "mutant": "I", "mutation": "T378I", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.1759, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4721, "ferret_sera_escape": null, "mature_H5_site": 378, "mouse_sera_escape": null, "mutant": "K", "mutation": "T378K", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.06678, "ferret_sera_escape": 0.05498, "mature_H5_site": 378, "mouse_sera_escape": null, "mutant": "L", "mutation": "T378L", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.08701, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.496, "ferret_sera_escape": -0.003803, "mature_H5_site": 378, "mouse_sera_escape": -0.08814, "mutant": "M", "mutation": "T378M", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.00125, "ferret_sera_escape": 0.1197, "mature_H5_site": 378, "mouse_sera_escape": 0.1095, "mutant": "N", "mutation": "T378N", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.02154, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 378, "mouse_sera_escape": null, "mutant": "P", "mutation": "T378P", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.03988, "ferret_sera_escape": 0.09374, "mature_H5_site": 378, "mouse_sera_escape": -0.002454, "mutant": "Q", "mutation": "T378Q", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.05409, "wildtype": "T"}, {"a26_usage": 0.183, "cell_entry": 0.02766, "ferret_sera_escape": 0.261, "mature_H5_site": 378, "mouse_sera_escape": 0.1591, "mutant": "R", "mutation": "T378R", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.09948, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.113, "ferret_sera_escape": -0.06396, "mature_H5_site": 378, "mouse_sera_escape": 0.01325, "mutant": "S", "mutation": "T378S", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.1873, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 378, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T378T", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.275, "ferret_sera_escape": -0.3814, "mature_H5_site": 378, "mouse_sera_escape": -0.1747, "mutant": "V", "mutation": "T378V", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.04362, "ferret_sera_escape": -0.1157, "mature_H5_site": 378, "mouse_sera_escape": -0.06045, "mutant": "Y", "mutation": "T378Y", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.1941, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.128, "ferret_sera_escape": -0.0873, "mature_H5_site": 379, "mouse_sera_escape": -0.07302, "mutant": "A", "mutation": "N379A", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.2441, "wildtype": "N"}, {"a26_usage": 0.07288, "cell_entry": 0.06038, "ferret_sera_escape": -0.1121, "mature_H5_site": 379, "mouse_sera_escape": 0.03061, "mutant": "C", "mutation": "N379C", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": 0.01986, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.904, "ferret_sera_escape": null, "mature_H5_site": 379, "mouse_sera_escape": null, "mutant": "D", "mutation": "N379D", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.167, "ferret_sera_escape": 0.00908, "mature_H5_site": 379, "mouse_sera_escape": 0.08496, "mutant": "E", "mutation": "N379E", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.2129, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.461, "ferret_sera_escape": -0.2607, "mature_H5_site": 379, "mouse_sera_escape": null, "mutant": "F", "mutation": "N379F", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.2711, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.857, "ferret_sera_escape": null, "mature_H5_site": 379, "mouse_sera_escape": null, "mutant": "G", "mutation": "N379G", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4054, "ferret_sera_escape": -0.1081, "mature_H5_site": 379, "mouse_sera_escape": -0.1095, "mutant": "H", "mutation": "N379H", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.256, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.567, "ferret_sera_escape": null, "mature_H5_site": 379, "mouse_sera_escape": null, "mutant": "K", "mutation": "N379K", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": null, "wildtype": "N"}, {"a26_usage": 0.1078, "cell_entry": -0.2277, "ferret_sera_escape": -0.1387, "mature_H5_site": 379, "mouse_sera_escape": 0.02888, "mutant": "M", "mutation": "N379M", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.6238, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 379, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N379N", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 379, "mouse_sera_escape": null, "mutant": "P", "mutation": "N379P", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1106, "ferret_sera_escape": 0.1692, "mature_H5_site": 379, "mouse_sera_escape": -0.009046, "mutant": "Q", "mutation": "N379Q", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.1142, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8377, "ferret_sera_escape": -0.002971, "mature_H5_site": 379, "mouse_sera_escape": 0.002575, "mutant": "S", "mutation": "N379S", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.2359, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4985, "ferret_sera_escape": 0.0167, "mature_H5_site": 379, "mouse_sera_escape": 0.0648, "mutant": "T", "mutation": "N379T", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.3502, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1851, "ferret_sera_escape": -0.1713, "mature_H5_site": 379, "mouse_sera_escape": -0.02247, "mutant": "V", "mutation": "N379V", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.2744, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.242, "ferret_sera_escape": null, "mature_H5_site": 379, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N379Y", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3828, "ferret_sera_escape": null, "mature_H5_site": 28, "mouse_sera_escape": null, "mutant": "C", "mutation": "H38C", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4376, "ferret_sera_escape": 0.1093, "mature_H5_site": 28, "mouse_sera_escape": 0.009816, "mutant": "D", "mutation": "H38D", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.06377, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.7857, "ferret_sera_escape": null, "mature_H5_site": 28, "mouse_sera_escape": null, "mutant": "E", "mutation": "H38E", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4315, "ferret_sera_escape": 0.07293, "mature_H5_site": 28, "mouse_sera_escape": 0.02962, "mutant": "G", "mutation": "H38G", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.7879, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 28, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H38H", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.311, "ferret_sera_escape": null, "mature_H5_site": 28, "mouse_sera_escape": null, "mutant": "I", "mutation": "H38I", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.05457, "ferret_sera_escape": 0.1288, "mature_H5_site": 28, "mouse_sera_escape": 0.0261, "mutant": "K", "mutation": "H38K", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.5803, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.8934, "ferret_sera_escape": 0.09786, "mature_H5_site": 28, "mouse_sera_escape": 0.02448, "mutant": "L", "mutation": "H38L", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.06623, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1058, "ferret_sera_escape": 0.187, "mature_H5_site": 28, "mouse_sera_escape": 0.08503, "mutant": "M", "mutation": "H38M", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.4301, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1779, "ferret_sera_escape": 0.1144, "mature_H5_site": 28, "mouse_sera_escape": -0.02218, "mutant": "N", "mutation": "H38N", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.009514, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 28, "mouse_sera_escape": null, "mutant": "P", "mutation": "H38P", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": null, "wildtype": "H"}, {"a26_usage": 0.01952, "cell_entry": -0.1169, "ferret_sera_escape": 0.09371, "mature_H5_site": 28, "mouse_sera_escape": 0.01646, "mutant": "Q", "mutation": "H38Q", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.06745, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5789, "ferret_sera_escape": 0.06422, "mature_H5_site": 28, "mouse_sera_escape": -0.02068, "mutant": "R", "mutation": "H38R", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.8089, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.009455, "ferret_sera_escape": 0.07742, "mature_H5_site": 28, "mouse_sera_escape": 0.08129, "mutant": "S", "mutation": "H38S", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.8359, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3096, "ferret_sera_escape": null, "mature_H5_site": 28, "mouse_sera_escape": null, "mutant": "T", "mutation": "H38T", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.123, "ferret_sera_escape": 0.05121, "mature_H5_site": 28, "mouse_sera_escape": 0.01575, "mutant": "V", "mutation": "H38V", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": -0.08786, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.464, "ferret_sera_escape": 0.2835, "mature_H5_site": 28, "mouse_sera_escape": -0.07472, "mutant": "W", "mutation": "H38W", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.4911, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5849, "ferret_sera_escape": 0.0608, "mature_H5_site": 28, "mouse_sera_escape": 0.09519, "mutant": "Y", "mutation": "H38Y", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 1.04, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.764, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "C", "mutation": "K380C", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "D", "mutation": "K380D", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.878, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "E", "mutation": "K380E", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "F", "mutation": "K380F", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.825, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "G", "mutation": "K380G", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "H", "mutation": "K380H", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.931, "ferret_sera_escape": 0.1045, "mature_H5_site": 380, "mouse_sera_escape": 0.02815, "mutant": "I", "mutation": "K380I", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": -0.05952, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 380, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K380K", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.889, "ferret_sera_escape": 0.1424, "mature_H5_site": 380, "mouse_sera_escape": 0.3108, "mutant": "L", "mutation": "K380L", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.23, "ferret_sera_escape": 0.03235, "mature_H5_site": 380, "mouse_sera_escape": 0.2446, "mutant": "M", "mutation": "K380M", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": 0.2599, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "N", "mutation": "K380N", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "P", "mutation": "K380P", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.585, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "Q", "mutation": "K380Q", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.494, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "R", "mutation": "K380R", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.657, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "S", "mutation": "K380S", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "T", "mutation": "K380T", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "W", "mutation": "K380W", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.356, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K380Y", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5301, "ferret_sera_escape": -0.0891, "mature_H5_site": 381, "mouse_sera_escape": -0.126, "mutant": "A", "mutation": "V381A", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": -0.3457, "wildtype": "V"}, {"a26_usage": 0.02138, "cell_entry": 0.06348, "ferret_sera_escape": -0.06401, "mature_H5_site": 381, "mouse_sera_escape": -0.02887, "mutant": "C", "mutation": "V381C", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": -0.2664, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "D", "mutation": "V381D", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.975, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "E", "mutation": "V381E", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.614, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "F", "mutation": "V381F", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.994, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "G", "mutation": "V381G", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.514, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "H", "mutation": "V381H", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.643, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "K", "mutation": "V381K", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6062, "ferret_sera_escape": -0.1018, "mature_H5_site": 381, "mouse_sera_escape": -0.0673, "mutant": "L", "mutation": "V381L", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": -0.2605, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7463, "ferret_sera_escape": -0.1506, "mature_H5_site": 381, "mouse_sera_escape": -0.01654, "mutant": "M", "mutation": "V381M", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": -0.281, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.886, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "N", "mutation": "V381N", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "P", "mutation": "V381P", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.674, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V381Q", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.742, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "R", "mutation": "V381R", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "S", "mutation": "V381S", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "T", "mutation": "V381T", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 381, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V381V", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.156, "ferret_sera_escape": null, "mature_H5_site": 382, "mouse_sera_escape": null, "mutant": "A", "mutation": "N382A", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.305, "ferret_sera_escape": null, "mature_H5_site": 382, "mouse_sera_escape": null, "mutant": "C", "mutation": "N382C", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02307, "ferret_sera_escape": -0.2049, "mature_H5_site": 382, "mouse_sera_escape": -0.02658, "mutant": "D", "mutation": "N382D", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.2057, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.459, "ferret_sera_escape": 0.01651, "mature_H5_site": 382, "mouse_sera_escape": 0.1738, "mutant": "E", "mutation": "N382E", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.24, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.942, "ferret_sera_escape": -0.08693, "mature_H5_site": 382, "mouse_sera_escape": null, "mutant": "F", "mutation": "N382F", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.393, "ferret_sera_escape": 0.1043, "mature_H5_site": 382, "mouse_sera_escape": 0.5642, "mutant": "H", "mutation": "N382H", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.04847, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7948, "ferret_sera_escape": -0.01629, "mature_H5_site": 382, "mouse_sera_escape": -0.01331, "mutant": "I", "mutation": "N382I", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.3108, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.231, "ferret_sera_escape": 0.1245, "mature_H5_site": 382, "mouse_sera_escape": 0.4179, "mutant": "K", "mutation": "N382K", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.198, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7235, "ferret_sera_escape": -0.007163, "mature_H5_site": 382, "mouse_sera_escape": 0.02517, "mutant": "L", "mutation": "N382L", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.248, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.557, "ferret_sera_escape": null, "mature_H5_site": 382, "mouse_sera_escape": null, "mutant": "M", "mutation": "N382M", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 382, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N382N", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 382, "mouse_sera_escape": null, "mutant": "P", "mutation": "N382P", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.003, "ferret_sera_escape": -0.04507, "mature_H5_site": 382, "mouse_sera_escape": 0.06608, "mutant": "Q", "mutation": "N382Q", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5337, "ferret_sera_escape": 0.02227, "mature_H5_site": 382, "mouse_sera_escape": 0.04442, "mutant": "R", "mutation": "N382R", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.05055, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.00319, "ferret_sera_escape": -0.04688, "mature_H5_site": 382, "mouse_sera_escape": -0.08796, "mutant": "S", "mutation": "N382S", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.2901, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1704, "ferret_sera_escape": 0.00514, "mature_H5_site": 382, "mouse_sera_escape": 0.04844, "mutant": "T", "mutation": "N382T", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.3569, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1851, "ferret_sera_escape": -0.1406, "mature_H5_site": 382, "mouse_sera_escape": 0.08735, "mutant": "V", "mutation": "N382V", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.5831, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.075, "ferret_sera_escape": -0.111, "mature_H5_site": 382, "mouse_sera_escape": 0.1002, "mutant": "W", "mutation": "N382W", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.322, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.399, "ferret_sera_escape": null, "mature_H5_site": 382, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N382Y", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.01306, "ferret_sera_escape": -0.08314, "mature_H5_site": 383, "mouse_sera_escape": 0.03095, "mutant": "A", "mutation": "S383A", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": 0.04929, "wildtype": "S"}, {"a26_usage": 0.3868, "cell_entry": -0.4896, "ferret_sera_escape": 0.007403, "mature_H5_site": 383, "mouse_sera_escape": 0.1208, "mutant": "C", "mutation": "S383C", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": -0.1818, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.796, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "D", "mutation": "S383D", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.7635, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "E", "mutation": "S383E", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.058, "ferret_sera_escape": 0.07427, "mature_H5_site": 383, "mouse_sera_escape": 0.1409, "mutant": "F", "mutation": "S383F", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": 0.08136, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.726, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "G", "mutation": "S383G", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.02006, "ferret_sera_escape": 0.1726, "mature_H5_site": 383, "mouse_sera_escape": 0.03486, "mutant": "H", "mutation": "S383H", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": 1.204, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.649, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "I", "mutation": "S383I", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.031, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "K", "mutation": "S383K", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.131, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "L", "mutation": "S383L", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.77, "ferret_sera_escape": 0.03278, "mature_H5_site": 383, "mouse_sera_escape": 0.1069, "mutant": "M", "mutation": "S383M", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": -0.4126, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3177, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "N", "mutation": "S383N", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "P", "mutation": "S383P", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1286, "ferret_sera_escape": -0.09028, "mature_H5_site": 383, "mouse_sera_escape": -0.03359, "mutant": "Q", "mutation": "S383Q", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": -0.03165, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.756, "ferret_sera_escape": 0.1995, "mature_H5_site": 383, "mouse_sera_escape": -0.0349, "mutant": "R", "mutation": "S383R", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 383, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S383S", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.592, "ferret_sera_escape": 0.1852, "mature_H5_site": 383, "mouse_sera_escape": 0.1778, "mutant": "T", "mutation": "S383T", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": 0.9713, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.876, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "V", "mutation": "S383V", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.24, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "W", "mutation": "S383W", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6387, "ferret_sera_escape": -0.01168, "mature_H5_site": 383, "mouse_sera_escape": 0.03235, "mutant": "Y", "mutation": "S383Y", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": 0.03749, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "A", "mutation": "I384A", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.41, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "C", "mutation": "I384C", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.865, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "D", "mutation": "I384D", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.838, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "E", "mutation": "I384E", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "F", "mutation": "I384F", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.428, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "G", "mutation": "I384G", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 384, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I384I", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "K", "mutation": "I384K", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.08789, "ferret_sera_escape": -0.06528, "mature_H5_site": 384, "mouse_sera_escape": 0.05478, "mutant": "L", "mutation": "I384L", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": -0.2902, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.05531, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "M", "mutation": "I384M", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "N", "mutation": "I384N", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "P", "mutation": "I384P", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.812, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I384Q", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "R", "mutation": "I384R", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "S", "mutation": "I384S", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "T", "mutation": "I384T", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.07887, "ferret_sera_escape": -0.01496, "mature_H5_site": 384, "mouse_sera_escape": 0.0184, "mutant": "V", "mutation": "I384V", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": -0.319, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.643, "ferret_sera_escape": -0.1834, "mature_H5_site": 384, "mouse_sera_escape": 0.01634, "mutant": "W", "mutation": "I384W", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": -0.02701, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.7933, "ferret_sera_escape": -0.09297, "mature_H5_site": 384, "mouse_sera_escape": 0.1313, "mutant": "Y", "mutation": "I384Y", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": 0.8802, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.8579, "ferret_sera_escape": -0.04637, "mature_H5_site": 385, "mouse_sera_escape": 0.01156, "mutant": "A", "mutation": "I385A", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": -0.1061, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.094, "ferret_sera_escape": 0.04301, "mature_H5_site": 385, "mouse_sera_escape": 0.03655, "mutant": "C", "mutation": "I385C", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": 1.843, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "D", "mutation": "I385D", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "E", "mutation": "I385E", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.67, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "F", "mutation": "I385F", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.935, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "H", "mutation": "I385H", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 385, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I385I", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2661, "ferret_sera_escape": -0.06524, "mature_H5_site": 385, "mouse_sera_escape": 0.07492, "mutant": "L", "mutation": "I385L", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": -0.3608, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.565, "ferret_sera_escape": -0.1717, "mature_H5_site": 385, "mouse_sera_escape": 0.05824, "mutant": "M", "mutation": "I385M", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": 0.4598, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.2, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "N", "mutation": "I385N", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.858, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "P", "mutation": "I385P", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.051, "ferret_sera_escape": -0.2662, "mature_H5_site": 385, "mouse_sera_escape": 0.2445, "mutant": "Q", "mutation": "I385Q", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.891, "ferret_sera_escape": -0.1091, "mature_H5_site": 385, "mouse_sera_escape": 0.2279, "mutant": "R", "mutation": "I385R", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": 0.7311, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.327, "ferret_sera_escape": -0.1587, "mature_H5_site": 385, "mouse_sera_escape": 0.1683, "mutant": "S", "mutation": "I385S", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": 0.06389, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5425, "ferret_sera_escape": -0.03451, "mature_H5_site": 385, "mouse_sera_escape": 0.005185, "mutant": "T", "mutation": "I385T", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": -0.04606, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06388, "ferret_sera_escape": -0.19, "mature_H5_site": 385, "mouse_sera_escape": -0.1446, "mutant": "V", "mutation": "I385V", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": -0.46, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "W", "mutation": "I385W", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.588, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I385Y", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.2406, "cell_entry": -0.2489, "ferret_sera_escape": 0.09529, "mature_H5_site": 386, "mouse_sera_escape": 0.1423, "mutant": "A", "mutation": "D386A", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": -0.1231, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4324, "ferret_sera_escape": 0.2616, "mature_H5_site": 386, "mouse_sera_escape": 0.2418, "mutant": "C", "mutation": "D386C", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 0.9094, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 386, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D386D", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.4295, "cell_entry": -0.3902, "ferret_sera_escape": 0.02958, "mature_H5_site": 386, "mouse_sera_escape": -0.008534, "mutant": "E", "mutation": "D386E", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 0.04817, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.05201, "ferret_sera_escape": 0.02025, "mature_H5_site": 386, "mouse_sera_escape": 0.04321, "mutant": "F", "mutation": "D386F", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 1.398, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6954, "ferret_sera_escape": -0.02572, "mature_H5_site": 386, "mouse_sera_escape": 0.0727, "mutant": "G", "mutation": "D386G", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 1.283, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4652, "ferret_sera_escape": 0.04519, "mature_H5_site": 386, "mouse_sera_escape": 0.002734, "mutant": "H", "mutation": "D386H", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 1.02, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.07297, "ferret_sera_escape": -0.0414, "mature_H5_site": 386, "mouse_sera_escape": -0.07842, "mutant": "I", "mutation": "D386I", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": -0.1715, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6246, "ferret_sera_escape": 0.02856, "mature_H5_site": 386, "mouse_sera_escape": 0.1008, "mutant": "K", "mutation": "D386K", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": -0.1576, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3314, "ferret_sera_escape": 0.2173, "mature_H5_site": 386, "mouse_sera_escape": 0.01179, "mutant": "M", "mutation": "D386M", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 0.2341, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2731, "ferret_sera_escape": 0.0487, "mature_H5_site": 386, "mouse_sera_escape": 0.005812, "mutant": "N", "mutation": "D386N", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 0.961, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 386, "mouse_sera_escape": null, "mutant": "P", "mutation": "D386P", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.01364, "ferret_sera_escape": 0.06237, "mature_H5_site": 386, "mouse_sera_escape": 0.03129, "mutant": "Q", "mutation": "D386Q", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 0.3412, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.04728, "ferret_sera_escape": 0.05259, "mature_H5_site": 386, "mouse_sera_escape": 0.09068, "mutant": "T", "mutation": "D386T", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 1.283, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.05536, "ferret_sera_escape": -0.007658, "mature_H5_site": 386, "mouse_sera_escape": -0.01954, "mutant": "V", "mutation": "D386V", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": -0.1235, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3205, "ferret_sera_escape": -0.007573, "mature_H5_site": 386, "mouse_sera_escape": 0.05302, "mutant": "Y", "mutation": "D386Y", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 1.508, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4461, "ferret_sera_escape": 0.09446, "mature_H5_site": 387, "mouse_sera_escape": 0.07017, "mutant": "A", "mutation": "K387A", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": 0.611, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0548, "ferret_sera_escape": 0.02285, "mature_H5_site": 387, "mouse_sera_escape": 0.05705, "mutant": "C", "mutation": "K387C", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": 0.6692, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.448, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "D", "mutation": "K387D", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.529, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "E", "mutation": "K387E", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 387, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K387K", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.822, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "L", "mutation": "K387L", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.13, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "M", "mutation": "K387M", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2553, "ferret_sera_escape": -0.1775, "mature_H5_site": 387, "mouse_sera_escape": -0.04884, "mutant": "N", "mutation": "K387N", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": -0.2541, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "P", "mutation": "K387P", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.029, "ferret_sera_escape": -0.2887, "mature_H5_site": 387, "mouse_sera_escape": -0.08553, "mutant": "Q", "mutation": "K387Q", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": -0.3146, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4854, "ferret_sera_escape": -0.04253, "mature_H5_site": 387, "mouse_sera_escape": 0.01335, "mutant": "R", "mutation": "K387R", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": -0.2264, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04736, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "S", "mutation": "K387S", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03702, "ferret_sera_escape": 0.06456, "mature_H5_site": 387, "mouse_sera_escape": -0.04051, "mutant": "T", "mutation": "K387T", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": 0.02732, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.353, "ferret_sera_escape": 0.3941, "mature_H5_site": 387, "mouse_sera_escape": 0.3017, "mutant": "V", "mutation": "K387V", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": 1.816, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "W", "mutation": "K387W", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.776, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K387Y", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.683, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "A", "mutation": "M388A", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.811, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "C", "mutation": "M388C", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.864, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "D", "mutation": "M388D", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "E", "mutation": "M388E", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.367, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "F", "mutation": "M388F", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.648, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "G", "mutation": "M388G", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.885, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "H", "mutation": "M388H", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.483, "ferret_sera_escape": 0.02593, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "I", "mutation": "M388I", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": 0.02815, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.805, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "K", "mutation": "M388K", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.142, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "L", "mutation": "M388L", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 388, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M388M", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.941, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "N", "mutation": "M388N", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "R", "mutation": "M388R", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.896, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "T", "mutation": "M388T", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.067, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "V", "mutation": "M388V", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "W", "mutation": "M388W", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.352, "ferret_sera_escape": 0.07466, "mature_H5_site": 389, "mouse_sera_escape": 0.1389, "mutant": "C", "mutation": "N389C", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.1193, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9133, "ferret_sera_escape": -0.007947, "mature_H5_site": 389, "mouse_sera_escape": -0.1293, "mutant": "D", "mutation": "N389D", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": -0.4135, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.06765, "ferret_sera_escape": -0.0586, "mature_H5_site": 389, "mouse_sera_escape": 0.01119, "mutant": "E", "mutation": "N389E", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": -0.02471, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5404, "ferret_sera_escape": 0.01159, "mature_H5_site": 389, "mouse_sera_escape": -0.01738, "mutant": "G", "mutation": "N389G", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": -0.0149, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3852, "ferret_sera_escape": 0.02851, "mature_H5_site": 389, "mouse_sera_escape": 0.1074, "mutant": "H", "mutation": "N389H", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.3951, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7934, "ferret_sera_escape": 0.09485, "mature_H5_site": 389, "mouse_sera_escape": 0.06356, "mutant": "I", "mutation": "N389I", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 1.041, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.876, "ferret_sera_escape": 0.2288, "mature_H5_site": 389, "mouse_sera_escape": 0.2334, "mutant": "K", "mutation": "N389K", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.3485, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 389, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N389N", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.795, "ferret_sera_escape": null, "mature_H5_site": 389, "mouse_sera_escape": null, "mutant": "P", "mutation": "N389P", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4306, "ferret_sera_escape": 0.005414, "mature_H5_site": 389, "mouse_sera_escape": 0.0429, "mutant": "Q", "mutation": "N389Q", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.06365, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.322, "ferret_sera_escape": 0.2183, "mature_H5_site": 389, "mouse_sera_escape": 0.1559, "mutant": "R", "mutation": "N389R", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.2802, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4582, "ferret_sera_escape": 0.0121, "mature_H5_site": 389, "mouse_sera_escape": -0.03788, "mutant": "S", "mutation": "N389S", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.6192, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1446, "ferret_sera_escape": 0.2185, "mature_H5_site": 389, "mouse_sera_escape": 0.07399, "mutant": "T", "mutation": "N389T", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.03419, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2366, "ferret_sera_escape": -0.002318, "mature_H5_site": 389, "mouse_sera_escape": 0.1088, "mutant": "V", "mutation": "N389V", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 1.259, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.785, "ferret_sera_escape": null, "mature_H5_site": 389, "mouse_sera_escape": 0.1465, "mutant": "W", "mutation": "N389W", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04963, "ferret_sera_escape": 0.1665, "mature_H5_site": 389, "mouse_sera_escape": -0.06861, "mutant": "Y", "mutation": "N389Y", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": -0.1708, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 29, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A39A", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1739, "ferret_sera_escape": -0.04791, "mature_H5_site": 29, "mouse_sera_escape": null, "mutant": "C", "mutation": "A39C", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 29, "mouse_sera_escape": null, "mutant": "D", "mutation": "A39D", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 29, "mouse_sera_escape": null, "mutant": "E", "mutation": "A39E", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.027, "ferret_sera_escape": 0.001163, "mature_H5_site": 29, "mouse_sera_escape": 0.157, "mutant": "F", "mutation": "A39F", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 1.28, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7388, "ferret_sera_escape": -0.04578, "mature_H5_site": 29, "mouse_sera_escape": 0.01454, "mutant": "G", "mutation": "A39G", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 0.07747, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.06004, "ferret_sera_escape": 0.06746, "mature_H5_site": 29, "mouse_sera_escape": 0.1073, "mutant": "I", "mutation": "A39I", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 1.356, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.784, "ferret_sera_escape": 0.1632, "mature_H5_site": 29, "mouse_sera_escape": 0.1058, "mutant": "L", "mutation": "A39L", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2987, "ferret_sera_escape": null, "mature_H5_site": 29, "mouse_sera_escape": null, "mutant": "M", "mutation": "A39M", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.495, "ferret_sera_escape": null, "mature_H5_site": 29, "mouse_sera_escape": null, "mutant": "N", "mutation": "A39N", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.178, "ferret_sera_escape": null, "mature_H5_site": 29, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A39Q", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.246, "ferret_sera_escape": null, "mature_H5_site": 29, "mouse_sera_escape": null, "mutant": "R", "mutation": "A39R", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3373, "ferret_sera_escape": -0.264, "mature_H5_site": 29, "mouse_sera_escape": -0.092, "mutant": "S", "mutation": "A39S", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3065, "ferret_sera_escape": -0.02992, "mature_H5_site": 29, "mouse_sera_escape": 0.06449, "mutant": "T", "mutation": "A39T", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 1.395, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.09754, "ferret_sera_escape": -0.01163, "mature_H5_site": 29, "mouse_sera_escape": -0.05207, "mutant": "V", "mutation": "A39V", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 0.8518, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.07439, "ferret_sera_escape": 0.0666, "mature_H5_site": 29, "mouse_sera_escape": 0.03098, "mutant": "W", "mutation": "A39W", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 1.619, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2895, "ferret_sera_escape": -0.1755, "mature_H5_site": 29, "mouse_sera_escape": 0.03361, "mutant": "Y", "mutation": "A39Y", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 1.207, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.324, "ferret_sera_escape": 0.1627, "mature_H5_site": 390, "mouse_sera_escape": 0.2271, "mutant": "A", "mutation": "T390A", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": -0.00728, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.099, "ferret_sera_escape": 0.2526, "mature_H5_site": 390, "mouse_sera_escape": -0.01112, "mutant": "C", "mutation": "T390C", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": 0.2441, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.147, "ferret_sera_escape": 0.96, "mature_H5_site": 390, "mouse_sera_escape": 0.1322, "mutant": "E", "mutation": "T390E", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.762, "ferret_sera_escape": null, "mature_H5_site": 390, "mouse_sera_escape": null, "mutant": "F", "mutation": "T390F", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.853, "ferret_sera_escape": 0.02422, "mature_H5_site": 390, "mouse_sera_escape": 0.1173, "mutant": "G", "mutation": "T390G", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": -0.02997, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.057, "ferret_sera_escape": 0.02277, "mature_H5_site": 390, "mouse_sera_escape": 0.07416, "mutant": "I", "mutation": "T390I", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": 0.6983, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 390, "mouse_sera_escape": null, "mutant": "K", "mutation": "T390K", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.005, "ferret_sera_escape": -0.145, "mature_H5_site": 390, "mouse_sera_escape": -0.007517, "mutant": "L", "mutation": "T390L", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": -0.3676, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.6905, "ferret_sera_escape": -0.04432, "mature_H5_site": 390, "mouse_sera_escape": 0.09562, "mutant": "M", "mutation": "T390M", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": -0.02424, "wildtype": "T"}, {"a26_usage": 0.7677, "cell_entry": -0.9642, "ferret_sera_escape": -0.2589, "mature_H5_site": 390, "mouse_sera_escape": null, "mutant": "N", "mutation": "T390N", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.9618, "ferret_sera_escape": -0.01795, "mature_H5_site": 390, "mouse_sera_escape": -0.17, "mutant": "Q", "mutation": "T390Q", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": -0.05523, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.182, "ferret_sera_escape": null, "mature_H5_site": 390, "mouse_sera_escape": null, "mutant": "R", "mutation": "T390R", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 390, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T390T", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.0215, "ferret_sera_escape": -0.02794, "mature_H5_site": 390, "mouse_sera_escape": -0.03329, "mutant": "V", "mutation": "T390V", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": -0.06492, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.626, "ferret_sera_escape": null, "mature_H5_site": 390, "mouse_sera_escape": null, "mutant": "W", "mutation": "T390W", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.731, "ferret_sera_escape": null, "mature_H5_site": 390, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T390Y", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.45, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "C", "mutation": "Q391C", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.04577, "ferret_sera_escape": -0.02237, "mature_H5_site": 391, "mouse_sera_escape": 0.1568, "mutant": "D", "mutation": "Q391D", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": 0.9144, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.01487, "ferret_sera_escape": -0.04111, "mature_H5_site": 391, "mouse_sera_escape": 0.09521, "mutant": "E", "mutation": "Q391E", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": 1.267, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.35, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "F", "mutation": "Q391F", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.048, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "G", "mutation": "Q391G", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2074, "ferret_sera_escape": 0.1207, "mature_H5_site": 391, "mouse_sera_escape": 0.1037, "mutant": "H", "mutation": "Q391H", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": 0.821, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "I", "mutation": "Q391I", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.854, "ferret_sera_escape": -0.03499, "mature_H5_site": 391, "mouse_sera_escape": -0.03696, "mutant": "K", "mutation": "Q391K", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": -0.6098, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "L", "mutation": "Q391L", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "M", "mutation": "Q391M", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0242, "cell_entry": 0.05083, "ferret_sera_escape": -0.03789, "mature_H5_site": 391, "mouse_sera_escape": -0.07705, "mutant": "N", "mutation": "Q391N", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": -0.1423, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.053, "ferret_sera_escape": 0.01911, "mature_H5_site": 391, "mouse_sera_escape": -0.02228, "mutant": "P", "mutation": "Q391P", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": 0.04534, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 391, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q391Q", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.7793, "ferret_sera_escape": -0.008034, "mature_H5_site": 391, "mouse_sera_escape": 0.1603, "mutant": "R", "mutation": "Q391R", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": 0.1133, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.47, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "S", "mutation": "Q391S", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.09, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "T", "mutation": "Q391T", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.777, "ferret_sera_escape": 0.06526, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "V", "mutation": "Q391V", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.646, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "W", "mutation": "Q391W", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "Y", "mutation": "Q391Y", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.369, "ferret_sera_escape": -0.2577, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "A", "mutation": "F392A", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.13, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "C", "mutation": "F392C", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.687, "ferret_sera_escape": -0.1175, "mature_H5_site": 392, "mouse_sera_escape": 0.08179, "mutant": "D", "mutation": "F392D", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": -0.2133, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.15, "ferret_sera_escape": -0.01144, "mature_H5_site": 392, "mouse_sera_escape": 0.09996, "mutant": "E", "mutation": "F392E", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": -0.2199, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 392, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F392F", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "G", "mutation": "F392G", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.877, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "H", "mutation": "F392H", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.608, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "I", "mutation": "F392I", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.716, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "K", "mutation": "F392K", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.319, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "L", "mutation": "F392L", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.6621, "ferret_sera_escape": -0.03627, "mature_H5_site": 392, "mouse_sera_escape": -0.05475, "mutant": "M", "mutation": "F392M", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.545, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "N", "mutation": "F392N", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.559, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F392Q", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "R", "mutation": "F392R", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.351, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "S", "mutation": "F392S", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "T", "mutation": "F392T", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.684, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "V", "mutation": "F392V", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.03541, "cell_entry": 0.06695, "ferret_sera_escape": 0.105, "mature_H5_site": 392, "mouse_sera_escape": 0.05836, "mutant": "W", "mutation": "F392W", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": -0.09249, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.06471, "ferret_sera_escape": -0.1059, "mature_H5_site": 392, "mouse_sera_escape": -0.005196, "mutant": "Y", "mutation": "F392Y", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": -0.01713, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.6151, "ferret_sera_escape": -0.1275, "mature_H5_site": 393, "mouse_sera_escape": -0.03869, "mutant": "C", "mutation": "E393C", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": -0.1168, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4048, "ferret_sera_escape": -0.1193, "mature_H5_site": 393, "mouse_sera_escape": -0.04378, "mutant": "D", "mutation": "E393D", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 393, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E393E", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.937, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "F", "mutation": "E393F", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.115, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "G", "mutation": "E393G", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.063, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "H", "mutation": "E393H", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.005, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "I", "mutation": "E393I", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.528, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "K", "mutation": "E393K", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.632, "ferret_sera_escape": -0.00948, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "L", "mutation": "E393L", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": -0.08601, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7436, "ferret_sera_escape": 0.1573, "mature_H5_site": 393, "mouse_sera_escape": 0.1227, "mutant": "M", "mutation": "E393M", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": 0.5148, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.673, "ferret_sera_escape": -0.05259, "mature_H5_site": 393, "mouse_sera_escape": -0.05035, "mutant": "N", "mutation": "E393N", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": -0.2455, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "P", "mutation": "E393P", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9021, "ferret_sera_escape": 0.09864, "mature_H5_site": 393, "mouse_sera_escape": 0.03689, "mutant": "Q", "mutation": "E393Q", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": 0.3659, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "R", "mutation": "E393R", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5766, "ferret_sera_escape": -0.0452, "mature_H5_site": 393, "mouse_sera_escape": 0.00158, "mutant": "S", "mutation": "E393S", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": 0.2572, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9938, "ferret_sera_escape": -0.1112, "mature_H5_site": 393, "mouse_sera_escape": 0.0329, "mutant": "T", "mutation": "E393T", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": -0.1567, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.239, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "V", "mutation": "E393V", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.037, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "W", "mutation": "E393W", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.535, "ferret_sera_escape": -0.1768, "mature_H5_site": 393, "mouse_sera_escape": 0.0474, "mutant": "Y", "mutation": "E393Y", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 394, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A394A", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "D", "mutation": "A394D", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "E", "mutation": "A394E", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.272, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "F", "mutation": "A394F", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4164, "ferret_sera_escape": -0.03109, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "G", "mutation": "A394G", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "H", "mutation": "A394H", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.966, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "L", "mutation": "A394L", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.016, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "N", "mutation": "A394N", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.848, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A394Q", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3754, "ferret_sera_escape": -0.08439, "mature_H5_site": 394, "mouse_sera_escape": 0.06331, "mutant": "S", "mutation": "A394S", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": -0.294, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.753, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "T", "mutation": "A394T", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.396, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "V", "mutation": "A394V", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.447, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "W", "mutation": "A394W", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.758, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A394Y", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.04238, "cell_entry": -0.1565, "ferret_sera_escape": -0.08094, "mature_H5_site": 395, "mouse_sera_escape": -0.1623, "mutant": "A", "mutation": "V395A", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": -0.2025, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1455, "ferret_sera_escape": -0.04332, "mature_H5_site": 395, "mouse_sera_escape": -0.04361, "mutant": "C", "mutation": "V395C", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": 0.5284, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.303, "ferret_sera_escape": -0.01186, "mature_H5_site": 395, "mouse_sera_escape": -0.006312, "mutant": "D", "mutation": "V395D", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": -0.2851, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2526, "ferret_sera_escape": -0.03257, "mature_H5_site": 395, "mouse_sera_escape": 0.2011, "mutant": "F", "mutation": "V395F", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": 1.538, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6314, "ferret_sera_escape": 0.007603, "mature_H5_site": 395, "mouse_sera_escape": 0.08996, "mutant": "G", "mutation": "V395G", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": -0.03766, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.329, "ferret_sera_escape": -0.1677, "mature_H5_site": 395, "mouse_sera_escape": null, "mutant": "K", "mutation": "V395K", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.9791, "ferret_sera_escape": -0.04588, "mature_H5_site": 395, "mouse_sera_escape": -0.007262, "mutant": "L", "mutation": "V395L", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": 0.1443, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0625, "ferret_sera_escape": -0.0868, "mature_H5_site": 395, "mouse_sera_escape": 0.07819, "mutant": "M", "mutation": "V395M", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": 0.3047, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.227, "ferret_sera_escape": null, "mature_H5_site": 395, "mouse_sera_escape": null, "mutant": "N", "mutation": "V395N", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.316, "ferret_sera_escape": null, "mature_H5_site": 395, "mouse_sera_escape": null, "mutant": "P", "mutation": "V395P", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1606, "ferret_sera_escape": -0.03407, "mature_H5_site": 395, "mouse_sera_escape": -0.06103, "mutant": "Q", "mutation": "V395Q", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": -0.5452, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5861, "ferret_sera_escape": -0.1648, "mature_H5_site": 395, "mouse_sera_escape": 0.4395, "mutant": "R", "mutation": "V395R", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": 1.247, "wildtype": "V"}, {"a26_usage": 0.3893, "cell_entry": 0.01376, "ferret_sera_escape": 0.02431, "mature_H5_site": 395, "mouse_sera_escape": 0.06659, "mutant": "S", "mutation": "V395S", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": -0.1421, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.05529, "ferret_sera_escape": -0.08247, "mature_H5_site": 395, "mouse_sera_escape": -0.02504, "mutant": "T", "mutation": "V395T", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": -0.1157, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 395, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V395V", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.886, "ferret_sera_escape": null, "mature_H5_site": 395, "mouse_sera_escape": null, "mutant": "W", "mutation": "V395W", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.736, "ferret_sera_escape": null, "mature_H5_site": 395, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V395Y", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.521, "ferret_sera_escape": 0.07289, "mature_H5_site": 396, "mouse_sera_escape": 0.2027, "mutant": "A", "mutation": "G396A", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": 0.0688, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.01034, "ferret_sera_escape": 0.02617, "mature_H5_site": 396, "mouse_sera_escape": 0.1273, "mutant": "C", "mutation": "G396C", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": -0.5722, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.9118, "ferret_sera_escape": -0.1433, "mature_H5_site": 396, "mouse_sera_escape": -0.02759, "mutant": "D", "mutation": "G396D", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": -0.2287, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.774, "ferret_sera_escape": -0.02541, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "F", "mutation": "G396F", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 396, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G396G", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.603, "ferret_sera_escape": null, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "I", "mutation": "G396I", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "K", "mutation": "G396K", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.358, "ferret_sera_escape": null, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "L", "mutation": "G396L", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.635, "ferret_sera_escape": 0.1525, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "M", "mutation": "G396M", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.826, "ferret_sera_escape": 0.07072, "mature_H5_site": 396, "mouse_sera_escape": 0.1572, "mutant": "N", "mutation": "G396N", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": 0.1042, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.354, "ferret_sera_escape": null, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "P", "mutation": "G396P", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.341, "ferret_sera_escape": 0.06246, "mature_H5_site": 396, "mouse_sera_escape": 0.2885, "mutant": "Q", "mutation": "G396Q", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": 0.01885, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.738, "ferret_sera_escape": null, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "R", "mutation": "G396R", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.317, "ferret_sera_escape": -0.06863, "mature_H5_site": 396, "mouse_sera_escape": 0.04222, "mutant": "S", "mutation": "G396S", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": -0.00352, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5512, "ferret_sera_escape": 0.3609, "mature_H5_site": 396, "mouse_sera_escape": 0.2729, "mutant": "T", "mutation": "G396T", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": -0.4363, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.925, "ferret_sera_escape": 0.1101, "mature_H5_site": 396, "mouse_sera_escape": 0.2264, "mutant": "V", "mutation": "G396V", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": 0.1641, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.691, "ferret_sera_escape": 0.4797, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "W", "mutation": "G396W", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.697, "ferret_sera_escape": null, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G396Y", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7532, "ferret_sera_escape": -0.02135, "mature_H5_site": 397, "mouse_sera_escape": 0.1151, "mutant": "A", "mutation": "R397A", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 0.2169, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.439, "ferret_sera_escape": -0.08105, "mature_H5_site": 397, "mouse_sera_escape": 0.0523, "mutant": "C", "mutation": "R397C", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 1.627, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2741, "ferret_sera_escape": -0.01186, "mature_H5_site": 397, "mouse_sera_escape": 0.01802, "mutant": "E", "mutation": "R397E", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 0.4435, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.7, "ferret_sera_escape": null, "mature_H5_site": 397, "mouse_sera_escape": null, "mutant": "F", "mutation": "R397F", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.09892, "ferret_sera_escape": -0.2096, "mature_H5_site": 397, "mouse_sera_escape": 0.1358, "mutant": "G", "mutation": "R397G", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 0.08968, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.33, "ferret_sera_escape": null, "mature_H5_site": 397, "mouse_sera_escape": null, "mutant": "I", "mutation": "R397I", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1115, "ferret_sera_escape": -0.0537, "mature_H5_site": 397, "mouse_sera_escape": -0.02408, "mutant": "K", "mutation": "R397K", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": -0.3344, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.856, "ferret_sera_escape": 0.2157, "mature_H5_site": 397, "mouse_sera_escape": null, "mutant": "M", "mutation": "R397M", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 1.955, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.04207, "ferret_sera_escape": -0.03913, "mature_H5_site": 397, "mouse_sera_escape": 0.01119, "mutant": "N", "mutation": "R397N", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 1.063, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.417, "ferret_sera_escape": -0.04704, "mature_H5_site": 397, "mouse_sera_escape": 0.2182, "mutant": "P", "mutation": "R397P", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 0.9182, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.01926, "ferret_sera_escape": -0.03096, "mature_H5_site": 397, "mouse_sera_escape": 0.1216, "mutant": "Q", "mutation": "R397Q", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 0.9139, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 397, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R397R", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7415, "ferret_sera_escape": -0.1023, "mature_H5_site": 397, "mouse_sera_escape": 0.1909, "mutant": "S", "mutation": "R397S", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 2.099, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.821, "ferret_sera_escape": 0.006374, "mature_H5_site": 397, "mouse_sera_escape": null, "mutant": "V", "mutation": "R397V", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 1.091, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7234, "ferret_sera_escape": null, "mature_H5_site": 397, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R397Y", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "A", "mutation": "E398A", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2475, "ferret_sera_escape": 0.01031, "mature_H5_site": 398, "mouse_sera_escape": -0.05375, "mutant": "C", "mutation": "E398C", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": -0.1042, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.05463, "ferret_sera_escape": -0.001492, "mature_H5_site": 398, "mouse_sera_escape": -0.0001438, "mutant": "D", "mutation": "E398D", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": -0.4834, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 398, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E398E", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.685, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "F", "mutation": "E398F", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "G", "mutation": "E398G", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.933, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "H", "mutation": "E398H", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.925, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "I", "mutation": "E398I", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.223, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "K", "mutation": "E398K", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.425, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "L", "mutation": "E398L", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.572, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "M", "mutation": "E398M", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.789, "ferret_sera_escape": -0.1711, "mature_H5_site": 398, "mouse_sera_escape": 0.8449, "mutant": "N", "mutation": "E398N", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": 0.3455, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7298, "ferret_sera_escape": 0.07972, "mature_H5_site": 398, "mouse_sera_escape": 0.4876, "mutant": "P", "mutation": "E398P", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.617, "ferret_sera_escape": -0.09907, "mature_H5_site": 398, "mouse_sera_escape": -0.04305, "mutant": "Q", "mutation": "E398Q", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": -0.3129, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.533, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "R", "mutation": "E398R", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6365, "ferret_sera_escape": -0.3135, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "T", "mutation": "E398T", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.783, "ferret_sera_escape": -0.07115, "mature_H5_site": 398, "mouse_sera_escape": 1.014, "mutant": "V", "mutation": "E398V", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": 0.8262, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.562, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E398Y", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "A", "mutation": "F399A", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.019, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "C", "mutation": "F399C", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.914, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "D", "mutation": "F399D", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "E", "mutation": "F399E", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 399, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F399F", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.712, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "G", "mutation": "F399G", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "H", "mutation": "F399H", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "I", "mutation": "F399I", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "L", "mutation": "F399L", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "M", "mutation": "F399M", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F399Q", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.852, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "S", "mutation": "F399S", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "V", "mutation": "F399V", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.8844, "ferret_sera_escape": -0.0207, "mature_H5_site": 399, "mouse_sera_escape": 0.2748, "mutant": "W", "mutation": "F399W", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": 1.39, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.097, "ferret_sera_escape": 0.3406, "mature_H5_site": -7, "mouse_sera_escape": 0.07878, "mutant": "A", "mutation": "I4A", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.05993, "ferret_sera_escape": -0.1704, "mature_H5_site": -7, "mouse_sera_escape": -0.1065, "mutant": "C", "mutation": "I4C", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": -0.01576, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.454, "ferret_sera_escape": -0.07749, "mature_H5_site": -7, "mouse_sera_escape": -0.09242, "mutant": "H", "mutation": "I4H", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": -0.1527, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -7, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I4I", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.02342, "ferret_sera_escape": 0.1197, "mature_H5_site": -7, "mouse_sera_escape": null, "mutant": "L", "mutation": "I4L", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03197, "ferret_sera_escape": -0.111, "mature_H5_site": -7, "mouse_sera_escape": -0.1791, "mutant": "M", "mutation": "I4M", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": -0.04943, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.7, "ferret_sera_escape": null, "mature_H5_site": -7, "mouse_sera_escape": null, "mutant": "N", "mutation": "I4N", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.195, "ferret_sera_escape": null, "mature_H5_site": -7, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I4Q", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": -7, "mouse_sera_escape": null, "mutant": "R", "mutation": "I4R", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5877, "ferret_sera_escape": null, "mature_H5_site": -7, "mouse_sera_escape": null, "mutant": "V", "mutation": "I4V", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.7617, "ferret_sera_escape": 0.2113, "mature_H5_site": -7, "mouse_sera_escape": 0.08095, "mutant": "W", "mutation": "I4W", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": 0.004053, "wildtype": "I"}, {"a26_usage": 0.01598, "cell_entry": 0.02726, "ferret_sera_escape": null, "mature_H5_site": -7, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I4Y", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.1514, "cell_entry": -0.2044, "ferret_sera_escape": -0.02214, "mature_H5_site": 30, "mouse_sera_escape": 0.02034, "mutant": "C", "mutation": "Q40C", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": 0.724, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.612, "ferret_sera_escape": null, "mature_H5_site": 30, "mouse_sera_escape": null, "mutant": "D", "mutation": "Q40D", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2469, "ferret_sera_escape": -0.1092, "mature_H5_site": 30, "mouse_sera_escape": -0.06486, "mutant": "E", "mutation": "Q40E", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": -0.02949, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1545, "ferret_sera_escape": -0.05905, "mature_H5_site": 30, "mouse_sera_escape": -0.1272, "mutant": "H", "mutation": "Q40H", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": 0.1993, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.9664, "ferret_sera_escape": 0.01859, "mature_H5_site": 30, "mouse_sera_escape": 0.009966, "mutant": "I", "mutation": "Q40I", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2197, "ferret_sera_escape": null, "mature_H5_site": 30, "mouse_sera_escape": null, "mutant": "K", "mutation": "Q40K", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": 0.4784, "wildtype": "Q"}, {"a26_usage": 0.7307, "cell_entry": -0.3981, "ferret_sera_escape": 0.3083, "mature_H5_site": 30, "mouse_sera_escape": null, "mutant": "L", "mutation": "Q40L", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.693, "ferret_sera_escape": null, "mature_H5_site": 30, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q40P", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 30, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q40Q", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.426, "ferret_sera_escape": 0.1616, "mature_H5_site": 30, "mouse_sera_escape": 0.325, "mutant": "R", "mutation": "Q40R", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": 0.4541, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2906, "ferret_sera_escape": -0.3253, "mature_H5_site": 30, "mouse_sera_escape": -0.201, "mutant": "S", "mutation": "Q40S", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": 0.8475, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.01736, "ferret_sera_escape": -0.166, "mature_H5_site": 30, "mouse_sera_escape": 0.009143, "mutant": "V", "mutation": "Q40V", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": 1.621, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1165, "ferret_sera_escape": -0.03681, "mature_H5_site": 30, "mouse_sera_escape": 0.02139, "mutant": "W", "mutation": "Q40W", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": -0.1532, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.01834, "ferret_sera_escape": -0.3145, "mature_H5_site": 400, "mouse_sera_escape": -0.0938, "mutant": "C", "mutation": "N400C", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": -0.3174, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.981, "ferret_sera_escape": -0.1088, "mature_H5_site": 400, "mouse_sera_escape": 0.0105, "mutant": "D", "mutation": "N400D", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": -0.253, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.633, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "E", "mutation": "N400E", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5786, "ferret_sera_escape": -0.01646, "mature_H5_site": 400, "mouse_sera_escape": 0.1012, "mutant": "G", "mutation": "N400G", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": 0.261, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3016, "ferret_sera_escape": -0.06842, "mature_H5_site": 400, "mouse_sera_escape": -0.003189, "mutant": "H", "mutation": "N400H", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": -0.1351, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "I", "mutation": "N400I", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.741, "ferret_sera_escape": 0.1219, "mature_H5_site": 400, "mouse_sera_escape": 0.07115, "mutant": "K", "mutation": "N400K", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": -0.2876, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.978, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "L", "mutation": "N400L", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.614, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "M", "mutation": "N400M", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 400, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N400N", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "P", "mutation": "N400P", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.287, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N400Q", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.489, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "R", "mutation": "N400R", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.06839, "ferret_sera_escape": -0.1014, "mature_H5_site": 400, "mouse_sera_escape": 0.01365, "mutant": "S", "mutation": "N400S", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": -0.03817, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.453, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "V", "mutation": "N400V", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "W", "mutation": "N400W", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -6.017, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N400Y", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04626, "ferret_sera_escape": -0.02229, "mature_H5_site": 401, "mouse_sera_escape": -0.04736, "mutant": "A", "mutation": "N401A", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.1279, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1383, "ferret_sera_escape": 0.08884, "mature_H5_site": 401, "mouse_sera_escape": 0.001731, "mutant": "C", "mutation": "N401C", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.04709, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.106, "ferret_sera_escape": 0.06327, "mature_H5_site": 401, "mouse_sera_escape": 0.0131, "mutant": "D", "mutation": "N401D", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.01146, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2854, "ferret_sera_escape": -0.2993, "mature_H5_site": 401, "mouse_sera_escape": -0.1341, "mutant": "E", "mutation": "N401E", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.07544, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07135, "ferret_sera_escape": -0.01018, "mature_H5_site": 401, "mouse_sera_escape": -0.03125, "mutant": "F", "mutation": "N401F", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.203, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04331, "ferret_sera_escape": 0.1173, "mature_H5_site": 401, "mouse_sera_escape": 0.0456, "mutant": "G", "mutation": "N401G", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.002678, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1922, "ferret_sera_escape": -0.01541, "mature_H5_site": 401, "mouse_sera_escape": -0.06635, "mutant": "I", "mutation": "N401I", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04602, "ferret_sera_escape": 0.07719, "mature_H5_site": 401, "mouse_sera_escape": 0.1581, "mutant": "K", "mutation": "N401K", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": 0.2206, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 401, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N401N", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7028, "ferret_sera_escape": -0.144, "mature_H5_site": 401, "mouse_sera_escape": -0.02139, "mutant": "P", "mutation": "N401P", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.1534, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.07158, "ferret_sera_escape": -0.0255, "mature_H5_site": 401, "mouse_sera_escape": -0.07116, "mutant": "Q", "mutation": "N401Q", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": 0.05023, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05539, "ferret_sera_escape": -0.02517, "mature_H5_site": 401, "mouse_sera_escape": 0.02307, "mutant": "R", "mutation": "N401R", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": 0.008294, "wildtype": "N"}, {"a26_usage": 0.2881, "cell_entry": -0.5873, "ferret_sera_escape": null, "mature_H5_site": 401, "mouse_sera_escape": -0.09779, "mutant": "S", "mutation": "N401S", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.06799, "ferret_sera_escape": 0.03892, "mature_H5_site": 401, "mouse_sera_escape": -0.06534, "mutant": "T", "mutation": "N401T", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.1781, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.04712, "ferret_sera_escape": 0.01916, "mature_H5_site": 401, "mouse_sera_escape": 0.05708, "mutant": "V", "mutation": "N401V", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.1774, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.06691, "ferret_sera_escape": 0.06245, "mature_H5_site": 401, "mouse_sera_escape": -0.008749, "mutant": "W", "mutation": "N401W", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": 0.8301, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04162, "ferret_sera_escape": -0.02603, "mature_H5_site": 401, "mouse_sera_escape": -0.05511, "mutant": "Y", "mutation": "N401Y", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.2652, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.953, "ferret_sera_escape": 0.1161, "mature_H5_site": 402, "mouse_sera_escape": 0.07234, "mutant": "A", "mutation": "L402A", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.101, "ferret_sera_escape": 0.1474, "mature_H5_site": 402, "mouse_sera_escape": 0.2435, "mutant": "C", "mutation": "L402C", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": 0.3942, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.153, "ferret_sera_escape": 0.08348, "mature_H5_site": 402, "mouse_sera_escape": 0.146, "mutant": "D", "mutation": "L402D", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": -0.04008, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.873, "ferret_sera_escape": 0.04138, "mature_H5_site": 402, "mouse_sera_escape": 0.3914, "mutant": "E", "mutation": "L402E", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": -0.09088, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2883, "ferret_sera_escape": 0.1378, "mature_H5_site": 402, "mouse_sera_escape": -0.07911, "mutant": "F", "mutation": "L402F", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": -0.3552, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.994, "ferret_sera_escape": 0.1193, "mature_H5_site": 402, "mouse_sera_escape": null, "mutant": "G", "mutation": "L402G", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": 0.1354, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3643, "ferret_sera_escape": 0.05689, "mature_H5_site": 402, "mouse_sera_escape": -0.02209, "mutant": "I", "mutation": "L402I", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": -0.2325, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.377, "ferret_sera_escape": null, "mature_H5_site": 402, "mouse_sera_escape": null, "mutant": "K", "mutation": "L402K", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 402, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L402L", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7639, "ferret_sera_escape": -0.1151, "mature_H5_site": 402, "mouse_sera_escape": 0.02099, "mutant": "M", "mutation": "L402M", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": 0.1347, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.304, "ferret_sera_escape": -0.04732, "mature_H5_site": 402, "mouse_sera_escape": 0.116, "mutant": "N", "mutation": "L402N", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": 0.1336, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.978, "ferret_sera_escape": null, "mature_H5_site": 402, "mouse_sera_escape": null, "mutant": "P", "mutation": "L402P", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7077, "ferret_sera_escape": 0.1042, "mature_H5_site": 402, "mouse_sera_escape": 0.274, "mutant": "Q", "mutation": "L402Q", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": -0.03667, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.058, "ferret_sera_escape": 0.4479, "mature_H5_site": 402, "mouse_sera_escape": 0.5319, "mutant": "R", "mutation": "L402R", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": 1.226, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 402, "mouse_sera_escape": null, "mutant": "T", "mutation": "L402T", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.002795, "ferret_sera_escape": -0.1329, "mature_H5_site": 402, "mouse_sera_escape": -0.1116, "mutant": "V", "mutation": "L402V", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": -0.1478, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1514, "ferret_sera_escape": null, "mature_H5_site": 402, "mouse_sera_escape": null, "mutant": "W", "mutation": "L402W", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4193, "ferret_sera_escape": 0.04761, "mature_H5_site": 402, "mouse_sera_escape": 0.06484, "mutant": "Y", "mutation": "L402Y", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": -0.2498, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.892, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "A", "mutation": "E403A", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "C", "mutation": "E403C", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "D", "mutation": "E403D", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 403, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E403E", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.747, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "F", "mutation": "E403F", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "G", "mutation": "E403G", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "H", "mutation": "E403H", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.997, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "I", "mutation": "E403I", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.845, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "K", "mutation": "E403K", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "L", "mutation": "E403L", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "M", "mutation": "E403M", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "N", "mutation": "E403N", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "P", "mutation": "E403P", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "Q", "mutation": "E403Q", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "R", "mutation": "E403R", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "S", "mutation": "E403S", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "T", "mutation": "E403T", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "V", "mutation": "E403V", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "W", "mutation": "E403W", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.167, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E403Y", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.271, "ferret_sera_escape": -0.1238, "mature_H5_site": 404, "mouse_sera_escape": -0.004708, "mutant": "C", "mutation": "R404C", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": -0.2587, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.811, "ferret_sera_escape": null, "mature_H5_site": 404, "mouse_sera_escape": null, "mutant": "F", "mutation": "R404F", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.926, "ferret_sera_escape": null, "mature_H5_site": 404, "mouse_sera_escape": null, "mutant": "G", "mutation": "R404G", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5145, "ferret_sera_escape": -0.2844, "mature_H5_site": 404, "mouse_sera_escape": -0.08383, "mutant": "H", "mutation": "R404H", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": -0.1338, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.553, "ferret_sera_escape": -0.09603, "mature_H5_site": 404, "mouse_sera_escape": -0.09995, "mutant": "I", "mutation": "R404I", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": -0.7531, "wildtype": "R"}, {"a26_usage": 0.0481, "cell_entry": -0.05765, "ferret_sera_escape": 0.04756, "mature_H5_site": 404, "mouse_sera_escape": 0.011, "mutant": "K", "mutation": "R404K", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": -0.1664, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.418, "ferret_sera_escape": -0.2313, "mature_H5_site": 404, "mouse_sera_escape": 0.06041, "mutant": "L", "mutation": "R404L", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": -0.3614, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1928, "ferret_sera_escape": -0.1314, "mature_H5_site": 404, "mouse_sera_escape": -0.04474, "mutant": "M", "mutation": "R404M", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": -0.3231, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.09634, "ferret_sera_escape": -0.05186, "mature_H5_site": 404, "mouse_sera_escape": -0.1309, "mutant": "Q", "mutation": "R404Q", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": -0.4108, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 404, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R404R", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.366, "ferret_sera_escape": null, "mature_H5_site": 404, "mouse_sera_escape": null, "mutant": "V", "mutation": "R404V", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.239, "ferret_sera_escape": null, "mature_H5_site": 404, "mouse_sera_escape": null, "mutant": "W", "mutation": "R404W", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.328, "ferret_sera_escape": null, "mature_H5_site": 404, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R404Y", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -6.015, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "A", "mutation": "R405A", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.325, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "C", "mutation": "R405C", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "D", "mutation": "R405D", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "E", "mutation": "R405E", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "F", "mutation": "R405F", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.894, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "H", "mutation": "R405H", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "I", "mutation": "R405I", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "K", "mutation": "R405K", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.711, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "L", "mutation": "R405L", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "M", "mutation": "R405M", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "N", "mutation": "R405N", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 405, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R405R", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.695, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "S", "mutation": "R405S", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.515, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "T", "mutation": "R405T", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.997, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "W", "mutation": "R405W", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R405Y", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.537, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "A", "mutation": "I406A", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.595, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "C", "mutation": "I406C", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "D", "mutation": "I406D", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "E", "mutation": "I406E", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.17, "ferret_sera_escape": -0.1051, "mature_H5_site": 406, "mouse_sera_escape": 0.06332, "mutant": "F", "mutation": "I406F", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": 0.8334, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "G", "mutation": "I406G", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 406, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I406I", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "K", "mutation": "I406K", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6878, "ferret_sera_escape": 0.02728, "mature_H5_site": 406, "mouse_sera_escape": 0.08092, "mutant": "L", "mutation": "I406L", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": 0.9376, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.404, "ferret_sera_escape": -0.126, "mature_H5_site": 406, "mouse_sera_escape": -0.02473, "mutant": "M", "mutation": "I406M", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "P", "mutation": "I406P", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.895, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "R", "mutation": "I406R", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "S", "mutation": "I406S", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.359, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "T", "mutation": "I406T", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.3184, "cell_entry": -0.4836, "ferret_sera_escape": -0.09341, "mature_H5_site": 406, "mouse_sera_escape": -0.01798, "mutant": "V", "mutation": "I406V", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": -0.05386, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.41, "ferret_sera_escape": 0.03791, "mature_H5_site": 406, "mouse_sera_escape": 0.1523, "mutant": "W", "mutation": "I406W", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": 0.4579, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.8275, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I406Y", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.752, "ferret_sera_escape": 0.01527, "mature_H5_site": 407, "mouse_sera_escape": 0.07276, "mutant": "A", "mutation": "E407A", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 1.483, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.755, "ferret_sera_escape": -0.09594, "mature_H5_site": 407, "mouse_sera_escape": -0.007637, "mutant": "C", "mutation": "E407C", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": -0.00858, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.647, "ferret_sera_escape": -0.1088, "mature_H5_site": 407, "mouse_sera_escape": -0.1113, "mutant": "D", "mutation": "E407D", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": -0.2119, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 407, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E407E", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2576, "ferret_sera_escape": 0.001543, "mature_H5_site": 407, "mouse_sera_escape": 0.1017, "mutant": "F", "mutation": "E407F", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 1.854, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.514, "ferret_sera_escape": -0.08591, "mature_H5_site": 407, "mouse_sera_escape": 0.02864, "mutant": "G", "mutation": "E407G", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": -0.0347, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.0126, "ferret_sera_escape": -0.07791, "mature_H5_site": 407, "mouse_sera_escape": -0.02443, "mutant": "H", "mutation": "E407H", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": -0.2141, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.029, "ferret_sera_escape": null, "mature_H5_site": 407, "mouse_sera_escape": null, "mutant": "I", "mutation": "E407I", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.201, "ferret_sera_escape": -0.06668, "mature_H5_site": 407, "mouse_sera_escape": 0.133, "mutant": "K", "mutation": "E407K", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 0.9306, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.501, "ferret_sera_escape": -0.208, "mature_H5_site": 407, "mouse_sera_escape": null, "mutant": "L", "mutation": "E407L", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 0.7533, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.544, "ferret_sera_escape": null, "mature_H5_site": 407, "mouse_sera_escape": 0.1348, "mutant": "M", "mutation": "E407M", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.286, "ferret_sera_escape": -0.2913, "mature_H5_site": 407, "mouse_sera_escape": -0.04817, "mutant": "N", "mutation": "E407N", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": -0.03245, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 407, "mouse_sera_escape": null, "mutant": "P", "mutation": "E407P", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.28, "ferret_sera_escape": -0.3233, "mature_H5_site": 407, "mouse_sera_escape": -0.03573, "mutant": "Q", "mutation": "E407Q", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.00553, "ferret_sera_escape": -0.2754, "mature_H5_site": 407, "mouse_sera_escape": -0.09899, "mutant": "S", "mutation": "E407S", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 0.8929, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.301, "ferret_sera_escape": -0.1529, "mature_H5_site": 407, "mouse_sera_escape": 0.662, "mutant": "T", "mutation": "E407T", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 0.7825, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.273, "ferret_sera_escape": null, "mature_H5_site": 407, "mouse_sera_escape": 0.7003, "mutant": "V", "mutation": "E407V", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.05611, "ferret_sera_escape": null, "mature_H5_site": 407, "mouse_sera_escape": null, "mutant": "W", "mutation": "E407W", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3366, "ferret_sera_escape": -0.03037, "mature_H5_site": 407, "mouse_sera_escape": 0.06667, "mutant": "Y", "mutation": "E407Y", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 1.665, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0657, "ferret_sera_escape": 0.01877, "mature_H5_site": 408, "mouse_sera_escape": 0.2403, "mutant": "A", "mutation": "N408A", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.8457, "wildtype": "N"}, {"a26_usage": 0.02503, "cell_entry": 0.07118, "ferret_sera_escape": 0.1214, "mature_H5_site": 408, "mouse_sera_escape": 0.09547, "mutant": "C", "mutation": "N408C", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.862, "ferret_sera_escape": 0.07795, "mature_H5_site": 408, "mouse_sera_escape": -0.1507, "mutant": "D", "mutation": "N408D", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6343, "ferret_sera_escape": -0.005562, "mature_H5_site": 408, "mouse_sera_escape": 0.01643, "mutant": "E", "mutation": "N408E", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": -0.9864, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9346, "ferret_sera_escape": -0.4838, "mature_H5_site": 408, "mouse_sera_escape": -0.1187, "mutant": "F", "mutation": "N408F", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.719, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1895, "ferret_sera_escape": -0.08427, "mature_H5_site": 408, "mouse_sera_escape": 0.06398, "mutant": "G", "mutation": "N408G", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.09722, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9085, "ferret_sera_escape": null, "mature_H5_site": 408, "mouse_sera_escape": null, "mutant": "I", "mutation": "N408I", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.672, "ferret_sera_escape": -0.1829, "mature_H5_site": 408, "mouse_sera_escape": 0.5602, "mutant": "K", "mutation": "N408K", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.768, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04266, "ferret_sera_escape": -0.007397, "mature_H5_site": 408, "mouse_sera_escape": 0.05612, "mutant": "L", "mutation": "N408L", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.8249, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7057, "ferret_sera_escape": -0.02978, "mature_H5_site": 408, "mouse_sera_escape": 0.3955, "mutant": "M", "mutation": "N408M", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 1.269, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 408, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N408N", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 408, "mouse_sera_escape": null, "mutant": "P", "mutation": "N408P", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04367, "ferret_sera_escape": -0.1771, "mature_H5_site": 408, "mouse_sera_escape": -0.04453, "mutant": "Q", "mutation": "N408Q", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": -0.1454, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6967, "ferret_sera_escape": 0.1085, "mature_H5_site": 408, "mouse_sera_escape": 0.06319, "mutant": "S", "mutation": "N408S", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.2856, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4969, "ferret_sera_escape": -0.1595, "mature_H5_site": 408, "mouse_sera_escape": 0.2932, "mutant": "T", "mutation": "N408T", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.6629, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.117, "ferret_sera_escape": -0.1472, "mature_H5_site": 408, "mouse_sera_escape": 0.2868, "mutant": "V", "mutation": "N408V", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 1.107, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9513, "ferret_sera_escape": -0.3485, "mature_H5_site": 408, "mouse_sera_escape": -0.02193, "mutant": "W", "mutation": "N408W", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.3808, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.169, "ferret_sera_escape": -0.1301, "mature_H5_site": 408, "mouse_sera_escape": 0.03912, "mutant": "Y", "mutation": "N408Y", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 1.236, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.878, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "A", "mutation": "L409A", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "C", "mutation": "L409C", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "D", "mutation": "L409D", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.894, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "E", "mutation": "L409E", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.996, "ferret_sera_escape": -0.113, "mature_H5_site": 409, "mouse_sera_escape": 0.3935, "mutant": "F", "mutation": "L409F", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "G", "mutation": "L409G", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "H", "mutation": "L409H", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.386, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "I", "mutation": "L409I", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "K", "mutation": "L409K", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 409, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L409L", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "N", "mutation": "L409N", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "P", "mutation": "L409P", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.835, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L409Q", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "R", "mutation": "L409R", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "S", "mutation": "L409S", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.154, "ferret_sera_escape": 0.008573, "mature_H5_site": 409, "mouse_sera_escape": 0.09263, "mutant": "V", "mutation": "L409V", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": 1.071, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.809, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "W", "mutation": "L409W", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.991, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L409Y", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.165, "ferret_sera_escape": -0.06804, "mature_H5_site": 31, "mouse_sera_escape": null, "mutant": "A", "mutation": "D41A", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 31, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D41D", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2946, "ferret_sera_escape": 0.04599, "mature_H5_site": 31, "mouse_sera_escape": 0.07897, "mutant": "E", "mutation": "D41E", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": 1.517, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3858, "ferret_sera_escape": -0.03651, "mature_H5_site": 31, "mouse_sera_escape": 0.1429, "mutant": "G", "mutation": "D41G", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": 1.604, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.04228, "ferret_sera_escape": null, "mature_H5_site": 31, "mouse_sera_escape": null, "mutant": "H", "mutation": "D41H", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3564, "ferret_sera_escape": -0.04557, "mature_H5_site": 31, "mouse_sera_escape": 0.02066, "mutant": "K", "mutation": "D41K", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": -0.2327, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5279, "ferret_sera_escape": -0.06159, "mature_H5_site": 31, "mouse_sera_escape": -0.01646, "mutant": "L", "mutation": "D41L", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": -0.275, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.05694, "ferret_sera_escape": 0.01191, "mature_H5_site": 31, "mouse_sera_escape": -0.02046, "mutant": "M", "mutation": "D41M", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": -0.02056, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.03961, "ferret_sera_escape": 0.1142, "mature_H5_site": 31, "mouse_sera_escape": 0.03631, "mutant": "N", "mutation": "D41N", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": -0.06964, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4959, "ferret_sera_escape": -0.111, "mature_H5_site": 31, "mouse_sera_escape": -0.06069, "mutant": "P", "mutation": "D41P", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.06001, "ferret_sera_escape": -0.00353, "mature_H5_site": 31, "mouse_sera_escape": 0.09851, "mutant": "Q", "mutation": "D41Q", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": -0.2865, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7866, "ferret_sera_escape": -0.1366, "mature_H5_site": 31, "mouse_sera_escape": -0.04646, "mutant": "R", "mutation": "D41R", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": -0.1953, "wildtype": "D"}, {"a26_usage": 0.8774, "cell_entry": -0.3387, "ferret_sera_escape": -0.2291, "mature_H5_site": 31, "mouse_sera_escape": 0.4573, "mutant": "S", "mutation": "D41S", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.9921, "ferret_sera_escape": 0.03458, "mature_H5_site": 31, "mouse_sera_escape": 0.2019, "mutant": "T", "mutation": "D41T", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": 1.707, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5968, "ferret_sera_escape": null, "mature_H5_site": 31, "mouse_sera_escape": null, "mutant": "V", "mutation": "D41V", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": null, "wildtype": "D"}, {"a26_usage": 0.3703, "cell_entry": -0.3471, "ferret_sera_escape": 0.1232, "mature_H5_site": 31, "mouse_sera_escape": 0.2546, "mutant": "W", "mutation": "D41W", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": 1.612, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2681, "ferret_sera_escape": 0.01765, "mature_H5_site": 31, "mouse_sera_escape": 0.007474, "mutant": "Y", "mutation": "D41Y", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": -0.184, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3307, "ferret_sera_escape": 0.03575, "mature_H5_site": 410, "mouse_sera_escape": 0.0247, "mutant": "A", "mutation": "N410A", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": 0.009286, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.231, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "C", "mutation": "N410C", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9637, "ferret_sera_escape": -0.04684, "mature_H5_site": 410, "mouse_sera_escape": 0.1223, "mutant": "D", "mutation": "N410D", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": -0.04098, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.21, "ferret_sera_escape": -0.2102, "mature_H5_site": 410, "mouse_sera_escape": 0.09249, "mutant": "E", "mutation": "N410E", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": 2.084, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3021, "ferret_sera_escape": -0.1244, "mature_H5_site": 410, "mouse_sera_escape": 0.2747, "mutant": "G", "mutation": "N410G", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": 0.5542, "wildtype": "N"}, {"a26_usage": 0.01257, "cell_entry": 0.005135, "ferret_sera_escape": 0.01191, "mature_H5_site": 410, "mouse_sera_escape": 0.0348, "mutant": "H", "mutation": "N410H", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": -0.1774, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.223, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "K", "mutation": "N410K", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.6, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "L", "mutation": "N410L", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.161, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": 1.15, "mutant": "M", "mutation": "N410M", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 410, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N410N", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.296, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N410Q", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": 0.5852, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.611, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "R", "mutation": "N410R", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.587, "ferret_sera_escape": -0.115, "mature_H5_site": 410, "mouse_sera_escape": 0.01127, "mutant": "S", "mutation": "N410S", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": -0.192, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.83, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "T", "mutation": "N410T", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "V", "mutation": "N410V", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.067, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "W", "mutation": "N410W", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.231, "ferret_sera_escape": -0.2415, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N410Y", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4272, "ferret_sera_escape": -0.1127, "mature_H5_site": 411, "mouse_sera_escape": 0.1439, "mutant": "A", "mutation": "K411A", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.803, "ferret_sera_escape": 0.3686, "mature_H5_site": 411, "mouse_sera_escape": 0.2578, "mutant": "C", "mutation": "K411C", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": -0.2077, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.699, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "D", "mutation": "K411D", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.7162, "cell_entry": -1.829, "ferret_sera_escape": 0.03857, "mature_H5_site": 411, "mouse_sera_escape": 0.02637, "mutant": "E", "mutation": "K411E", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": -0.2591, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.481, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "F", "mutation": "K411F", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.289, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "I", "mutation": "K411I", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 411, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K411K", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.723, "ferret_sera_escape": -0.1469, "mature_H5_site": 411, "mouse_sera_escape": 0.1327, "mutant": "L", "mutation": "K411L", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5161, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "M", "mutation": "K411M", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.522, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "N", "mutation": "K411N", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "P", "mutation": "K411P", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07197, "ferret_sera_escape": -0.01675, "mature_H5_site": 411, "mouse_sera_escape": -0.07209, "mutant": "R", "mutation": "K411R", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": -0.2515, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2978, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "T", "mutation": "K411T", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.332, "ferret_sera_escape": -0.07142, "mature_H5_site": 411, "mouse_sera_escape": -0.07595, "mutant": "V", "mutation": "K411V", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": -0.2335, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "W", "mutation": "K411W", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.706, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K411Y", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.322, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "C", "mutation": "K412C", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.861, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "D", "mutation": "K412D", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.178, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "E", "mutation": "K412E", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.22, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "F", "mutation": "K412F", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.606, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "G", "mutation": "K412G", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.093, "ferret_sera_escape": 0.247, "mature_H5_site": 412, "mouse_sera_escape": 0.1306, "mutant": "H", "mutation": "K412H", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.9367, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.598, "ferret_sera_escape": -0.1227, "mature_H5_site": 412, "mouse_sera_escape": -0.1041, "mutant": "I", "mutation": "K412I", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.606, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 412, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K412K", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.642, "ferret_sera_escape": 0.1448, "mature_H5_site": 412, "mouse_sera_escape": 0.1274, "mutant": "L", "mutation": "K412L", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.8767, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.0, "ferret_sera_escape": 0.1616, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "M", "mutation": "K412M", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.572, "ferret_sera_escape": 0.2111, "mature_H5_site": 412, "mouse_sera_escape": 0.3292, "mutant": "N", "mutation": "K412N", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.1688, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.692, "ferret_sera_escape": 0.1466, "mature_H5_site": 412, "mouse_sera_escape": 0.1232, "mutant": "Q", "mutation": "K412Q", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.8259, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.737, "ferret_sera_escape": -0.2484, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "R", "mutation": "K412R", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "S", "mutation": "K412S", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "T", "mutation": "K412T", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.35, "ferret_sera_escape": 0.306, "mature_H5_site": 412, "mouse_sera_escape": 0.3033, "mutant": "V", "mutation": "K412V", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.3306, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.083, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "W", "mutation": "K412W", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.118, "ferret_sera_escape": -0.01199, "mature_H5_site": 412, "mouse_sera_escape": 0.3236, "mutant": "Y", "mutation": "K412Y", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.9124, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "A", "mutation": "M413A", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.797, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "F", "mutation": "M413F", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "G", "mutation": "M413G", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "H", "mutation": "M413H", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.2718, "ferret_sera_escape": -0.1016, "mature_H5_site": 413, "mouse_sera_escape": 0.0636, "mutant": "I", "mutation": "M413I", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": 0.5607, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "K", "mutation": "M413K", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.00092, "ferret_sera_escape": -0.07905, "mature_H5_site": 413, "mouse_sera_escape": -0.006619, "mutant": "L", "mutation": "M413L", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": 1.17, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 413, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M413M", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "N", "mutation": "M413N", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.964, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "P", "mutation": "M413P", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.409, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "Q", "mutation": "M413Q", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "S", "mutation": "M413S", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.29, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "T", "mutation": "M413T", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.1254, "ferret_sera_escape": 0.08285, "mature_H5_site": 413, "mouse_sera_escape": -0.01779, "mutant": "V", "mutation": "M413V", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": -0.002705, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.028, "ferret_sera_escape": -0.09727, "mature_H5_site": 414, "mouse_sera_escape": 0.2234, "mutant": "A", "mutation": "E414A", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": 0.2993, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.315, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "C", "mutation": "E414C", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.457, "ferret_sera_escape": -0.1068, "mature_H5_site": 414, "mouse_sera_escape": 0.4814, "mutant": "D", "mutation": "E414D", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": 0.8328, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 414, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E414E", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.964, "ferret_sera_escape": -0.2996, "mature_H5_site": 414, "mouse_sera_escape": 0.3608, "mutant": "F", "mutation": "E414F", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.069, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "G", "mutation": "E414G", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2649, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "H", "mutation": "E414H", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2315, "ferret_sera_escape": 0.1856, "mature_H5_site": 414, "mouse_sera_escape": 0.1507, "mutant": "I", "mutation": "E414I", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": -0.3983, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.641, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "K", "mutation": "E414K", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4277, "ferret_sera_escape": 0.03067, "mature_H5_site": 414, "mouse_sera_escape": 0.27, "mutant": "M", "mutation": "E414M", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": -0.3099, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.718, "ferret_sera_escape": -0.02499, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "N", "mutation": "E414N", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": -0.254, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3755, "ferret_sera_escape": 0.002617, "mature_H5_site": 414, "mouse_sera_escape": 0.1129, "mutant": "Q", "mutation": "E414Q", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": -0.2922, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.983, "ferret_sera_escape": 0.2877, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "R", "mutation": "E414R", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": -0.226, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5457, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "S", "mutation": "E414S", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.559, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": 0.1182, "mutant": "T", "mutation": "E414T", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.06156, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "V", "mutation": "E414V", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "W", "mutation": "E414W", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.839, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E414Y", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.343, "ferret_sera_escape": -0.4333, "mature_H5_site": 415, "mouse_sera_escape": -0.4182, "mutant": "A", "mutation": "D415A", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": -0.1906, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.099, "ferret_sera_escape": -0.2813, "mature_H5_site": 415, "mouse_sera_escape": -0.3007, "mutant": "C", "mutation": "D415C", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 415, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D415D", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.162, "ferret_sera_escape": -0.4499, "mature_H5_site": 415, "mouse_sera_escape": -0.3733, "mutant": "E", "mutation": "D415E", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": -0.3738, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.854, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "F", "mutation": "D415F", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7687, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "G", "mutation": "D415G", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.396, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "H", "mutation": "D415H", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": 0.1328, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.012, "ferret_sera_escape": -0.59, "mature_H5_site": 415, "mouse_sera_escape": -0.3836, "mutant": "I", "mutation": "D415I", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.726, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "K", "mutation": "D415K", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.829, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": -0.07787, "mutant": "L", "mutation": "D415L", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.508, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "M", "mutation": "D415M", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7733, "ferret_sera_escape": -0.2487, "mature_H5_site": 415, "mouse_sera_escape": -0.2303, "mutant": "N", "mutation": "D415N", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": -0.205, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "P", "mutation": "D415P", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.832, "ferret_sera_escape": -0.03999, "mature_H5_site": 415, "mouse_sera_escape": -0.02953, "mutant": "Q", "mutation": "D415Q", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": -0.04485, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.599, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "R", "mutation": "D415R", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.308, "ferret_sera_escape": -0.4954, "mature_H5_site": 415, "mouse_sera_escape": -0.557, "mutant": "T", "mutation": "D415T", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": -0.1006, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.055, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "V", "mutation": "D415V", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.747, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "W", "mutation": "D415W", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.365, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D415Y", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7084, "ferret_sera_escape": -0.2291, "mature_H5_site": 416, "mouse_sera_escape": -0.1096, "mutant": "A", "mutation": "G416A", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": -0.2343, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "C", "mutation": "G416C", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.053, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "D", "mutation": "G416D", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.229, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "E", "mutation": "G416E", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "F", "mutation": "G416F", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 416, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G416G", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "H", "mutation": "G416H", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "I", "mutation": "G416I", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.865, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "K", "mutation": "G416K", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "L", "mutation": "G416L", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.516, "ferret_sera_escape": 0.1183, "mature_H5_site": 416, "mouse_sera_escape": 0.3029, "mutant": "N", "mutation": "G416N", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": 0.8296, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "P", "mutation": "G416P", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.183, "ferret_sera_escape": -0.1813, "mature_H5_site": 416, "mouse_sera_escape": 0.1031, "mutant": "Q", "mutation": "G416Q", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": 0.6068, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.271, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "R", "mutation": "G416R", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.225, "ferret_sera_escape": -0.1979, "mature_H5_site": 416, "mouse_sera_escape": 0.05541, "mutant": "S", "mutation": "G416S", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": -0.2475, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.29, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "T", "mutation": "G416T", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "V", "mutation": "G416V", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.716, "ferret_sera_escape": 0.05853, "mature_H5_site": 416, "mouse_sera_escape": 0.3744, "mutant": "Y", "mutation": "G416Y", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": -0.1817, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.796, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "A", "mutation": "F417A", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.012, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "C", "mutation": "F417C", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.256, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "D", "mutation": "F417D", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "E", "mutation": "F417E", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 417, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F417F", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "G", "mutation": "F417G", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.848, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "H", "mutation": "F417H", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.617, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "I", "mutation": "F417I", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.71, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "K", "mutation": "F417K", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.915, "ferret_sera_escape": 0.03742, "mature_H5_site": 417, "mouse_sera_escape": 0.008507, "mutant": "L", "mutation": "F417L", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": 0.3511, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "N", "mutation": "F417N", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.89, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "P", "mutation": "F417P", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.86, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F417Q", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "R", "mutation": "F417R", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "S", "mutation": "F417S", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "T", "mutation": "F417T", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "V", "mutation": "F417V", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "W", "mutation": "F417W", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "Y", "mutation": "F417Y", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.791, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "C", "mutation": "L418C", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9041, "ferret_sera_escape": 0.09284, "mature_H5_site": 418, "mouse_sera_escape": 0.1316, "mutant": "D", "mutation": "L418D", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 1.671, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.364, "ferret_sera_escape": 0.007684, "mature_H5_site": 418, "mouse_sera_escape": 0.09424, "mutant": "E", "mutation": "L418E", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 1.698, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.561, "ferret_sera_escape": 0.06553, "mature_H5_site": 418, "mouse_sera_escape": 0.3025, "mutant": "F", "mutation": "L418F", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 1.818, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.891, "ferret_sera_escape": -0.1008, "mature_H5_site": 418, "mouse_sera_escape": 0.0475, "mutant": "H", "mutation": "L418H", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.62, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "I", "mutation": "L418I", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.51, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "K", "mutation": "L418K", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 418, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L418L", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.664, "ferret_sera_escape": -0.0091, "mature_H5_site": 418, "mouse_sera_escape": 0.1316, "mutant": "N", "mutation": "L418N", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 1.805, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.719, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "P", "mutation": "L418P", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06695, "ferret_sera_escape": -0.1301, "mature_H5_site": 418, "mouse_sera_escape": 0.1966, "mutant": "Q", "mutation": "L418Q", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 0.5193, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.776, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "R", "mutation": "L418R", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.079, "ferret_sera_escape": -0.07414, "mature_H5_site": 418, "mouse_sera_escape": 0.5139, "mutant": "S", "mutation": "L418S", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 1.268, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.886, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "T", "mutation": "L418T", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.516, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "V", "mutation": "L418V", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.723, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "W", "mutation": "L418W", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.164, "ferret_sera_escape": 0.01811, "mature_H5_site": 418, "mouse_sera_escape": 0.1803, "mutant": "Y", "mutation": "L418Y", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 1.089, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 419, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D419D", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.031, "ferret_sera_escape": -0.08571, "mature_H5_site": 419, "mouse_sera_escape": 0.06388, "mutant": "E", "mutation": "D419E", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": 1.518, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.331, "ferret_sera_escape": null, "mature_H5_site": 419, "mouse_sera_escape": null, "mutant": "F", "mutation": "D419F", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8767, "ferret_sera_escape": 0.08097, "mature_H5_site": 419, "mouse_sera_escape": 0.1508, "mutant": "G", "mutation": "D419G", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": -0.1231, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 419, "mouse_sera_escape": null, "mutant": "I", "mutation": "D419I", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.402, "ferret_sera_escape": null, "mature_H5_site": 419, "mouse_sera_escape": null, "mutant": "L", "mutation": "D419L", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3654, "ferret_sera_escape": 0.004667, "mature_H5_site": 419, "mouse_sera_escape": 0.2683, "mutant": "M", "mutation": "D419M", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": 1.454, "wildtype": "D"}, {"a26_usage": 0.5048, "cell_entry": -0.8315, "ferret_sera_escape": 0.01171, "mature_H5_site": 419, "mouse_sera_escape": 0.1504, "mutant": "N", "mutation": "D419N", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": -0.1477, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.325, "ferret_sera_escape": null, "mature_H5_site": 419, "mouse_sera_escape": null, "mutant": "P", "mutation": "D419P", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.552, "ferret_sera_escape": -0.2125, "mature_H5_site": 419, "mouse_sera_escape": 0.4522, "mutant": "Q", "mutation": "D419Q", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": 0.1899, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 419, "mouse_sera_escape": null, "mutant": "R", "mutation": "D419R", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2809, "ferret_sera_escape": -0.04027, "mature_H5_site": 419, "mouse_sera_escape": 0.06462, "mutant": "S", "mutation": "D419S", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": 0.2792, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.383, "ferret_sera_escape": -0.1384, "mature_H5_site": 419, "mouse_sera_escape": 0.07944, "mutant": "V", "mutation": "D419V", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": -0.3396, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.487, "ferret_sera_escape": null, "mature_H5_site": 419, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D419Y", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.048, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "A", "mutation": "I42A", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.505, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "C", "mutation": "I42C", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "D", "mutation": "I42D", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.861, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "E", "mutation": "I42E", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.98, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "F", "mutation": "I42F", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.961, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "G", "mutation": "I42G", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.715, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "H", "mutation": "I42H", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 32, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I42I", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "K", "mutation": "I42K", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.388, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "M", "mutation": "I42M", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.592, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "N", "mutation": "I42N", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "P", "mutation": "I42P", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I42Q", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.232, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "R", "mutation": "I42R", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.871, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "S", "mutation": "I42S", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "T", "mutation": "I42T", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6063, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "V", "mutation": "I42V", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "W", "mutation": "I42W", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.873, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "A", "mutation": "V420A", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.861, "ferret_sera_escape": 0.07914, "mature_H5_site": 420, "mouse_sera_escape": 0.1183, "mutant": "C", "mutation": "V420C", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.821, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "D", "mutation": "V420D", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.788, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "E", "mutation": "V420E", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.907, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "F", "mutation": "V420F", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "G", "mutation": "V420G", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "H", "mutation": "V420H", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.106, "ferret_sera_escape": 0.03035, "mature_H5_site": 420, "mouse_sera_escape": 0.03598, "mutant": "I", "mutation": "V420I", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": 0.4243, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.977, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "K", "mutation": "V420K", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.03869, "ferret_sera_escape": -0.05563, "mature_H5_site": 420, "mouse_sera_escape": -0.05888, "mutant": "L", "mutation": "V420L", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": -0.1246, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.333, "ferret_sera_escape": -0.08646, "mature_H5_site": 420, "mouse_sera_escape": -0.0006362, "mutant": "M", "mutation": "V420M", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": 1.69, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "N", "mutation": "V420N", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.881, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "P", "mutation": "V420P", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.615, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V420Q", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "R", "mutation": "V420R", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.897, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "S", "mutation": "V420S", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.581, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "T", "mutation": "V420T", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 420, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V420V", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "W", "mutation": "V420W", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V420Y", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "C", "mutation": "W421C", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "D", "mutation": "W421D", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "E", "mutation": "W421E", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "G", "mutation": "W421G", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "H", "mutation": "W421H", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.879, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "I", "mutation": "W421I", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "K", "mutation": "W421K", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.88, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "L", "mutation": "W421L", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.247, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "M", "mutation": "W421M", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "N", "mutation": "W421N", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "P", "mutation": "W421P", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W421Q", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.095, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "R", "mutation": "W421R", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.874, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "S", "mutation": "W421S", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.465, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "T", "mutation": "W421T", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.107, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "V", "mutation": "W421V", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 421, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W421W", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.834, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "Y", "mutation": "W421Y", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "A", "mutation": "T422A", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.221, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "C", "mutation": "T422C", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "D", "mutation": "T422D", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "E", "mutation": "T422E", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.801, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "G", "mutation": "T422G", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "H", "mutation": "T422H", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.746, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "I", "mutation": "T422I", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "L", "mutation": "T422L", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.59, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "M", "mutation": "T422M", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.923, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "N", "mutation": "T422N", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.194, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "P", "mutation": "T422P", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.24, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T422Q", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "R", "mutation": "T422R", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.786, "ferret_sera_escape": 0.05483, "mature_H5_site": 422, "mouse_sera_escape": 0.1205, "mutant": "S", "mutation": "T422S", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": -0.1377, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 422, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T422T", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "V", "mutation": "T422V", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "W", "mutation": "T422W", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.99, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T422Y", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.98, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y423A", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.46, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y423C", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.177, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y423D", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.502, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y423E", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7398, "ferret_sera_escape": -0.1458, "mature_H5_site": 423, "mouse_sera_escape": 0.259, "mutant": "F", "mutation": "Y423F", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.065, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y423H", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.714, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y423I", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.374, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y423K", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y423L", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y423M", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.907, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y423N", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.617, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y423P", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.93, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y423Q", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.806, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y423R", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.538, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y423V", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.197, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y423W", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 423, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y423Y", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.056, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "C", "mutation": "N424C", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.332, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "D", "mutation": "N424D", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3063, "ferret_sera_escape": -0.06419, "mature_H5_site": 424, "mouse_sera_escape": -0.08343, "mutant": "E", "mutation": "N424E", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": 0.8584, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.772, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "F", "mutation": "N424F", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.815, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "H", "mutation": "N424H", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "I", "mutation": "N424I", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.694, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "K", "mutation": "N424K", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.708, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "M", "mutation": "N424M", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 424, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N424N", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "P", "mutation": "N424P", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.907, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N424Q", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "R", "mutation": "N424R", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.704, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "S", "mutation": "N424S", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.867, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "T", "mutation": "N424T", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -6.021, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "V", "mutation": "N424V", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 425, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A425A", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.328, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "C", "mutation": "A425C", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.778, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "D", "mutation": "A425D", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.986, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "E", "mutation": "A425E", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.681, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "F", "mutation": "A425F", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.472, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "G", "mutation": "A425G", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.822, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "H", "mutation": "A425H", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.8683, "ferret_sera_escape": -0.06039, "mature_H5_site": 425, "mouse_sera_escape": 0.04859, "mutant": "I", "mutation": "A425I", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": -0.1382, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "K", "mutation": "A425K", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "L", "mutation": "A425L", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.399, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "N", "mutation": "A425N", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.888, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "P", "mutation": "A425P", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.876, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A425Q", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "R", "mutation": "A425R", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5487, "ferret_sera_escape": 0.004343, "mature_H5_site": 425, "mouse_sera_escape": -0.2134, "mutant": "S", "mutation": "A425S", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": 0.3656, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.9384, "ferret_sera_escape": -0.1295, "mature_H5_site": 425, "mouse_sera_escape": -0.1229, "mutant": "T", "mutation": "A425T", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": -0.3693, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.986, "ferret_sera_escape": -0.1152, "mature_H5_site": 425, "mouse_sera_escape": 0.005449, "mutant": "V", "mutation": "A425V", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": -0.06037, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.564, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "W", "mutation": "A425W", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.846, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A425Y", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.135, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "A", "mutation": "E426A", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.829, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "C", "mutation": "E426C", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.55, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "D", "mutation": "E426D", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 426, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E426E", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "F", "mutation": "E426F", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.967, "ferret_sera_escape": 0.02262, "mature_H5_site": 426, "mouse_sera_escape": 0.02021, "mutant": "G", "mutation": "E426G", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.457, "ferret_sera_escape": 0.0469, "mature_H5_site": 426, "mouse_sera_escape": 0.1059, "mutant": "K", "mutation": "E426K", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "L", "mutation": "E426L", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.007, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "M", "mutation": "E426M", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.558, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "P", "mutation": "E426P", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.756, "ferret_sera_escape": -0.1289, "mature_H5_site": 426, "mouse_sera_escape": 0.001571, "mutant": "Q", "mutation": "E426Q", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": -0.1506, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.856, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "S", "mutation": "E426S", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.86, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "T", "mutation": "E426T", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.746, "ferret_sera_escape": -0.0591, "mature_H5_site": 426, "mouse_sera_escape": 0.4253, "mutant": "V", "mutation": "E426V", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.994, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "W", "mutation": "E426W", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.85, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E426Y", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.914, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "A", "mutation": "L427A", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "D", "mutation": "L427D", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "G", "mutation": "L427G", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.716, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "H", "mutation": "L427H", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.266, "ferret_sera_escape": -0.2673, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "I", "mutation": "L427I", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "K", "mutation": "L427K", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 427, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L427L", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.566, "ferret_sera_escape": 0.2469, "mature_H5_site": 427, "mouse_sera_escape": 0.2186, "mutant": "M", "mutation": "L427M", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": 2.003, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.016, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "N", "mutation": "L427N", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "P", "mutation": "L427P", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L427Q", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.684, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "R", "mutation": "L427R", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "S", "mutation": "L427S", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.054, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "T", "mutation": "L427T", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.942, "ferret_sera_escape": -0.07797, "mature_H5_site": 427, "mouse_sera_escape": 0.4101, "mutant": "V", "mutation": "L427V", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": 0.7623, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.635, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "W", "mutation": "L427W", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.503, "ferret_sera_escape": 0.1675, "mature_H5_site": 427, "mouse_sera_escape": 0.1156, "mutant": "Y", "mutation": "L427Y", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": 1.617, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.541, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "A", "mutation": "L428A", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.239, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "C", "mutation": "L428C", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "D", "mutation": "L428D", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.637, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "E", "mutation": "L428E", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6339, "ferret_sera_escape": -0.01424, "mature_H5_site": 428, "mouse_sera_escape": 0.05013, "mutant": "F", "mutation": "L428F", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.555, "ferret_sera_escape": 0.4986, "mature_H5_site": 428, "mouse_sera_escape": 0.5666, "mutant": "I", "mutation": "L428I", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": 1.416, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "K", "mutation": "L428K", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 428, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L428L", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1434, "ferret_sera_escape": 0.1451, "mature_H5_site": 428, "mouse_sera_escape": 0.009208, "mutant": "M", "mutation": "L428M", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": 1.513, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.022, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "N", "mutation": "L428N", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "P", "mutation": "L428P", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L428Q", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.972, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "R", "mutation": "L428R", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.874, "ferret_sera_escape": 0.2334, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "T", "mutation": "L428T", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.224, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "V", "mutation": "L428V", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5822, "ferret_sera_escape": -0.2336, "mature_H5_site": 428, "mouse_sera_escape": -0.1656, "mutant": "W", "mutation": "L428W", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.163, "ferret_sera_escape": -0.04157, "mature_H5_site": 428, "mouse_sera_escape": 0.2015, "mutant": "Y", "mutation": "L428Y", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.556, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "C", "mutation": "V429C", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "E", "mutation": "V429E", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "F", "mutation": "V429F", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.84, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "G", "mutation": "V429G", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "H", "mutation": "V429H", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1104, "ferret_sera_escape": 0.07712, "mature_H5_site": 429, "mouse_sera_escape": 0.0004606, "mutant": "I", "mutation": "V429I", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": -0.1302, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "K", "mutation": "V429K", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.595, "ferret_sera_escape": -0.1606, "mature_H5_site": 429, "mouse_sera_escape": -0.1193, "mutant": "L", "mutation": "V429L", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.496, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "M", "mutation": "V429M", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "N", "mutation": "V429N", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "P", "mutation": "V429P", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V429Q", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "R", "mutation": "V429R", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.494, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "S", "mutation": "V429S", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8071, "ferret_sera_escape": -0.06854, "mature_H5_site": 429, "mouse_sera_escape": -0.08456, "mutant": "T", "mutation": "V429T", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": 0.2335, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 429, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V429V", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V429Y", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "A", "mutation": "L43A", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.913, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "C", "mutation": "L43C", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "D", "mutation": "L43D", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "E", "mutation": "L43E", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.796, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "F", "mutation": "L43F", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.745, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "G", "mutation": "L43G", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "H", "mutation": "L43H", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.289, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "I", "mutation": "L43I", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "K", "mutation": "L43K", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 33, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L43L", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.112, "ferret_sera_escape": -0.0122, "mature_H5_site": 33, "mouse_sera_escape": -0.163, "mutant": "M", "mutation": "L43M", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": 0.03442, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "N", "mutation": "L43N", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.791, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "P", "mutation": "L43P", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.596, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L43Q", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "R", "mutation": "L43R", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.746, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "S", "mutation": "L43S", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "T", "mutation": "L43T", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "W", "mutation": "L43W", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L43Y", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.542, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "A", "mutation": "L430A", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "C", "mutation": "L430C", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "E", "mutation": "L430E", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "F", "mutation": "L430F", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.521, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "G", "mutation": "L430G", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.697, "ferret_sera_escape": -0.09284, "mature_H5_site": 430, "mouse_sera_escape": -0.01187, "mutant": "I", "mutation": "L430I", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": -0.05187, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.729, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "K", "mutation": "L430K", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 430, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L430L", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.355, "ferret_sera_escape": -0.09206, "mature_H5_site": 430, "mouse_sera_escape": 0.1358, "mutant": "M", "mutation": "L430M", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": -0.2626, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "N", "mutation": "L430N", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "P", "mutation": "L430P", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.914, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L430Q", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "R", "mutation": "L430R", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "T", "mutation": "L430T", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.613, "ferret_sera_escape": -0.2478, "mature_H5_site": 430, "mouse_sera_escape": 0.01068, "mutant": "V", "mutation": "L430V", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": -0.2226, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "W", "mutation": "L430W", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.029, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L430Y", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.425, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "A", "mutation": "M431A", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "D", "mutation": "M431D", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.383, "ferret_sera_escape": -0.2085, "mature_H5_site": 431, "mouse_sera_escape": 0.2873, "mutant": "E", "mutation": "M431E", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.715, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "G", "mutation": "M431G", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.915, "ferret_sera_escape": -0.1324, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "H", "mutation": "M431H", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.519, "ferret_sera_escape": -0.1038, "mature_H5_site": 431, "mouse_sera_escape": 0.2612, "mutant": "I", "mutation": "M431I", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": 0.6702, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.249, "ferret_sera_escape": 0.09013, "mature_H5_site": 431, "mouse_sera_escape": 0.1272, "mutant": "K", "mutation": "M431K", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": 1.526, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.466, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "L", "mutation": "M431L", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": 0.7024, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 431, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M431M", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.696, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "N", "mutation": "M431N", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.647, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "Q", "mutation": "M431Q", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.29, "ferret_sera_escape": 0.2818, "mature_H5_site": 431, "mouse_sera_escape": 0.2798, "mutant": "R", "mutation": "M431R", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": 1.395, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.919, "ferret_sera_escape": 0.2248, "mature_H5_site": 431, "mouse_sera_escape": 0.006315, "mutant": "S", "mutation": "M431S", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.877, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "T", "mutation": "M431T", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.465, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "V", "mutation": "M431V", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.3077, "ferret_sera_escape": -0.06187, "mature_H5_site": 431, "mouse_sera_escape": 0.1993, "mutant": "W", "mutation": "M431W", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": 0.1453, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.131, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "Y", "mutation": "M431Y", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.07977, "ferret_sera_escape": 0.1713, "mature_H5_site": 432, "mouse_sera_escape": 0.05805, "mutant": "A", "mutation": "E432A", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": 0.05542, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.103, "ferret_sera_escape": 0.1643, "mature_H5_site": 432, "mouse_sera_escape": 0.07336, "mutant": "C", "mutation": "E432C", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "D", "mutation": "E432D", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 432, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E432E", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "F", "mutation": "E432F", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.746, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "H", "mutation": "E432H", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.875, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "I", "mutation": "E432I", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -6.04, "ferret_sera_escape": -0.09961, "mature_H5_site": 432, "mouse_sera_escape": -0.1797, "mutant": "K", "mutation": "E432K", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": -0.2381, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.645, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "L", "mutation": "E432L", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.314, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "M", "mutation": "E432M", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.098, "ferret_sera_escape": -0.262, "mature_H5_site": 432, "mouse_sera_escape": 0.5874, "mutant": "N", "mutation": "E432N", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": 0.4854, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "P", "mutation": "E432P", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.557, "ferret_sera_escape": -0.01028, "mature_H5_site": 432, "mouse_sera_escape": 0.03085, "mutant": "Q", "mutation": "E432Q", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "R", "mutation": "E432R", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5347, "ferret_sera_escape": -0.1607, "mature_H5_site": 432, "mouse_sera_escape": -0.09767, "mutant": "S", "mutation": "E432S", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": 1.111, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.329, "ferret_sera_escape": -0.09794, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "T", "mutation": "E432T", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": 0.2655, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.588, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "W", "mutation": "E432W", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.093, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E432Y", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.999, "ferret_sera_escape": null, "mature_H5_site": 433, "mouse_sera_escape": null, "mutant": "D", "mutation": "N433D", "reference_site": "433", "region": "HA2", "sequential_site": 449, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 433, "mouse_sera_escape": null, "mutant": "E", "mutation": "N433E", "reference_site": "433", "region": "HA2", "sequential_site": 449, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.009, "ferret_sera_escape": null, "mature_H5_site": 433, "mouse_sera_escape": null, "mutant": "G", "mutation": "N433G", "reference_site": "433", "region": "HA2", "sequential_site": 449, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 433, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N433N", "reference_site": "433", "region": "HA2", "sequential_site": 449, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 433, "mouse_sera_escape": null, "mutant": "S", "mutation": "N433S", "reference_site": "433", "region": "HA2", "sequential_site": 449, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.992, "ferret_sera_escape": null, "mature_H5_site": 433, "mouse_sera_escape": null, "mutant": "V", "mutation": "N433V", "reference_site": "433", "region": "HA2", "sequential_site": 449, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 433, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N433Y", "reference_site": "433", "region": "HA2", "sequential_site": 449, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.387, "ferret_sera_escape": 0.07113, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "A", "mutation": "E434A", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.741, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "C", "mutation": "E434C", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.063, "ferret_sera_escape": -0.08653, "mature_H5_site": 434, "mouse_sera_escape": 0.1699, "mutant": "D", "mutation": "E434D", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": 1.487, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 434, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E434E", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.234, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "F", "mutation": "E434F", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0387, "ferret_sera_escape": 0.1167, "mature_H5_site": 434, "mouse_sera_escape": 0.04604, "mutant": "G", "mutation": "E434G", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": 0.5272, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.711, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "H", "mutation": "E434H", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.087, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "I", "mutation": "E434I", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.369, "ferret_sera_escape": -0.07132, "mature_H5_site": 434, "mouse_sera_escape": 0.3653, "mutant": "K", "mutation": "E434K", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.675, "ferret_sera_escape": 0.1064, "mature_H5_site": 434, "mouse_sera_escape": 0.4753, "mutant": "L", "mutation": "E434L", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": 1.12, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.216, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "M", "mutation": "E434M", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "P", "mutation": "E434P", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6979, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "Q", "mutation": "E434Q", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.256, "ferret_sera_escape": 0.3391, "mature_H5_site": 434, "mouse_sera_escape": 0.3472, "mutant": "R", "mutation": "E434R", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": -0.1365, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7249, "ferret_sera_escape": 0.3183, "mature_H5_site": 434, "mouse_sera_escape": 0.4272, "mutant": "T", "mutation": "E434T", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": 1.076, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.39, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": 0.5883, "mutant": "V", "mutation": "E434V", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.506, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E434Y", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.371, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "C", "mutation": "R435C", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.672, "ferret_sera_escape": -0.1952, "mature_H5_site": 435, "mouse_sera_escape": 0.3825, "mutant": "D", "mutation": "R435D", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": 2.243, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.909, "ferret_sera_escape": -0.4258, "mature_H5_site": 435, "mouse_sera_escape": 0.3878, "mutant": "E", "mutation": "R435E", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": 2.157, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.732, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "F", "mutation": "R435F", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.082, "ferret_sera_escape": -0.1131, "mature_H5_site": 435, "mouse_sera_escape": 0.1421, "mutant": "G", "mutation": "R435G", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5032, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "H", "mutation": "R435H", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.72, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "I", "mutation": "R435I", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.13, "ferret_sera_escape": -0.06486, "mature_H5_site": 435, "mouse_sera_escape": 0.01396, "mutant": "K", "mutation": "R435K", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": 1.909, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "L", "mutation": "R435L", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.046, "ferret_sera_escape": -0.05447, "mature_H5_site": 435, "mouse_sera_escape": 0.00284, "mutant": "N", "mutation": "R435N", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": 0.9964, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "P", "mutation": "R435P", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.022, "ferret_sera_escape": -0.0395, "mature_H5_site": 435, "mouse_sera_escape": 0.2066, "mutant": "Q", "mutation": "R435Q", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": 2.158, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 435, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R435R", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.263, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "S", "mutation": "R435S", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -6.008, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "T", "mutation": "R435T", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.828, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "V", "mutation": "R435V", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "W", "mutation": "R435W", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.627, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R435Y", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "A", "mutation": "T436A", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "C", "mutation": "T436C", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.87, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "D", "mutation": "T436D", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "E", "mutation": "T436E", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.99, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "F", "mutation": "T436F", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "G", "mutation": "T436G", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "H", "mutation": "T436H", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "I", "mutation": "T436I", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "K", "mutation": "T436K", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "L", "mutation": "T436L", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.53, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "M", "mutation": "T436M", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "N", "mutation": "T436N", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "P", "mutation": "T436P", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T436Q", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.78, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "R", "mutation": "T436R", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.901, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "S", "mutation": "T436S", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 436, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T436T", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.975, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "V", "mutation": "T436V", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -6.014, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "W", "mutation": "T436W", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T436Y", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "A", "mutation": "L437A", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "C", "mutation": "L437C", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "D", "mutation": "L437D", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "E", "mutation": "L437E", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.315, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "F", "mutation": "L437F", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "G", "mutation": "L437G", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "H", "mutation": "L437H", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.833, "ferret_sera_escape": -0.1317, "mature_H5_site": 437, "mouse_sera_escape": -0.1162, "mutant": "I", "mutation": "L437I", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.025, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "K", "mutation": "L437K", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 437, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L437L", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5108, "ferret_sera_escape": 0.08894, "mature_H5_site": 437, "mouse_sera_escape": 0.07157, "mutant": "M", "mutation": "L437M", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": 1.447, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "N", "mutation": "L437N", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.03, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "P", "mutation": "L437P", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.617, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L437Q", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.895, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "R", "mutation": "L437R", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "S", "mutation": "L437S", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.822, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "T", "mutation": "L437T", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.03, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "V", "mutation": "L437V", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "W", "mutation": "L437W", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L437Y", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.03785, "ferret_sera_escape": 0.1314, "mature_H5_site": 438, "mouse_sera_escape": 0.07172, "mutant": "A", "mutation": "D438A", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 1.316, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.3, "ferret_sera_escape": -0.1835, "mature_H5_site": 438, "mouse_sera_escape": 0.08417, "mutant": "C", "mutation": "D438C", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 1.197, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 438, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D438D", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.005413, "ferret_sera_escape": 0.0158, "mature_H5_site": 438, "mouse_sera_escape": -0.01683, "mutant": "E", "mutation": "D438E", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 0.5611, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6214, "ferret_sera_escape": 0.02361, "mature_H5_site": 438, "mouse_sera_escape": 0.035, "mutant": "F", "mutation": "D438F", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": -0.157, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.09642, "ferret_sera_escape": 0.09123, "mature_H5_site": 438, "mouse_sera_escape": -0.06231, "mutant": "G", "mutation": "D438G", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 0.901, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.258, "ferret_sera_escape": null, "mature_H5_site": 438, "mouse_sera_escape": null, "mutant": "H", "mutation": "D438H", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.638, "ferret_sera_escape": -0.08338, "mature_H5_site": 438, "mouse_sera_escape": -0.125, "mutant": "I", "mutation": "D438I", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.039, "ferret_sera_escape": null, "mature_H5_site": 438, "mouse_sera_escape": null, "mutant": "K", "mutation": "D438K", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.496, "ferret_sera_escape": -0.03227, "mature_H5_site": 438, "mouse_sera_escape": 0.04889, "mutant": "L", "mutation": "D438L", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 0.4775, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2758, "ferret_sera_escape": 0.111, "mature_H5_site": 438, "mouse_sera_escape": -0.004324, "mutant": "M", "mutation": "D438M", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 0.6368, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.181, "ferret_sera_escape": -0.04643, "mature_H5_site": 438, "mouse_sera_escape": -0.04403, "mutant": "N", "mutation": "D438N", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 1.03, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 438, "mouse_sera_escape": null, "mutant": "P", "mutation": "D438P", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.04463, "ferret_sera_escape": -0.01261, "mature_H5_site": 438, "mouse_sera_escape": 0.03557, "mutant": "Q", "mutation": "D438Q", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 1.182, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.494, "ferret_sera_escape": null, "mature_H5_site": 438, "mouse_sera_escape": null, "mutant": "R", "mutation": "D438R", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.927, "ferret_sera_escape": -0.2326, "mature_H5_site": 438, "mouse_sera_escape": 0.2005, "mutant": "S", "mutation": "D438S", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 0.6721, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.139, "ferret_sera_escape": -0.3365, "mature_H5_site": 438, "mouse_sera_escape": -0.1121, "mutant": "W", "mutation": "D438W", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": -0.248, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.841, "ferret_sera_escape": -0.1357, "mature_H5_site": 438, "mouse_sera_escape": 0.04139, "mutant": "Y", "mutation": "D438Y", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": -0.1721, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.981, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "C", "mutation": "F439C", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.352, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "E", "mutation": "F439E", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 439, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F439F", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "G", "mutation": "F439G", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.314, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "H", "mutation": "F439H", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.985, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "I", "mutation": "F439I", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "K", "mutation": "F439K", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.66, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "L", "mutation": "F439L", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.119, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "N", "mutation": "F439N", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "P", "mutation": "F439P", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "R", "mutation": "F439R", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.98, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "S", "mutation": "F439S", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.891, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "T", "mutation": "F439T", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.04575, "ferret_sera_escape": 0.03407, "mature_H5_site": 439, "mouse_sera_escape": 0.03733, "mutant": "W", "mutation": "F439W", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": -0.1757, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.3818, "ferret_sera_escape": 0.145, "mature_H5_site": 439, "mouse_sera_escape": 0.06036, "mutant": "Y", "mutation": "F439Y", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": 0.5491, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.08625, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "A", "mutation": "E44A", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.04014, "cell_entry": 0.02215, "ferret_sera_escape": 0.1014, "mature_H5_site": 34, "mouse_sera_escape": 0.04893, "mutant": "C", "mutation": "E44C", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 0.5262, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7662, "ferret_sera_escape": -0.1223, "mature_H5_site": 34, "mouse_sera_escape": -0.06684, "mutant": "D", "mutation": "E44D", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": -0.5119, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 34, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E44E", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.846, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "F", "mutation": "E44F", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.8389, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "G", "mutation": "E44G", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.505, "ferret_sera_escape": -0.05772, "mature_H5_site": 34, "mouse_sera_escape": 0.01825, "mutant": "H", "mutation": "E44H", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 0.3479, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.561, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "I", "mutation": "E44I", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.332, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "K", "mutation": "E44K", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1896, "ferret_sera_escape": -0.01757, "mature_H5_site": 34, "mouse_sera_escape": 0.1305, "mutant": "L", "mutation": "E44L", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 1.231, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2553, "ferret_sera_escape": -0.2901, "mature_H5_site": 34, "mouse_sera_escape": -0.01246, "mutant": "M", "mutation": "E44M", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 1.632, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.765, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "N", "mutation": "E44N", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "P", "mutation": "E44P", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.05356, "ferret_sera_escape": 0.03587, "mature_H5_site": 34, "mouse_sera_escape": 0.1071, "mutant": "Q", "mutation": "E44Q", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 1.442, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.027, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "R", "mutation": "E44R", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.068, "ferret_sera_escape": -0.01962, "mature_H5_site": 34, "mouse_sera_escape": 0.1332, "mutant": "S", "mutation": "E44S", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 1.384, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4047, "ferret_sera_escape": 0.001483, "mature_H5_site": 34, "mouse_sera_escape": 0.2938, "mutant": "T", "mutation": "E44T", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 1.873, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.133, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "V", "mutation": "E44V", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.3527, "cell_entry": -0.1265, "ferret_sera_escape": 0.01564, "mature_H5_site": 34, "mouse_sera_escape": -0.04844, "mutant": "W", "mutation": "E44W", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1029, "ferret_sera_escape": -0.2138, "mature_H5_site": 34, "mouse_sera_escape": 0.09789, "mutant": "Y", "mutation": "E44Y", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 0.4516, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "A", "mutation": "H440A", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.788, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "C", "mutation": "H440C", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "D", "mutation": "H440D", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "E", "mutation": "H440E", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "F", "mutation": "H440F", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "G", "mutation": "H440G", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 440, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H440H", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.998, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "I", "mutation": "H440I", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "K", "mutation": "H440K", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.28, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "L", "mutation": "H440L", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.726, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "M", "mutation": "H440M", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "N", "mutation": "H440N", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.728, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "P", "mutation": "H440P", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "Q", "mutation": "H440Q", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.981, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "R", "mutation": "H440R", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.945, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "S", "mutation": "H440S", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "T", "mutation": "H440T", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "W", "mutation": "H440W", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.757, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "Y", "mutation": "H440Y", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.59, "ferret_sera_escape": -0.08953, "mature_H5_site": 441, "mouse_sera_escape": 0.1694, "mutant": "C", "mutation": "D441C", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.35, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 441, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D441D", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8354, "ferret_sera_escape": -0.1575, "mature_H5_site": 441, "mouse_sera_escape": 0.05994, "mutant": "E", "mutation": "D441E", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.01512, "ferret_sera_escape": -0.1219, "mature_H5_site": 441, "mouse_sera_escape": 0.09207, "mutant": "F", "mutation": "D441F", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.763, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3171, "ferret_sera_escape": -0.05642, "mature_H5_site": 441, "mouse_sera_escape": 0.273, "mutant": "G", "mutation": "D441G", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.287, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6087, "ferret_sera_escape": -0.06517, "mature_H5_site": 441, "mouse_sera_escape": 0.2391, "mutant": "H", "mutation": "D441H", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.874, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.06995, "ferret_sera_escape": -0.09854, "mature_H5_site": 441, "mouse_sera_escape": 0.06969, "mutant": "I", "mutation": "D441I", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.936, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3141, "ferret_sera_escape": -0.08157, "mature_H5_site": 441, "mouse_sera_escape": 0.4223, "mutant": "K", "mutation": "D441K", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7025, "ferret_sera_escape": -0.07062, "mature_H5_site": 441, "mouse_sera_escape": 0.02221, "mutant": "L", "mutation": "D441L", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 2.024, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0691, "ferret_sera_escape": -0.03978, "mature_H5_site": 441, "mouse_sera_escape": 0.1384, "mutant": "M", "mutation": "D441M", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.877, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1571, "ferret_sera_escape": -0.1332, "mature_H5_site": 441, "mouse_sera_escape": 0.4756, "mutant": "N", "mutation": "D441N", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.284, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 441, "mouse_sera_escape": null, "mutant": "P", "mutation": "D441P", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5308, "ferret_sera_escape": -0.02527, "mature_H5_site": 441, "mouse_sera_escape": 0.2975, "mutant": "Q", "mutation": "D441Q", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.565, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5698, "ferret_sera_escape": -0.255, "mature_H5_site": 441, "mouse_sera_escape": 0.2982, "mutant": "R", "mutation": "D441R", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.443, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6056, "ferret_sera_escape": null, "mature_H5_site": 441, "mouse_sera_escape": null, "mutant": "S", "mutation": "D441S", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4856, "ferret_sera_escape": -0.1587, "mature_H5_site": 441, "mouse_sera_escape": 0.1724, "mutant": "T", "mutation": "D441T", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.659, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.18, "ferret_sera_escape": -0.1412, "mature_H5_site": 441, "mouse_sera_escape": 0.01989, "mutant": "V", "mutation": "D441V", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.418, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1939, "ferret_sera_escape": -0.1646, "mature_H5_site": 441, "mouse_sera_escape": 0.1513, "mutant": "W", "mutation": "D441W", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.554, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1355, "ferret_sera_escape": -0.1523, "mature_H5_site": 441, "mouse_sera_escape": 0.1625, "mutant": "Y", "mutation": "D441Y", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.915, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6136, "ferret_sera_escape": 0.08761, "mature_H5_site": 442, "mouse_sera_escape": 0.03131, "mutant": "A", "mutation": "S442A", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 1.107, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4608, "ferret_sera_escape": 0.05552, "mature_H5_site": 442, "mouse_sera_escape": 0.3766, "mutant": "C", "mutation": "S442C", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 1.351, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4101, "ferret_sera_escape": 0.01014, "mature_H5_site": 442, "mouse_sera_escape": 0.3162, "mutant": "D", "mutation": "S442D", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 1.766, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.5783, "ferret_sera_escape": -0.05847, "mature_H5_site": 442, "mouse_sera_escape": 0.1595, "mutant": "G", "mutation": "S442G", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 0.918, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.848, "ferret_sera_escape": null, "mature_H5_site": 442, "mouse_sera_escape": null, "mutant": "H", "mutation": "S442H", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 2.281, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3888, "ferret_sera_escape": 0.0311, "mature_H5_site": 442, "mouse_sera_escape": 0.07787, "mutant": "I", "mutation": "S442I", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 1.031, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.25, "ferret_sera_escape": null, "mature_H5_site": 442, "mouse_sera_escape": null, "mutant": "K", "mutation": "S442K", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 442, "mouse_sera_escape": null, "mutant": "L", "mutation": "S442L", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4139, "ferret_sera_escape": -0.1313, "mature_H5_site": 442, "mouse_sera_escape": null, "mutant": "M", "mutation": "S442M", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.097, "ferret_sera_escape": -0.1239, "mature_H5_site": 442, "mouse_sera_escape": 0.2814, "mutant": "N", "mutation": "S442N", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 1.12, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 442, "mouse_sera_escape": null, "mutant": "P", "mutation": "S442P", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4683, "ferret_sera_escape": -0.09325, "mature_H5_site": 442, "mouse_sera_escape": 0.4498, "mutant": "Q", "mutation": "S442Q", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 1.131, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8379, "ferret_sera_escape": null, "mature_H5_site": 442, "mouse_sera_escape": null, "mutant": "R", "mutation": "S442R", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 442, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S442S", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8914, "ferret_sera_escape": -0.2744, "mature_H5_site": 442, "mouse_sera_escape": null, "mutant": "T", "mutation": "S442T", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 0.9715, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.5617, "ferret_sera_escape": -0.1535, "mature_H5_site": 442, "mouse_sera_escape": 0.1347, "mutant": "V", "mutation": "S442V", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 1.164, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3473, "ferret_sera_escape": -0.3638, "mature_H5_site": 442, "mouse_sera_escape": 0.1357, "mutant": "Y", "mutation": "S442Y", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 0.4876, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.646, "ferret_sera_escape": -0.1602, "mature_H5_site": 443, "mouse_sera_escape": -0.1522, "mutant": "A", "mutation": "N443A", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.353, "ferret_sera_escape": -0.07914, "mature_H5_site": 443, "mouse_sera_escape": -0.06529, "mutant": "C", "mutation": "N443C", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": 0.7636, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "D", "mutation": "N443D", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.988, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "E", "mutation": "N443E", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.698, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "F", "mutation": "N443F", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.381, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "H", "mutation": "N443H", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.409, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "K", "mutation": "N443K", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.655, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "L", "mutation": "N443L", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1554, "ferret_sera_escape": -0.004507, "mature_H5_site": 443, "mouse_sera_escape": -0.04831, "mutant": "M", "mutation": "N443M", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": 0.9516, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 443, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N443N", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "P", "mutation": "N443P", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.531, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "R", "mutation": "N443R", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4758, "ferret_sera_escape": -0.3637, "mature_H5_site": 443, "mouse_sera_escape": -0.05679, "mutant": "S", "mutation": "N443S", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": 0.3069, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3497, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "T", "mutation": "N443T", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5405, "ferret_sera_escape": -0.1613, "mature_H5_site": 443, "mouse_sera_escape": -0.04115, "mutant": "V", "mutation": "N443V", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": 0.1974, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.881, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "W", "mutation": "N443W", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.004, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N443Y", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "A", "mutation": "V444A", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "E", "mutation": "V444E", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "F", "mutation": "V444F", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.311, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "G", "mutation": "V444G", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "H", "mutation": "V444H", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.765, "ferret_sera_escape": -0.1006, "mature_H5_site": 444, "mouse_sera_escape": 0.2218, "mutant": "I", "mutation": "V444I", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": 1.131, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "K", "mutation": "V444K", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.00036, "ferret_sera_escape": 0.01457, "mature_H5_site": 444, "mouse_sera_escape": 0.08051, "mutant": "L", "mutation": "V444L", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": 1.624, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6685, "ferret_sera_escape": -0.2507, "mature_H5_site": 444, "mouse_sera_escape": -0.149, "mutant": "M", "mutation": "V444M", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": 0.6802, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.683, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "N", "mutation": "V444N", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.854, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "P", "mutation": "V444P", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V444Q", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "R", "mutation": "V444R", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "S", "mutation": "V444S", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.058, "ferret_sera_escape": -0.1317, "mature_H5_site": 444, "mouse_sera_escape": 0.05412, "mutant": "T", "mutation": "V444T", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": -0.1444, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 444, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V444V", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "W", "mutation": "V444W", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V444Y", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3579, "ferret_sera_escape": -0.1039, "mature_H5_site": 445, "mouse_sera_escape": 0.1569, "mutant": "A", "mutation": "K445A", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": -0.001421, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.127, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "C", "mutation": "K445C", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.641, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "D", "mutation": "K445D", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.235, "ferret_sera_escape": -0.2387, "mature_H5_site": 445, "mouse_sera_escape": -0.07138, "mutant": "E", "mutation": "K445E", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.017, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "G", "mutation": "K445G", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.02545, "ferret_sera_escape": -0.06812, "mature_H5_site": 445, "mouse_sera_escape": 0.01962, "mutant": "H", "mutation": "K445H", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": 0.4749, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.936, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "I", "mutation": "K445I", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 445, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K445K", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.663, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "L", "mutation": "K445L", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.988, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "M", "mutation": "K445M", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.711, "ferret_sera_escape": -0.2216, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "N", "mutation": "K445N", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": 0.7245, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "P", "mutation": "K445P", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.159, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "Q", "mutation": "K445Q", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": 0.6892, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1215, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": -0.05118, "mutant": "R", "mutation": "K445R", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": -0.05484, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.753, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "S", "mutation": "K445S", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "T", "mutation": "K445T", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.119, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "W", "mutation": "K445W", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.285, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K445Y", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2843, "ferret_sera_escape": 0.1055, "mature_H5_site": 446, "mouse_sera_escape": 0.1911, "mutant": "A", "mutation": "N446A", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.691, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2437, "ferret_sera_escape": -0.05428, "mature_H5_site": 446, "mouse_sera_escape": 0.04006, "mutant": "C", "mutation": "N446C", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.016, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.219, "ferret_sera_escape": -0.142, "mature_H5_site": 446, "mouse_sera_escape": 0.4486, "mutant": "D", "mutation": "N446D", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.437, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2193, "ferret_sera_escape": -0.02002, "mature_H5_site": 446, "mouse_sera_escape": 0.2439, "mutant": "E", "mutation": "N446E", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.827, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.65, "ferret_sera_escape": -0.01015, "mature_H5_site": 446, "mouse_sera_escape": -0.04212, "mutant": "F", "mutation": "N446F", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3095, "ferret_sera_escape": -0.04183, "mature_H5_site": 446, "mouse_sera_escape": 0.05794, "mutant": "G", "mutation": "N446G", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.294, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.01017, "ferret_sera_escape": 0.01532, "mature_H5_site": 446, "mouse_sera_escape": 0.07707, "mutant": "H", "mutation": "N446H", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.469, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.03955, "ferret_sera_escape": -0.03516, "mature_H5_site": 446, "mouse_sera_escape": 0.09203, "mutant": "I", "mutation": "N446I", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.354, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02098, "ferret_sera_escape": 0.00423, "mature_H5_site": 446, "mouse_sera_escape": 0.007829, "mutant": "K", "mutation": "N446K", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.237, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1061, "ferret_sera_escape": -0.07055, "mature_H5_site": 446, "mouse_sera_escape": 0.03355, "mutant": "L", "mutation": "N446L", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.732, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.02659, "ferret_sera_escape": -0.06875, "mature_H5_site": 446, "mouse_sera_escape": 0.1226, "mutant": "M", "mutation": "N446M", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.759, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 446, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N446N", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 446, "mouse_sera_escape": null, "mutant": "P", "mutation": "N446P", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": null, "wildtype": "N"}, {"a26_usage": 0.00455, "cell_entry": 0.01668, "ferret_sera_escape": 0.1104, "mature_H5_site": 446, "mouse_sera_escape": 0.05206, "mutant": "Q", "mutation": "N446Q", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 0.2712, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.05188, "ferret_sera_escape": -0.0326, "mature_H5_site": 446, "mouse_sera_escape": -0.01965, "mutant": "R", "mutation": "N446R", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.442, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.101, "ferret_sera_escape": 0.00653, "mature_H5_site": 446, "mouse_sera_escape": 0.1964, "mutant": "S", "mutation": "N446S", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.407, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3255, "ferret_sera_escape": -0.009927, "mature_H5_site": 446, "mouse_sera_escape": 0.09373, "mutant": "T", "mutation": "N446T", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.388, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3681, "ferret_sera_escape": null, "mature_H5_site": 446, "mouse_sera_escape": null, "mutant": "V", "mutation": "N446V", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.272, "ferret_sera_escape": -0.0581, "mature_H5_site": 446, "mouse_sera_escape": 0.2189, "mutant": "W", "mutation": "N446W", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.614, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.0834, "ferret_sera_escape": -0.06872, "mature_H5_site": 446, "mouse_sera_escape": 0.05918, "mutant": "Y", "mutation": "N446Y", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.686, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.258, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "A", "mutation": "L447A", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "D", "mutation": "L447D", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.008, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "E", "mutation": "L447E", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "F", "mutation": "L447F", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "G", "mutation": "L447G", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "H", "mutation": "L447H", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0705, "ferret_sera_escape": -0.1096, "mature_H5_site": 447, "mouse_sera_escape": -0.06218, "mutant": "I", "mutation": "L447I", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": 0.5094, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 447, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L447L", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.05356, "ferret_sera_escape": 0.06096, "mature_H5_site": 447, "mouse_sera_escape": 0.03215, "mutant": "M", "mutation": "L447M", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": 0.05475, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.345, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "N", "mutation": "L447N", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "P", "mutation": "L447P", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L447Q", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "R", "mutation": "L447R", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.287, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "S", "mutation": "L447S", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.185, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "T", "mutation": "L447T", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L447Y", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.413, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y448C", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y448D", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.773, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y448E", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.014, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "F", "mutation": "Y448F", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y448G", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.845, "ferret_sera_escape": 0.07162, "mature_H5_site": 448, "mouse_sera_escape": 0.4204, "mutant": "H", "mutation": "Y448H", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.489, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y448I", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.191, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y448L", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.498, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y448M", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y448N", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y448P", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.698, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y448R", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.873, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y448S", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.885, "ferret_sera_escape": -0.03581, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y448V", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.67, "ferret_sera_escape": -0.185, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y448W", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 448, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y448Y", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.5241, "ferret_sera_escape": null, "mature_H5_site": 449, "mouse_sera_escape": null, "mutant": "C", "mutation": "D449C", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 449, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D449D", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.00824, "cell_entry": 0.00806, "ferret_sera_escape": 0.008355, "mature_H5_site": 449, "mouse_sera_escape": 0.004877, "mutant": "E", "mutation": "D449E", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 0.03676, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.06767, "ferret_sera_escape": -0.03076, "mature_H5_site": 449, "mouse_sera_escape": 0.2857, "mutant": "F", "mutation": "D449F", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 0.887, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.349, "ferret_sera_escape": 0.04416, "mature_H5_site": 449, "mouse_sera_escape": 0.1455, "mutant": "G", "mutation": "D449G", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 1.306, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.02862, "ferret_sera_escape": null, "mature_H5_site": 449, "mouse_sera_escape": null, "mutant": "H", "mutation": "D449H", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3533, "ferret_sera_escape": -0.1194, "mature_H5_site": 449, "mouse_sera_escape": 0.02414, "mutant": "I", "mutation": "D449I", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.906, "ferret_sera_escape": 0.4766, "mature_H5_site": 449, "mouse_sera_escape": 0.3991, "mutant": "K", "mutation": "D449K", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": -0.02702, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.03253, "ferret_sera_escape": 0.076, "mature_H5_site": 449, "mouse_sera_escape": 0.09386, "mutant": "L", "mutation": "D449L", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 1.062, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0079, "ferret_sera_escape": -0.3089, "mature_H5_site": 449, "mouse_sera_escape": 0.001209, "mutant": "M", "mutation": "D449M", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.04793, "ferret_sera_escape": -0.05471, "mature_H5_site": 449, "mouse_sera_escape": -0.05255, "mutant": "N", "mutation": "D449N", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 0.3196, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 449, "mouse_sera_escape": null, "mutant": "P", "mutation": "D449P", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5868, "ferret_sera_escape": -0.02271, "mature_H5_site": 449, "mouse_sera_escape": 0.135, "mutant": "R", "mutation": "D449R", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 0.6655, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.07106, "ferret_sera_escape": -0.1427, "mature_H5_site": 449, "mouse_sera_escape": -0.03205, "mutant": "T", "mutation": "D449T", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5101, "ferret_sera_escape": -0.05308, "mature_H5_site": 449, "mouse_sera_escape": -0.06133, "mutant": "V", "mutation": "D449V", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": -0.03697, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.03921, "ferret_sera_escape": -0.0489, "mature_H5_site": 449, "mouse_sera_escape": 0.1285, "mutant": "Y", "mutation": "D449Y", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 1.581, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.002845, "ferret_sera_escape": 0.01048, "mature_H5_site": 35, "mouse_sera_escape": -0.1178, "mutant": "A", "mutation": "K45A", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": 1.158, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.193, "ferret_sera_escape": 0.006508, "mature_H5_site": 35, "mouse_sera_escape": -0.003256, "mutant": "C", "mutation": "K45C", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": -0.1556, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6934, "ferret_sera_escape": -0.02172, "mature_H5_site": 35, "mouse_sera_escape": 0.01686, "mutant": "D", "mutation": "K45D", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": -0.05104, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8504, "ferret_sera_escape": null, "mature_H5_site": 35, "mouse_sera_escape": null, "mutant": "E", "mutation": "K45E", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.346, "ferret_sera_escape": -0.3444, "mature_H5_site": 35, "mouse_sera_escape": -0.1655, "mutant": "F", "mutation": "K45F", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.034, "ferret_sera_escape": 0.1065, "mature_H5_site": 35, "mouse_sera_escape": -0.02161, "mutant": "G", "mutation": "K45G", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04934, "ferret_sera_escape": -0.07075, "mature_H5_site": 35, "mouse_sera_escape": 0.003753, "mutant": "H", "mutation": "K45H", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": 1.804, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0264, "ferret_sera_escape": 0.02581, "mature_H5_site": 35, "mouse_sera_escape": -0.09038, "mutant": "I", "mutation": "K45I", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": -0.3739, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 35, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K45K", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7104, "ferret_sera_escape": -0.0899, "mature_H5_site": 35, "mouse_sera_escape": -0.1047, "mutant": "L", "mutation": "K45L", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": -0.2232, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2496, "ferret_sera_escape": -0.07576, "mature_H5_site": 35, "mouse_sera_escape": -0.03595, "mutant": "M", "mutation": "K45M", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": -0.07502, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2623, "ferret_sera_escape": -0.02002, "mature_H5_site": 35, "mouse_sera_escape": -0.02556, "mutant": "N", "mutation": "K45N", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": 0.4382, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.022, "ferret_sera_escape": null, "mature_H5_site": 35, "mouse_sera_escape": null, "mutant": "P", "mutation": "K45P", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": null, "wildtype": "K"}, {"a26_usage": 0.01495, "cell_entry": 0.07419, "ferret_sera_escape": 0.03759, "mature_H5_site": 35, "mouse_sera_escape": -0.05355, "mutant": "Q", "mutation": "K45Q", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": 0.1593, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1975, "ferret_sera_escape": -0.09119, "mature_H5_site": 35, "mouse_sera_escape": -0.07666, "mutant": "R", "mutation": "K45R", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": 0.6176, "wildtype": "K"}, {"a26_usage": 0.151, "cell_entry": -0.03245, "ferret_sera_escape": -0.02371, "mature_H5_site": 35, "mouse_sera_escape": -0.01717, "mutant": "S", "mutation": "K45S", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": 1.398, "wildtype": "K"}, {"a26_usage": 0.1002, "cell_entry": -0.02913, "ferret_sera_escape": -0.004117, "mature_H5_site": 35, "mouse_sera_escape": -0.0936, "mutant": "T", "mutation": "K45T", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": -0.06112, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6207, "ferret_sera_escape": -0.1264, "mature_H5_site": 35, "mouse_sera_escape": -0.06621, "mutant": "V", "mutation": "K45V", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": -0.05815, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8548, "ferret_sera_escape": -0.1191, "mature_H5_site": 35, "mouse_sera_escape": -0.1392, "mutant": "W", "mutation": "K45W", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": null, "wildtype": "K"}, {"a26_usage": 0.2297, "cell_entry": -0.01907, "ferret_sera_escape": -0.08127, "mature_H5_site": 450, "mouse_sera_escape": 0.009541, "mutant": "A", "mutation": "K450A", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": -0.0405, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.639, "ferret_sera_escape": 0.04724, "mature_H5_site": 450, "mouse_sera_escape": 0.187, "mutant": "D", "mutation": "K450D", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": 0.03505, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.9716, "ferret_sera_escape": -0.005287, "mature_H5_site": 450, "mouse_sera_escape": 0.1535, "mutant": "E", "mutation": "K450E", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7024, "ferret_sera_escape": 0.3475, "mature_H5_site": 450, "mouse_sera_escape": 0.2773, "mutant": "F", "mutation": "K450F", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5758, "ferret_sera_escape": null, "mature_H5_site": 450, "mouse_sera_escape": -0.06747, "mutant": "I", "mutation": "K450I", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 450, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K450K", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.001765, "ferret_sera_escape": 0.02903, "mature_H5_site": 450, "mouse_sera_escape": -0.01948, "mutant": "L", "mutation": "K450L", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": 0.03724, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03883, "ferret_sera_escape": 0.04049, "mature_H5_site": 450, "mouse_sera_escape": 0.1865, "mutant": "M", "mutation": "K450M", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": -0.02278, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04594, "ferret_sera_escape": 0.02989, "mature_H5_site": 450, "mouse_sera_escape": -0.05571, "mutant": "N", "mutation": "K450N", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": 0.03022, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.384, "ferret_sera_escape": null, "mature_H5_site": 450, "mouse_sera_escape": null, "mutant": "P", "mutation": "K450P", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.004435, "ferret_sera_escape": 0.003753, "mature_H5_site": 450, "mouse_sera_escape": -0.004558, "mutant": "Q", "mutation": "K450Q", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": -0.08012, "wildtype": "K"}, {"a26_usage": 0.1631, "cell_entry": -0.4879, "ferret_sera_escape": 0.08906, "mature_H5_site": 450, "mouse_sera_escape": 0.0329, "mutant": "R", "mutation": "K450R", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": -0.06443, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04703, "ferret_sera_escape": 0.04334, "mature_H5_site": 450, "mouse_sera_escape": 0.09052, "mutant": "S", "mutation": "K450S", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": -0.0858, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.493, "ferret_sera_escape": -0.0002667, "mature_H5_site": 450, "mouse_sera_escape": 0.001463, "mutant": "T", "mutation": "K450T", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": -0.03077, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.548, "ferret_sera_escape": null, "mature_H5_site": 450, "mouse_sera_escape": null, "mutant": "W", "mutation": "K450W", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1986, "ferret_sera_escape": -0.2276, "mature_H5_site": 450, "mouse_sera_escape": 0.004321, "mutant": "Y", "mutation": "K450Y", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": -0.1256, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.00839, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "A", "mutation": "V451A", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.721, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "D", "mutation": "V451D", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.397, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "E", "mutation": "V451E", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.99, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "F", "mutation": "V451F", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.871, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "G", "mutation": "V451G", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.532, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "H", "mutation": "V451H", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2242, "ferret_sera_escape": 0.03815, "mature_H5_site": 451, "mouse_sera_escape": -0.01004, "mutant": "I", "mutation": "V451I", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": -0.09503, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "K", "mutation": "V451K", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1984, "ferret_sera_escape": -0.1102, "mature_H5_site": 451, "mouse_sera_escape": -0.0634, "mutant": "L", "mutation": "V451L", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": -0.05236, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8446, "ferret_sera_escape": 0.0009143, "mature_H5_site": 451, "mouse_sera_escape": -0.0482, "mutant": "M", "mutation": "V451M", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": -0.01841, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.361, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "P", "mutation": "V451P", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8448, "ferret_sera_escape": 0.02208, "mature_H5_site": 451, "mouse_sera_escape": 0.03232, "mutant": "Q", "mutation": "V451Q", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": -0.03771, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.845, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "R", "mutation": "V451R", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4827, "ferret_sera_escape": -0.01615, "mature_H5_site": 451, "mouse_sera_escape": 0.03384, "mutant": "S", "mutation": "V451S", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": -0.2027, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 451, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V451V", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -6.008, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "W", "mutation": "V451W", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V451Y", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.298, "ferret_sera_escape": 0.1987, "mature_H5_site": 452, "mouse_sera_escape": 0.09488, "mutant": "C", "mutation": "R452C", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.566, "ferret_sera_escape": 0.0726, "mature_H5_site": 452, "mouse_sera_escape": 0.3566, "mutant": "D", "mutation": "R452D", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.346, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "F", "mutation": "R452F", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7641, "ferret_sera_escape": 0.01998, "mature_H5_site": 452, "mouse_sera_escape": 0.09031, "mutant": "G", "mutation": "R452G", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": 0.8003, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5593, "ferret_sera_escape": -0.07221, "mature_H5_site": 452, "mouse_sera_escape": -0.001278, "mutant": "H", "mutation": "R452H", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": 0.7312, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "I", "mutation": "R452I", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.02398, "ferret_sera_escape": -0.1593, "mature_H5_site": 452, "mouse_sera_escape": -0.09131, "mutant": "K", "mutation": "R452K", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": 0.6882, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.894, "ferret_sera_escape": -0.06141, "mature_H5_site": 452, "mouse_sera_escape": -0.05162, "mutant": "L", "mutation": "R452L", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": 0.9826, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.099, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "M", "mutation": "R452M", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.703, "ferret_sera_escape": -0.3646, "mature_H5_site": 452, "mouse_sera_escape": -0.05115, "mutant": "N", "mutation": "R452N", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": 0.9411, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "P", "mutation": "R452P", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.8454, "ferret_sera_escape": -0.02968, "mature_H5_site": 452, "mouse_sera_escape": -0.0263, "mutant": "Q", "mutation": "R452Q", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 452, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R452R", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.507, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "S", "mutation": "R452S", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.024, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "T", "mutation": "R452T", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.378, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "V", "mutation": "R452V", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.23, "ferret_sera_escape": -0.1432, "mature_H5_site": 452, "mouse_sera_escape": 0.05852, "mutant": "W", "mutation": "R452W", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": 0.08079, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.954, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R452Y", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.9578, "ferret_sera_escape": 0.0317, "mature_H5_site": 453, "mouse_sera_escape": 0.0788, "mutant": "C", "mutation": "L453C", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": 0.6218, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.675, "ferret_sera_escape": null, "mature_H5_site": 453, "mouse_sera_escape": null, "mutant": "D", "mutation": "L453D", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.765, "ferret_sera_escape": null, "mature_H5_site": 453, "mouse_sera_escape": null, "mutant": "E", "mutation": "L453E", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": null, "wildtype": "L"}, {"a26_usage": 0.5937, "cell_entry": -0.2931, "ferret_sera_escape": -0.02494, "mature_H5_site": 453, "mouse_sera_escape": 0.0009806, "mutant": "H", "mutation": "L453H", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": -0.227, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.344, "ferret_sera_escape": null, "mature_H5_site": 453, "mouse_sera_escape": null, "mutant": "K", "mutation": "L453K", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 453, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L453L", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.03297, "ferret_sera_escape": -0.01435, "mature_H5_site": 453, "mouse_sera_escape": 0.02087, "mutant": "M", "mutation": "L453M", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": 0.4469, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.647, "ferret_sera_escape": null, "mature_H5_site": 453, "mouse_sera_escape": null, "mutant": "N", "mutation": "L453N", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": 0.03406, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.996, "ferret_sera_escape": null, "mature_H5_site": 453, "mouse_sera_escape": null, "mutant": "P", "mutation": "L453P", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1687, "ferret_sera_escape": -0.07756, "mature_H5_site": 453, "mouse_sera_escape": 0.1021, "mutant": "Q", "mutation": "L453Q", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": 1.082, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5708, "ferret_sera_escape": -0.0589, "mature_H5_site": 453, "mouse_sera_escape": 0.05823, "mutant": "R", "mutation": "L453R", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": 1.162, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.065, "ferret_sera_escape": 0.04066, "mature_H5_site": 453, "mouse_sera_escape": 0.04893, "mutant": "S", "mutation": "L453S", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4896, "ferret_sera_escape": 0.1363, "mature_H5_site": 453, "mouse_sera_escape": 0.09831, "mutant": "V", "mutation": "L453V", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6917, "ferret_sera_escape": 0.02627, "mature_H5_site": 453, "mouse_sera_escape": 0.006637, "mutant": "W", "mutation": "L453W", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": 0.3156, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1071, "ferret_sera_escape": 0.008665, "mature_H5_site": 454, "mouse_sera_escape": 0.05855, "mutant": "C", "mutation": "Q454C", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.02772, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.9606, "ferret_sera_escape": -0.002797, "mature_H5_site": 454, "mouse_sera_escape": 0.107, "mutant": "D", "mutation": "Q454D", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.1696, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1862, "ferret_sera_escape": 0.04314, "mature_H5_site": 454, "mouse_sera_escape": 0.09548, "mutant": "E", "mutation": "Q454E", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.006184, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.381, "ferret_sera_escape": -0.4447, "mature_H5_site": 454, "mouse_sera_escape": -0.1179, "mutant": "G", "mutation": "Q454G", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.00955, "ferret_sera_escape": 0.102, "mature_H5_site": 454, "mouse_sera_escape": 0.03364, "mutant": "H", "mutation": "Q454H", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.09894, "wildtype": "Q"}, {"a26_usage": 0.2263, "cell_entry": -0.3073, "ferret_sera_escape": -0.01026, "mature_H5_site": 454, "mouse_sera_escape": -0.03432, "mutant": "I", "mutation": "Q454I", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": 0.005626, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.015, "ferret_sera_escape": 0.1007, "mature_H5_site": 454, "mouse_sera_escape": 0.1414, "mutant": "K", "mutation": "Q454K", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": 0.511, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0651, "ferret_sera_escape": 0.1252, "mature_H5_site": 454, "mouse_sera_escape": 0.07188, "mutant": "M", "mutation": "Q454M", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": 0.1286, "wildtype": "Q"}, {"a26_usage": 0.2176, "cell_entry": -0.07897, "ferret_sera_escape": 0.2177, "mature_H5_site": 454, "mouse_sera_escape": null, "mutant": "N", "mutation": "Q454N", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 454, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q454Q", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.157, "ferret_sera_escape": -0.07183, "mature_H5_site": 454, "mouse_sera_escape": 0.0008825, "mutant": "R", "mutation": "Q454R", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.008293, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2767, "ferret_sera_escape": -0.02195, "mature_H5_site": 454, "mouse_sera_escape": 0.0568, "mutant": "S", "mutation": "Q454S", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.16, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5197, "ferret_sera_escape": -0.0365, "mature_H5_site": 454, "mouse_sera_escape": 0.04878, "mutant": "T", "mutation": "Q454T", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.05936, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.01913, "ferret_sera_escape": 0.04793, "mature_H5_site": 454, "mouse_sera_escape": 0.1164, "mutant": "V", "mutation": "Q454V", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.03508, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.111, "ferret_sera_escape": null, "mature_H5_site": 454, "mouse_sera_escape": null, "mutant": "W", "mutation": "Q454W", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.776, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "A", "mutation": "L455A", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.191, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "C", "mutation": "L455C", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "D", "mutation": "L455D", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "E", "mutation": "L455E", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "H", "mutation": "L455H", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5988, "ferret_sera_escape": -0.03344, "mature_H5_site": 455, "mouse_sera_escape": 0.03017, "mutant": "I", "mutation": "L455I", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": -0.05777, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "K", "mutation": "L455K", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 455, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L455L", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.148, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "M", "mutation": "L455M", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.945, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "N", "mutation": "L455N", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "P", "mutation": "L455P", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L455Q", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "R", "mutation": "L455R", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "S", "mutation": "L455S", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2562, "ferret_sera_escape": -0.1022, "mature_H5_site": 455, "mouse_sera_escape": 0.06407, "mutant": "T", "mutation": "L455T", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": -0.008337, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1249, "ferret_sera_escape": -0.2587, "mature_H5_site": 456, "mouse_sera_escape": 0.312, "mutant": "A", "mutation": "R456A", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": -0.01742, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7026, "ferret_sera_escape": 0.1216, "mature_H5_site": 456, "mouse_sera_escape": 0.07874, "mutant": "D", "mutation": "R456D", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": 0.01205, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.613, "ferret_sera_escape": 0.05628, "mature_H5_site": 456, "mouse_sera_escape": 0.05379, "mutant": "E", "mutation": "R456E", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": -0.3205, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4486, "ferret_sera_escape": null, "mature_H5_site": 456, "mouse_sera_escape": null, "mutant": "H", "mutation": "R456H", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": 0.1056, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1729, "ferret_sera_escape": -0.0007667, "mature_H5_site": 456, "mouse_sera_escape": 0.08708, "mutant": "I", "mutation": "R456I", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": -0.1546, "wildtype": "R"}, {"a26_usage": 0.3557, "cell_entry": -0.1463, "ferret_sera_escape": 0.1335, "mature_H5_site": 456, "mouse_sera_escape": -0.004457, "mutant": "L", "mutation": "R456L", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": 0.002477, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.04334, "ferret_sera_escape": 0.02663, "mature_H5_site": 456, "mouse_sera_escape": -0.07565, "mutant": "M", "mutation": "R456M", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": -0.02119, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.09277, "ferret_sera_escape": 0.00288, "mature_H5_site": 456, "mouse_sera_escape": -0.01883, "mutant": "N", "mutation": "R456N", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": -0.04876, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.139, "ferret_sera_escape": null, "mature_H5_site": 456, "mouse_sera_escape": null, "mutant": "P", "mutation": "R456P", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0732, "ferret_sera_escape": 0.07948, "mature_H5_site": 456, "mouse_sera_escape": 0.05116, "mutant": "Q", "mutation": "R456Q", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": 0.3651, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 456, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R456R", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1887, "ferret_sera_escape": -0.1187, "mature_H5_site": 456, "mouse_sera_escape": null, "mutant": "S", "mutation": "R456S", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.263, "ferret_sera_escape": null, "mature_H5_site": 456, "mouse_sera_escape": null, "mutant": "T", "mutation": "R456T", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7692, "ferret_sera_escape": 0.01149, "mature_H5_site": 456, "mouse_sera_escape": -0.03336, "mutant": "V", "mutation": "R456V", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": 0.007682, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5899, "ferret_sera_escape": 0.03393, "mature_H5_site": 456, "mouse_sera_escape": 0.183, "mutant": "W", "mutation": "R456W", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": 0.2861, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.076, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "C", "mutation": "D457C", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 457, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D457D", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.191, "ferret_sera_escape": -0.02275, "mature_H5_site": 457, "mouse_sera_escape": -0.0778, "mutant": "E", "mutation": "D457E", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": 0.5922, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.381, "ferret_sera_escape": 0.1378, "mature_H5_site": 457, "mouse_sera_escape": 0.1245, "mutant": "F", "mutation": "D457F", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": -0.17, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3666, "ferret_sera_escape": -0.2094, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "G", "mutation": "D457G", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": -0.02864, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.935, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "H", "mutation": "D457H", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.635, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "I", "mutation": "D457I", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.399, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "K", "mutation": "D457K", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.408, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "L", "mutation": "D457L", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.153, "ferret_sera_escape": -0.1074, "mature_H5_site": 457, "mouse_sera_escape": 0.1941, "mutant": "M", "mutation": "D457M", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": -0.1282, "wildtype": "D"}, {"a26_usage": 0.04511, "cell_entry": -1.779, "ferret_sera_escape": -0.1253, "mature_H5_site": 457, "mouse_sera_escape": -0.1662, "mutant": "N", "mutation": "D457N", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.9528, "ferret_sera_escape": -0.188, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "Q", "mutation": "D457Q", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.002, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "R", "mutation": "D457R", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4259, "ferret_sera_escape": -0.00269, "mature_H5_site": 457, "mouse_sera_escape": 0.008229, "mutant": "S", "mutation": "D457S", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": -0.02501, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6107, "ferret_sera_escape": -0.0872, "mature_H5_site": 457, "mouse_sera_escape": 0.00122, "mutant": "T", "mutation": "D457T", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": -0.06334, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.555, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "V", "mutation": "D457V", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.674, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "W", "mutation": "D457W", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.507, "ferret_sera_escape": 0.001189, "mature_H5_site": 457, "mouse_sera_escape": 0.07954, "mutant": "Y", "mutation": "D457Y", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": -0.2305, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.693, "ferret_sera_escape": 0.05665, "mature_H5_site": 458, "mouse_sera_escape": 0.01458, "mutant": "A", "mutation": "N458A", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.937, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "C", "mutation": "N458C", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.048, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "D", "mutation": "N458D", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "E", "mutation": "N458E", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "F", "mutation": "N458F", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.802, "ferret_sera_escape": 0.04178, "mature_H5_site": 458, "mouse_sera_escape": 0.09727, "mutant": "G", "mutation": "N458G", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": -0.06885, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1576, "ferret_sera_escape": 0.05242, "mature_H5_site": 458, "mouse_sera_escape": 0.1048, "mutant": "H", "mutation": "N458H", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": -0.1049, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "I", "mutation": "N458I", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "K", "mutation": "N458K", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "L", "mutation": "N458L", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.697, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "M", "mutation": "N458M", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 458, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N458N", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "P", "mutation": "N458P", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.574, "ferret_sera_escape": 0.1119, "mature_H5_site": 458, "mouse_sera_escape": 0.04735, "mutant": "Q", "mutation": "N458Q", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": -0.06056, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "R", "mutation": "N458R", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.497, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "S", "mutation": "N458S", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.349, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "T", "mutation": "N458T", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "V", "mutation": "N458V", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "W", "mutation": "N458W", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N458Y", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 459, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A459A", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.6902, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "C", "mutation": "A459C", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "D", "mutation": "A459D", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "E", "mutation": "A459E", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "F", "mutation": "A459F", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1281, "ferret_sera_escape": -0.06379, "mature_H5_site": 459, "mouse_sera_escape": 0.02087, "mutant": "G", "mutation": "A459G", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": -0.1016, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.177, "ferret_sera_escape": -0.1114, "mature_H5_site": 459, "mouse_sera_escape": -0.01529, "mutant": "I", "mutation": "A459I", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": -0.2223, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "K", "mutation": "A459K", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "L", "mutation": "A459L", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.938, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "M", "mutation": "A459M", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "N", "mutation": "A459N", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A459Q", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "R", "mutation": "A459R", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.06205, "ferret_sera_escape": -0.04292, "mature_H5_site": 459, "mouse_sera_escape": -0.04387, "mutant": "S", "mutation": "A459S", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": -0.1625, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.013, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "T", "mutation": "A459T", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3183, "ferret_sera_escape": 0.1077, "mature_H5_site": 459, "mouse_sera_escape": 0.1729, "mutant": "V", "mutation": "A459V", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": 0.01815, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "W", "mutation": "A459W", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A459Y", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.06573, "cell_entry": -0.1257, "ferret_sera_escape": 0.007626, "mature_H5_site": 36, "mouse_sera_escape": -0.01238, "mutant": "A", "mutation": "T46A", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": null, "wildtype": "T"}, {"a26_usage": 0.1262, "cell_entry": -0.009955, "ferret_sera_escape": -0.04358, "mature_H5_site": 36, "mouse_sera_escape": 0.003527, "mutant": "C", "mutation": "T46C", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": -0.0926, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5014, "ferret_sera_escape": -0.08219, "mature_H5_site": 36, "mouse_sera_escape": -0.0275, "mutant": "D", "mutation": "T46D", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": 0.1726, "wildtype": "T"}, {"a26_usage": 0.04344, "cell_entry": 0.03948, "ferret_sera_escape": -0.04316, "mature_H5_site": 36, "mouse_sera_escape": -0.03944, "mutant": "F", "mutation": "T46F", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": 0.05047, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.7, "ferret_sera_escape": 0.0235, "mature_H5_site": 36, "mouse_sera_escape": -0.1098, "mutant": "G", "mutation": "T46G", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": null, "wildtype": "T"}, {"a26_usage": 0.4604, "cell_entry": -0.2944, "ferret_sera_escape": -0.04202, "mature_H5_site": 36, "mouse_sera_escape": -0.05043, "mutant": "I", "mutation": "T46I", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": 0.01446, "wildtype": "T"}, {"a26_usage": 0.5146, "cell_entry": -0.1861, "ferret_sera_escape": -0.05077, "mature_H5_site": 36, "mouse_sera_escape": 0.01332, "mutant": "K", "mutation": "T46K", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": 0.05015, "wildtype": "T"}, {"a26_usage": 0.1591, "cell_entry": -0.2306, "ferret_sera_escape": null, "mature_H5_site": 36, "mouse_sera_escape": null, "mutant": "L", "mutation": "T46L", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": null, "wildtype": "T"}, {"a26_usage": 0.1329, "cell_entry": -0.1133, "ferret_sera_escape": 0.09653, "mature_H5_site": 36, "mouse_sera_escape": 0.05032, "mutant": "M", "mutation": "T46M", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": 0.007377, "wildtype": "T"}, {"a26_usage": 0.2583, "cell_entry": -0.02238, "ferret_sera_escape": 0.1144, "mature_H5_site": 36, "mouse_sera_escape": 0.004991, "mutant": "N", "mutation": "T46N", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": -0.0529, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 36, "mouse_sera_escape": null, "mutant": "P", "mutation": "T46P", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": null, "wildtype": "T"}, {"a26_usage": 0.09724, "cell_entry": -0.3068, "ferret_sera_escape": null, "mature_H5_site": 36, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T46Q", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.01962, "ferret_sera_escape": 0.06951, "mature_H5_site": 36, "mouse_sera_escape": -0.02286, "mutant": "R", "mutation": "T46R", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": -0.01583, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.003142, "ferret_sera_escape": -0.03301, "mature_H5_site": 36, "mouse_sera_escape": -0.05843, "mutant": "S", "mutation": "T46S", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": -0.0537, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 36, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T46T", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.02424, "ferret_sera_escape": -0.03494, "mature_H5_site": 36, "mouse_sera_escape": -0.09287, "mutant": "W", "mutation": "T46W", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": 0.02111, "wildtype": "T"}, {"a26_usage": 0.07428, "cell_entry": 0.06686, "ferret_sera_escape": 0.08213, "mature_H5_site": 36, "mouse_sera_escape": -0.1593, "mutant": "Y", "mutation": "T46Y", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.02059, "ferret_sera_escape": -0.00322, "mature_H5_site": 460, "mouse_sera_escape": -0.03946, "mutant": "C", "mutation": "K460C", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": -0.04841, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2447, "ferret_sera_escape": null, "mature_H5_site": 460, "mouse_sera_escape": null, "mutant": "D", "mutation": "K460D", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1981, "ferret_sera_escape": -0.05363, "mature_H5_site": 460, "mouse_sera_escape": -0.09486, "mutant": "E", "mutation": "K460E", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": 0.02291, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3082, "ferret_sera_escape": -0.07719, "mature_H5_site": 460, "mouse_sera_escape": -0.0947, "mutant": "F", "mutation": "K460F", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": 0.0174, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5496, "ferret_sera_escape": -0.09281, "mature_H5_site": 460, "mouse_sera_escape": -0.02869, "mutant": "G", "mutation": "K460G", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.01041, "ferret_sera_escape": -0.2617, "mature_H5_site": 460, "mouse_sera_escape": 0.05299, "mutant": "I", "mutation": "K460I", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 460, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K460K", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.02373, "cell_entry": -0.3389, "ferret_sera_escape": 0.01886, "mature_H5_site": 460, "mouse_sera_escape": 0.01032, "mutant": "M", "mutation": "K460M", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": 0.08023, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1367, "ferret_sera_escape": -0.03183, "mature_H5_site": 460, "mouse_sera_escape": 0.03565, "mutant": "N", "mutation": "K460N", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": 0.217, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.02157, "ferret_sera_escape": 0.05331, "mature_H5_site": 460, "mouse_sera_escape": 0.05073, "mutant": "R", "mutation": "K460R", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": -0.1462, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.989, "ferret_sera_escape": -0.05908, "mature_H5_site": 460, "mouse_sera_escape": 0.01981, "mutant": "S", "mutation": "K460S", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": -0.02249, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.783, "ferret_sera_escape": null, "mature_H5_site": 460, "mouse_sera_escape": null, "mutant": "T", "mutation": "K460T", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5993, "ferret_sera_escape": 0.08311, "mature_H5_site": 460, "mouse_sera_escape": -0.09388, "mutant": "V", "mutation": "K460V", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": -0.04686, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0338, "ferret_sera_escape": 0.08974, "mature_H5_site": 460, "mouse_sera_escape": 0.01514, "mutant": "W", "mutation": "K460W", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": 0.1686, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.00807, "ferret_sera_escape": 0.03642, "mature_H5_site": 460, "mouse_sera_escape": 0.0935, "mutant": "Y", "mutation": "K460Y", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": 0.06024, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.133, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "C", "mutation": "E461C", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.144, "ferret_sera_escape": -0.04953, "mature_H5_site": 461, "mouse_sera_escape": 0.1029, "mutant": "D", "mutation": "E461D", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": 1.289, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 461, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E461E", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "F", "mutation": "E461F", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.026, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "I", "mutation": "E461I", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.796, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "K", "mutation": "E461K", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.08, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "L", "mutation": "E461L", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.801, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "M", "mutation": "E461M", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.713, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "Q", "mutation": "E461Q", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "R", "mutation": "E461R", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.677, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "S", "mutation": "E461S", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.786, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "T", "mutation": "E461T", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.965, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "V", "mutation": "E461V", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "W", "mutation": "E461W", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.356, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E461Y", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.8518, "ferret_sera_escape": -0.0287, "mature_H5_site": 462, "mouse_sera_escape": 0.03931, "mutant": "C", "mutation": "L462C", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": -0.01282, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1594, "ferret_sera_escape": 0.1011, "mature_H5_site": 462, "mouse_sera_escape": 0.06159, "mutant": "E", "mutation": "L462E", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": 0.2245, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.102, "ferret_sera_escape": -0.02211, "mature_H5_site": 462, "mouse_sera_escape": null, "mutant": "F", "mutation": "L462F", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9594, "ferret_sera_escape": -0.1265, "mature_H5_site": 462, "mouse_sera_escape": -0.01209, "mutant": "H", "mutation": "L462H", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1211, "ferret_sera_escape": -0.06565, "mature_H5_site": 462, "mouse_sera_escape": -0.08213, "mutant": "I", "mutation": "L462I", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": -0.08319, "wildtype": "L"}, {"a26_usage": 0.5155, "cell_entry": -0.2561, "ferret_sera_escape": -0.04429, "mature_H5_site": 462, "mouse_sera_escape": 0.05299, "mutant": "K", "mutation": "L462K", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": -0.01095, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 462, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L462L", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.02356, "ferret_sera_escape": -0.01349, "mature_H5_site": 462, "mouse_sera_escape": -0.01674, "mutant": "M", "mutation": "L462M", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": -0.0193, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5155, "ferret_sera_escape": -0.007977, "mature_H5_site": 462, "mouse_sera_escape": 0.02687, "mutant": "N", "mutation": "L462N", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": 0.0002655, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.471, "ferret_sera_escape": null, "mature_H5_site": 462, "mouse_sera_escape": null, "mutant": "P", "mutation": "L462P", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": null, "wildtype": "L"}, {"a26_usage": 0.3408, "cell_entry": -0.2969, "ferret_sera_escape": -0.1366, "mature_H5_site": 462, "mouse_sera_escape": 0.01259, "mutant": "Q", "mutation": "L462Q", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": -0.03445, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1847, "ferret_sera_escape": null, "mature_H5_site": 462, "mouse_sera_escape": null, "mutant": "R", "mutation": "L462R", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5838, "ferret_sera_escape": -0.03387, "mature_H5_site": 462, "mouse_sera_escape": -0.08454, "mutant": "S", "mutation": "L462S", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": -0.06686, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.06068, "ferret_sera_escape": 0.02853, "mature_H5_site": 462, "mouse_sera_escape": -0.02567, "mutant": "V", "mutation": "L462V", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": 0.03482, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6858, "ferret_sera_escape": -0.02801, "mature_H5_site": 462, "mouse_sera_escape": 0.0432, "mutant": "W", "mutation": "L462W", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4408, "ferret_sera_escape": 0.03111, "mature_H5_site": 462, "mouse_sera_escape": 0.02935, "mutant": "Y", "mutation": "L462Y", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": -0.1233, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2323, "ferret_sera_escape": -0.02564, "mature_H5_site": 463, "mouse_sera_escape": 0.02868, "mutant": "A", "mutation": "G463A", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": 0.702, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.748, "ferret_sera_escape": -0.282, "mature_H5_site": 463, "mouse_sera_escape": 0.2094, "mutant": "C", "mutation": "G463C", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": -0.08797, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.857, "ferret_sera_escape": -0.3363, "mature_H5_site": 463, "mouse_sera_escape": 0.14, "mutant": "D", "mutation": "G463D", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.408, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "E", "mutation": "G463E", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.758, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "F", "mutation": "G463F", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 463, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G463G", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.192, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "H", "mutation": "G463H", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.527, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "I", "mutation": "G463I", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.053, "ferret_sera_escape": -0.1923, "mature_H5_site": 463, "mouse_sera_escape": 0.05211, "mutant": "L", "mutation": "G463L", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": 1.013, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.036, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "N", "mutation": "G463N", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": 1.386, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.9111, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "P", "mutation": "G463P", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.893, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G463Q", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.705, "ferret_sera_escape": -0.1795, "mature_H5_site": 463, "mouse_sera_escape": 0.1528, "mutant": "R", "mutation": "G463R", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.597, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "S", "mutation": "G463S", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2863, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "T", "mutation": "G463T", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.399, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "V", "mutation": "G463V", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.018, "ferret_sera_escape": 0.07141, "mature_H5_site": 463, "mouse_sera_escape": 0.02969, "mutant": "Y", "mutation": "G463Y", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.9042, "ferret_sera_escape": -0.1162, "mature_H5_site": 464, "mouse_sera_escape": -0.06756, "mutant": "C", "mutation": "N464C", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.047, "ferret_sera_escape": null, "mature_H5_site": 464, "mouse_sera_escape": null, "mutant": "D", "mutation": "N464D", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.595, "ferret_sera_escape": null, "mature_H5_site": 464, "mouse_sera_escape": null, "mutant": "E", "mutation": "N464E", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5102, "ferret_sera_escape": -0.05627, "mature_H5_site": 464, "mouse_sera_escape": -0.09421, "mutant": "F", "mutation": "N464F", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.2767, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.29, "ferret_sera_escape": 0.04779, "mature_H5_site": 464, "mouse_sera_escape": 0.2042, "mutant": "G", "mutation": "N464G", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.09938, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.768, "ferret_sera_escape": 0.09651, "mature_H5_site": 464, "mouse_sera_escape": 0.08089, "mutant": "H", "mutation": "N464H", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.099, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.841, "ferret_sera_escape": null, "mature_H5_site": 464, "mouse_sera_escape": null, "mutant": "I", "mutation": "N464I", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.178, "ferret_sera_escape": -0.1201, "mature_H5_site": 464, "mouse_sera_escape": 0.1772, "mutant": "K", "mutation": "N464K", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.158, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.271, "ferret_sera_escape": -0.5411, "mature_H5_site": 464, "mouse_sera_escape": 0.1444, "mutant": "L", "mutation": "N464L", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.017, "ferret_sera_escape": -0.03292, "mature_H5_site": 464, "mouse_sera_escape": 0.01147, "mutant": "M", "mutation": "N464M", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.2788, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 464, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N464N", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.574, "ferret_sera_escape": null, "mature_H5_site": 464, "mouse_sera_escape": null, "mutant": "P", "mutation": "N464P", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05627, "ferret_sera_escape": -0.07061, "mature_H5_site": 464, "mouse_sera_escape": -0.002135, "mutant": "Q", "mutation": "N464Q", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.2839, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.164, "ferret_sera_escape": -0.05436, "mature_H5_site": 464, "mouse_sera_escape": 0.04602, "mutant": "R", "mutation": "N464R", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.1114, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6914, "ferret_sera_escape": -0.07957, "mature_H5_site": 464, "mouse_sera_escape": 0.007685, "mutant": "S", "mutation": "N464S", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.1971, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04759, "ferret_sera_escape": null, "mature_H5_site": 464, "mouse_sera_escape": null, "mutant": "T", "mutation": "N464T", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.803, "ferret_sera_escape": null, "mature_H5_site": 464, "mouse_sera_escape": null, "mutant": "V", "mutation": "N464V", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8419, "ferret_sera_escape": -0.1156, "mature_H5_site": 464, "mouse_sera_escape": null, "mutant": "W", "mutation": "N464W", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.236, "ferret_sera_escape": -0.0797, "mature_H5_site": 464, "mouse_sera_escape": -0.06784, "mutant": "Y", "mutation": "N464Y", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.1858, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.507, "ferret_sera_escape": -0.04891, "mature_H5_site": 465, "mouse_sera_escape": 0.02723, "mutant": "A", "mutation": "G465A", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": -0.01593, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.696, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "C", "mutation": "G465C", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "D", "mutation": "G465D", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "E", "mutation": "G465E", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.612, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "F", "mutation": "G465F", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 465, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G465G", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.822, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "H", "mutation": "G465H", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "I", "mutation": "G465I", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.673, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "L", "mutation": "G465L", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.927, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "M", "mutation": "G465M", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "N", "mutation": "G465N", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "P", "mutation": "G465P", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G465Q", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.277, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "R", "mutation": "G465R", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.309, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "S", "mutation": "G465S", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "T", "mutation": "G465T", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "V", "mutation": "G465V", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.08, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "W", "mutation": "G465W", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.799, "ferret_sera_escape": -0.3427, "mature_H5_site": 465, "mouse_sera_escape": 0.3107, "mutant": "Y", "mutation": "G465Y", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": 1.124, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "A", "mutation": "C466A", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 466, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C466C", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "D", "mutation": "C466D", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "E", "mutation": "C466E", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.724, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "F", "mutation": "C466F", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.665, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "G", "mutation": "C466G", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "H", "mutation": "C466H", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "I", "mutation": "C466I", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "K", "mutation": "C466K", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "L", "mutation": "C466L", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.978, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "M", "mutation": "C466M", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.683, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "N", "mutation": "C466N", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.694, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "P", "mutation": "C466P", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C466Q", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.835, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "R", "mutation": "C466R", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "S", "mutation": "C466S", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "V", "mutation": "C466V", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.032, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C466Y", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "C", "mutation": "F467C", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -4.138, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "D", "mutation": "F467D", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.854, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "E", "mutation": "F467E", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 467, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F467F", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "G", "mutation": "F467G", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.746, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "H", "mutation": "F467H", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.08, "ferret_sera_escape": 0.01055, "mature_H5_site": 467, "mouse_sera_escape": 0.1009, "mutant": "I", "mutation": "F467I", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": -0.1754, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "K", "mutation": "F467K", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.2499, "ferret_sera_escape": -0.002523, "mature_H5_site": 467, "mouse_sera_escape": 0.005606, "mutant": "L", "mutation": "F467L", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": -0.2101, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.1281, "ferret_sera_escape": -0.0411, "mature_H5_site": 467, "mouse_sera_escape": 0.0183, "mutant": "M", "mutation": "F467M", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": -0.1863, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.019, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "N", "mutation": "F467N", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "P", "mutation": "F467P", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.752, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F467Q", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.861, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "R", "mutation": "F467R", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "S", "mutation": "F467S", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.991, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "T", "mutation": "F467T", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.335, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": 0.1746, "mutant": "V", "mutation": "F467V", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.3004, "ferret_sera_escape": -0.1227, "mature_H5_site": 467, "mouse_sera_escape": 0.00901, "mutant": "W", "mutation": "F467W", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": 0.4898, "wildtype": "F"}, {"a26_usage": 0.4561, "cell_entry": -0.2208, "ferret_sera_escape": -0.1063, "mature_H5_site": 467, "mouse_sera_escape": 0.04231, "mutant": "Y", "mutation": "F467Y", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": 0.2105, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.03044, "ferret_sera_escape": 0.002663, "mature_H5_site": 468, "mouse_sera_escape": 0.01745, "mutant": "A", "mutation": "E468A", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.02791, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7865, "ferret_sera_escape": 0.009581, "mature_H5_site": 468, "mouse_sera_escape": 0.02855, "mutant": "C", "mutation": "E468C", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": -0.1399, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.0153, "ferret_sera_escape": -0.05675, "mature_H5_site": 468, "mouse_sera_escape": -0.05068, "mutant": "D", "mutation": "E468D", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": -0.05354, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 468, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E468E", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.03095, "ferret_sera_escape": 0.06745, "mature_H5_site": 468, "mouse_sera_escape": -0.02878, "mutant": "F", "mutation": "E468F", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.06107, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2032, "ferret_sera_escape": 0.1937, "mature_H5_site": 468, "mouse_sera_escape": null, "mutant": "G", "mutation": "E468G", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": -0.01223, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.005651, "ferret_sera_escape": 0.1735, "mature_H5_site": 468, "mouse_sera_escape": 0.1271, "mutant": "H", "mutation": "E468H", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.05895, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1486, "ferret_sera_escape": 0.1363, "mature_H5_site": 468, "mouse_sera_escape": 0.2347, "mutant": "I", "mutation": "E468I", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4674, "ferret_sera_escape": -0.04577, "mature_H5_site": 468, "mouse_sera_escape": -0.05989, "mutant": "K", "mutation": "E468K", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": -0.04289, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.01707, "ferret_sera_escape": -0.1187, "mature_H5_site": 468, "mouse_sera_escape": 0.01804, "mutant": "L", "mutation": "E468L", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.1005, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.05639, "ferret_sera_escape": null, "mature_H5_site": 468, "mouse_sera_escape": null, "mutant": "M", "mutation": "E468M", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2253, "ferret_sera_escape": -0.03848, "mature_H5_site": 468, "mouse_sera_escape": -0.09725, "mutant": "N", "mutation": "E468N", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.2978, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 468, "mouse_sera_escape": null, "mutant": "P", "mutation": "E468P", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7376, "ferret_sera_escape": -0.02819, "mature_H5_site": 468, "mouse_sera_escape": -0.01658, "mutant": "Q", "mutation": "E468Q", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": -0.01457, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.004885, "ferret_sera_escape": 0.05043, "mature_H5_site": 468, "mouse_sera_escape": 0.04895, "mutant": "R", "mutation": "E468R", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.01785, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.00313, "ferret_sera_escape": 0.1002, "mature_H5_site": 468, "mouse_sera_escape": 0.01088, "mutant": "S", "mutation": "E468S", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.06273, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.8816, "ferret_sera_escape": null, "mature_H5_site": 468, "mouse_sera_escape": null, "mutant": "T", "mutation": "E468T", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.1663, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9877, "ferret_sera_escape": -0.01183, "mature_H5_site": 468, "mouse_sera_escape": -0.008792, "mutant": "V", "mutation": "E468V", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": -0.07847, "wildtype": "E"}, {"a26_usage": 0.4248, "cell_entry": -0.2617, "ferret_sera_escape": -0.1262, "mature_H5_site": 468, "mouse_sera_escape": 0.01428, "mutant": "W", "mutation": "E468W", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.144, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.04634, "ferret_sera_escape": -0.0006551, "mature_H5_site": 468, "mouse_sera_escape": 0.04158, "mutant": "Y", "mutation": "E468Y", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.04786, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "A", "mutation": "F469A", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "C", "mutation": "F469C", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "D", "mutation": "F469D", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "E", "mutation": "F469E", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 469, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F469F", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.04, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "G", "mutation": "F469G", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "H", "mutation": "F469H", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.8797, "ferret_sera_escape": 0.02063, "mature_H5_site": 469, "mouse_sera_escape": 0.06531, "mutant": "I", "mutation": "F469I", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": -0.4546, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.817, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "K", "mutation": "F469K", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.1193, "ferret_sera_escape": -0.0002663, "mature_H5_site": 469, "mouse_sera_escape": 0.03077, "mutant": "L", "mutation": "F469L", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": -0.2203, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.3085, "ferret_sera_escape": 0.007731, "mature_H5_site": 469, "mouse_sera_escape": 0.003166, "mutant": "M", "mutation": "F469M", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": -0.1842, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "N", "mutation": "F469N", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "P", "mutation": "F469P", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F469Q", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "R", "mutation": "F469R", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "S", "mutation": "F469S", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.231, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": 0.08779, "mutant": "T", "mutation": "F469T", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "V", "mutation": "F469V", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "W", "mutation": "F469W", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.5527, "ferret_sera_escape": -0.1041, "mature_H5_site": 469, "mouse_sera_escape": -0.0191, "mutant": "Y", "mutation": "F469Y", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": -0.216, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.05332, "ferret_sera_escape": 0.01828, "mature_H5_site": 37, "mouse_sera_escape": 0.02492, "mutant": "A", "mutation": "H47A", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": 0.07366, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.12, "ferret_sera_escape": -0.1154, "mature_H5_site": 37, "mouse_sera_escape": -0.002099, "mutant": "C", "mutation": "H47C", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.965, "ferret_sera_escape": null, "mature_H5_site": 37, "mouse_sera_escape": null, "mutant": "D", "mutation": "H47D", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.977, "ferret_sera_escape": null, "mature_H5_site": 37, "mouse_sera_escape": null, "mutant": "E", "mutation": "H47E", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.21, "ferret_sera_escape": -0.04465, "mature_H5_site": 37, "mouse_sera_escape": 0.05865, "mutant": "F", "mutation": "H47F", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": -0.1343, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.09, "ferret_sera_escape": -0.1747, "mature_H5_site": 37, "mouse_sera_escape": 0.07248, "mutant": "G", "mutation": "H47G", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": -0.1973, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 37, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H47H", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.057, "ferret_sera_escape": null, "mature_H5_site": 37, "mouse_sera_escape": null, "mutant": "I", "mutation": "H47I", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.181, "ferret_sera_escape": null, "mature_H5_site": 37, "mouse_sera_escape": null, "mutant": "M", "mutation": "H47M", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3071, "ferret_sera_escape": -0.01044, "mature_H5_site": 37, "mouse_sera_escape": 0.045, "mutant": "N", "mutation": "H47N", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": -0.112, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.95, "ferret_sera_escape": null, "mature_H5_site": 37, "mouse_sera_escape": null, "mutant": "P", "mutation": "H47P", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.7665, "ferret_sera_escape": 0.004176, "mature_H5_site": 37, "mouse_sera_escape": 0.01814, "mutant": "Q", "mutation": "H47Q", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": -0.1626, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.986, "ferret_sera_escape": null, "mature_H5_site": 37, "mouse_sera_escape": null, "mutant": "R", "mutation": "H47R", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3071, "ferret_sera_escape": 0.03, "mature_H5_site": 37, "mouse_sera_escape": 0.04447, "mutant": "S", "mutation": "H47S", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": -0.2037, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.2926, "ferret_sera_escape": 0.05329, "mature_H5_site": 37, "mouse_sera_escape": 0.2068, "mutant": "T", "mutation": "H47T", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": -0.0244, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.02953, "ferret_sera_escape": -0.1244, "mature_H5_site": 37, "mouse_sera_escape": 0.06347, "mutant": "V", "mutation": "H47V", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": 0.4462, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.268, "ferret_sera_escape": null, "mature_H5_site": 37, "mouse_sera_escape": null, "mutant": "W", "mutation": "H47W", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4809, "ferret_sera_escape": -0.157, "mature_H5_site": 37, "mouse_sera_escape": 0.05475, "mutant": "Y", "mutation": "H47Y", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": -0.1818, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.925, "ferret_sera_escape": 0.248, "mature_H5_site": 470, "mouse_sera_escape": 0.2605, "mutant": "A", "mutation": "Y470A", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.0134, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.48, "ferret_sera_escape": null, "mature_H5_site": 470, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y470C", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.004, "ferret_sera_escape": null, "mature_H5_site": 470, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y470D", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.565, "ferret_sera_escape": 0.1364, "mature_H5_site": 470, "mouse_sera_escape": 0.1274, "mutant": "E", "mutation": "Y470E", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": -0.007482, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.01928, "ferret_sera_escape": 0.1698, "mature_H5_site": 470, "mouse_sera_escape": 0.02062, "mutant": "F", "mutation": "Y470F", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": -0.02451, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.364, "ferret_sera_escape": -0.1035, "mature_H5_site": 470, "mouse_sera_escape": 0.02713, "mutant": "I", "mutation": "Y470I", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.001558, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.8497, "ferret_sera_escape": -0.04406, "mature_H5_site": 470, "mouse_sera_escape": -0.1454, "mutant": "K", "mutation": "Y470K", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.03657, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4909, "ferret_sera_escape": 0.03712, "mature_H5_site": 470, "mouse_sera_escape": 0.07367, "mutant": "L", "mutation": "Y470L", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.07176, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.9718, "ferret_sera_escape": 0.08922, "mature_H5_site": 470, "mouse_sera_escape": 0.06939, "mutant": "M", "mutation": "Y470M", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.026, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.006, "ferret_sera_escape": -0.02899, "mature_H5_site": 470, "mouse_sera_escape": 0.04629, "mutant": "N", "mutation": "Y470N", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": -0.048, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 470, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y470P", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7145, "ferret_sera_escape": null, "mature_H5_site": 470, "mouse_sera_escape": 0.02054, "mutant": "Q", "mutation": "Y470Q", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": -0.01652, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6609, "ferret_sera_escape": 0.08386, "mature_H5_site": 470, "mouse_sera_escape": 0.02226, "mutant": "R", "mutation": "Y470R", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": -0.06138, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.208, "ferret_sera_escape": -0.1035, "mature_H5_site": 470, "mouse_sera_escape": -0.06043, "mutant": "S", "mutation": "Y470S", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": -0.02879, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.259, "ferret_sera_escape": -0.01747, "mature_H5_site": 470, "mouse_sera_escape": -0.09619, "mutant": "T", "mutation": "Y470T", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.461, "ferret_sera_escape": 0.1504, "mature_H5_site": 470, "mouse_sera_escape": 0.008646, "mutant": "V", "mutation": "Y470V", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.009008, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6884, "ferret_sera_escape": -0.1376, "mature_H5_site": 470, "mouse_sera_escape": -0.06329, "mutant": "W", "mutation": "Y470W", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.1579, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 470, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y470Y", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.837, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "A", "mutation": "H471A", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.245, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "C", "mutation": "H471C", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "D", "mutation": "H471D", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "E", "mutation": "H471E", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.298, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "F", "mutation": "H471F", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.892, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "G", "mutation": "H471G", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 471, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H471H", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.018, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "K", "mutation": "H471K", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "M", "mutation": "H471M", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "N", "mutation": "H471N", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "P", "mutation": "H471P", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "Q", "mutation": "H471Q", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "R", "mutation": "H471R", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "S", "mutation": "H471S", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "T", "mutation": "H471T", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.847, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "V", "mutation": "H471V", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "W", "mutation": "H471W", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.72, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "Y", "mutation": "H471Y", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.03444, "cell_entry": -0.08278, "ferret_sera_escape": 0.02238, "mature_H5_site": 472, "mouse_sera_escape": -0.00617, "mutant": "A", "mutation": "K472A", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.02391, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0182, "ferret_sera_escape": 0.09362, "mature_H5_site": 472, "mouse_sera_escape": 0.1394, "mutant": "C", "mutation": "K472C", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.0721, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1708, "ferret_sera_escape": -0.07664, "mature_H5_site": 472, "mouse_sera_escape": 0.02273, "mutant": "D", "mutation": "K472D", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": 0.02457, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.156, "ferret_sera_escape": 0.03268, "mature_H5_site": 472, "mouse_sera_escape": 0.09155, "mutant": "E", "mutation": "K472E", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.03857, "wildtype": "K"}, {"a26_usage": 0.06373, "cell_entry": -0.0614, "ferret_sera_escape": 0.00185, "mature_H5_site": 472, "mouse_sera_escape": 0.02924, "mutant": "F", "mutation": "K472F", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.01771, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.00799, "ferret_sera_escape": 0.01297, "mature_H5_site": 472, "mouse_sera_escape": 0.1087, "mutant": "G", "mutation": "K472G", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.01907, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2637, "ferret_sera_escape": -0.2263, "mature_H5_site": 472, "mouse_sera_escape": 0.03101, "mutant": "H", "mutation": "K472H", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.07241, "wildtype": "K"}, {"a26_usage": 0.05594, "cell_entry": 0.02784, "ferret_sera_escape": -0.07901, "mature_H5_site": 472, "mouse_sera_escape": -0.02947, "mutant": "I", "mutation": "K472I", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.07822, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 472, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K472K", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2482, "ferret_sera_escape": 0.01327, "mature_H5_site": 472, "mouse_sera_escape": 0.04185, "mutant": "L", "mutation": "K472L", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": 0.003607, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0753, "ferret_sera_escape": 0.01112, "mature_H5_site": 472, "mouse_sera_escape": 0.08489, "mutant": "M", "mutation": "K472M", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.01356, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04923, "ferret_sera_escape": -0.03346, "mature_H5_site": 472, "mouse_sera_escape": 0.02843, "mutant": "N", "mutation": "K472N", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.04268, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.209, "ferret_sera_escape": 0.06498, "mature_H5_site": 472, "mouse_sera_escape": -0.02109, "mutant": "Q", "mutation": "K472Q", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.002295, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03329, "ferret_sera_escape": 0.03112, "mature_H5_site": 472, "mouse_sera_escape": 0.05719, "mutant": "R", "mutation": "K472R", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": 0.01398, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05821, "ferret_sera_escape": null, "mature_H5_site": 472, "mouse_sera_escape": null, "mutant": "S", "mutation": "K472S", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.0997, "ferret_sera_escape": -0.05328, "mature_H5_site": 472, "mouse_sera_escape": -0.01352, "mutant": "T", "mutation": "K472T", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.0636, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3759, "ferret_sera_escape": 0.1093, "mature_H5_site": 472, "mouse_sera_escape": -0.07362, "mutant": "V", "mutation": "K472V", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.04456, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5537, "ferret_sera_escape": -0.003405, "mature_H5_site": 472, "mouse_sera_escape": 0.1162, "mutant": "W", "mutation": "K472W", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.09736, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.119, "ferret_sera_escape": null, "mature_H5_site": 472, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K472Y", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.978, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "A", "mutation": "C473A", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 473, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C473C", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "D", "mutation": "C473D", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "E", "mutation": "C473E", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.891, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "F", "mutation": "C473F", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.694, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "G", "mutation": "C473G", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.848, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "H", "mutation": "C473H", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "I", "mutation": "C473I", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.993, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "K", "mutation": "C473K", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "L", "mutation": "C473L", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "M", "mutation": "C473M", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "N", "mutation": "C473N", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "P", "mutation": "C473P", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C473Q", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "R", "mutation": "C473R", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.277, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "S", "mutation": "C473S", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "T", "mutation": "C473T", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "V", "mutation": "C473V", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.763, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "W", "mutation": "C473W", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C473Y", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.2777, "ferret_sera_escape": 0.1222, "mature_H5_site": 474, "mouse_sera_escape": 0.05603, "mutant": "A", "mutation": "D474A", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": 0.007051, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3002, "ferret_sera_escape": -0.002654, "mature_H5_site": 474, "mouse_sera_escape": 0.0006444, "mutant": "C", "mutation": "D474C", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.007925, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 474, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D474D", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.04672, "ferret_sera_escape": null, "mature_H5_site": 474, "mouse_sera_escape": null, "mutant": "E", "mutation": "D474E", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6101, "ferret_sera_escape": -0.00683, "mature_H5_site": 474, "mouse_sera_escape": 0.03173, "mutant": "F", "mutation": "D474F", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.05808, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1828, "ferret_sera_escape": null, "mature_H5_site": 474, "mouse_sera_escape": null, "mutant": "G", "mutation": "D474G", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1123, "ferret_sera_escape": 0.129, "mature_H5_site": 474, "mouse_sera_escape": 0.05728, "mutant": "H", "mutation": "D474H", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.03574, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.776, "ferret_sera_escape": -0.2652, "mature_H5_site": 474, "mouse_sera_escape": -0.02841, "mutant": "I", "mutation": "D474I", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1623, "ferret_sera_escape": 0.1191, "mature_H5_site": 474, "mouse_sera_escape": 0.05449, "mutant": "L", "mutation": "D474L", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": 0.05988, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5227, "ferret_sera_escape": null, "mature_H5_site": 474, "mouse_sera_escape": null, "mutant": "M", "mutation": "D474M", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": null, "wildtype": "D"}, {"a26_usage": 0.05467, "cell_entry": 0.004995, "ferret_sera_escape": -0.02047, "mature_H5_site": 474, "mouse_sera_escape": 0.00547, "mutant": "N", "mutation": "D474N", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": 0.03676, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.05199, "ferret_sera_escape": 0.08187, "mature_H5_site": 474, "mouse_sera_escape": 0.03622, "mutant": "P", "mutation": "D474P", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.02689, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6385, "ferret_sera_escape": 0.1445, "mature_H5_site": 474, "mouse_sera_escape": 0.05405, "mutant": "Q", "mutation": "D474Q", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2171, "ferret_sera_escape": -0.02922, "mature_H5_site": 474, "mouse_sera_escape": -0.02334, "mutant": "R", "mutation": "D474R", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.1123, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2033, "ferret_sera_escape": 0.0345, "mature_H5_site": 474, "mouse_sera_escape": 0.03753, "mutant": "S", "mutation": "D474S", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.01805, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3021, "ferret_sera_escape": -0.008487, "mature_H5_site": 474, "mouse_sera_escape": 0.005721, "mutant": "T", "mutation": "D474T", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.04846, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.804, "ferret_sera_escape": null, "mature_H5_site": 474, "mouse_sera_escape": null, "mutant": "W", "mutation": "D474W", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8531, "ferret_sera_escape": 0.2217, "mature_H5_site": 474, "mouse_sera_escape": -0.02212, "mutant": "Y", "mutation": "D474Y", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.08201, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4861, "ferret_sera_escape": null, "mature_H5_site": 475, "mouse_sera_escape": null, "mutant": "A", "mutation": "N475A", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7183, "ferret_sera_escape": -0.06756, "mature_H5_site": 475, "mouse_sera_escape": 0.04213, "mutant": "C", "mutation": "N475C", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.1871, "wildtype": "N"}, {"a26_usage": 0.09419, "cell_entry": -0.1398, "ferret_sera_escape": -0.02913, "mature_H5_site": 475, "mouse_sera_escape": 0.1062, "mutant": "D", "mutation": "N475D", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.07342, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.07039, "ferret_sera_escape": -0.263, "mature_H5_site": 475, "mouse_sera_escape": 0.009285, "mutant": "E", "mutation": "N475E", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9918, "ferret_sera_escape": -0.06129, "mature_H5_site": 475, "mouse_sera_escape": -0.01838, "mutant": "G", "mutation": "N475G", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.1201, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.089, "ferret_sera_escape": 0.00313, "mature_H5_site": 475, "mouse_sera_escape": 0.1537, "mutant": "H", "mutation": "N475H", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.1791, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.263, "ferret_sera_escape": -0.1417, "mature_H5_site": 475, "mouse_sera_escape": -0.0384, "mutant": "K", "mutation": "N475K", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7843, "ferret_sera_escape": -0.0453, "mature_H5_site": 475, "mouse_sera_escape": 0.2227, "mutant": "L", "mutation": "N475L", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.142, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 475, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N475N", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8844, "ferret_sera_escape": null, "mature_H5_site": 475, "mouse_sera_escape": null, "mutant": "P", "mutation": "N475P", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9446, "ferret_sera_escape": 0.0059, "mature_H5_site": 475, "mouse_sera_escape": 0.1149, "mutant": "Q", "mutation": "N475Q", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.1203, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.756, "ferret_sera_escape": null, "mature_H5_site": 475, "mouse_sera_escape": null, "mutant": "R", "mutation": "N475R", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6235, "ferret_sera_escape": -0.02934, "mature_H5_site": 475, "mouse_sera_escape": 0.09256, "mutant": "S", "mutation": "N475S", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.1188, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.09094, "ferret_sera_escape": -0.05147, "mature_H5_site": 475, "mouse_sera_escape": 0.06634, "mutant": "T", "mutation": "N475T", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.3013, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.415, "ferret_sera_escape": -0.1083, "mature_H5_site": 475, "mouse_sera_escape": 0.07208, "mutant": "V", "mutation": "N475V", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.417, "ferret_sera_escape": null, "mature_H5_site": 475, "mouse_sera_escape": null, "mutant": "W", "mutation": "N475W", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7666, "ferret_sera_escape": -0.006467, "mature_H5_site": 475, "mouse_sera_escape": 0.1359, "mutant": "Y", "mutation": "N475Y", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04997, "ferret_sera_escape": 0.09285, "mature_H5_site": 476, "mouse_sera_escape": 0.04904, "mutant": "A", "mutation": "E476A", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.03422, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7759, "ferret_sera_escape": 0.1192, "mature_H5_site": 476, "mouse_sera_escape": -0.05715, "mutant": "C", "mutation": "E476C", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": -0.04018, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.592, "ferret_sera_escape": null, "mature_H5_site": 476, "mouse_sera_escape": null, "mutant": "D", "mutation": "E476D", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 476, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E476E", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.5285, "cell_entry": -0.1221, "ferret_sera_escape": -0.06338, "mature_H5_site": 476, "mouse_sera_escape": 0.03335, "mutant": "G", "mutation": "E476G", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.02157, "wildtype": "E"}, {"a26_usage": 0.1099, "cell_entry": -0.05299, "ferret_sera_escape": 0.0742, "mature_H5_site": 476, "mouse_sera_escape": -0.03912, "mutant": "H", "mutation": "E476H", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": -0.01018, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7167, "ferret_sera_escape": 0.1499, "mature_H5_site": 476, "mouse_sera_escape": 0.09611, "mutant": "I", "mutation": "E476I", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": -0.0005629, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.00132, "ferret_sera_escape": 0.1284, "mature_H5_site": 476, "mouse_sera_escape": 0.0626, "mutant": "K", "mutation": "E476K", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.03765, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01675, "ferret_sera_escape": 0.1923, "mature_H5_site": 476, "mouse_sera_escape": 0.02247, "mutant": "L", "mutation": "E476L", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.06569, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2813, "ferret_sera_escape": 0.03375, "mature_H5_site": 476, "mouse_sera_escape": -0.00864, "mutant": "M", "mutation": "E476M", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": -0.02215, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2554, "ferret_sera_escape": null, "mature_H5_site": 476, "mouse_sera_escape": null, "mutant": "N", "mutation": "E476N", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1415, "ferret_sera_escape": 0.1133, "mature_H5_site": 476, "mouse_sera_escape": 0.06348, "mutant": "P", "mutation": "E476P", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": -0.05708, "wildtype": "E"}, {"a26_usage": 0.1341, "cell_entry": 0.07608, "ferret_sera_escape": 0.08131, "mature_H5_site": 476, "mouse_sera_escape": 0.1086, "mutant": "Q", "mutation": "E476Q", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.03044, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.03489, "ferret_sera_escape": 0.02843, "mature_H5_site": 476, "mouse_sera_escape": -0.01873, "mutant": "S", "mutation": "E476S", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.03182, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.306, "ferret_sera_escape": -0.02386, "mature_H5_site": 476, "mouse_sera_escape": -0.1, "mutant": "T", "mutation": "E476T", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": -0.01048, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.03134, "ferret_sera_escape": 0.3073, "mature_H5_site": 476, "mouse_sera_escape": 0.147, "mutant": "V", "mutation": "E476V", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.05441, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06209, "ferret_sera_escape": 0.03604, "mature_H5_site": 476, "mouse_sera_escape": -0.004136, "mutant": "W", "mutation": "E476W", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.03752, "wildtype": "E"}, {"a26_usage": 0.06743, "cell_entry": -0.01797, "ferret_sera_escape": 0.06543, "mature_H5_site": 476, "mouse_sera_escape": -0.1107, "mutant": "Y", "mutation": "E476Y", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.03292, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "A", "mutation": "C477A", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 477, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C477C", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.966, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "D", "mutation": "C477D", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.105, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "E", "mutation": "C477E", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "F", "mutation": "C477F", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.704, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "G", "mutation": "C477G", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "H", "mutation": "C477H", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.838, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "K", "mutation": "C477K", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.622, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "L", "mutation": "C477L", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.886, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "M", "mutation": "C477M", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "N", "mutation": "C477N", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.964, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C477Q", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.774, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "R", "mutation": "C477R", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.863, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "S", "mutation": "C477S", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "T", "mutation": "C477T", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "W", "mutation": "C477W", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.553, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C477Y", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.384, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "A", "mutation": "M478A", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.59, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "C", "mutation": "M478C", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "D", "mutation": "M478D", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "E", "mutation": "M478E", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.8904, "ferret_sera_escape": -0.00084, "mature_H5_site": 478, "mouse_sera_escape": 0.0885, "mutant": "F", "mutation": "M478F", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": -0.1553, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "G", "mutation": "M478G", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "H", "mutation": "M478H", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.7825, "ferret_sera_escape": 0.02627, "mature_H5_site": 478, "mouse_sera_escape": -0.003998, "mutant": "I", "mutation": "M478I", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": -0.2422, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -6.05, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "K", "mutation": "M478K", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.8727, "ferret_sera_escape": -0.183, "mature_H5_site": 478, "mouse_sera_escape": 0.09834, "mutant": "L", "mutation": "M478L", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": -0.2257, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 478, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M478M", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "N", "mutation": "M478N", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "P", "mutation": "M478P", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.535, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "Q", "mutation": "M478Q", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "R", "mutation": "M478R", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "S", "mutation": "M478S", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.548, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "T", "mutation": "M478T", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.6215, "ferret_sera_escape": 0.08772, "mature_H5_site": 478, "mouse_sera_escape": -0.0115, "mutant": "V", "mutation": "M478V", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "W", "mutation": "M478W", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.3402, "ferret_sera_escape": -0.02155, "mature_H5_site": 479, "mouse_sera_escape": -0.06735, "mutant": "A", "mutation": "E479A", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.01393, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.07176, "ferret_sera_escape": -0.03943, "mature_H5_site": 479, "mouse_sera_escape": 0.0437, "mutant": "C", "mutation": "E479C", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.008387, "wildtype": "E"}, {"a26_usage": 0.11, "cell_entry": -0.5454, "ferret_sera_escape": -0.003227, "mature_H5_site": 479, "mouse_sera_escape": 0.0131, "mutant": "D", "mutation": "E479D", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.01866, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 479, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E479E", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2217, "ferret_sera_escape": -0.02874, "mature_H5_site": 479, "mouse_sera_escape": -0.05029, "mutant": "F", "mutation": "E479F", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5922, "ferret_sera_escape": 0.1443, "mature_H5_site": 479, "mouse_sera_escape": -0.01388, "mutant": "G", "mutation": "E479G", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.02659, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3883, "ferret_sera_escape": 0.05595, "mature_H5_site": 479, "mouse_sera_escape": 0.1191, "mutant": "H", "mutation": "E479H", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.02118, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.162, "ferret_sera_escape": 0.1288, "mature_H5_site": 479, "mouse_sera_escape": 0.05969, "mutant": "I", "mutation": "E479I", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.04456, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5117, "ferret_sera_escape": 0.0348, "mature_H5_site": 479, "mouse_sera_escape": -0.02546, "mutant": "K", "mutation": "E479K", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": -0.002853, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2853, "ferret_sera_escape": 0.1501, "mature_H5_site": 479, "mouse_sera_escape": 0.03485, "mutant": "L", "mutation": "E479L", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.06063, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.07452, "ferret_sera_escape": -0.03841, "mature_H5_site": 479, "mouse_sera_escape": -0.0666, "mutant": "M", "mutation": "E479M", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.01543, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1925, "ferret_sera_escape": 0.02632, "mature_H5_site": 479, "mouse_sera_escape": -0.001332, "mutant": "N", "mutation": "E479N", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.03838, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.845, "ferret_sera_escape": null, "mature_H5_site": 479, "mouse_sera_escape": null, "mutant": "P", "mutation": "E479P", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7171, "ferret_sera_escape": 0.07366, "mature_H5_site": 479, "mouse_sera_escape": -0.01557, "mutant": "Q", "mutation": "E479Q", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.05397, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.575, "ferret_sera_escape": 0.1693, "mature_H5_site": 479, "mouse_sera_escape": 0.008851, "mutant": "R", "mutation": "E479R", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.04269, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2402, "ferret_sera_escape": 0.1124, "mature_H5_site": 479, "mouse_sera_escape": 0.01496, "mutant": "S", "mutation": "E479S", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.09553, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07883, "ferret_sera_escape": -0.00116, "mature_H5_site": 479, "mouse_sera_escape": -0.02387, "mutant": "T", "mutation": "E479T", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": -0.0354, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02541, "ferret_sera_escape": 0.008497, "mature_H5_site": 479, "mouse_sera_escape": 0.02404, "mutant": "V", "mutation": "E479V", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": -0.02631, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.416, "ferret_sera_escape": 0.01206, "mature_H5_site": 479, "mouse_sera_escape": 0.03488, "mutant": "W", "mutation": "E479W", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": -0.01001, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4616, "ferret_sera_escape": -0.02932, "mature_H5_site": 479, "mouse_sera_escape": 0.1165, "mutant": "Y", "mutation": "E479Y", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.09307, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3413, "ferret_sera_escape": 0.02905, "mature_H5_site": 38, "mouse_sera_escape": 0.0385, "mutant": "D", "mutation": "N48D", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": -0.1501, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.135, "ferret_sera_escape": null, "mature_H5_site": 38, "mouse_sera_escape": null, "mutant": "E", "mutation": "N48E", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.069, "ferret_sera_escape": -0.1579, "mature_H5_site": 38, "mouse_sera_escape": 0.07801, "mutant": "F", "mutation": "N48F", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": -0.2229, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.08924, "ferret_sera_escape": 0.1594, "mature_H5_site": 38, "mouse_sera_escape": 0.003307, "mutant": "G", "mutation": "N48G", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": -0.09558, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.086, "ferret_sera_escape": -0.05718, "mature_H5_site": 38, "mouse_sera_escape": 0.1561, "mutant": "H", "mutation": "N48H", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": -0.3148, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.223, "ferret_sera_escape": null, "mature_H5_site": 38, "mouse_sera_escape": null, "mutant": "K", "mutation": "N48K", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.234, "ferret_sera_escape": -0.13, "mature_H5_site": 38, "mouse_sera_escape": -0.01812, "mutant": "L", "mutation": "N48L", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": 0.09217, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.734, "ferret_sera_escape": null, "mature_H5_site": 38, "mouse_sera_escape": null, "mutant": "M", "mutation": "N48M", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 38, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N48N", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.716, "ferret_sera_escape": null, "mature_H5_site": 38, "mouse_sera_escape": null, "mutant": "P", "mutation": "N48P", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.56, "ferret_sera_escape": -0.06244, "mature_H5_site": 38, "mouse_sera_escape": 0.0006662, "mutant": "Q", "mutation": "N48Q", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": -0.2057, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.986, "ferret_sera_escape": null, "mature_H5_site": 38, "mouse_sera_escape": null, "mutant": "R", "mutation": "N48R", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.151, "ferret_sera_escape": 0.01226, "mature_H5_site": 38, "mouse_sera_escape": -0.002999, "mutant": "S", "mutation": "N48S", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.03306, "ferret_sera_escape": null, "mature_H5_site": 38, "mouse_sera_escape": -0.1947, "mutant": "T", "mutation": "N48T", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.246, "ferret_sera_escape": -0.02873, "mature_H5_site": 38, "mouse_sera_escape": 0.1266, "mutant": "V", "mutation": "N48V", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": -0.1463, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.224, "ferret_sera_escape": -0.293, "mature_H5_site": 38, "mouse_sera_escape": 0.0586, "mutant": "Y", "mutation": "N48Y", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": -0.3066, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4241, "ferret_sera_escape": -0.0417, "mature_H5_site": 480, "mouse_sera_escape": 0.1121, "mutant": "C", "mutation": "S480C", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.03353, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6581, "ferret_sera_escape": -0.02009, "mature_H5_site": 480, "mouse_sera_escape": 0.001329, "mutant": "D", "mutation": "S480D", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.04857, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.08343, "ferret_sera_escape": 0.05242, "mature_H5_site": 480, "mouse_sera_escape": 0.03594, "mutant": "E", "mutation": "S480E", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.03651, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.7335, "ferret_sera_escape": 0.1648, "mature_H5_site": 480, "mouse_sera_escape": 0.08614, "mutant": "F", "mutation": "S480F", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.1562, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.132, "ferret_sera_escape": -0.06312, "mature_H5_site": 480, "mouse_sera_escape": -0.06035, "mutant": "G", "mutation": "S480G", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.02897, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.7248, "ferret_sera_escape": 0.1998, "mature_H5_site": 480, "mouse_sera_escape": 0.1495, "mutant": "H", "mutation": "S480H", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": 0.02546, "wildtype": "S"}, {"a26_usage": 0.1128, "cell_entry": -0.4846, "ferret_sera_escape": null, "mature_H5_site": 480, "mouse_sera_escape": null, "mutant": "K", "mutation": "S480K", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.007, "ferret_sera_escape": 0.004673, "mature_H5_site": 480, "mouse_sera_escape": 0.06156, "mutant": "L", "mutation": "S480L", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.1475, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.01755, "ferret_sera_escape": 0.01229, "mature_H5_site": 480, "mouse_sera_escape": -0.02905, "mutant": "M", "mutation": "S480M", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.05217, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 480, "mouse_sera_escape": null, "mutant": "P", "mutation": "S480P", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1154, "ferret_sera_escape": -0.03623, "mature_H5_site": 480, "mouse_sera_escape": -0.04901, "mutant": "Q", "mutation": "S480Q", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.04446, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.01786, "ferret_sera_escape": 0.1472, "mature_H5_site": 480, "mouse_sera_escape": 0.07722, "mutant": "R", "mutation": "S480R", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.05052, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 480, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S480S", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.004784, "cell_entry": 0.0577, "ferret_sera_escape": -0.04838, "mature_H5_site": 480, "mouse_sera_escape": 0.001034, "mutant": "T", "mutation": "S480T", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.06706, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.113, "ferret_sera_escape": 0.1942, "mature_H5_site": 480, "mouse_sera_escape": null, "mutant": "V", "mutation": "S480V", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.01, "ferret_sera_escape": null, "mature_H5_site": 480, "mouse_sera_escape": null, "mutant": "W", "mutation": "S480W", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.135, "ferret_sera_escape": 0.1486, "mature_H5_site": 480, "mouse_sera_escape": 0.04185, "mutant": "Y", "mutation": "S480Y", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.1386, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.987, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "A", "mutation": "V481A", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2965, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "C", "mutation": "V481C", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "D", "mutation": "V481D", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "E", "mutation": "V481E", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "F", "mutation": "V481F", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.755, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "G", "mutation": "V481G", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -6.024, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "H", "mutation": "V481H", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.07554, "ferret_sera_escape": -0.1238, "mature_H5_site": 481, "mouse_sera_escape": -0.04285, "mutant": "I", "mutation": "V481I", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": -0.05477, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "K", "mutation": "V481K", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1209, "ferret_sera_escape": 0.1186, "mature_H5_site": 481, "mouse_sera_escape": 0.1545, "mutant": "L", "mutation": "V481L", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": -0.06899, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.518, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "M", "mutation": "V481M", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "P", "mutation": "V481P", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V481Q", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "R", "mutation": "V481R", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.556, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "S", "mutation": "V481S", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.839, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "T", "mutation": "V481T", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 481, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V481V", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.748, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "W", "mutation": "V481W", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V481Y", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.9165, "ferret_sera_escape": -0.1888, "mature_H5_site": 482, "mouse_sera_escape": -0.1089, "mutant": "A", "mutation": "R482A", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1701, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3311, "ferret_sera_escape": -0.1591, "mature_H5_site": 482, "mouse_sera_escape": -0.09391, "mutant": "C", "mutation": "R482C", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1438, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.506, "ferret_sera_escape": 0.04659, "mature_H5_site": 482, "mouse_sera_escape": 0.06001, "mutant": "D", "mutation": "R482D", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.04525, "wildtype": "R"}, {"a26_usage": 0.7712, "cell_entry": -0.9797, "ferret_sera_escape": -0.02209, "mature_H5_site": 482, "mouse_sera_escape": -0.04521, "mutant": "E", "mutation": "R482E", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": 0.02405, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4458, "ferret_sera_escape": 0.017, "mature_H5_site": 482, "mouse_sera_escape": 0.165, "mutant": "F", "mutation": "R482F", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1245, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.628, "ferret_sera_escape": 0.04398, "mature_H5_site": 482, "mouse_sera_escape": null, "mutant": "H", "mutation": "R482H", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1539, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4002, "ferret_sera_escape": 0.04623, "mature_H5_site": 482, "mouse_sera_escape": 0.03565, "mutant": "K", "mutation": "R482K", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.004461, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.497, "ferret_sera_escape": null, "mature_H5_site": 482, "mouse_sera_escape": null, "mutant": "L", "mutation": "R482L", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2461, "ferret_sera_escape": 0.01753, "mature_H5_site": 482, "mouse_sera_escape": -0.05053, "mutant": "M", "mutation": "R482M", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.05069, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.897, "ferret_sera_escape": null, "mature_H5_site": 482, "mouse_sera_escape": null, "mutant": "P", "mutation": "R482P", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4239, "ferret_sera_escape": null, "mature_H5_site": 482, "mouse_sera_escape": null, "mutant": "Q", "mutation": "R482Q", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 482, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R482R", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1832, "ferret_sera_escape": 0.04419, "mature_H5_site": 482, "mouse_sera_escape": -0.05158, "mutant": "S", "mutation": "R482S", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1556, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5665, "ferret_sera_escape": -0.02183, "mature_H5_site": 482, "mouse_sera_escape": 0.02301, "mutant": "T", "mutation": "R482T", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1077, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2518, "ferret_sera_escape": -0.2844, "mature_H5_site": 482, "mouse_sera_escape": -0.0005412, "mutant": "V", "mutation": "R482V", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1226, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.798, "ferret_sera_escape": null, "mature_H5_site": 482, "mouse_sera_escape": null, "mutant": "W", "mutation": "R482W", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.54, "ferret_sera_escape": -0.03842, "mature_H5_site": 482, "mouse_sera_escape": 0.1033, "mutant": "Y", "mutation": "R482Y", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1712, "wildtype": "R"}, {"a26_usage": 0.1731, "cell_entry": 0.01077, "ferret_sera_escape": -0.07382, "mature_H5_site": 483, "mouse_sera_escape": 0.2063, "mutant": "A", "mutation": "N483A", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.01999, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.06985, "ferret_sera_escape": -0.2094, "mature_H5_site": 483, "mouse_sera_escape": 0.02496, "mutant": "F", "mutation": "N483F", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": 0.006271, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.469, "ferret_sera_escape": 0.00864, "mature_H5_site": 483, "mouse_sera_escape": -0.01401, "mutant": "H", "mutation": "N483H", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.06717, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2435, "ferret_sera_escape": -0.09124, "mature_H5_site": 483, "mouse_sera_escape": 0.1531, "mutant": "I", "mutation": "N483I", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.06742, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.313, "ferret_sera_escape": 0.1406, "mature_H5_site": 483, "mouse_sera_escape": 0.2881, "mutant": "K", "mutation": "N483K", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": 0.08266, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.03695, "ferret_sera_escape": null, "mature_H5_site": 483, "mouse_sera_escape": null, "mutant": "M", "mutation": "N483M", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 483, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N483N", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 483, "mouse_sera_escape": null, "mutant": "P", "mutation": "N483P", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2143, "ferret_sera_escape": 0.03515, "mature_H5_site": 483, "mouse_sera_escape": -0.00882, "mutant": "Q", "mutation": "N483Q", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.04623, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.005845, "ferret_sera_escape": -0.1113, "mature_H5_site": 483, "mouse_sera_escape": 0.05608, "mutant": "R", "mutation": "N483R", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.03492, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05613, "ferret_sera_escape": -0.1501, "mature_H5_site": 483, "mouse_sera_escape": 0.01173, "mutant": "T", "mutation": "N483T", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.0795, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4616, "ferret_sera_escape": null, "mature_H5_site": 483, "mouse_sera_escape": -0.1457, "mutant": "V", "mutation": "N483V", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.08416, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.95, "ferret_sera_escape": -0.1005, "mature_H5_site": 483, "mouse_sera_escape": 0.0499, "mutant": "W", "mutation": "N483W", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.04403, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.293, "ferret_sera_escape": -0.04107, "mature_H5_site": 483, "mouse_sera_escape": 0.1856, "mutant": "Y", "mutation": "N483Y", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": null, "wildtype": "N"}, {"a26_usage": 0.1058, "cell_entry": -0.2218, "ferret_sera_escape": -0.07855, "mature_H5_site": 484, "mouse_sera_escape": -0.05522, "mutant": "A", "mutation": "G484A", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4692, "ferret_sera_escape": 0.01772, "mature_H5_site": 484, "mouse_sera_escape": 0.02099, "mutant": "C", "mutation": "G484C", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": 0.02961, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.05982, "ferret_sera_escape": 0.216, "mature_H5_site": 484, "mouse_sera_escape": -0.03881, "mutant": "D", "mutation": "G484D", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": -0.04878, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5809, "ferret_sera_escape": -0.1524, "mature_H5_site": 484, "mouse_sera_escape": 0.0768, "mutant": "E", "mutation": "G484E", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": 0.1361, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1127, "ferret_sera_escape": null, "mature_H5_site": 484, "mouse_sera_escape": null, "mutant": "F", "mutation": "G484F", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 484, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G484G", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.214, "ferret_sera_escape": 0.1419, "mature_H5_site": 484, "mouse_sera_escape": 0.08371, "mutant": "H", "mutation": "G484H", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": 1.152, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.509, "ferret_sera_escape": null, "mature_H5_site": 484, "mouse_sera_escape": null, "mutant": "I", "mutation": "G484I", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.328, "ferret_sera_escape": 0.07516, "mature_H5_site": 484, "mouse_sera_escape": 0.3594, "mutant": "L", "mutation": "G484L", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": -0.1193, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2729, "ferret_sera_escape": 0.0733, "mature_H5_site": 484, "mouse_sera_escape": 0.0007063, "mutant": "M", "mutation": "G484M", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": 0.1534, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.003895, "ferret_sera_escape": 0.01005, "mature_H5_site": 484, "mouse_sera_escape": -0.06427, "mutant": "N", "mutation": "G484N", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": -0.004433, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 484, "mouse_sera_escape": null, "mutant": "P", "mutation": "G484P", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": null, "wildtype": "G"}, {"a26_usage": 0.1481, "cell_entry": -0.9005, "ferret_sera_escape": -0.1341, "mature_H5_site": 484, "mouse_sera_escape": -0.2029, "mutant": "Q", "mutation": "G484Q", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": -0.01042, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.05835, "ferret_sera_escape": 0.05878, "mature_H5_site": 484, "mouse_sera_escape": -0.04683, "mutant": "R", "mutation": "G484R", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": 0.01681, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3554, "ferret_sera_escape": 0.06507, "mature_H5_site": 484, "mouse_sera_escape": 0.05255, "mutant": "S", "mutation": "G484S", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": -0.01896, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2872, "ferret_sera_escape": -0.05073, "mature_H5_site": 484, "mouse_sera_escape": -0.007237, "mutant": "T", "mutation": "G484T", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": -0.1222, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.018, "ferret_sera_escape": null, "mature_H5_site": 484, "mouse_sera_escape": null, "mutant": "V", "mutation": "G484V", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.08666, "ferret_sera_escape": -0.1106, "mature_H5_site": 484, "mouse_sera_escape": -0.03945, "mutant": "W", "mutation": "G484W", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": 0.01183, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2061, "ferret_sera_escape": null, "mature_H5_site": 484, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G484Y", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": null, "wildtype": "G"}, {"a26_usage": 0.2613, "cell_entry": -0.02251, "ferret_sera_escape": -0.1925, "mature_H5_site": 485, "mouse_sera_escape": 0.01651, "mutant": "A", "mutation": "T485A", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.1055, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7313, "ferret_sera_escape": -0.03523, "mature_H5_site": 485, "mouse_sera_escape": 0.09408, "mutant": "C", "mutation": "T485C", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.1864, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.05696, "ferret_sera_escape": -0.2477, "mature_H5_site": 485, "mouse_sera_escape": 0.004812, "mutant": "D", "mutation": "T485D", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.1181, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2538, "ferret_sera_escape": -0.08826, "mature_H5_site": 485, "mouse_sera_escape": -0.003605, "mutant": "E", "mutation": "T485E", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.08511, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4049, "ferret_sera_escape": null, "mature_H5_site": 485, "mouse_sera_escape": null, "mutant": "F", "mutation": "T485F", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4218, "ferret_sera_escape": -0.03859, "mature_H5_site": 485, "mouse_sera_escape": 0.04721, "mutant": "G", "mutation": "T485G", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.1286, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.003445, "ferret_sera_escape": -0.1585, "mature_H5_site": 485, "mouse_sera_escape": 0.08029, "mutant": "H", "mutation": "T485H", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.05436, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.388, "ferret_sera_escape": -0.1291, "mature_H5_site": 485, "mouse_sera_escape": -0.09505, "mutant": "I", "mutation": "T485I", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.6316, "ferret_sera_escape": -0.1067, "mature_H5_site": 485, "mouse_sera_escape": 0.03449, "mutant": "K", "mutation": "T485K", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.058, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4477, "ferret_sera_escape": -0.057, "mature_H5_site": 485, "mouse_sera_escape": 0.1268, "mutant": "L", "mutation": "T485L", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.06834, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1615, "ferret_sera_escape": 0.01678, "mature_H5_site": 485, "mouse_sera_escape": 0.07952, "mutant": "M", "mutation": "T485M", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.2203, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.02644, "ferret_sera_escape": -0.1403, "mature_H5_site": 485, "mouse_sera_escape": 0.05064, "mutant": "N", "mutation": "T485N", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": 0.03994, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.28, "ferret_sera_escape": null, "mature_H5_site": 485, "mouse_sera_escape": null, "mutant": "P", "mutation": "T485P", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5237, "ferret_sera_escape": -0.1187, "mature_H5_site": 485, "mouse_sera_escape": 0.02692, "mutant": "Q", "mutation": "T485Q", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.08441, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.08727, "ferret_sera_escape": -0.05868, "mature_H5_site": 485, "mouse_sera_escape": 0.02264, "mutant": "R", "mutation": "T485R", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.077, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.04661, "ferret_sera_escape": -0.1367, "mature_H5_site": 485, "mouse_sera_escape": -0.1089, "mutant": "S", "mutation": "T485S", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.03816, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 485, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T485T", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5876, "ferret_sera_escape": -0.1364, "mature_H5_site": 485, "mouse_sera_escape": 0.1533, "mutant": "V", "mutation": "T485V", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.08917, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5887, "ferret_sera_escape": -0.00562, "mature_H5_site": 485, "mouse_sera_escape": 0.1038, "mutant": "W", "mutation": "T485W", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.08858, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.011, "ferret_sera_escape": -0.1911, "mature_H5_site": 485, "mouse_sera_escape": 0.02749, "mutant": "Y", "mutation": "T485Y", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.1081, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y486A", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y486C", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y486E", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "F", "mutation": "Y486F", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y486G", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.986, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y486H", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y486I", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.008, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y486K", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y486L", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.026, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y486M", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.69, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y486N", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y486Q", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y486R", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y486S", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y486T", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.524, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y486V", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y486W", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 486, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y486Y", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4682, "ferret_sera_escape": 0.04825, "mature_H5_site": 487, "mouse_sera_escape": -0.004618, "mutant": "A", "mutation": "D487A", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.005016, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.173, "ferret_sera_escape": 0.178, "mature_H5_site": 487, "mouse_sera_escape": -0.1463, "mutant": "C", "mutation": "D487C", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.009653, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 487, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D487D", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1731, "ferret_sera_escape": -0.003282, "mature_H5_site": 487, "mouse_sera_escape": -0.0936, "mutant": "E", "mutation": "D487E", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.01722, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 487, "mouse_sera_escape": null, "mutant": "G", "mutation": "D487G", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2668, "ferret_sera_escape": -0.04972, "mature_H5_site": 487, "mouse_sera_escape": -0.02422, "mutant": "H", "mutation": "D487H", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": 0.05022, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5252, "ferret_sera_escape": -0.05669, "mature_H5_site": 487, "mouse_sera_escape": -0.07358, "mutant": "I", "mutation": "D487I", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": 0.001618, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8147, "ferret_sera_escape": null, "mature_H5_site": 487, "mouse_sera_escape": null, "mutant": "K", "mutation": "D487K", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.261, "ferret_sera_escape": 0.03677, "mature_H5_site": 487, "mouse_sera_escape": -0.01068, "mutant": "L", "mutation": "D487L", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.03419, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.007755, "ferret_sera_escape": 0.0293, "mature_H5_site": 487, "mouse_sera_escape": 0.03563, "mutant": "M", "mutation": "D487M", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": 0.00607, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2084, "ferret_sera_escape": -0.002944, "mature_H5_site": 487, "mouse_sera_escape": 0.01645, "mutant": "N", "mutation": "D487N", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.05864, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7202, "ferret_sera_escape": -0.01938, "mature_H5_site": 487, "mouse_sera_escape": -0.08052, "mutant": "Q", "mutation": "D487Q", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.03337, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.934, "ferret_sera_escape": 0.05385, "mature_H5_site": 487, "mouse_sera_escape": 0.1254, "mutant": "R", "mutation": "D487R", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.1158, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.332, "ferret_sera_escape": 0.004047, "mature_H5_site": 487, "mouse_sera_escape": -0.01615, "mutant": "S", "mutation": "D487S", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8407, "ferret_sera_escape": -0.008417, "mature_H5_site": 487, "mouse_sera_escape": -0.04829, "mutant": "T", "mutation": "D487T", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.009314, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7742, "ferret_sera_escape": 0.08631, "mature_H5_site": 487, "mouse_sera_escape": 0.02906, "mutant": "V", "mutation": "D487V", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1915, "ferret_sera_escape": 0.1837, "mature_H5_site": 487, "mouse_sera_escape": 0.0142, "mutant": "W", "mutation": "D487W", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.0038, "ferret_sera_escape": 0.08072, "mature_H5_site": 487, "mouse_sera_escape": 0.03014, "mutant": "Y", "mutation": "D487Y", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": 0.005994, "wildtype": "D"}, {"a26_usage": 0.1383, "cell_entry": 0.07365, "ferret_sera_escape": 0.0986, "mature_H5_site": 488, "mouse_sera_escape": 0.06566, "mutant": "A", "mutation": "Y488A", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": 0.05392, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.376, "ferret_sera_escape": -0.02226, "mature_H5_site": 488, "mouse_sera_escape": 0.2638, "mutant": "C", "mutation": "Y488C", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.112, "ferret_sera_escape": null, "mature_H5_site": 488, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y488D", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.084, "ferret_sera_escape": -0.07626, "mature_H5_site": 488, "mouse_sera_escape": -0.04471, "mutant": "E", "mutation": "Y488E", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": -0.1476, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4645, "ferret_sera_escape": null, "mature_H5_site": 488, "mouse_sera_escape": null, "mutant": "F", "mutation": "Y488F", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.05038, "ferret_sera_escape": -0.02821, "mature_H5_site": 488, "mouse_sera_escape": 0.03168, "mutant": "H", "mutation": "Y488H", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": 0.06562, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.344, "ferret_sera_escape": -0.114, "mature_H5_site": 488, "mouse_sera_escape": 0.07447, "mutant": "I", "mutation": "Y488I", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": -0.04052, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1512, "ferret_sera_escape": -0.06652, "mature_H5_site": 488, "mouse_sera_escape": 0.06024, "mutant": "L", "mutation": "Y488L", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": 0.252, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.02742, "ferret_sera_escape": null, "mature_H5_site": 488, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y488M", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4111, "ferret_sera_escape": 0.1236, "mature_H5_site": 488, "mouse_sera_escape": 0.01596, "mutant": "N", "mutation": "Y488N", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": -0.3093, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6532, "ferret_sera_escape": null, "mature_H5_site": 488, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y488Q", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.745, "ferret_sera_escape": -0.4679, "mature_H5_site": 488, "mouse_sera_escape": 0.04581, "mutant": "R", "mutation": "Y488R", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7654, "ferret_sera_escape": 0.1234, "mature_H5_site": 488, "mouse_sera_escape": 0.1816, "mutant": "S", "mutation": "Y488S", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": -0.02091, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.371, "ferret_sera_escape": null, "mature_H5_site": 488, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y488T", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7161, "ferret_sera_escape": 0.1677, "mature_H5_site": 488, "mouse_sera_escape": 0.09412, "mutant": "V", "mutation": "Y488V", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": 0.05021, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.04519, "ferret_sera_escape": -0.05489, "mature_H5_site": 488, "mouse_sera_escape": 0.08623, "mutant": "W", "mutation": "Y488W", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": -0.021, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 488, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y488Y", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.1065, "cell_entry": -0.1552, "ferret_sera_escape": 0.01578, "mature_H5_site": 489, "mouse_sera_escape": null, "mutant": "A", "mutation": "P489A", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.04013, "ferret_sera_escape": -0.08114, "mature_H5_site": 489, "mouse_sera_escape": -0.09864, "mutant": "D", "mutation": "P489D", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.04188, "wildtype": "P"}, {"a26_usage": 0.05559, "cell_entry": 0.01254, "ferret_sera_escape": -0.02879, "mature_H5_site": 489, "mouse_sera_escape": -0.007419, "mutant": "F", "mutation": "P489F", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.1571, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.02938, "ferret_sera_escape": -0.008341, "mature_H5_site": 489, "mouse_sera_escape": -0.03831, "mutant": "G", "mutation": "P489G", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": 0.01021, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.04882, "ferret_sera_escape": -0.13, "mature_H5_site": 489, "mouse_sera_escape": -0.1292, "mutant": "H", "mutation": "P489H", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.1497, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.02565, "ferret_sera_escape": 0.1073, "mature_H5_site": 489, "mouse_sera_escape": 0.0902, "mutant": "I", "mutation": "P489I", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.0572, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1846, "ferret_sera_escape": 0.04503, "mature_H5_site": 489, "mouse_sera_escape": -0.0008303, "mutant": "K", "mutation": "P489K", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": 0.01046, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3002, "ferret_sera_escape": 0.01532, "mature_H5_site": 489, "mouse_sera_escape": -0.01713, "mutant": "L", "mutation": "P489L", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.1017, "wildtype": "P"}, {"a26_usage": 0.2463, "cell_entry": -0.05812, "ferret_sera_escape": -0.1003, "mature_H5_site": 489, "mouse_sera_escape": -0.06198, "mutant": "M", "mutation": "P489M", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.04655, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.03125, "ferret_sera_escape": -0.05052, "mature_H5_site": 489, "mouse_sera_escape": 0.04904, "mutant": "N", "mutation": "P489N", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.1082, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 489, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P489P", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.04562, "ferret_sera_escape": -0.04763, "mature_H5_site": 489, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P489Q", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.001623, "ferret_sera_escape": 0.01454, "mature_H5_site": 489, "mouse_sera_escape": -0.03628, "mutant": "R", "mutation": "P489R", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.0638, "wildtype": "P"}, {"a26_usage": 0.3141, "cell_entry": -0.1684, "ferret_sera_escape": -0.05553, "mature_H5_site": 489, "mouse_sera_escape": -0.07532, "mutant": "S", "mutation": "P489S", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.04727, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.00477, "ferret_sera_escape": -0.01775, "mature_H5_site": 489, "mouse_sera_escape": -0.0118, "mutant": "T", "mutation": "P489T", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": 0.01112, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.07207, "ferret_sera_escape": 0.06028, "mature_H5_site": 489, "mouse_sera_escape": -0.05548, "mutant": "V", "mutation": "P489V", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.02577, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.04756, "ferret_sera_escape": -0.09197, "mature_H5_site": 489, "mouse_sera_escape": -0.07195, "mutant": "W", "mutation": "P489W", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.3593, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.7819, "ferret_sera_escape": null, "mature_H5_site": 489, "mouse_sera_escape": null, "mutant": "Y", "mutation": "P489Y", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.05816, "ferret_sera_escape": 0.04179, "mature_H5_site": 39, "mouse_sera_escape": 0.06745, "mutant": "A", "mutation": "G49A", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": -0.242, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.9058, "ferret_sera_escape": -0.3209, "mature_H5_site": 39, "mouse_sera_escape": -0.2144, "mutant": "C", "mutation": "G49C", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": -0.1228, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.6956, "ferret_sera_escape": -0.07903, "mature_H5_site": 39, "mouse_sera_escape": 0.1095, "mutant": "D", "mutation": "G49D", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": -0.09096, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4272, "ferret_sera_escape": 0.07139, "mature_H5_site": 39, "mouse_sera_escape": 0.1007, "mutant": "E", "mutation": "G49E", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": -0.0009832, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.06056, "ferret_sera_escape": 0.1391, "mature_H5_site": 39, "mouse_sera_escape": 0.098, "mutant": "F", "mutation": "G49F", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": 0.08422, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 39, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G49G", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.61, "ferret_sera_escape": null, "mature_H5_site": 39, "mouse_sera_escape": null, "mutant": "I", "mutation": "G49I", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.05038, "ferret_sera_escape": -0.08449, "mature_H5_site": 39, "mouse_sera_escape": 0.07819, "mutant": "K", "mutation": "G49K", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": -0.09203, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.062, "ferret_sera_escape": null, "mature_H5_site": 39, "mouse_sera_escape": null, "mutant": "L", "mutation": "G49L", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3176, "ferret_sera_escape": null, "mature_H5_site": 39, "mouse_sera_escape": null, "mutant": "M", "mutation": "G49M", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2082, "ferret_sera_escape": -0.3137, "mature_H5_site": 39, "mouse_sera_escape": -0.01293, "mutant": "N", "mutation": "G49N", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2848, "ferret_sera_escape": -0.05959, "mature_H5_site": 39, "mouse_sera_escape": 0.01099, "mutant": "P", "mutation": "G49P", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": -0.6273, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3163, "ferret_sera_escape": 0.06917, "mature_H5_site": 39, "mouse_sera_escape": 0.2008, "mutant": "Q", "mutation": "G49Q", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2613, "ferret_sera_escape": 0.01032, "mature_H5_site": 39, "mouse_sera_escape": 0.02293, "mutant": "R", "mutation": "G49R", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": -0.08033, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.03599, "ferret_sera_escape": -0.128, "mature_H5_site": 39, "mouse_sera_escape": -0.05649, "mutant": "S", "mutation": "G49S", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": 0.006178, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1132, "ferret_sera_escape": -0.1521, "mature_H5_site": 39, "mouse_sera_escape": 0.01068, "mutant": "T", "mutation": "G49T", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": 0.007772, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.383, "ferret_sera_escape": -0.4338, "mature_H5_site": 39, "mouse_sera_escape": 0.09786, "mutant": "V", "mutation": "G49V", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.9783, "ferret_sera_escape": null, "mature_H5_site": 39, "mouse_sera_escape": null, "mutant": "W", "mutation": "G49W", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": -0.02615, "mature_H5_site": 490, "mouse_sera_escape": 0.02489, "mutant": "A", "mutation": "Q490A", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": 0.002273, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.262, "ferret_sera_escape": -0.09716, "mature_H5_site": 490, "mouse_sera_escape": 0.03823, "mutant": "D", "mutation": "Q490D", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.03974, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.04284, "ferret_sera_escape": -0.02687, "mature_H5_site": 490, "mouse_sera_escape": -0.02296, "mutant": "E", "mutation": "Q490E", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.004834, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1291, "ferret_sera_escape": -0.06777, "mature_H5_site": 490, "mouse_sera_escape": -0.01027, "mutant": "F", "mutation": "Q490F", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.02245, "wildtype": "Q"}, {"a26_usage": 0.1202, "cell_entry": 0.05589, "ferret_sera_escape": -0.07583, "mature_H5_site": 490, "mouse_sera_escape": -0.1652, "mutant": "G", "mutation": "Q490G", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.03651, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.02865, "ferret_sera_escape": 0.05054, "mature_H5_site": 490, "mouse_sera_escape": -0.1217, "mutant": "K", "mutation": "Q490K", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.1201, "wildtype": "Q"}, {"a26_usage": 0.31, "cell_entry": -0.3354, "ferret_sera_escape": -0.04921, "mature_H5_site": 490, "mouse_sera_escape": -0.01687, "mutant": "L", "mutation": "Q490L", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": 0.08774, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.06731, "ferret_sera_escape": 0.108, "mature_H5_site": 490, "mouse_sera_escape": 0.01115, "mutant": "M", "mutation": "Q490M", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.02495, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.02872, "ferret_sera_escape": 0.05543, "mature_H5_site": 490, "mouse_sera_escape": -0.001378, "mutant": "N", "mutation": "Q490N", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": 0.004789, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.6023, "ferret_sera_escape": -0.1503, "mature_H5_site": 490, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q490P", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 490, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q490Q", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.07169, "ferret_sera_escape": -0.003198, "mature_H5_site": 490, "mouse_sera_escape": -0.03308, "mutant": "S", "mutation": "Q490S", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.004215, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2175, "ferret_sera_escape": -0.03473, "mature_H5_site": 490, "mouse_sera_escape": 0.05188, "mutant": "T", "mutation": "Q490T", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": 0.01537, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.852, "ferret_sera_escape": 0.1552, "mature_H5_site": 490, "mouse_sera_escape": 0.04384, "mutant": "Y", "mutation": "Q490Y", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.0288, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.857, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y491A", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.018, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y491C", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y491D", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y491E", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.0366, "ferret_sera_escape": 0.03685, "mature_H5_site": 491, "mouse_sera_escape": -0.007037, "mutant": "F", "mutation": "Y491F", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": -0.001366, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.73, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y491G", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4017, "ferret_sera_escape": 0.03519, "mature_H5_site": 491, "mouse_sera_escape": 0.0873, "mutant": "H", "mutation": "Y491H", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": -0.03523, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.176, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y491I", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.453, "ferret_sera_escape": 0.1444, "mature_H5_site": 491, "mouse_sera_escape": 0.2205, "mutant": "K", "mutation": "Y491K", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": -0.2449, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.957, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y491L", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.419, "ferret_sera_escape": 0.04907, "mature_H5_site": 491, "mouse_sera_escape": 0.03843, "mutant": "M", "mutation": "Y491M", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": -0.1013, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.244, "ferret_sera_escape": -0.2383, "mature_H5_site": 491, "mouse_sera_escape": 0.04204, "mutant": "N", "mutation": "Y491N", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y491P", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.158, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y491Q", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.141, "ferret_sera_escape": -0.02028, "mature_H5_site": 491, "mouse_sera_escape": 0.02637, "mutant": "R", "mutation": "Y491R", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": -0.09213, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.632, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y491S", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y491T", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y491V", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1085, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y491W", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 491, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y491Y", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.06918, "ferret_sera_escape": 0.00212, "mature_H5_site": 492, "mouse_sera_escape": -0.02229, "mutant": "A", "mutation": "S492A", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.01557, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.5055, "ferret_sera_escape": null, "mature_H5_site": 492, "mouse_sera_escape": null, "mutant": "D", "mutation": "S492D", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.09166, "ferret_sera_escape": 0.08649, "mature_H5_site": 492, "mouse_sera_escape": -0.006167, "mutant": "E", "mutation": "S492E", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.1629, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3677, "ferret_sera_escape": null, "mature_H5_site": 492, "mouse_sera_escape": null, "mutant": "F", "mutation": "S492F", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.0695, "ferret_sera_escape": -0.05282, "mature_H5_site": 492, "mouse_sera_escape": 0.08057, "mutant": "G", "mutation": "S492G", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.04017, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1219, "ferret_sera_escape": -0.01079, "mature_H5_site": 492, "mouse_sera_escape": 0.008454, "mutant": "H", "mutation": "S492H", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.2178, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1893, "ferret_sera_escape": 0.05336, "mature_H5_site": 492, "mouse_sera_escape": -0.004489, "mutant": "I", "mutation": "S492I", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.1167, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1648, "ferret_sera_escape": -0.09105, "mature_H5_site": 492, "mouse_sera_escape": 0.003927, "mutant": "K", "mutation": "S492K", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": 0.1179, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.03846, "ferret_sera_escape": 0.1025, "mature_H5_site": 492, "mouse_sera_escape": -0.1745, "mutant": "L", "mutation": "S492L", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.07809, "ferret_sera_escape": 0.04069, "mature_H5_site": 492, "mouse_sera_escape": 0.03954, "mutant": "M", "mutation": "S492M", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": 0.1057, "wildtype": "S"}, {"a26_usage": 0.4265, "cell_entry": -0.193, "ferret_sera_escape": 0.03217, "mature_H5_site": 492, "mouse_sera_escape": 0.107, "mutant": "N", "mutation": "S492N", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.03062, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.593, "ferret_sera_escape": null, "mature_H5_site": 492, "mouse_sera_escape": null, "mutant": "P", "mutation": "S492P", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06974, "ferret_sera_escape": 0.03439, "mature_H5_site": 492, "mouse_sera_escape": 0.001119, "mutant": "Q", "mutation": "S492Q", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": 0.04227, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.04308, "ferret_sera_escape": -0.1017, "mature_H5_site": 492, "mouse_sera_escape": -0.03168, "mutant": "R", "mutation": "S492R", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": 0.1357, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 492, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S492S", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.4411, "cell_entry": -2.152, "ferret_sera_escape": 0.02309, "mature_H5_site": 492, "mouse_sera_escape": 0.05752, "mutant": "T", "mutation": "S492T", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.06466, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.08991, "ferret_sera_escape": 0.09907, "mature_H5_site": 492, "mouse_sera_escape": -0.007721, "mutant": "V", "mutation": "S492V", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.01128, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.05597, "ferret_sera_escape": -0.06082, "mature_H5_site": 492, "mouse_sera_escape": 0.03563, "mutant": "Y", "mutation": "S492Y", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.1048, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.02256, "ferret_sera_escape": -0.09179, "mature_H5_site": 493, "mouse_sera_escape": -0.0445, "mutant": "A", "mutation": "E493A", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.01168, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.00506, "ferret_sera_escape": 0.07341, "mature_H5_site": 493, "mouse_sera_escape": 0.1107, "mutant": "D", "mutation": "E493D", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.06634, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 493, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E493E", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1319, "ferret_sera_escape": 0.003744, "mature_H5_site": 493, "mouse_sera_escape": -0.01105, "mutant": "F", "mutation": "E493F", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1969, "ferret_sera_escape": -0.02376, "mature_H5_site": 493, "mouse_sera_escape": 0.02527, "mutant": "G", "mutation": "E493G", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.0286, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.8727, "ferret_sera_escape": -0.1817, "mature_H5_site": 493, "mouse_sera_escape": 0.08723, "mutant": "H", "mutation": "E493H", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": -0.02668, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02653, "ferret_sera_escape": 0.1466, "mature_H5_site": 493, "mouse_sera_escape": 0.05136, "mutant": "I", "mutation": "E493I", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.05681, "wildtype": "E"}, {"a26_usage": 0.004545, "cell_entry": -0.05364, "ferret_sera_escape": -0.1433, "mature_H5_site": 493, "mouse_sera_escape": 0.01083, "mutant": "K", "mutation": "E493K", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.1884, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1879, "ferret_sera_escape": 0.1026, "mature_H5_site": 493, "mouse_sera_escape": -0.1019, "mutant": "L", "mutation": "E493L", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.04629, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6119, "ferret_sera_escape": -0.08209, "mature_H5_site": 493, "mouse_sera_escape": 0.08415, "mutant": "N", "mutation": "E493N", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": -0.0277, "wildtype": "E"}, {"a26_usage": 0.2579, "cell_entry": -0.1191, "ferret_sera_escape": -0.001429, "mature_H5_site": 493, "mouse_sera_escape": 0.01071, "mutant": "P", "mutation": "E493P", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.006802, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01898, "ferret_sera_escape": 0.005411, "mature_H5_site": 493, "mouse_sera_escape": -0.03353, "mutant": "Q", "mutation": "E493Q", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.1238, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.04886, "ferret_sera_escape": 0.02694, "mature_H5_site": 493, "mouse_sera_escape": 0.02908, "mutant": "S", "mutation": "E493S", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.01313, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06264, "ferret_sera_escape": -0.1339, "mature_H5_site": 493, "mouse_sera_escape": -0.0608, "mutant": "T", "mutation": "E493T", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.108, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1598, "ferret_sera_escape": 5.333e-05, "mature_H5_site": 493, "mouse_sera_escape": 0.03537, "mutant": "V", "mutation": "E493V", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.1188, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9448, "ferret_sera_escape": 0.06824, "mature_H5_site": 493, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E493Y", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3478, "ferret_sera_escape": -0.0607, "mature_H5_site": 494, "mouse_sera_escape": -0.05069, "mutant": "A", "mutation": "E494A", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.01482, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1606, "ferret_sera_escape": -0.1325, "mature_H5_site": 494, "mouse_sera_escape": -0.05403, "mutant": "C", "mutation": "E494C", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.03347, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7727, "ferret_sera_escape": 0.205, "mature_H5_site": 494, "mouse_sera_escape": 0.1005, "mutant": "D", "mutation": "E494D", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 494, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E494E", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1087, "ferret_sera_escape": 0.1699, "mature_H5_site": 494, "mouse_sera_escape": 0.09308, "mutant": "F", "mutation": "E494F", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.02558, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5398, "ferret_sera_escape": -0.0675, "mature_H5_site": 494, "mouse_sera_escape": -0.0364, "mutant": "G", "mutation": "E494G", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.01888, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.05363, "ferret_sera_escape": 0.02023, "mature_H5_site": 494, "mouse_sera_escape": 0.1831, "mutant": "H", "mutation": "E494H", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.02558, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2148, "ferret_sera_escape": 0.1172, "mature_H5_site": 494, "mouse_sera_escape": -0.04148, "mutant": "I", "mutation": "E494I", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": 0.02221, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3865, "ferret_sera_escape": 0.02701, "mature_H5_site": 494, "mouse_sera_escape": 0.08049, "mutant": "K", "mutation": "E494K", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.04477, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1426, "ferret_sera_escape": 0.01843, "mature_H5_site": 494, "mouse_sera_escape": 0.0003306, "mutant": "L", "mutation": "E494L", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.03609, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.19, "ferret_sera_escape": -0.182, "mature_H5_site": 494, "mouse_sera_escape": -0.1774, "mutant": "M", "mutation": "E494M", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.002752, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4734, "ferret_sera_escape": 0.1948, "mature_H5_site": 494, "mouse_sera_escape": 0.08114, "mutant": "N", "mutation": "E494N", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.03529, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.02692, "ferret_sera_escape": 0.01838, "mature_H5_site": 494, "mouse_sera_escape": 0.03283, "mutant": "P", "mutation": "E494P", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": 0.03233, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.005685, "ferret_sera_escape": -0.007367, "mature_H5_site": 494, "mouse_sera_escape": 0.01564, "mutant": "Q", "mutation": "E494Q", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.0003115, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4497, "ferret_sera_escape": -0.09871, "mature_H5_site": 494, "mouse_sera_escape": 0.1468, "mutant": "R", "mutation": "E494R", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.02833, "wildtype": "E"}, {"a26_usage": 0.115, "cell_entry": -0.1459, "ferret_sera_escape": -0.007721, "mature_H5_site": 494, "mouse_sera_escape": 0.1014, "mutant": "S", "mutation": "E494S", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": 0.0226, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.04645, "ferret_sera_escape": -0.1432, "mature_H5_site": 494, "mouse_sera_escape": -0.1108, "mutant": "T", "mutation": "E494T", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.0207, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01831, "ferret_sera_escape": -0.03138, "mature_H5_site": 494, "mouse_sera_escape": -0.01676, "mutant": "V", "mutation": "E494V", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": 0.02321, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3052, "ferret_sera_escape": null, "mature_H5_site": 494, "mouse_sera_escape": null, "mutant": "W", "mutation": "E494W", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.09479, "ferret_sera_escape": 0.03682, "mature_H5_site": 494, "mouse_sera_escape": 0.1577, "mutant": "Y", "mutation": "E494Y", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.2066, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 495, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A495A", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.95, "ferret_sera_escape": null, "mature_H5_site": 495, "mouse_sera_escape": null, "mutant": "D", "mutation": "A495D", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.461, "ferret_sera_escape": null, "mature_H5_site": 495, "mouse_sera_escape": null, "mutant": "E", "mutation": "A495E", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.558, "ferret_sera_escape": null, "mature_H5_site": 495, "mouse_sera_escape": null, "mutant": "F", "mutation": "A495F", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.236, "ferret_sera_escape": null, "mature_H5_site": 495, "mouse_sera_escape": null, "mutant": "H", "mutation": "A495H", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.00379, "ferret_sera_escape": -0.148, "mature_H5_site": 495, "mouse_sera_escape": -0.06656, "mutant": "I", "mutation": "A495I", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.1046, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.599, "ferret_sera_escape": -0.1602, "mature_H5_site": 495, "mouse_sera_escape": -0.03917, "mutant": "K", "mutation": "A495K", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.1843, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3244, "ferret_sera_escape": -0.04316, "mature_H5_site": 495, "mouse_sera_escape": -0.07021, "mutant": "L", "mutation": "A495L", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.04391, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2422, "ferret_sera_escape": -0.02921, "mature_H5_site": 495, "mouse_sera_escape": -0.06416, "mutant": "M", "mutation": "A495M", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.08084, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.904, "ferret_sera_escape": null, "mature_H5_site": 495, "mouse_sera_escape": null, "mutant": "P", "mutation": "A495P", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.445, "ferret_sera_escape": -0.2363, "mature_H5_site": 495, "mouse_sera_escape": -0.1034, "mutant": "Q", "mutation": "A495Q", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.2266, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.281, "ferret_sera_escape": 0.1069, "mature_H5_site": 495, "mouse_sera_escape": -0.05605, "mutant": "R", "mutation": "A495R", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.1804, "wildtype": "A"}, {"a26_usage": 0.2654, "cell_entry": -0.7931, "ferret_sera_escape": -0.05299, "mature_H5_site": 495, "mouse_sera_escape": 0.02797, "mutant": "S", "mutation": "A495S", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.03581, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.129, "ferret_sera_escape": 0.04064, "mature_H5_site": 495, "mouse_sera_escape": 0.0058, "mutant": "T", "mutation": "A495T", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.07746, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2765, "ferret_sera_escape": 0.008657, "mature_H5_site": 495, "mouse_sera_escape": -0.01175, "mutant": "V", "mutation": "A495V", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.07112, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.57, "ferret_sera_escape": -0.129, "mature_H5_site": 495, "mouse_sera_escape": 0.07449, "mutant": "W", "mutation": "A495W", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.216, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.309, "ferret_sera_escape": 0.07837, "mature_H5_site": 495, "mouse_sera_escape": 0.07343, "mutant": "Y", "mutation": "A495Y", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.583, "ferret_sera_escape": -0.03315, "mature_H5_site": 496, "mouse_sera_escape": -0.004372, "mutant": "C", "mutation": "R496C", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.1036, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1516, "ferret_sera_escape": 0.06152, "mature_H5_site": 496, "mouse_sera_escape": -0.04717, "mutant": "E", "mutation": "R496E", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.03159, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.21, "ferret_sera_escape": -0.08823, "mature_H5_site": 496, "mouse_sera_escape": -0.01108, "mutant": "F", "mutation": "R496F", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.07574, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.526, "ferret_sera_escape": 0.02566, "mature_H5_site": 496, "mouse_sera_escape": 0.05257, "mutant": "G", "mutation": "R496G", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.08315, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.757, "ferret_sera_escape": 0.07383, "mature_H5_site": 496, "mouse_sera_escape": 0.02623, "mutant": "H", "mutation": "R496H", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.02449, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.14, "ferret_sera_escape": -0.05312, "mature_H5_site": 496, "mouse_sera_escape": 0.008679, "mutant": "I", "mutation": "R496I", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": null, "wildtype": "R"}, {"a26_usage": 0.3851, "cell_entry": -0.5592, "ferret_sera_escape": -0.07896, "mature_H5_site": 496, "mouse_sera_escape": 8.375e-05, "mutant": "K", "mutation": "R496K", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.02942, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.9737, "ferret_sera_escape": null, "mature_H5_site": 496, "mouse_sera_escape": null, "mutant": "L", "mutation": "R496L", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1597, "ferret_sera_escape": 0.02108, "mature_H5_site": 496, "mouse_sera_escape": -0.03502, "mutant": "M", "mutation": "R496M", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.05652, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3315, "ferret_sera_escape": 0.1042, "mature_H5_site": 496, "mouse_sera_escape": -0.003181, "mutant": "N", "mutation": "R496N", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.01511, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.002, "ferret_sera_escape": null, "mature_H5_site": 496, "mouse_sera_escape": null, "mutant": "P", "mutation": "R496P", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.06183, "ferret_sera_escape": 0.06539, "mature_H5_site": 496, "mouse_sera_escape": 0.1002, "mutant": "Q", "mutation": "R496Q", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.003019, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 496, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R496R", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2787, "ferret_sera_escape": -0.1037, "mature_H5_site": 496, "mouse_sera_escape": -0.04402, "mutant": "S", "mutation": "R496S", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.02686, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.131, "ferret_sera_escape": 0.0916, "mature_H5_site": 496, "mouse_sera_escape": -0.03548, "mutant": "T", "mutation": "R496T", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.02779, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.166, "ferret_sera_escape": 0.08526, "mature_H5_site": 496, "mouse_sera_escape": 0.1357, "mutant": "V", "mutation": "R496V", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.06477, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.151, "ferret_sera_escape": -0.05887, "mature_H5_site": 496, "mouse_sera_escape": -0.1455, "mutant": "W", "mutation": "R496W", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.09356, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4927, "ferret_sera_escape": -0.06816, "mature_H5_site": 496, "mouse_sera_escape": -0.01294, "mutant": "Y", "mutation": "R496Y", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": 0.1228, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.008565, "ferret_sera_escape": 0.06321, "mature_H5_site": 497, "mouse_sera_escape": 0.08347, "mutant": "C", "mutation": "L497C", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.0508, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6236, "ferret_sera_escape": 0.1154, "mature_H5_site": 497, "mouse_sera_escape": 0.1496, "mutant": "D", "mutation": "L497D", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.006577, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4429, "ferret_sera_escape": 0.08356, "mature_H5_site": 497, "mouse_sera_escape": 0.1517, "mutant": "E", "mutation": "L497E", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.02115, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.235, "ferret_sera_escape": 0.04899, "mature_H5_site": 497, "mouse_sera_escape": 0.09433, "mutant": "F", "mutation": "L497F", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.02851, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 497, "mouse_sera_escape": null, "mutant": "G", "mutation": "L497G", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": null, "wildtype": "L"}, {"a26_usage": 0.009325, "cell_entry": 0.06297, "ferret_sera_escape": -0.005041, "mature_H5_site": 497, "mouse_sera_escape": -0.02918, "mutant": "H", "mutation": "L497H", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.01789, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.05432, "ferret_sera_escape": 0.1455, "mature_H5_site": 497, "mouse_sera_escape": -0.03722, "mutant": "I", "mutation": "L497I", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.04074, "wildtype": "L"}, {"a26_usage": 0.1695, "cell_entry": 0.02366, "ferret_sera_escape": -0.002391, "mature_H5_site": 497, "mouse_sera_escape": 0.01489, "mutant": "K", "mutation": "L497K", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.01214, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 497, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L497L", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.0541, "ferret_sera_escape": -0.1003, "mature_H5_site": 497, "mouse_sera_escape": 0.08403, "mutant": "M", "mutation": "L497M", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.06037, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2107, "ferret_sera_escape": -0.1165, "mature_H5_site": 497, "mouse_sera_escape": -0.08121, "mutant": "N", "mutation": "L497N", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7451, "ferret_sera_escape": -0.1638, "mature_H5_site": 497, "mouse_sera_escape": 0.08131, "mutant": "P", "mutation": "L497P", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.03041, "wildtype": "L"}, {"a26_usage": 0.04594, "cell_entry": -1.244, "ferret_sera_escape": 0.1233, "mature_H5_site": 497, "mouse_sera_escape": 0.1481, "mutant": "Q", "mutation": "L497Q", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.04323, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.07033, "ferret_sera_escape": -0.008766, "mature_H5_site": 497, "mouse_sera_escape": -0.008842, "mutant": "R", "mutation": "L497R", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.03897, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2087, "ferret_sera_escape": -0.04179, "mature_H5_site": 497, "mouse_sera_escape": 0.01519, "mutant": "T", "mutation": "L497T", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.002994, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2893, "ferret_sera_escape": 0.02422, "mature_H5_site": 497, "mouse_sera_escape": 0.08137, "mutant": "V", "mutation": "L497V", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.01233, "wildtype": "L"}, {"a26_usage": 0.1774, "cell_entry": -0.2701, "ferret_sera_escape": -0.1625, "mature_H5_site": 497, "mouse_sera_escape": 0.1865, "mutant": "W", "mutation": "L497W", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.01821, "wildtype": "L"}, {"a26_usage": 0.1022, "cell_entry": -0.00332, "ferret_sera_escape": 0.06122, "mature_H5_site": 497, "mouse_sera_escape": 0.0143, "mutant": "Y", "mutation": "L497Y", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.01715, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.03753, "ferret_sera_escape": null, "mature_H5_site": 498, "mouse_sera_escape": null, "mutant": "A", "mutation": "K498A", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4897, "ferret_sera_escape": 0.1583, "mature_H5_site": 498, "mouse_sera_escape": 0.04448, "mutant": "C", "mutation": "K498C", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.08597, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3524, "ferret_sera_escape": null, "mature_H5_site": 498, "mouse_sera_escape": null, "mutant": "E", "mutation": "K498E", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2255, "ferret_sera_escape": 0.1557, "mature_H5_site": 498, "mouse_sera_escape": 0.1221, "mutant": "F", "mutation": "K498F", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.01328, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3829, "ferret_sera_escape": 0.07204, "mature_H5_site": 498, "mouse_sera_escape": -0.1036, "mutant": "G", "mutation": "K498G", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.02262, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.06501, "ferret_sera_escape": 0.0437, "mature_H5_site": 498, "mouse_sera_escape": 0.1082, "mutant": "H", "mutation": "K498H", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": 0.007073, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03191, "ferret_sera_escape": null, "mature_H5_site": 498, "mouse_sera_escape": null, "mutant": "I", "mutation": "K498I", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 498, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K498K", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0996, "cell_entry": -0.1194, "ferret_sera_escape": 0.01417, "mature_H5_site": 498, "mouse_sera_escape": 0.04639, "mutant": "L", "mutation": "K498L", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": 0.007424, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.01002, "ferret_sera_escape": -0.0007947, "mature_H5_site": 498, "mouse_sera_escape": 0.02899, "mutant": "M", "mutation": "K498M", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.02202, "wildtype": "K"}, {"a26_usage": 0.1855, "cell_entry": -0.09131, "ferret_sera_escape": 0.09979, "mature_H5_site": 498, "mouse_sera_escape": 0.02128, "mutant": "N", "mutation": "K498N", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.07246, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.386, "ferret_sera_escape": -0.05107, "mature_H5_site": 498, "mouse_sera_escape": 0.04971, "mutant": "P", "mutation": "K498P", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.1673, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1485, "ferret_sera_escape": 0.1388, "mature_H5_site": 498, "mouse_sera_escape": -0.02596, "mutant": "Q", "mutation": "K498Q", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.03113, "wildtype": "K"}, {"a26_usage": 0.02363, "cell_entry": -0.04749, "ferret_sera_escape": null, "mature_H5_site": 498, "mouse_sera_escape": null, "mutant": "R", "mutation": "K498R", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2218, "ferret_sera_escape": 0.001063, "mature_H5_site": 498, "mouse_sera_escape": -0.0595, "mutant": "S", "mutation": "K498S", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.1209, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.02015, "ferret_sera_escape": 0.06683, "mature_H5_site": 498, "mouse_sera_escape": 0.09578, "mutant": "T", "mutation": "K498T", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.05548, "wildtype": "K"}, {"a26_usage": 0.03131, "cell_entry": -0.6544, "ferret_sera_escape": -0.008566, "mature_H5_site": 498, "mouse_sera_escape": 0.01677, "mutant": "V", "mutation": "K498V", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.04272, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.145, "ferret_sera_escape": null, "mature_H5_site": 498, "mouse_sera_escape": null, "mutant": "W", "mutation": "K498W", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.07562, "ferret_sera_escape": -0.01475, "mature_H5_site": 498, "mouse_sera_escape": 0.05973, "mutant": "Y", "mutation": "K498Y", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.01622, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.041, "ferret_sera_escape": -0.0706, "mature_H5_site": 499, "mouse_sera_escape": -0.0345, "mutant": "A", "mutation": "R499A", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.08452, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.822, "ferret_sera_escape": null, "mature_H5_site": 499, "mouse_sera_escape": null, "mutant": "C", "mutation": "R499C", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.446, "ferret_sera_escape": -0.1759, "mature_H5_site": 499, "mouse_sera_escape": -0.2058, "mutant": "D", "mutation": "R499D", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.2941, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5095, "ferret_sera_escape": 0.006315, "mature_H5_site": 499, "mouse_sera_escape": -0.05333, "mutant": "E", "mutation": "R499E", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.07757, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3064, "ferret_sera_escape": -0.07939, "mature_H5_site": 499, "mouse_sera_escape": -0.05205, "mutant": "F", "mutation": "R499F", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.01785, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7239, "ferret_sera_escape": 0.09597, "mature_H5_site": 499, "mouse_sera_escape": 0.08157, "mutant": "G", "mutation": "R499G", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.1406, "cell_entry": -0.7707, "ferret_sera_escape": -0.07501, "mature_H5_site": 499, "mouse_sera_escape": -0.003245, "mutant": "H", "mutation": "R499H", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.02892, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2035, "ferret_sera_escape": -0.1753, "mature_H5_site": 499, "mouse_sera_escape": -0.06128, "mutant": "I", "mutation": "R499I", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4959, "ferret_sera_escape": -0.0256, "mature_H5_site": 499, "mouse_sera_escape": 0.07508, "mutant": "K", "mutation": "R499K", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5152, "ferret_sera_escape": 0.05444, "mature_H5_site": 499, "mouse_sera_escape": 0.1088, "mutant": "L", "mutation": "R499L", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": 0.02887, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.02553, "ferret_sera_escape": null, "mature_H5_site": 499, "mouse_sera_escape": null, "mutant": "M", "mutation": "R499M", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4061, "ferret_sera_escape": 0.1319, "mature_H5_site": 499, "mouse_sera_escape": 0.05889, "mutant": "N", "mutation": "R499N", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.1168, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.681, "ferret_sera_escape": null, "mature_H5_site": 499, "mouse_sera_escape": 0.01576, "mutant": "P", "mutation": "R499P", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3311, "ferret_sera_escape": -0.08897, "mature_H5_site": 499, "mouse_sera_escape": -0.008083, "mutant": "Q", "mutation": "R499Q", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.08045, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 499, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R499R", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3597, "ferret_sera_escape": null, "mature_H5_site": 499, "mouse_sera_escape": null, "mutant": "S", "mutation": "R499S", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.903, "ferret_sera_escape": -0.06766, "mature_H5_site": 499, "mouse_sera_escape": 0.05051, "mutant": "T", "mutation": "R499T", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.07565, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.189, "ferret_sera_escape": -0.08731, "mature_H5_site": 499, "mouse_sera_escape": -0.007919, "mutant": "V", "mutation": "R499V", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": 0.0181, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.6838, "ferret_sera_escape": 0.1142, "mature_H5_site": 499, "mouse_sera_escape": 0.08438, "mutant": "W", "mutation": "R499W", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.09863, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2148, "ferret_sera_escape": 0.02855, "mature_H5_site": 499, "mouse_sera_escape": -0.0372, "mutant": "Y", "mutation": "R499Y", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.8321, "ferret_sera_escape": 0.06205, "mature_H5_site": -6, "mouse_sera_escape": 0.03136, "mutant": "A", "mutation": "V5A", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": 0.01956, "wildtype": "V"}, {"a26_usage": 0.02815, "cell_entry": -0.1513, "ferret_sera_escape": -0.1393, "mature_H5_site": -6, "mouse_sera_escape": 0.01775, "mutant": "C", "mutation": "V5C", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.933, "ferret_sera_escape": null, "mature_H5_site": -6, "mouse_sera_escape": null, "mutant": "D", "mutation": "V5D", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.08, "ferret_sera_escape": -0.07795, "mature_H5_site": -6, "mouse_sera_escape": -0.1506, "mutant": "E", "mutation": "V5E", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4356, "ferret_sera_escape": null, "mature_H5_site": -6, "mouse_sera_escape": -0.01948, "mutant": "F", "mutation": "V5F", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.03311, "wildtype": "V"}, {"a26_usage": 0.1851, "cell_entry": -0.5053, "ferret_sera_escape": 0.004713, "mature_H5_site": -6, "mouse_sera_escape": 0.04949, "mutant": "G", "mutation": "V5G", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.05397, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.626, "ferret_sera_escape": -0.08917, "mature_H5_site": -6, "mouse_sera_escape": 0.02683, "mutant": "H", "mutation": "V5H", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.1906, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.745, "ferret_sera_escape": -0.03836, "mature_H5_site": -6, "mouse_sera_escape": -0.01961, "mutant": "L", "mutation": "V5L", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.05853, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.01567, "ferret_sera_escape": -0.0183, "mature_H5_site": -6, "mouse_sera_escape": -0.04618, "mutant": "M", "mutation": "V5M", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.05565, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": -0.2471, "mature_H5_site": -6, "mouse_sera_escape": 0.01008, "mutant": "Q", "mutation": "V5Q", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.07756, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.441, "ferret_sera_escape": null, "mature_H5_site": -6, "mouse_sera_escape": null, "mutant": "R", "mutation": "V5R", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.027, "ferret_sera_escape": null, "mature_H5_site": -6, "mouse_sera_escape": null, "mutant": "S", "mutation": "V5S", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": null, "wildtype": "V"}, {"a26_usage": 0.392, "cell_entry": -0.3184, "ferret_sera_escape": 0.01792, "mature_H5_site": -6, "mouse_sera_escape": -0.03739, "mutant": "T", "mutation": "V5T", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.02988, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -6, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V5V", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4115, "ferret_sera_escape": 0.02867, "mature_H5_site": -6, "mouse_sera_escape": 0.0395, "mutant": "W", "mutation": "V5W", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.1216, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1183, "ferret_sera_escape": -0.04423, "mature_H5_site": -6, "mouse_sera_escape": -0.06841, "mutant": "Y", "mutation": "V5Y", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.3741, "wildtype": "V"}, {"a26_usage": 0.01487, "cell_entry": 0.05976, "ferret_sera_escape": -0.0498, "mature_H5_site": 40, "mouse_sera_escape": 0.03119, "mutant": "A", "mutation": "K50A", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": 0.2145, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6661, "ferret_sera_escape": null, "mature_H5_site": 40, "mouse_sera_escape": null, "mutant": "C", "mutation": "K50C", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3111, "ferret_sera_escape": 0.004537, "mature_H5_site": 40, "mouse_sera_escape": null, "mutant": "E", "mutation": "K50E", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1095, "ferret_sera_escape": 0.08462, "mature_H5_site": 40, "mouse_sera_escape": null, "mutant": "F", "mutation": "K50F", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3245, "ferret_sera_escape": -0.09536, "mature_H5_site": 40, "mouse_sera_escape": -0.1453, "mutant": "I", "mutation": "K50I", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": -0.06722, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 40, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K50K", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.02824, "ferret_sera_escape": -0.1497, "mature_H5_site": 40, "mouse_sera_escape": -0.1647, "mutant": "L", "mutation": "K50L", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": -0.1958, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.183, "ferret_sera_escape": -0.06439, "mature_H5_site": 40, "mouse_sera_escape": -0.01998, "mutant": "N", "mutation": "K50N", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": 0.07, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1249, "ferret_sera_escape": 0.008873, "mature_H5_site": 40, "mouse_sera_escape": -0.02708, "mutant": "Q", "mutation": "K50Q", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": -0.02251, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03866, "ferret_sera_escape": -0.2065, "mature_H5_site": 40, "mouse_sera_escape": -0.1086, "mutant": "R", "mutation": "K50R", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": -0.01151, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 40, "mouse_sera_escape": null, "mutant": "T", "mutation": "K50T", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4268, "ferret_sera_escape": 0.02995, "mature_H5_site": 40, "mouse_sera_escape": 0.005554, "mutant": "V", "mutation": "K50V", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": 0.05297, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.02721, "ferret_sera_escape": null, "mature_H5_site": 40, "mouse_sera_escape": null, "mutant": "W", "mutation": "K50W", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5956, "ferret_sera_escape": -0.08586, "mature_H5_site": 40, "mouse_sera_escape": -0.1402, "mutant": "Y", "mutation": "K50Y", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": 0.09788, "wildtype": "K"}, {"a26_usage": 0.1248, "cell_entry": -0.1615, "ferret_sera_escape": -0.0005707, "mature_H5_site": 500, "mouse_sera_escape": -0.0645, "mutant": "A", "mutation": "E500A", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.002435, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.315, "ferret_sera_escape": null, "mature_H5_site": 500, "mouse_sera_escape": -0.3504, "mutant": "C", "mutation": "E500C", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.08881, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01179, "ferret_sera_escape": 0.02196, "mature_H5_site": 500, "mouse_sera_escape": 0.002811, "mutant": "D", "mutation": "E500D", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.05384, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 500, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E500E", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6934, "ferret_sera_escape": -0.01636, "mature_H5_site": 500, "mouse_sera_escape": 0.02578, "mutant": "F", "mutation": "E500F", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.02732, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.09315, "ferret_sera_escape": 0.08517, "mature_H5_site": 500, "mouse_sera_escape": 0.1007, "mutant": "G", "mutation": "E500G", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.01502, "wildtype": "E"}, {"a26_usage": 0.02207, "cell_entry": -0.02537, "ferret_sera_escape": 0.00696, "mature_H5_site": 500, "mouse_sera_escape": 0.008886, "mutant": "H", "mutation": "E500H", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.07797, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9311, "ferret_sera_escape": -0.008747, "mature_H5_site": 500, "mouse_sera_escape": -0.05978, "mutant": "I", "mutation": "E500I", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.00529, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1361, "ferret_sera_escape": 0.001789, "mature_H5_site": 500, "mouse_sera_escape": -0.01765, "mutant": "K", "mutation": "E500K", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.1091, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.45, "ferret_sera_escape": 0.09115, "mature_H5_site": 500, "mouse_sera_escape": null, "mutant": "L", "mutation": "E500L", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.06356, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.05083, "ferret_sera_escape": 0.156, "mature_H5_site": 500, "mouse_sera_escape": 0.06842, "mutant": "M", "mutation": "E500M", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.02426, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.092, "ferret_sera_escape": -0.0266, "mature_H5_site": 500, "mouse_sera_escape": -0.01786, "mutant": "N", "mutation": "E500N", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.06066, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2163, "ferret_sera_escape": 0.01699, "mature_H5_site": 500, "mouse_sera_escape": 0.1919, "mutant": "P", "mutation": "E500P", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.09694, "wildtype": "E"}, {"a26_usage": 0.3591, "cell_entry": -0.5321, "ferret_sera_escape": 0.02088, "mature_H5_site": 500, "mouse_sera_escape": -0.02506, "mutant": "Q", "mutation": "E500Q", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.03839, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.8014, "ferret_sera_escape": -0.03723, "mature_H5_site": 500, "mouse_sera_escape": -0.08727, "mutant": "R", "mutation": "E500R", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.08879, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1573, "ferret_sera_escape": 0.025, "mature_H5_site": 500, "mouse_sera_escape": 0.0946, "mutant": "S", "mutation": "E500S", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.002569, "wildtype": "E"}, {"a26_usage": 0.1059, "cell_entry": -0.4283, "ferret_sera_escape": -0.01768, "mature_H5_site": 500, "mouse_sera_escape": 0.008856, "mutant": "T", "mutation": "E500T", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.05948, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1775, "ferret_sera_escape": -0.06702, "mature_H5_site": 500, "mouse_sera_escape": 0.006827, "mutant": "V", "mutation": "E500V", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.02879, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.0, "ferret_sera_escape": 0.01342, "mature_H5_site": 500, "mouse_sera_escape": 0.03967, "mutant": "W", "mutation": "E500W", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.05419, "wildtype": "E"}, {"a26_usage": 0.08013, "cell_entry": -0.4338, "ferret_sera_escape": 0.1247, "mature_H5_site": 500, "mouse_sera_escape": 0.2154, "mutant": "Y", "mutation": "E500Y", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.2655, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02073, "ferret_sera_escape": 0.03378, "mature_H5_site": 501, "mouse_sera_escape": 0.009169, "mutant": "A", "mutation": "E501A", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.545, "ferret_sera_escape": null, "mature_H5_site": 501, "mouse_sera_escape": null, "mutant": "C", "mutation": "E501C", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1677, "ferret_sera_escape": 0.1912, "mature_H5_site": 501, "mouse_sera_escape": 0.00433, "mutant": "D", "mutation": "E501D", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": 0.009861, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 501, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E501E", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5825, "ferret_sera_escape": -0.1017, "mature_H5_site": 501, "mouse_sera_escape": 0.006612, "mutant": "F", "mutation": "E501F", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.02993, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.04225, "ferret_sera_escape": 0.005582, "mature_H5_site": 501, "mouse_sera_escape": -0.004959, "mutant": "G", "mutation": "E501G", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.1043, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.698, "ferret_sera_escape": 0.015, "mature_H5_site": 501, "mouse_sera_escape": 0.07412, "mutant": "H", "mutation": "E501H", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.02581, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.364, "ferret_sera_escape": -0.02507, "mature_H5_site": 501, "mouse_sera_escape": 0.07509, "mutant": "I", "mutation": "E501I", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.02773, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4753, "ferret_sera_escape": -0.1548, "mature_H5_site": 501, "mouse_sera_escape": 0.1343, "mutant": "K", "mutation": "E501K", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.05335, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.00811, "ferret_sera_escape": 0.02485, "mature_H5_site": 501, "mouse_sera_escape": -0.01447, "mutant": "L", "mutation": "E501L", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": 0.01767, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4849, "ferret_sera_escape": -0.01883, "mature_H5_site": 501, "mouse_sera_escape": 0.05084, "mutant": "M", "mutation": "E501M", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.0579, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4322, "ferret_sera_escape": -0.0008437, "mature_H5_site": 501, "mouse_sera_escape": 0.01874, "mutant": "N", "mutation": "E501N", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.06068, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2273, "ferret_sera_escape": -0.0245, "mature_H5_site": 501, "mouse_sera_escape": -0.081, "mutant": "P", "mutation": "E501P", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.06289, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1893, "ferret_sera_escape": 0.1136, "mature_H5_site": 501, "mouse_sera_escape": 0.06409, "mutant": "Q", "mutation": "E501Q", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.474, "ferret_sera_escape": -0.1173, "mature_H5_site": 501, "mouse_sera_escape": -0.03919, "mutant": "R", "mutation": "E501R", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.05969, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4944, "ferret_sera_escape": -0.0352, "mature_H5_site": 501, "mouse_sera_escape": -0.06843, "mutant": "S", "mutation": "E501S", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.06384, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1152, "ferret_sera_escape": 0.008691, "mature_H5_site": 501, "mouse_sera_escape": 0.02445, "mutant": "T", "mutation": "E501T", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.02985, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4811, "ferret_sera_escape": -0.1554, "mature_H5_site": 501, "mouse_sera_escape": 0.0414, "mutant": "V", "mutation": "E501V", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.03421, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.315, "ferret_sera_escape": 0.02893, "mature_H5_site": 501, "mouse_sera_escape": 0.03215, "mutant": "W", "mutation": "E501W", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.07838, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9951, "ferret_sera_escape": 0.05194, "mature_H5_site": 501, "mouse_sera_escape": 0.06304, "mutant": "Y", "mutation": "E501Y", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.06391, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.71, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "A", "mutation": "I502A", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "C", "mutation": "I502C", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.563, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "D", "mutation": "I502D", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "E", "mutation": "I502E", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.855, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "F", "mutation": "I502F", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.787, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "G", "mutation": "I502G", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.894, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "H", "mutation": "I502H", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 502, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I502I", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.51, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "K", "mutation": "I502K", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.172, "cell_entry": 0.02552, "ferret_sera_escape": -0.01298, "mature_H5_site": 502, "mouse_sera_escape": 0.03653, "mutant": "L", "mutation": "I502L", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": 0.04969, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.629, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "M", "mutation": "I502M", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "N", "mutation": "I502N", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.754, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "P", "mutation": "I502P", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.996, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I502Q", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.994, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "R", "mutation": "I502R", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.848, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "S", "mutation": "I502S", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.789, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "T", "mutation": "I502T", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2473, "ferret_sera_escape": -0.01045, "mature_H5_site": 502, "mouse_sera_escape": -0.01908, "mutant": "V", "mutation": "I502V", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": -0.1084, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.752, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "W", "mutation": "I502W", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.779, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I502Y", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.1119, "cell_entry": -0.4825, "ferret_sera_escape": -0.03764, "mature_H5_site": 503, "mouse_sera_escape": -0.04009, "mutant": "A", "mutation": "S503A", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.05346, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.756, "ferret_sera_escape": null, "mature_H5_site": 503, "mouse_sera_escape": null, "mutant": "C", "mutation": "S503C", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.01054, "ferret_sera_escape": -0.003662, "mature_H5_site": 503, "mouse_sera_escape": -0.1065, "mutant": "D", "mutation": "S503D", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.01436, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2407, "ferret_sera_escape": 0.03193, "mature_H5_site": 503, "mouse_sera_escape": 0.06761, "mutant": "E", "mutation": "S503E", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.09155, "wildtype": "S"}, {"a26_usage": 0.03386, "cell_entry": -0.2629, "ferret_sera_escape": 0.04586, "mature_H5_site": 503, "mouse_sera_escape": 0.05471, "mutant": "F", "mutation": "S503F", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": -0.06583, "wildtype": "S"}, {"a26_usage": 0.1635, "cell_entry": 0.05104, "ferret_sera_escape": -0.01745, "mature_H5_site": 503, "mouse_sera_escape": -0.03265, "mutant": "G", "mutation": "S503G", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": -0.02308, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.003905, "ferret_sera_escape": -0.07855, "mature_H5_site": 503, "mouse_sera_escape": -0.09125, "mutant": "H", "mutation": "S503H", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.05291, "wildtype": "S"}, {"a26_usage": 0.7656, "cell_entry": -0.1962, "ferret_sera_escape": -0.07462, "mature_H5_site": 503, "mouse_sera_escape": -0.06238, "mutant": "I", "mutation": "S503I", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": -0.01172, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.917, "ferret_sera_escape": -0.1199, "mature_H5_site": 503, "mouse_sera_escape": null, "mutant": "L", "mutation": "S503L", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1007, "ferret_sera_escape": 0.02077, "mature_H5_site": 503, "mouse_sera_escape": -0.05164, "mutant": "N", "mutation": "S503N", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": -0.1379, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2142, "ferret_sera_escape": 0.01478, "mature_H5_site": 503, "mouse_sera_escape": 0.04623, "mutant": "P", "mutation": "S503P", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.001422, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.06417, "ferret_sera_escape": -0.001078, "mature_H5_site": 503, "mouse_sera_escape": -0.03393, "mutant": "Q", "mutation": "S503Q", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.04319, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1256, "ferret_sera_escape": 0.01205, "mature_H5_site": 503, "mouse_sera_escape": 0.04446, "mutant": "R", "mutation": "S503R", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": -0.03213, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 503, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S503S", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.05039, "ferret_sera_escape": 0.08302, "mature_H5_site": 503, "mouse_sera_escape": -0.04205, "mutant": "V", "mutation": "S503V", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.04156, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.01874, "ferret_sera_escape": -0.1036, "mature_H5_site": 503, "mouse_sera_escape": -0.02621, "mutant": "Y", "mutation": "S503Y", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": -0.06744, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.05732, "ferret_sera_escape": 0.06392, "mature_H5_site": 504, "mouse_sera_escape": 0.06609, "mutant": "A", "mutation": "G504A", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.815, "ferret_sera_escape": null, "mature_H5_site": 504, "mouse_sera_escape": null, "mutant": "C", "mutation": "G504C", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3519, "ferret_sera_escape": -0.009363, "mature_H5_site": 504, "mouse_sera_escape": 0.02818, "mutant": "D", "mutation": "G504D", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": -0.04488, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4668, "ferret_sera_escape": 0.0523, "mature_H5_site": 504, "mouse_sera_escape": 0.07541, "mutant": "F", "mutation": "G504F", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": 0.04933, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 504, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G504G", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.069, "ferret_sera_escape": 0.08569, "mature_H5_site": 504, "mouse_sera_escape": -0.04596, "mutant": "I", "mutation": "G504I", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": 0.009294, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5598, "ferret_sera_escape": 0.2261, "mature_H5_site": 504, "mouse_sera_escape": 0.09849, "mutant": "K", "mutation": "G504K", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": -0.06818, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3764, "ferret_sera_escape": 0.008366, "mature_H5_site": 504, "mouse_sera_escape": 0.08214, "mutant": "M", "mutation": "G504M", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": -0.02725, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3606, "ferret_sera_escape": -0.2058, "mature_H5_site": 504, "mouse_sera_escape": -0.02896, "mutant": "N", "mutation": "G504N", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": -0.06239, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1082, "ferret_sera_escape": -0.0222, "mature_H5_site": 504, "mouse_sera_escape": -0.1717, "mutant": "P", "mutation": "G504P", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": -0.07532, "wildtype": "G"}, {"a26_usage": 0.1426, "cell_entry": -0.5511, "ferret_sera_escape": 0.01622, "mature_H5_site": 504, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G504Q", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.0628, "ferret_sera_escape": -0.06453, "mature_H5_site": 504, "mouse_sera_escape": -0.06225, "mutant": "R", "mutation": "G504R", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.05533, "ferret_sera_escape": 0.003407, "mature_H5_site": 504, "mouse_sera_escape": -0.001358, "mutant": "S", "mutation": "G504S", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.254, "ferret_sera_escape": -0.0273, "mature_H5_site": 504, "mouse_sera_escape": -0.08314, "mutant": "T", "mutation": "G504T", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": -0.03242, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2858, "ferret_sera_escape": 0.1493, "mature_H5_site": 504, "mouse_sera_escape": -0.005065, "mutant": "V", "mutation": "G504V", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": 3.585e-05, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.6058, "ferret_sera_escape": 0.01672, "mature_H5_site": 504, "mouse_sera_escape": 0.1636, "mutant": "W", "mutation": "G504W", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": 0.01375, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.7, "ferret_sera_escape": 0.1483, "mature_H5_site": 504, "mouse_sera_escape": 0.08495, "mutant": "Y", "mutation": "G504Y", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": -0.03892, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.03402, "ferret_sera_escape": 0.0124, "mature_H5_site": 505, "mouse_sera_escape": 0.0944, "mutant": "A", "mutation": "V505A", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": -0.04235, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.535, "ferret_sera_escape": null, "mature_H5_site": 505, "mouse_sera_escape": null, "mutant": "D", "mutation": "V505D", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.102, "ferret_sera_escape": 0.2263, "mature_H5_site": 505, "mouse_sera_escape": 0.468, "mutant": "E", "mutation": "V505E", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1692, "ferret_sera_escape": 0.07562, "mature_H5_site": 505, "mouse_sera_escape": 0.03655, "mutant": "F", "mutation": "V505F", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": -0.08812, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.837, "ferret_sera_escape": 0.5868, "mature_H5_site": 505, "mouse_sera_escape": 0.1202, "mutant": "G", "mutation": "V505G", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3118, "ferret_sera_escape": 0.08436, "mature_H5_site": 505, "mouse_sera_escape": -0.00542, "mutant": "I", "mutation": "V505I", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": 0.01134, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.448, "ferret_sera_escape": -0.2066, "mature_H5_site": 505, "mouse_sera_escape": 0.2504, "mutant": "K", "mutation": "V505K", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": -0.02584, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.06217, "ferret_sera_escape": 0.009382, "mature_H5_site": 505, "mouse_sera_escape": 0.08648, "mutant": "L", "mutation": "V505L", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": -0.01124, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8361, "ferret_sera_escape": 0.1321, "mature_H5_site": 505, "mouse_sera_escape": 0.2844, "mutant": "M", "mutation": "V505M", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": 0.0294, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.893, "ferret_sera_escape": null, "mature_H5_site": 505, "mouse_sera_escape": null, "mutant": "N", "mutation": "V505N", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.583, "ferret_sera_escape": 0.435, "mature_H5_site": 505, "mouse_sera_escape": 0.2979, "mutant": "P", "mutation": "V505P", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.424, "ferret_sera_escape": null, "mature_H5_site": 505, "mouse_sera_escape": null, "mutant": "S", "mutation": "V505S", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.263, "ferret_sera_escape": 0.0613, "mature_H5_site": 505, "mouse_sera_escape": 0.1087, "mutant": "T", "mutation": "V505T", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": -0.02737, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 505, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V505V", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.982, "ferret_sera_escape": -0.08405, "mature_H5_site": 505, "mouse_sera_escape": 0.3145, "mutant": "W", "mutation": "V505W", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": 0.04164, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2801, "ferret_sera_escape": 0.2156, "mature_H5_site": 506, "mouse_sera_escape": 0.1254, "mutant": "A", "mutation": "K506A", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.01909, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 506, "mouse_sera_escape": null, "mutant": "C", "mutation": "K506C", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5555, "ferret_sera_escape": 0.01711, "mature_H5_site": 506, "mouse_sera_escape": 0.007777, "mutant": "D", "mutation": "K506D", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.02175, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.111, "ferret_sera_escape": -0.1844, "mature_H5_site": 506, "mouse_sera_escape": 0.03259, "mutant": "E", "mutation": "K506E", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": -0.02939, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8389, "ferret_sera_escape": -0.07956, "mature_H5_site": 506, "mouse_sera_escape": 0.1683, "mutant": "F", "mutation": "K506F", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.02451, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1898, "ferret_sera_escape": -0.02713, "mature_H5_site": 506, "mouse_sera_escape": 0.004165, "mutant": "H", "mutation": "K506H", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": -0.05507, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8564, "ferret_sera_escape": 0.05164, "mature_H5_site": 506, "mouse_sera_escape": 0.02767, "mutant": "I", "mutation": "K506I", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": -0.08819, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 506, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K506K", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.9919, "cell_entry": -0.06916, "ferret_sera_escape": 0.2102, "mature_H5_site": 506, "mouse_sera_escape": 0.02239, "mutant": "M", "mutation": "K506M", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": -0.1297, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7509, "ferret_sera_escape": -0.02698, "mature_H5_site": 506, "mouse_sera_escape": 0.1334, "mutant": "N", "mutation": "K506N", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.09542, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.212, "ferret_sera_escape": 0.1471, "mature_H5_site": 506, "mouse_sera_escape": 0.08896, "mutant": "P", "mutation": "K506P", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.008369, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3191, "ferret_sera_escape": 0.08631, "mature_H5_site": 506, "mouse_sera_escape": 0.07484, "mutant": "Q", "mutation": "K506Q", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.0003654, "wildtype": "K"}, {"a26_usage": 0.05841, "cell_entry": -0.3658, "ferret_sera_escape": -0.01978, "mature_H5_site": 506, "mouse_sera_escape": -0.07413, "mutant": "R", "mutation": "K506R", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": -0.002218, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.9623, "ferret_sera_escape": null, "mature_H5_site": 506, "mouse_sera_escape": null, "mutant": "S", "mutation": "K506S", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": null, "wildtype": "K"}, {"a26_usage": 0.198, "cell_entry": -0.2971, "ferret_sera_escape": -0.0455, "mature_H5_site": 506, "mouse_sera_escape": 0.02168, "mutant": "T", "mutation": "K506T", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": -0.06678, "wildtype": "K"}, {"a26_usage": 0.1785, "cell_entry": -0.04565, "ferret_sera_escape": 0.06315, "mature_H5_site": 506, "mouse_sera_escape": 0.08551, "mutant": "V", "mutation": "K506V", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.02307, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.151, "ferret_sera_escape": 0.08529, "mature_H5_site": 506, "mouse_sera_escape": 0.02414, "mutant": "W", "mutation": "K506W", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.01206, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2867, "ferret_sera_escape": -0.1766, "mature_H5_site": 506, "mouse_sera_escape": -0.06706, "mutant": "Y", "mutation": "K506Y", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.01501, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7611, "ferret_sera_escape": -0.226, "mature_H5_site": 507, "mouse_sera_escape": 0.468, "mutant": "A", "mutation": "L507A", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.637, "ferret_sera_escape": null, "mature_H5_site": 507, "mouse_sera_escape": null, "mutant": "C", "mutation": "L507C", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.528, "ferret_sera_escape": null, "mature_H5_site": 507, "mouse_sera_escape": null, "mutant": "D", "mutation": "L507D", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.467, "ferret_sera_escape": null, "mature_H5_site": 507, "mouse_sera_escape": null, "mutant": "E", "mutation": "L507E", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.454, "ferret_sera_escape": -0.122, "mature_H5_site": 507, "mouse_sera_escape": null, "mutant": "G", "mutation": "L507G", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.02697, "ferret_sera_escape": -0.02433, "mature_H5_site": 507, "mouse_sera_escape": 0.006116, "mutant": "I", "mutation": "L507I", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": 0.03806, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.563, "ferret_sera_escape": 0.07523, "mature_H5_site": 507, "mouse_sera_escape": 0.5783, "mutant": "K", "mutation": "L507K", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": 0.1802, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 507, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L507L", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2904, "ferret_sera_escape": -0.08014, "mature_H5_site": 507, "mouse_sera_escape": -0.03673, "mutant": "M", "mutation": "L507M", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": -0.01705, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 507, "mouse_sera_escape": null, "mutant": "N", "mutation": "L507N", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.713, "ferret_sera_escape": null, "mature_H5_site": 507, "mouse_sera_escape": 0.1814, "mutant": "P", "mutation": "L507P", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": -0.0008649, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.672, "ferret_sera_escape": -0.262, "mature_H5_site": 507, "mouse_sera_escape": 0.09086, "mutant": "Q", "mutation": "L507Q", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": 0.04313, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.826, "ferret_sera_escape": 0.05231, "mature_H5_site": 507, "mouse_sera_escape": 0.5728, "mutant": "R", "mutation": "L507R", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": 0.07686, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.036, "ferret_sera_escape": -0.2052, "mature_H5_site": 507, "mouse_sera_escape": 0.2425, "mutant": "T", "mutation": "L507T", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": -0.01721, "wildtype": "L"}, {"a26_usage": 0.1517, "cell_entry": -0.2207, "ferret_sera_escape": 0.07788, "mature_H5_site": 507, "mouse_sera_escape": 0.04654, "mutant": "W", "mutation": "L507W", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": 0.02518, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3744, "ferret_sera_escape": 0.01269, "mature_H5_site": 507, "mouse_sera_escape": 0.01849, "mutant": "Y", "mutation": "L507Y", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": -0.001028, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.006375, "ferret_sera_escape": 0.1201, "mature_H5_site": 508, "mouse_sera_escape": 0.1116, "mutant": "D", "mutation": "E508D", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -9.588e-05, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 508, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E508E", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1684, "ferret_sera_escape": -0.136, "mature_H5_site": 508, "mouse_sera_escape": 0.08272, "mutant": "F", "mutation": "E508F", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": 0.01314, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.057, "ferret_sera_escape": -0.03038, "mature_H5_site": 508, "mouse_sera_escape": 0.2883, "mutant": "G", "mutation": "E508G", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": 0.001093, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.381, "ferret_sera_escape": -0.1676, "mature_H5_site": 508, "mouse_sera_escape": 0.2847, "mutant": "H", "mutation": "E508H", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.05666, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.091, "ferret_sera_escape": -0.01054, "mature_H5_site": 508, "mouse_sera_escape": 0.1304, "mutant": "I", "mutation": "E508I", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.01765, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.386, "ferret_sera_escape": -0.1646, "mature_H5_site": 508, "mouse_sera_escape": 0.1333, "mutant": "K", "mutation": "E508K", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.04404, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.464, "ferret_sera_escape": 0.1714, "mature_H5_site": 508, "mouse_sera_escape": 0.3026, "mutant": "M", "mutation": "E508M", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.05226, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3241, "ferret_sera_escape": 0.04772, "mature_H5_site": 508, "mouse_sera_escape": 0.2647, "mutant": "N", "mutation": "E508N", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.03382, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.48, "ferret_sera_escape": -0.2164, "mature_H5_site": 508, "mouse_sera_escape": 0.4627, "mutant": "P", "mutation": "E508P", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.899, "ferret_sera_escape": 0.1415, "mature_H5_site": 508, "mouse_sera_escape": 0.2939, "mutant": "R", "mutation": "E508R", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": null, "wildtype": "E"}, {"a26_usage": 0.1631, "cell_entry": -0.4898, "ferret_sera_escape": 0.001213, "mature_H5_site": 508, "mouse_sera_escape": 0.3305, "mutant": "S", "mutation": "E508S", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.04487, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5888, "ferret_sera_escape": -0.1116, "mature_H5_site": 508, "mouse_sera_escape": 0.176, "mutant": "T", "mutation": "E508T", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.08488, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4438, "ferret_sera_escape": -0.01796, "mature_H5_site": 508, "mouse_sera_escape": -0.005396, "mutant": "V", "mutation": "E508V", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.07226, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.08527, "ferret_sera_escape": -0.00384, "mature_H5_site": 508, "mouse_sera_escape": 0.05229, "mutant": "W", "mutation": "E508W", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.09781, "wildtype": "E"}, {"a26_usage": 0.368, "cell_entry": -0.3224, "ferret_sera_escape": 0.1549, "mature_H5_site": 508, "mouse_sera_escape": 0.1134, "mutant": "Y", "mutation": "E508Y", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.01296, "wildtype": "E"}, {"a26_usage": 0.1364, "cell_entry": -0.7495, "ferret_sera_escape": null, "mature_H5_site": 509, "mouse_sera_escape": null, "mutant": "A", "mutation": "S509A", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.365, "ferret_sera_escape": 0.003113, "mature_H5_site": 509, "mouse_sera_escape": 0.03644, "mutant": "C", "mutation": "S509C", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": 0.007373, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2337, "ferret_sera_escape": -0.01025, "mature_H5_site": 509, "mouse_sera_escape": -0.0007425, "mutant": "D", "mutation": "S509D", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": 0.02555, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.003676, "ferret_sera_escape": 0.02664, "mature_H5_site": 509, "mouse_sera_escape": 0.01155, "mutant": "F", "mutation": "S509F", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": -0.003255, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.165, "ferret_sera_escape": -0.04879, "mature_H5_site": 509, "mouse_sera_escape": 0.05237, "mutant": "G", "mutation": "S509G", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": 0.01793, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4995, "ferret_sera_escape": 0.08269, "mature_H5_site": 509, "mouse_sera_escape": 0.009296, "mutant": "H", "mutation": "S509H", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": 0.0003993, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.000925, "ferret_sera_escape": -0.04515, "mature_H5_site": 509, "mouse_sera_escape": -0.004216, "mutant": "I", "mutation": "S509I", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": -0.03007, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3224, "ferret_sera_escape": -0.01915, "mature_H5_site": 509, "mouse_sera_escape": -0.08704, "mutant": "K", "mutation": "S509K", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": null, "wildtype": "S"}, {"a26_usage": 0.08801, "cell_entry": 0.05769, "ferret_sera_escape": 0.1405, "mature_H5_site": 509, "mouse_sera_escape": 0.03903, "mutant": "M", "mutation": "S509M", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": -0.04056, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.198, "ferret_sera_escape": 0.01604, "mature_H5_site": 509, "mouse_sera_escape": -0.0284, "mutant": "N", "mutation": "S509N", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": -0.01941, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4033, "ferret_sera_escape": -0.2101, "mature_H5_site": 509, "mouse_sera_escape": -0.0494, "mutant": "P", "mutation": "S509P", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": -0.04379, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.04827, "ferret_sera_escape": -0.07628, "mature_H5_site": 509, "mouse_sera_escape": -0.06158, "mutant": "Q", "mutation": "S509Q", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": 0.005277, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2289, "ferret_sera_escape": -0.0157, "mature_H5_site": 509, "mouse_sera_escape": -0.08389, "mutant": "R", "mutation": "S509R", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": -0.0473, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 509, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S509S", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.386, "ferret_sera_escape": -0.1378, "mature_H5_site": 509, "mouse_sera_escape": -0.07037, "mutant": "V", "mutation": "S509V", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": -0.03548, "wildtype": "S"}, {"a26_usage": 0.2096, "cell_entry": -0.1222, "ferret_sera_escape": 0.1182, "mature_H5_site": 509, "mouse_sera_escape": null, "mutant": "W", "mutation": "S509W", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0102, "cell_entry": 0.001205, "ferret_sera_escape": 0.02727, "mature_H5_site": 509, "mouse_sera_escape": -0.05867, "mutant": "Y", "mutation": "S509Y", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": 0.002686, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.887, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "C", "mutation": "L51C", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "D", "mutation": "L51D", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.856, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "E", "mutation": "L51E", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1445, "ferret_sera_escape": 0.008463, "mature_H5_site": 41, "mouse_sera_escape": 0.1418, "mutant": "F", "mutation": "L51F", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": -0.403, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.524, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "G", "mutation": "L51G", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.897, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "H", "mutation": "L51H", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2439, "ferret_sera_escape": 0.0098, "mature_H5_site": 41, "mouse_sera_escape": 0.1449, "mutant": "I", "mutation": "L51I", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": 1.43, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "K", "mutation": "L51K", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 41, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L51L", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.04328, "ferret_sera_escape": -0.00247, "mature_H5_site": 41, "mouse_sera_escape": 0.2604, "mutant": "M", "mutation": "L51M", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": -0.01392, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.874, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "P", "mutation": "L51P", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L51Q", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "R", "mutation": "L51R", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.462, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "V", "mutation": "L51V", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.975, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "W", "mutation": "L51W", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.5245, "cell_entry": -1.859, "ferret_sera_escape": null, "mature_H5_site": 510, "mouse_sera_escape": null, "mutant": "A", "mutation": "V510A", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.15, "ferret_sera_escape": -0.04497, "mature_H5_site": 510, "mouse_sera_escape": -0.04155, "mutant": "C", "mutation": "V510C", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.9661, "ferret_sera_escape": 0.008653, "mature_H5_site": 510, "mouse_sera_escape": -0.01954, "mutant": "D", "mutation": "V510D", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": -0.0182, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3661, "ferret_sera_escape": -0.2229, "mature_H5_site": 510, "mouse_sera_escape": -0.1579, "mutant": "E", "mutation": "V510E", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": -0.02867, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6906, "ferret_sera_escape": 0.06481, "mature_H5_site": 510, "mouse_sera_escape": 0.02693, "mutant": "F", "mutation": "V510F", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": 0.002531, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2837, "ferret_sera_escape": 0.06022, "mature_H5_site": 510, "mouse_sera_escape": 0.05009, "mutant": "G", "mutation": "V510G", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": 0.0111, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.01828, "ferret_sera_escape": null, "mature_H5_site": 510, "mouse_sera_escape": null, "mutant": "I", "mutation": "V510I", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.607, "ferret_sera_escape": -0.04586, "mature_H5_site": 510, "mouse_sera_escape": 0.2198, "mutant": "K", "mutation": "V510K", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": -0.0009203, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4676, "ferret_sera_escape": 0.09453, "mature_H5_site": 510, "mouse_sera_escape": 0.08553, "mutant": "L", "mutation": "V510L", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": 0.04141, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2118, "ferret_sera_escape": 0.06007, "mature_H5_site": 510, "mouse_sera_escape": 0.1131, "mutant": "M", "mutation": "V510M", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": -0.03658, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8712, "ferret_sera_escape": 0.1053, "mature_H5_site": 510, "mouse_sera_escape": 0.2842, "mutant": "N", "mutation": "V510N", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.04129, "ferret_sera_escape": 0.04684, "mature_H5_site": 510, "mouse_sera_escape": 0.06849, "mutant": "Q", "mutation": "V510Q", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": -0.04402, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.656, "ferret_sera_escape": -0.091, "mature_H5_site": 510, "mouse_sera_escape": 0.0402, "mutant": "R", "mutation": "V510R", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": -0.01594, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.459, "ferret_sera_escape": -0.002067, "mature_H5_site": 510, "mouse_sera_escape": -0.1239, "mutant": "S", "mutation": "V510S", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.03982, "ferret_sera_escape": -0.04552, "mature_H5_site": 510, "mouse_sera_escape": 0.002845, "mutant": "T", "mutation": "V510T", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": 0.02783, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 510, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V510V", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1841, "ferret_sera_escape": 0.1097, "mature_H5_site": 510, "mouse_sera_escape": null, "mutant": "W", "mutation": "V510W", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2478, "ferret_sera_escape": null, "mature_H5_site": 510, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V510Y", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": null, "wildtype": "V"}, {"a26_usage": 0.2929, "cell_entry": 0.06809, "ferret_sera_escape": -0.03894, "mature_H5_site": 511, "mouse_sera_escape": 0.0508, "mutant": "A", "mutation": "G510aA", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.01433, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.375, "ferret_sera_escape": -0.1084, "mature_H5_site": 511, "mouse_sera_escape": -0.08608, "mutant": "C", "mutation": "G510aC", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1301, "ferret_sera_escape": -0.03727, "mature_H5_site": 511, "mouse_sera_escape": -0.01707, "mutant": "D", "mutation": "G510aD", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.05768, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5626, "ferret_sera_escape": null, "mature_H5_site": 511, "mouse_sera_escape": null, "mutant": "E", "mutation": "G510aE", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": null, "wildtype": "G"}, {"a26_usage": 0.3861, "cell_entry": -0.1437, "ferret_sera_escape": 0.007317, "mature_H5_site": 511, "mouse_sera_escape": 0.04277, "mutant": "F", "mutation": "G510aF", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 511, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G510aG", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.086, "ferret_sera_escape": 0.1483, "mature_H5_site": 511, "mouse_sera_escape": 0.06689, "mutant": "H", "mutation": "G510aH", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": 0.03107, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3814, "ferret_sera_escape": 0.03268, "mature_H5_site": 511, "mouse_sera_escape": 0.02375, "mutant": "I", "mutation": "G510aI", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.01112, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.003, "ferret_sera_escape": 0.2477, "mature_H5_site": 511, "mouse_sera_escape": 0.06612, "mutant": "K", "mutation": "G510aK", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.01837, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2961, "ferret_sera_escape": 0.07288, "mature_H5_site": 511, "mouse_sera_escape": 0.06369, "mutant": "L", "mutation": "G510aL", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.06493, "wildtype": "G"}, {"a26_usage": 0.3723, "cell_entry": 0.0516, "ferret_sera_escape": 0.1099, "mature_H5_site": 511, "mouse_sera_escape": 0.1376, "mutant": "M", "mutation": "G510aM", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.01059, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.09419, "ferret_sera_escape": 0.1027, "mature_H5_site": 511, "mouse_sera_escape": 0.01273, "mutant": "N", "mutation": "G510aN", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.04352, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.172, "ferret_sera_escape": -0.1075, "mature_H5_site": 511, "mouse_sera_escape": 0.08178, "mutant": "P", "mutation": "G510aP", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.08209, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5129, "ferret_sera_escape": 0.008033, "mature_H5_site": 511, "mouse_sera_escape": 0.09427, "mutant": "Q", "mutation": "G510aQ", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.01559, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.353, "ferret_sera_escape": 0.1284, "mature_H5_site": 511, "mouse_sera_escape": 0.1345, "mutant": "R", "mutation": "G510aR", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": 0.01657, "wildtype": "G"}, {"a26_usage": 0.1862, "cell_entry": -0.1341, "ferret_sera_escape": -0.06036, "mature_H5_site": 511, "mouse_sera_escape": 0.04504, "mutant": "S", "mutation": "G510aS", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.03931, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.07283, "ferret_sera_escape": -0.01964, "mature_H5_site": 511, "mouse_sera_escape": -0.08027, "mutant": "V", "mutation": "G510aV", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.01072, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3565, "ferret_sera_escape": -0.07072, "mature_H5_site": 511, "mouse_sera_escape": -0.07683, "mutant": "W", "mutation": "G510aW", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.04715, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.916, "ferret_sera_escape": 0.01132, "mature_H5_site": 511, "mouse_sera_escape": 0.1039, "mutant": "Y", "mutation": "G510aY", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.05457, "ferret_sera_escape": null, "mature_H5_site": 512, "mouse_sera_escape": null, "mutant": "A", "mutation": "T511A", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.9057, "ferret_sera_escape": null, "mature_H5_site": 512, "mouse_sera_escape": null, "mutant": "C", "mutation": "T511C", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.437, "ferret_sera_escape": -0.1208, "mature_H5_site": 512, "mouse_sera_escape": -0.08603, "mutant": "D", "mutation": "T511D", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.1684, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.442, "ferret_sera_escape": null, "mature_H5_site": 512, "mouse_sera_escape": null, "mutant": "E", "mutation": "T511E", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": null, "wildtype": "T"}, {"a26_usage": 0.03281, "cell_entry": -0.01387, "ferret_sera_escape": -0.1172, "mature_H5_site": 512, "mouse_sera_escape": -0.1298, "mutant": "F", "mutation": "T511F", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.0748, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.508, "ferret_sera_escape": -0.2099, "mature_H5_site": 512, "mouse_sera_escape": 0.1008, "mutant": "G", "mutation": "T511G", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.06247, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.369, "ferret_sera_escape": -0.06052, "mature_H5_site": 512, "mouse_sera_escape": 0.1529, "mutant": "H", "mutation": "T511H", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.06475, "ferret_sera_escape": -0.05092, "mature_H5_site": 512, "mouse_sera_escape": -0.09524, "mutant": "I", "mutation": "T511I", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.1076, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.461, "ferret_sera_escape": -0.1218, "mature_H5_site": 512, "mouse_sera_escape": 0.04653, "mutant": "K", "mutation": "T511K", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.06592, "wildtype": "T"}, {"a26_usage": 0.1879, "cell_entry": -0.4985, "ferret_sera_escape": null, "mature_H5_site": 512, "mouse_sera_escape": null, "mutant": "L", "mutation": "T511L", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2211, "ferret_sera_escape": 0.07193, "mature_H5_site": 512, "mouse_sera_escape": 0.05634, "mutant": "M", "mutation": "T511M", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": 0.0199, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.9485, "ferret_sera_escape": -0.2285, "mature_H5_site": 512, "mouse_sera_escape": -0.1905, "mutant": "N", "mutation": "T511N", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.09634, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1322, "ferret_sera_escape": -0.08752, "mature_H5_site": 512, "mouse_sera_escape": -0.07357, "mutant": "P", "mutation": "T511P", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.1155, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.334, "ferret_sera_escape": null, "mature_H5_site": 512, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T511Q", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.465, "ferret_sera_escape": -0.2832, "mature_H5_site": 512, "mouse_sera_escape": -0.06317, "mutant": "R", "mutation": "T511R", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.0492, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.01817, "ferret_sera_escape": -0.2837, "mature_H5_site": 512, "mouse_sera_escape": -0.1498, "mutant": "S", "mutation": "T511S", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.1041, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 512, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T511T", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.06309, "ferret_sera_escape": 0.1191, "mature_H5_site": 512, "mouse_sera_escape": 0.03597, "mutant": "V", "mutation": "T511V", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": 0.004565, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.07134, "ferret_sera_escape": -0.1377, "mature_H5_site": 512, "mouse_sera_escape": -0.1268, "mutant": "W", "mutation": "T511W", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.0296, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.09866, "ferret_sera_escape": -0.05766, "mature_H5_site": 512, "mouse_sera_escape": 0.04567, "mutant": "Y", "mutation": "T511Y", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.01649, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.883, "ferret_sera_escape": -0.1387, "mature_H5_site": 513, "mouse_sera_escape": 0.06671, "mutant": "A", "mutation": "Y512A", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.01577, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.566, "ferret_sera_escape": 0.006183, "mature_H5_site": 513, "mouse_sera_escape": 0.03772, "mutant": "C", "mutation": "Y512C", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": 0.04777, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.984, "ferret_sera_escape": 0.01782, "mature_H5_site": 513, "mouse_sera_escape": -0.1418, "mutant": "D", "mutation": "Y512D", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.1266, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.404, "ferret_sera_escape": -0.1593, "mature_H5_site": 513, "mouse_sera_escape": -0.1344, "mutant": "E", "mutation": "Y512E", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.2295, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.01194, "ferret_sera_escape": -0.02168, "mature_H5_site": 513, "mouse_sera_escape": 0.007416, "mutant": "F", "mutation": "Y512F", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.068, "ferret_sera_escape": -0.1544, "mature_H5_site": 513, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y512G", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.04843, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.412, "ferret_sera_escape": -0.1386, "mature_H5_site": 513, "mouse_sera_escape": 0.03352, "mutant": "H", "mutation": "Y512H", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.1151, "wildtype": "Y"}, {"a26_usage": 0.4196, "cell_entry": -0.5964, "ferret_sera_escape": -0.09143, "mature_H5_site": 513, "mouse_sera_escape": 0.008771, "mutant": "I", "mutation": "Y512I", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.02466, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 513, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y512K", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.00766, "ferret_sera_escape": 0.2784, "mature_H5_site": 513, "mouse_sera_escape": 0.09211, "mutant": "L", "mutation": "Y512L", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6298, "ferret_sera_escape": 0.0525, "mature_H5_site": 513, "mouse_sera_escape": -0.01134, "mutant": "M", "mutation": "Y512M", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.07149, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.681, "ferret_sera_escape": -0.2002, "mature_H5_site": 513, "mouse_sera_escape": -0.04486, "mutant": "P", "mutation": "Y512P", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7171, "ferret_sera_escape": -0.1043, "mature_H5_site": 513, "mouse_sera_escape": -0.08892, "mutant": "Q", "mutation": "Y512Q", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.1152, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.591, "ferret_sera_escape": null, "mature_H5_site": 513, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y512R", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4365, "ferret_sera_escape": 0.002081, "mature_H5_site": 513, "mouse_sera_escape": 0.07524, "mutant": "T", "mutation": "Y512T", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7799, "ferret_sera_escape": -0.1013, "mature_H5_site": 513, "mouse_sera_escape": 0.02572, "mutant": "V", "mutation": "Y512V", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.07286, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.06133, "ferret_sera_escape": -0.01216, "mature_H5_site": 513, "mouse_sera_escape": 0.01783, "mutant": "W", "mutation": "Y512W", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.006573, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 513, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y512Y", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6407, "ferret_sera_escape": 0.01753, "mature_H5_site": 514, "mouse_sera_escape": 0.06685, "mutant": "A", "mutation": "Q513A", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.001842, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.848, "ferret_sera_escape": -0.01108, "mature_H5_site": 514, "mouse_sera_escape": -0.082, "mutant": "C", "mutation": "Q513C", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": 0.02226, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.837, "ferret_sera_escape": -0.2386, "mature_H5_site": 514, "mouse_sera_escape": 0.04464, "mutant": "D", "mutation": "Q513D", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.07119, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2224, "ferret_sera_escape": 0.02254, "mature_H5_site": 514, "mouse_sera_escape": 0.0514, "mutant": "E", "mutation": "Q513E", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.0005322, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2705, "ferret_sera_escape": 0.01134, "mature_H5_site": 514, "mouse_sera_escape": 0.01262, "mutant": "F", "mutation": "Q513F", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.00971, "wildtype": "Q"}, {"a26_usage": 0.05897, "cell_entry": -0.4027, "ferret_sera_escape": 0.09066, "mature_H5_site": 514, "mouse_sera_escape": 0.07207, "mutant": "H", "mutation": "Q513H", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.02499, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.166, "ferret_sera_escape": -0.1675, "mature_H5_site": 514, "mouse_sera_escape": -0.1703, "mutant": "I", "mutation": "Q513I", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.577, "ferret_sera_escape": -0.1852, "mature_H5_site": 514, "mouse_sera_escape": 0.07874, "mutant": "K", "mutation": "Q513K", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": 0.1466, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.03, "ferret_sera_escape": -0.09911, "mature_H5_site": 514, "mouse_sera_escape": 0.09479, "mutant": "L", "mutation": "Q513L", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.003031, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.02108, "ferret_sera_escape": 0.04419, "mature_H5_site": 514, "mouse_sera_escape": 0.05485, "mutant": "M", "mutation": "Q513M", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": 0.08596, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.7373, "ferret_sera_escape": -0.09377, "mature_H5_site": 514, "mouse_sera_escape": -0.07384, "mutant": "N", "mutation": "Q513N", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.1336, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.946, "ferret_sera_escape": -0.1685, "mature_H5_site": 514, "mouse_sera_escape": -0.02188, "mutant": "P", "mutation": "Q513P", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.1162, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 514, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q513Q", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.167, "ferret_sera_escape": -0.2429, "mature_H5_site": 514, "mouse_sera_escape": null, "mutant": "R", "mutation": "Q513R", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": 0.05072, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.828, "ferret_sera_escape": -0.1018, "mature_H5_site": 514, "mouse_sera_escape": 0.01658, "mutant": "S", "mutation": "Q513S", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.04283, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5694, "ferret_sera_escape": -0.0485, "mature_H5_site": 514, "mouse_sera_escape": 0.1052, "mutant": "T", "mutation": "Q513T", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.07026, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.8354, "ferret_sera_escape": -0.07323, "mature_H5_site": 514, "mouse_sera_escape": 0.007949, "mutant": "V", "mutation": "Q513V", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.8107, "cell_entry": -0.2589, "ferret_sera_escape": 0.09078, "mature_H5_site": 514, "mouse_sera_escape": 0.1974, "mutant": "W", "mutation": "Q513W", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.02129, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.395, "ferret_sera_escape": 0.0579, "mature_H5_site": 514, "mouse_sera_escape": 0.1166, "mutant": "Y", "mutation": "Q513Y", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": 0.05894, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5839, "ferret_sera_escape": 0.03564, "mature_H5_site": 515, "mouse_sera_escape": 0.2317, "mutant": "A", "mutation": "I514A", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": -0.0007493, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.082, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "C", "mutation": "I514C", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.793, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "D", "mutation": "I514D", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "E", "mutation": "I514E", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.5658, "cell_entry": -0.4273, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": -0.04841, "mutant": "F", "mutation": "I514F", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.463, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "G", "mutation": "I514G", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 515, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I514I", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6142, "ferret_sera_escape": -0.1402, "mature_H5_site": 515, "mouse_sera_escape": 0.03719, "mutant": "L", "mutation": "I514L", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": -0.08699, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.9195, "ferret_sera_escape": -0.042, "mature_H5_site": 515, "mouse_sera_escape": 0.1383, "mutant": "M", "mutation": "I514M", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": -0.03779, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.869, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "N", "mutation": "I514N", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "P", "mutation": "I514P", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.448, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I514Q", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.433, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "R", "mutation": "I514R", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.191, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "S", "mutation": "I514S", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.16, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "T", "mutation": "I514T", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3844, "ferret_sera_escape": -0.08591, "mature_H5_site": 515, "mouse_sera_escape": -0.05638, "mutant": "Y", "mutation": "I514Y", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": -0.06811, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "A", "mutation": "L515A", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "C", "mutation": "L515C", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.887, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "D", "mutation": "L515D", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "E", "mutation": "L515E", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.748, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "F", "mutation": "L515F", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.274, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "G", "mutation": "L515G", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.565, "ferret_sera_escape": -0.3659, "mature_H5_site": 516, "mouse_sera_escape": -0.09073, "mutant": "I", "mutation": "L515I", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": -0.05267, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "K", "mutation": "L515K", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 516, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L515L", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.05149, "cell_entry": -0.01683, "ferret_sera_escape": -0.01808, "mature_H5_site": 516, "mouse_sera_escape": 0.08846, "mutant": "M", "mutation": "L515M", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": -0.004975, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.976, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "P", "mutation": "L515P", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L515Q", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "R", "mutation": "L515R", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.196, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "T", "mutation": "L515T", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.978, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "V", "mutation": "L515V", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.751, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L515Y", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.1984, "cell_entry": -0.6924, "ferret_sera_escape": null, "mature_H5_site": 517, "mouse_sera_escape": null, "mutant": "G", "mutation": "S516G", "reference_site": "516", "region": "HA2", "sequential_site": 533, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2904, "ferret_sera_escape": -0.00396, "mature_H5_site": 517, "mouse_sera_escape": -0.03884, "mutant": "N", "mutation": "S516N", "reference_site": "516", "region": "HA2", "sequential_site": 533, "stability": -0.02375, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.928, "ferret_sera_escape": null, "mature_H5_site": 517, "mouse_sera_escape": null, "mutant": "R", "mutation": "S516R", "reference_site": "516", "region": "HA2", "sequential_site": 533, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 517, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S516S", "reference_site": "516", "region": "HA2", "sequential_site": 533, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "C", "mutation": "I517C", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "D", "mutation": "I517D", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.867, "ferret_sera_escape": -0.07379, "mature_H5_site": 518, "mouse_sera_escape": -0.2079, "mutant": "F", "mutation": "I517F", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": -0.08813, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.89, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "G", "mutation": "I517G", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "H", "mutation": "I517H", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 518, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I517I", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "K", "mutation": "I517K", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.327, "ferret_sera_escape": -0.2523, "mature_H5_site": 518, "mouse_sera_escape": -0.2013, "mutant": "L", "mutation": "I517L", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.228, "ferret_sera_escape": -0.3295, "mature_H5_site": 518, "mouse_sera_escape": -0.2169, "mutant": "M", "mutation": "I517M", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": -0.09243, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.433, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "N", "mutation": "I517N", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "P", "mutation": "I517P", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I517Q", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.433, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "R", "mutation": "I517R", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.134, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "S", "mutation": "I517S", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "T", "mutation": "I517T", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3729, "ferret_sera_escape": 7.667e-05, "mature_H5_site": 518, "mouse_sera_escape": -0.01239, "mutant": "V", "mutation": "I517V", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": -0.05581, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4182, "ferret_sera_escape": -0.02016, "mature_H5_site": 518, "mouse_sera_escape": 0.008592, "mutant": "W", "mutation": "I517W", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": -0.1314, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.194, "ferret_sera_escape": -0.2095, "mature_H5_site": 518, "mouse_sera_escape": -0.06743, "mutant": "Y", "mutation": "I517Y", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": -0.1527, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y518A", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.046, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y518C", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.544, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y518E", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.479, "ferret_sera_escape": 0.04355, "mature_H5_site": 519, "mouse_sera_escape": -0.2162, "mutant": "F", "mutation": "Y518F", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": -0.0279, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y518G", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.449, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y518H", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y518I", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y518K", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y518L", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.765, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y518M", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y518N", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y518Q", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y518R", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.065, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y518S", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y518T", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.212, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y518V", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.01, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y518W", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 519, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y518Y", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.06183, "cell_entry": -0.2142, "ferret_sera_escape": 0.07071, "mature_H5_site": 520, "mouse_sera_escape": 0.1384, "mutant": "A", "mutation": "S519A", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "D", "mutation": "S519D", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "F", "mutation": "S519F", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6794, "ferret_sera_escape": -0.07214, "mature_H5_site": 520, "mouse_sera_escape": 0.02664, "mutant": "G", "mutation": "S519G", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": -0.05836, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.725, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "H", "mutation": "S519H", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.753, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "I", "mutation": "S519I", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "L", "mutation": "S519L", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.862, "ferret_sera_escape": -0.124, "mature_H5_site": 520, "mouse_sera_escape": 0.054, "mutant": "N", "mutation": "S519N", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": -0.1807, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "Q", "mutation": "S519Q", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.641, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "R", "mutation": "S519R", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 520, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S519S", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.469, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "W", "mutation": "S519W", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.897, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S519Y", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 42, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C52C", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "D", "mutation": "C52D", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.724, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "E", "mutation": "C52E", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "F", "mutation": "C52F", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "G", "mutation": "C52G", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "H", "mutation": "C52H", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.789, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "K", "mutation": "C52K", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "L", "mutation": "C52L", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "N", "mutation": "C52N", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.894, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "P", "mutation": "C52P", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.821, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "R", "mutation": "C52R", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "S", "mutation": "C52S", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "V", "mutation": "C52V", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "W", "mutation": "C52W", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.05, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C52Y", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.3999, "ferret_sera_escape": 0.01435, "mature_H5_site": 521, "mouse_sera_escape": -0.004358, "mutant": "A", "mutation": "T520A", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": 0.01948, "wildtype": "T"}, {"a26_usage": 0.3566, "cell_entry": 0.003055, "ferret_sera_escape": 0.06554, "mature_H5_site": 521, "mouse_sera_escape": 0.1019, "mutant": "C", "mutation": "T520C", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": 0.004768, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": null, "mutant": "D", "mutation": "T520D", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.649, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": null, "mutant": "E", "mutation": "T520E", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.546, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": -0.05049, "mutant": "G", "mutation": "T520G", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": -0.06212, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.99, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": null, "mutant": "H", "mutation": "T520H", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.275, "ferret_sera_escape": 0.1865, "mature_H5_site": 521, "mouse_sera_escape": -0.01959, "mutant": "I", "mutation": "T520I", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": 0.06272, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.89, "ferret_sera_escape": 0.01933, "mature_H5_site": 521, "mouse_sera_escape": -0.03885, "mutant": "M", "mutation": "T520M", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": 0.07973, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.032, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": null, "mutant": "N", "mutation": "T520N", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -6.049, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": null, "mutant": "P", "mutation": "T520P", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.123, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": null, "mutant": "R", "mutation": "T520R", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.913, "ferret_sera_escape": 0.00059, "mature_H5_site": 521, "mouse_sera_escape": -0.04408, "mutant": "S", "mutation": "T520S", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": -0.1007, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 521, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T520T", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7542, "ferret_sera_escape": 0.0003797, "mature_H5_site": 521, "mouse_sera_escape": -0.08142, "mutant": "V", "mutation": "T520V", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": -0.04749, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T520Y", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 522, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A521A", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2395, "ferret_sera_escape": -0.1913, "mature_H5_site": 522, "mouse_sera_escape": -0.08198, "mutant": "C", "mutation": "A521C", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "D", "mutation": "A521D", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.81, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "E", "mutation": "A521E", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.784, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "F", "mutation": "A521F", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7254, "ferret_sera_escape": -0.1418, "mature_H5_site": 522, "mouse_sera_escape": -0.1248, "mutant": "G", "mutation": "A521G", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": -0.08357, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "H", "mutation": "A521H", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "K", "mutation": "A521K", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.795, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "M", "mutation": "A521M", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.749, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "N", "mutation": "A521N", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "P", "mutation": "A521P", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A521Q", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "R", "mutation": "A521R", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.359, "ferret_sera_escape": -0.1845, "mature_H5_site": 522, "mouse_sera_escape": -0.2223, "mutant": "S", "mutation": "A521S", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": -0.06587, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.04, "ferret_sera_escape": 0.0144, "mature_H5_site": 522, "mouse_sera_escape": -0.01525, "mutant": "T", "mutation": "A521T", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": -0.09072, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5401, "ferret_sera_escape": 0.1352, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "V", "mutation": "A521V", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "W", "mutation": "A521W", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 523, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A522A", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.453, "ferret_sera_escape": 0.0169, "mature_H5_site": 523, "mouse_sera_escape": -0.03655, "mutant": "C", "mutation": "A522C", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": -0.05224, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "D", "mutation": "A522D", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "E", "mutation": "A522E", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "F", "mutation": "A522F", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "G", "mutation": "A522G", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "H", "mutation": "A522H", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.014, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "K", "mutation": "A522K", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.975, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "L", "mutation": "A522L", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.22, "ferret_sera_escape": -0.2558, "mature_H5_site": 523, "mouse_sera_escape": -0.2598, "mutant": "M", "mutation": "A522M", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": -0.149, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.881, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "N", "mutation": "A522N", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "P", "mutation": "A522P", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A522Q", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "R", "mutation": "A522R", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.862, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "S", "mutation": "A522S", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.805, "ferret_sera_escape": -0.1643, "mature_H5_site": 523, "mouse_sera_escape": 0.007194, "mutant": "T", "mutation": "A522T", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": -0.1423, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.237, "ferret_sera_escape": -0.07419, "mature_H5_site": 523, "mouse_sera_escape": -0.01635, "mutant": "V", "mutation": "A522V", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": -0.01953, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.013, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "W", "mutation": "A522W", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A522Y", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1254, "ferret_sera_escape": 0.003079, "mature_H5_site": 524, "mouse_sera_escape": -0.04788, "mutant": "A", "mutation": "S523A", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": -0.06016, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -6.014, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "C", "mutation": "S523C", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "D", "mutation": "S523D", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "E", "mutation": "S523E", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "F", "mutation": "S523F", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.704, "ferret_sera_escape": 0.3775, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "G", "mutation": "S523G", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": -0.03557, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "H", "mutation": "S523H", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.542, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "I", "mutation": "S523I", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "K", "mutation": "S523K", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -6.009, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "L", "mutation": "S523L", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.563, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "M", "mutation": "S523M", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "N", "mutation": "S523N", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.019, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "P", "mutation": "S523P", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "R", "mutation": "S523R", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 524, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S523S", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "T", "mutation": "S523T", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.567, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "V", "mutation": "S523V", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "W", "mutation": "S523W", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.977, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S523Y", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "C", "mutation": "S524C", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "D", "mutation": "S524D", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "E", "mutation": "S524E", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.93, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "F", "mutation": "S524F", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "G", "mutation": "S524G", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.787, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "H", "mutation": "S524H", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "I", "mutation": "S524I", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "N", "mutation": "S524N", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.84, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "P", "mutation": "S524P", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.653, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "R", "mutation": "S524R", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 525, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S524S", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.587, "ferret_sera_escape": 0.03086, "mature_H5_site": 525, "mouse_sera_escape": -0.09942, "mutant": "T", "mutation": "S524T", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "V", "mutation": "S524V", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "W", "mutation": "S524W", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S524Y", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 526, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L525L", "reference_site": "525", "region": "HA2", "sequential_site": 542, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.708, "ferret_sera_escape": null, "mature_H5_site": 526, "mouse_sera_escape": null, "mutant": "P", "mutation": "L525P", "reference_site": "525", "region": "HA2", "sequential_site": 542, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 527, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A526A", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4592, "ferret_sera_escape": 0.0307, "mature_H5_site": 527, "mouse_sera_escape": -0.05847, "mutant": "C", "mutation": "A526C", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": -0.04216, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 527, "mouse_sera_escape": null, "mutant": "D", "mutation": "A526D", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 527, "mouse_sera_escape": null, "mutant": "E", "mutation": "A526E", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.688, "ferret_sera_escape": null, "mature_H5_site": 527, "mouse_sera_escape": null, "mutant": "F", "mutation": "A526F", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5366, "ferret_sera_escape": -0.03084, "mature_H5_site": 527, "mouse_sera_escape": 0.0548, "mutant": "G", "mutation": "A526G", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": -0.4739, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.867, "ferret_sera_escape": null, "mature_H5_site": 527, "mouse_sera_escape": null, "mutant": "H", "mutation": "A526H", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.8662, "ferret_sera_escape": 0.03041, "mature_H5_site": 527, "mouse_sera_escape": -0.144, "mutant": "I", "mutation": "A526I", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": -0.05213, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 527, "mouse_sera_escape": null, "mutant": "K", "mutation": "A526K", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.476, "ferret_sera_escape": -0.3348, "mature_H5_site": 527, "mouse_sera_escape": 0.08335, "mutant": "N", "mutation": "A526N", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": -0.0727, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 527, "mouse_sera_escape": null, "mutant": "P", "mutation": "A526P", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 527, "mouse_sera_escape": null, "mutant": "R", "mutation": "A526R", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": null, "wildtype": "A"}, {"a26_usage": 0.07782, "cell_entry": -0.2572, "ferret_sera_escape": -0.07856, "mature_H5_site": 527, "mouse_sera_escape": -0.009656, "mutant": "S", "mutation": "A526S", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": -0.007198, "wildtype": "A"}, {"a26_usage": 0.05535, "cell_entry": -0.1571, "ferret_sera_escape": 0.01533, "mature_H5_site": 527, "mouse_sera_escape": 0.02439, "mutant": "T", "mutation": "A526T", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": -0.02197, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.6622, "ferret_sera_escape": -0.03508, "mature_H5_site": 527, "mouse_sera_escape": 0.0405, "mutant": "V", "mutation": "A526V", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": -0.008279, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "A", "mutation": "L527A", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.034, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "C", "mutation": "L527C", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "D", "mutation": "L527D", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "E", "mutation": "L527E", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.041, "ferret_sera_escape": -0.5417, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "F", "mutation": "L527F", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.568, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "H", "mutation": "L527H", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.68, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "K", "mutation": "L527K", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 528, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L527L", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.603, "ferret_sera_escape": -0.0661, "mature_H5_site": 528, "mouse_sera_escape": 0.0348, "mutant": "M", "mutation": "L527M", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": -0.1064, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "N", "mutation": "L527N", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "P", "mutation": "L527P", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.993, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L527Q", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.533, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "R", "mutation": "L527R", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "S", "mutation": "L527S", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "T", "mutation": "L527T", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.365, "ferret_sera_escape": -0.2094, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "V", "mutation": "L527V", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.748, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "W", "mutation": "L527W", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L527Y", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 529, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A528A", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.02856, "ferret_sera_escape": 0.01629, "mature_H5_site": 529, "mouse_sera_escape": -0.02121, "mutant": "C", "mutation": "A528C", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": 0.03738, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.796, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "D", "mutation": "A528D", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.007, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "E", "mutation": "A528E", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.349, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "F", "mutation": "A528F", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.384, "ferret_sera_escape": -0.01327, "mature_H5_site": 529, "mouse_sera_escape": 0.003502, "mutant": "G", "mutation": "A528G", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": -0.02057, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.389, "ferret_sera_escape": -0.00176, "mature_H5_site": 529, "mouse_sera_escape": 0.1245, "mutant": "I", "mutation": "A528I", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": 0.1434, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.013, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "K", "mutation": "A528K", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A528Q", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.824, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "R", "mutation": "A528R", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.03506, "cell_entry": -0.06288, "ferret_sera_escape": 0.005613, "mature_H5_site": 529, "mouse_sera_escape": -0.02507, "mutant": "S", "mutation": "A528S", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": -0.06727, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.05315, "ferret_sera_escape": -0.06048, "mature_H5_site": 529, "mouse_sera_escape": 0.01973, "mutant": "T", "mutation": "A528T", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": -0.09065, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.339, "ferret_sera_escape": -0.1351, "mature_H5_site": 529, "mouse_sera_escape": 0.04747, "mutant": "V", "mutation": "A528V", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": 0.2381, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.863, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "W", "mutation": "A528W", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A528Y", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.428, "ferret_sera_escape": null, "mature_H5_site": 530, "mouse_sera_escape": null, "mutant": "A", "mutation": "I529A", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4947, "ferret_sera_escape": -0.04742, "mature_H5_site": 530, "mouse_sera_escape": 0.2328, "mutant": "C", "mutation": "I529C", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.81, "ferret_sera_escape": null, "mature_H5_site": 530, "mouse_sera_escape": null, "mutant": "D", "mutation": "I529D", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.704, "ferret_sera_escape": null, "mature_H5_site": 530, "mouse_sera_escape": null, "mutant": "E", "mutation": "I529E", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.698, "ferret_sera_escape": null, "mature_H5_site": 530, "mouse_sera_escape": null, "mutant": "H", "mutation": "I529H", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 530, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I529I", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.453, "ferret_sera_escape": null, "mature_H5_site": 530, "mouse_sera_escape": null, "mutant": "K", "mutation": "I529K", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.193, "ferret_sera_escape": 0.06629, "mature_H5_site": 530, "mouse_sera_escape": -0.06689, "mutant": "L", "mutation": "I529L", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": -0.006619, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.323, "ferret_sera_escape": null, "mature_H5_site": 530, "mouse_sera_escape": null, "mutant": "N", "mutation": "I529N", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.016, "ferret_sera_escape": null, "mature_H5_site": 530, "mouse_sera_escape": null, "mutant": "P", "mutation": "I529P", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5203, "ferret_sera_escape": 0.05232, "mature_H5_site": 530, "mouse_sera_escape": 0.08203, "mutant": "S", "mutation": "I529S", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": 0.02028, "wildtype": "I"}, {"a26_usage": 0.2004, "cell_entry": -0.09735, "ferret_sera_escape": 0.04679, "mature_H5_site": 530, "mouse_sera_escape": -0.01198, "mutant": "V", "mutation": "I529V", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": 0.003756, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6709, "ferret_sera_escape": -0.003102, "mature_H5_site": 530, "mouse_sera_escape": -0.01007, "mutant": "Y", "mutation": "I529Y", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": -0.09582, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2831, "ferret_sera_escape": 0.05783, "mature_H5_site": 43, "mouse_sera_escape": -0.07813, "mutant": "A", "mutation": "D53A", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": -0.01888, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.06545, "ferret_sera_escape": 0.06806, "mature_H5_site": 43, "mouse_sera_escape": -0.0396, "mutant": "C", "mutation": "D53C", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 43, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D53D", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7098, "ferret_sera_escape": -0.01263, "mature_H5_site": 43, "mouse_sera_escape": -0.03004, "mutant": "E", "mutation": "D53E", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": -0.1291, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.426, "ferret_sera_escape": null, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "F", "mutation": "D53F", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6269, "ferret_sera_escape": -0.1145, "mature_H5_site": 43, "mouse_sera_escape": 0.07152, "mutant": "G", "mutation": "D53G", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": 0.6907, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1916, "ferret_sera_escape": -0.102, "mature_H5_site": 43, "mouse_sera_escape": -0.007991, "mutant": "H", "mutation": "D53H", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": -0.05533, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.727, "ferret_sera_escape": null, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "I", "mutation": "D53I", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.321, "ferret_sera_escape": -0.4272, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "L", "mutation": "D53L", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0379, "ferret_sera_escape": 0.01719, "mature_H5_site": 43, "mouse_sera_escape": 0.222, "mutant": "M", "mutation": "D53M", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": -0.01664, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4213, "ferret_sera_escape": -0.04095, "mature_H5_site": 43, "mouse_sera_escape": 0.0006729, "mutant": "N", "mutation": "D53N", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": -0.06689, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "P", "mutation": "D53P", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.128, "ferret_sera_escape": null, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "Q", "mutation": "D53Q", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7636, "ferret_sera_escape": -0.02886, "mature_H5_site": 43, "mouse_sera_escape": 0.06618, "mutant": "R", "mutation": "D53R", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": -0.0498, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1046, "ferret_sera_escape": 0.2311, "mature_H5_site": 43, "mouse_sera_escape": 0.1728, "mutant": "S", "mutation": "D53S", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": -0.0894, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.9862, "ferret_sera_escape": -0.3456, "mature_H5_site": 43, "mouse_sera_escape": 0.2474, "mutant": "T", "mutation": "D53T", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.373, "ferret_sera_escape": null, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "V", "mutation": "D53V", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.767, "ferret_sera_escape": -0.2256, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "W", "mutation": "D53W", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.189, "ferret_sera_escape": null, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D53Y", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.304, "ferret_sera_escape": 0.06221, "mature_H5_site": 531, "mouse_sera_escape": 0.1029, "mutant": "C", "mutation": "M530C", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": 0.1741, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.628, "ferret_sera_escape": null, "mature_H5_site": 531, "mouse_sera_escape": 0.02637, "mutant": "D", "mutation": "M530D", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": -0.09658, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.846, "ferret_sera_escape": null, "mature_H5_site": 531, "mouse_sera_escape": null, "mutant": "E", "mutation": "M530E", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.649, "ferret_sera_escape": null, "mature_H5_site": 531, "mouse_sera_escape": 0.04029, "mutant": "G", "mutation": "M530G", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": 0.7557, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.702, "ferret_sera_escape": -0.08559, "mature_H5_site": 531, "mouse_sera_escape": -0.05258, "mutant": "H", "mutation": "M530H", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.07698, "ferret_sera_escape": 0.06039, "mature_H5_site": 531, "mouse_sera_escape": -0.04281, "mutant": "I", "mutation": "M530I", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": 0.04743, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.99, "ferret_sera_escape": null, "mature_H5_site": 531, "mouse_sera_escape": null, "mutant": "K", "mutation": "M530K", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.6774, "ferret_sera_escape": null, "mature_H5_site": 531, "mouse_sera_escape": null, "mutant": "L", "mutation": "M530L", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 531, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M530M", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.587, "ferret_sera_escape": -0.2225, "mature_H5_site": 531, "mouse_sera_escape": -0.1239, "mutant": "N", "mutation": "M530N", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": -0.06721, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.716, "ferret_sera_escape": 0.05918, "mature_H5_site": 531, "mouse_sera_escape": 0.09563, "mutant": "P", "mutation": "M530P", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": -0.1026, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.8279, "ferret_sera_escape": -0.2082, "mature_H5_site": 531, "mouse_sera_escape": -0.1303, "mutant": "Q", "mutation": "M530Q", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": -0.07697, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 531, "mouse_sera_escape": null, "mutant": "R", "mutation": "M530R", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.057, "ferret_sera_escape": -0.05606, "mature_H5_site": 531, "mouse_sera_escape": -0.2933, "mutant": "S", "mutation": "M530S", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": 0.4353, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.4919, "ferret_sera_escape": 0.0166, "mature_H5_site": 531, "mouse_sera_escape": 0.07412, "mutant": "T", "mutation": "M530T", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": 0.007967, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.06889, "ferret_sera_escape": 0.006183, "mature_H5_site": 531, "mouse_sera_escape": 0.0613, "mutant": "V", "mutation": "M530V", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": 0.05095, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.801, "ferret_sera_escape": null, "mature_H5_site": 531, "mouse_sera_escape": null, "mutant": "W", "mutation": "M530W", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.478, "ferret_sera_escape": -0.1717, "mature_H5_site": 531, "mouse_sera_escape": -0.2317, "mutant": "Y", "mutation": "M530Y", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": -0.05, "wildtype": "M"}, {"a26_usage": 0.3367, "cell_entry": -0.06842, "ferret_sera_escape": -0.1249, "mature_H5_site": 532, "mouse_sera_escape": 0.02182, "mutant": "C", "mutation": "M531C", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": -0.04251, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 532, "mouse_sera_escape": null, "mutant": "D", "mutation": "M531D", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 532, "mouse_sera_escape": null, "mutant": "E", "mutation": "M531E", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.04019, "ferret_sera_escape": 0.09001, "mature_H5_site": 532, "mouse_sera_escape": -0.02754, "mutant": "F", "mutation": "M531F", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": 0.1519, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.1551, "ferret_sera_escape": -0.005767, "mature_H5_site": 532, "mouse_sera_escape": -0.07695, "mutant": "G", "mutation": "M531G", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": -0.08655, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.805, "ferret_sera_escape": null, "mature_H5_site": 532, "mouse_sera_escape": null, "mutant": "H", "mutation": "M531H", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.02984, "ferret_sera_escape": 0.02202, "mature_H5_site": 532, "mouse_sera_escape": -0.02259, "mutant": "I", "mutation": "M531I", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": 0.01229, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": 0.4882, "mature_H5_site": 532, "mouse_sera_escape": 0.2329, "mutant": "L", "mutation": "M531L", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 532, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M531M", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 532, "mouse_sera_escape": null, "mutant": "N", "mutation": "M531N", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.996, "ferret_sera_escape": null, "mature_H5_site": 532, "mouse_sera_escape": null, "mutant": "Q", "mutation": "M531Q", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 532, "mouse_sera_escape": null, "mutant": "R", "mutation": "M531R", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.288, "ferret_sera_escape": -0.09031, "mature_H5_site": 532, "mouse_sera_escape": -0.04637, "mutant": "S", "mutation": "M531S", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": -0.06977, "wildtype": "M"}, {"a26_usage": 0.4007, "cell_entry": -0.6916, "ferret_sera_escape": -0.02443, "mature_H5_site": 532, "mouse_sera_escape": 0.03536, "mutant": "T", "mutation": "M531T", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": 0.009667, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.1233, "ferret_sera_escape": -0.1064, "mature_H5_site": 532, "mouse_sera_escape": -0.01188, "mutant": "V", "mutation": "M531V", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": 0.009725, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.05344, "ferret_sera_escape": 0.04856, "mature_H5_site": 532, "mouse_sera_escape": -0.0749, "mutant": "W", "mutation": "M531W", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": 0.02207, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.896, "ferret_sera_escape": -0.06557, "mature_H5_site": 532, "mouse_sera_escape": -0.2372, "mutant": "Y", "mutation": "M531Y", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": -0.02336, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 533, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A532A", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.7522, "cell_entry": -0.6583, "ferret_sera_escape": -0.00809, "mature_H5_site": 533, "mouse_sera_escape": 0.001117, "mutant": "C", "mutation": "A532C", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.1019, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "D", "mutation": "A532D", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.012, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "E", "mutation": "A532E", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.118, "ferret_sera_escape": 0.06909, "mature_H5_site": 533, "mouse_sera_escape": 0.05406, "mutant": "F", "mutation": "A532F", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.3115, "wildtype": "A"}, {"a26_usage": 0.03345, "cell_entry": 0.01457, "ferret_sera_escape": 0.1302, "mature_H5_site": 533, "mouse_sera_escape": 0.09268, "mutant": "G", "mutation": "A532G", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.01617, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.873, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "H", "mutation": "A532H", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.045, "ferret_sera_escape": -0.08966, "mature_H5_site": 533, "mouse_sera_escape": -0.05387, "mutant": "I", "mutation": "A532I", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.2505, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.696, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "K", "mutation": "A532K", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.426, "ferret_sera_escape": -0.1652, "mature_H5_site": 533, "mouse_sera_escape": 0.09695, "mutant": "L", "mutation": "A532L", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.09446, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.218, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "M", "mutation": "A532M", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.793, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "N", "mutation": "A532N", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.801, "ferret_sera_escape": -0.0951, "mature_H5_site": 533, "mouse_sera_escape": -0.08918, "mutant": "P", "mutation": "A532P", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": -0.01589, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.833, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A532Q", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7084, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "S", "mutation": "A532S", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.6654, "ferret_sera_escape": -0.05233, "mature_H5_site": 533, "mouse_sera_escape": -0.05542, "mutant": "T", "mutation": "A532T", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": -0.02929, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.139, "ferret_sera_escape": -0.09568, "mature_H5_site": 533, "mouse_sera_escape": 0.1937, "mutant": "V", "mutation": "A532V", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.2529, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.568, "ferret_sera_escape": -0.1264, "mature_H5_site": 533, "mouse_sera_escape": -0.4083, "mutant": "W", "mutation": "A532W", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.5519, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.934, "ferret_sera_escape": -0.1987, "mature_H5_site": 533, "mouse_sera_escape": -0.444, "mutant": "Y", "mutation": "A532Y", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.392, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.812, "ferret_sera_escape": null, "mature_H5_site": 534, "mouse_sera_escape": null, "mutant": "C", "mutation": "G533C", "reference_site": "533", "region": "HA2", "sequential_site": 550, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.056, "ferret_sera_escape": null, "mature_H5_site": 534, "mouse_sera_escape": null, "mutant": "D", "mutation": "G533D", "reference_site": "533", "region": "HA2", "sequential_site": 550, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 534, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G533G", "reference_site": "533", "region": "HA2", "sequential_site": 550, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.1827, "cell_entry": -0.5002, "ferret_sera_escape": -0.006758, "mature_H5_site": 534, "mouse_sera_escape": 0.0401, "mutant": "S", "mutation": "G533S", "reference_site": "533", "region": "HA2", "sequential_site": 550, "stability": -0.02041, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 535, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L534L", "reference_site": "534", "region": "HA2", "sequential_site": 551, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.004685, "ferret_sera_escape": 0.07938, "mature_H5_site": 535, "mouse_sera_escape": 0.1405, "mutant": "M", "mutation": "L534M", "reference_site": "534", "region": "HA2", "sequential_site": 551, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.931, "ferret_sera_escape": null, "mature_H5_site": 535, "mouse_sera_escape": -0.3225, "mutant": "P", "mutation": "L534P", "reference_site": "534", "region": "HA2", "sequential_site": 551, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 537, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L536L", "reference_site": "536", "region": "HA2", "sequential_site": 553, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3951, "ferret_sera_escape": 0.003553, "mature_H5_site": 537, "mouse_sera_escape": null, "mutant": "M", "mutation": "L536M", "reference_site": "536", "region": "HA2", "sequential_site": 553, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.769, "ferret_sera_escape": -0.369, "mature_H5_site": 538, "mouse_sera_escape": -0.2625, "mutant": "C", "mutation": "W537C", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": 0.6363, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.614, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "D", "mutation": "W537D", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.399, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "E", "mutation": "W537E", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.529, "ferret_sera_escape": -0.1871, "mature_H5_site": 538, "mouse_sera_escape": -0.2676, "mutant": "H", "mutation": "W537H", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": 0.4161, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.212, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "I", "mutation": "W537I", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "K", "mutation": "W537K", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.393, "ferret_sera_escape": -0.0371, "mature_H5_site": 538, "mouse_sera_escape": -0.134, "mutant": "L", "mutation": "W537L", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": 0.2048, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.212, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "M", "mutation": "W537M", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.858, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "N", "mutation": "W537N", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.403, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W537Q", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.865, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "R", "mutation": "W537R", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.931, "ferret_sera_escape": -0.1829, "mature_H5_site": 538, "mouse_sera_escape": -0.1377, "mutant": "S", "mutation": "W537S", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.71, "ferret_sera_escape": -0.1242, "mature_H5_site": 538, "mouse_sera_escape": -0.02528, "mutant": "V", "mutation": "W537V", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": 0.1967, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 538, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W537W", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.573, "ferret_sera_escape": 0.1758, "mature_H5_site": 538, "mouse_sera_escape": 0.1255, "mutant": "Y", "mutation": "W537Y", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.5521, "ferret_sera_escape": 0.02657, "mature_H5_site": 539, "mouse_sera_escape": 0.02564, "mutant": "A", "mutation": "M538A", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.05962, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.755, "ferret_sera_escape": -0.1838, "mature_H5_site": 539, "mouse_sera_escape": -0.5356, "mutant": "C", "mutation": "M538C", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.6566, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "D", "mutation": "M538D", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.82, "ferret_sera_escape": null, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "E", "mutation": "M538E", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.306, "ferret_sera_escape": 0.006627, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "F", "mutation": "M538F", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.129, "ferret_sera_escape": -0.09007, "mature_H5_site": 539, "mouse_sera_escape": -0.08074, "mutant": "G", "mutation": "M538G", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.883, "ferret_sera_escape": null, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "H", "mutation": "M538H", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.467, "ferret_sera_escape": -0.3934, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "I", "mutation": "M538I", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.7884, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.311, "ferret_sera_escape": -0.2177, "mature_H5_site": 539, "mouse_sera_escape": -0.2676, "mutant": "K", "mutation": "M538K", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.3617, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.759, "ferret_sera_escape": -0.3669, "mature_H5_site": 539, "mouse_sera_escape": 0.2969, "mutant": "L", "mutation": "M538L", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 539, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M538M", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.338, "ferret_sera_escape": -0.0641, "mature_H5_site": 539, "mouse_sera_escape": -0.2345, "mutant": "N", "mutation": "M538N", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": -0.04382, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.535, "ferret_sera_escape": -0.03788, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "P", "mutation": "M538P", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.4395, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.749, "ferret_sera_escape": -0.1429, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "R", "mutation": "M538R", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.2833, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.5393, "ferret_sera_escape": -0.02672, "mature_H5_site": 539, "mouse_sera_escape": 0.1145, "mutant": "S", "mutation": "M538S", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.1178, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.533, "ferret_sera_escape": -0.1099, "mature_H5_site": 539, "mouse_sera_escape": -0.1403, "mutant": "T", "mutation": "M538T", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.01073, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.782, "ferret_sera_escape": 0.06823, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "V", "mutation": "M538V", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.6945, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.257, "ferret_sera_escape": -0.2136, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "W", "mutation": "M538W", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.981, "ferret_sera_escape": null, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "Y", "mutation": "M538Y", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.07273, "cell_entry": -0.8099, "ferret_sera_escape": 0.1936, "mature_H5_site": 540, "mouse_sera_escape": 0.07541, "mutant": "A", "mutation": "C539A", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": 0.02277, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 540, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C539C", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.016, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "D", "mutation": "C539D", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "E", "mutation": "C539E", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -1.696, "ferret_sera_escape": -0.01097, "mature_H5_site": 540, "mouse_sera_escape": -0.1197, "mutant": "F", "mutation": "C539F", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": -0.03069, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.888, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "G", "mutation": "C539G", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.108, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "H", "mutation": "C539H", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.29, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "K", "mutation": "C539K", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.9479, "ferret_sera_escape": -0.1669, "mature_H5_site": 540, "mouse_sera_escape": -0.1796, "mutant": "M", "mutation": "C539M", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": -0.05143, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.969, "ferret_sera_escape": -0.2897, "mature_H5_site": 540, "mouse_sera_escape": -0.6414, "mutant": "N", "mutation": "C539N", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "P", "mutation": "C539P", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.653, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "R", "mutation": "C539R", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -1.778, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "S", "mutation": "C539S", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.278, "ferret_sera_escape": -0.3505, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "T", "mutation": "C539T", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": -0.03267, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.8322, "ferret_sera_escape": -0.02047, "mature_H5_site": 540, "mouse_sera_escape": -0.1233, "mutant": "V", "mutation": "C539V", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": -0.01822, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.528, "ferret_sera_escape": 0.07198, "mature_H5_site": 540, "mouse_sera_escape": -0.001145, "mutant": "Y", "mutation": "C539Y", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": 0.05091, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "C", "mutation": "L54C", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.868, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "E", "mutation": "L54E", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.889, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "F", "mutation": "L54F", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.33, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "H", "mutation": "L54H", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06702, "ferret_sera_escape": -0.01081, "mature_H5_site": 44, "mouse_sera_escape": 0.124, "mutant": "I", "mutation": "L54I", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": 1.049, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "K", "mutation": "L54K", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 44, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L54L", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.04107, "ferret_sera_escape": -0.1426, "mature_H5_site": 44, "mouse_sera_escape": 0.02963, "mutant": "M", "mutation": "L54M", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": 1.11, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "N", "mutation": "L54N", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "P", "mutation": "L54P", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L54Q", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "R", "mutation": "L54R", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "S", "mutation": "L54S", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "T", "mutation": "L54T", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.06016, "cell_entry": -0.2463, "ferret_sera_escape": -0.05204, "mature_H5_site": 44, "mouse_sera_escape": 0.08993, "mutant": "V", "mutation": "L54V", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": -0.1082, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.259, "ferret_sera_escape": 0.3533, "mature_H5_site": 44, "mouse_sera_escape": 0.05584, "mutant": "W", "mutation": "L54W", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06314, "ferret_sera_escape": -0.124, "mature_H5_site": 44, "mouse_sera_escape": 0.05207, "mutant": "Y", "mutation": "L54Y", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": 2.069, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.648, "ferret_sera_escape": null, "mature_H5_site": 542, "mouse_sera_escape": null, "mutant": "D", "mutation": "N541D", "reference_site": "541", "region": "HA2", "sequential_site": 558, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.729, "ferret_sera_escape": -0.1441, "mature_H5_site": 542, "mouse_sera_escape": 0.1496, "mutant": "K", "mutation": "N541K", "reference_site": "541", "region": "HA2", "sequential_site": 558, "stability": 0.1613, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 542, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N541N", "reference_site": "541", "region": "HA2", "sequential_site": 558, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.711, "ferret_sera_escape": null, "mature_H5_site": 543, "mouse_sera_escape": null, "mutant": "C", "mutation": "G542C", "reference_site": "542", "region": "HA2", "sequential_site": 559, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.421, "ferret_sera_escape": 0.619, "mature_H5_site": 543, "mouse_sera_escape": null, "mutant": "D", "mutation": "G542D", "reference_site": "542", "region": "HA2", "sequential_site": 559, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 543, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G542G", "reference_site": "542", "region": "HA2", "sequential_site": 559, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5446, "ferret_sera_escape": null, "mature_H5_site": 543, "mouse_sera_escape": null, "mutant": "S", "mutation": "G542S", "reference_site": "542", "region": "HA2", "sequential_site": 559, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.265, "ferret_sera_escape": -0.1287, "mature_H5_site": 544, "mouse_sera_escape": -0.334, "mutant": "C", "mutation": "S543C", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.9252, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.125, "ferret_sera_escape": 0.0347, "mature_H5_site": 544, "mouse_sera_escape": null, "mutant": "E", "mutation": "S543E", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.64, "ferret_sera_escape": 0.1206, "mature_H5_site": 544, "mouse_sera_escape": -0.08128, "mutant": "F", "mutation": "S543F", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.05901, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.634, "ferret_sera_escape": null, "mature_H5_site": 544, "mouse_sera_escape": null, "mutant": "G", "mutation": "S543G", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.616, "ferret_sera_escape": null, "mature_H5_site": 544, "mouse_sera_escape": null, "mutant": "H", "mutation": "S543H", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.119, "ferret_sera_escape": null, "mature_H5_site": 544, "mouse_sera_escape": null, "mutant": "I", "mutation": "S543I", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.04634, "ferret_sera_escape": -0.07298, "mature_H5_site": 544, "mouse_sera_escape": 0.03777, "mutant": "L", "mutation": "S543L", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.1963, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.792, "ferret_sera_escape": -0.01437, "mature_H5_site": 544, "mouse_sera_escape": 0.01171, "mutant": "M", "mutation": "S543M", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.05089, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.267, "ferret_sera_escape": null, "mature_H5_site": 544, "mouse_sera_escape": null, "mutant": "N", "mutation": "S543N", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.09684, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.867, "ferret_sera_escape": null, "mature_H5_site": 544, "mouse_sera_escape": null, "mutant": "P", "mutation": "S543P", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.783, "ferret_sera_escape": -0.1701, "mature_H5_site": 544, "mouse_sera_escape": -0.3435, "mutant": "Q", "mutation": "S543Q", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.792, "ferret_sera_escape": null, "mature_H5_site": 544, "mouse_sera_escape": null, "mutant": "R", "mutation": "S543R", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 544, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S543S", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.06, "ferret_sera_escape": -0.06595, "mature_H5_site": 544, "mouse_sera_escape": -0.04285, "mutant": "T", "mutation": "S543T", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": -0.01016, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6961, "ferret_sera_escape": -0.06913, "mature_H5_site": 544, "mouse_sera_escape": -0.01143, "mutant": "V", "mutation": "S543V", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.01125, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4506, "ferret_sera_escape": -0.1059, "mature_H5_site": 544, "mouse_sera_escape": -0.07511, "mutant": "W", "mutation": "S543W", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.04512, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.581, "ferret_sera_escape": -0.02505, "mature_H5_site": 544, "mouse_sera_escape": 0.09378, "mutant": "Y", "mutation": "S543Y", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": -0.01074, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.878, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "A", "mutation": "L544A", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.712, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "C", "mutation": "L544C", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "D", "mutation": "L544D", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.549, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "E", "mutation": "L544E", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.8, "ferret_sera_escape": 0.06899, "mature_H5_site": 545, "mouse_sera_escape": -0.4364, "mutant": "G", "mutation": "L544G", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.076, "ferret_sera_escape": -0.1625, "mature_H5_site": 545, "mouse_sera_escape": -0.2437, "mutant": "I", "mutation": "L544I", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": 0.4127, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": -0.394, "mutant": "K", "mutation": "L544K", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 545, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L544L", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.7662, "cell_entry": -0.5561, "ferret_sera_escape": -0.0148, "mature_H5_site": 545, "mouse_sera_escape": 0.1285, "mutant": "M", "mutation": "L544M", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": 0.1557, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.779, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "N", "mutation": "L544N", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "P", "mutation": "L544P", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.239, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L544Q", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.448, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "R", "mutation": "L544R", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.782, "ferret_sera_escape": -0.0376, "mature_H5_site": 545, "mouse_sera_escape": -0.3414, "mutant": "S", "mutation": "L544S", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": 0.6127, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.176, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "T", "mutation": "L544T", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3333, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "V", "mutation": "L544V", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.504, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "W", "mutation": "L544W", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.845, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L544Y", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6986, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "A", "mutation": "Q545A", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.899, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "C", "mutation": "Q545C", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.854, "ferret_sera_escape": 0.07849, "mature_H5_site": 546, "mouse_sera_escape": 0.2831, "mutant": "D", "mutation": "Q545D", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.359, "ferret_sera_escape": 0.02809, "mature_H5_site": 546, "mouse_sera_escape": 0.1153, "mutant": "E", "mutation": "Q545E", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": 0.06606, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.717, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": -0.2797, "mutant": "F", "mutation": "Q545F", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.277, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "G", "mutation": "Q545G", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": 0.6403, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.394, "ferret_sera_escape": -0.04155, "mature_H5_site": 546, "mouse_sera_escape": -0.08148, "mutant": "H", "mutation": "Q545H", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": 0.1347, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.162, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "I", "mutation": "Q545I", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5215, "ferret_sera_escape": 0.1966, "mature_H5_site": 546, "mouse_sera_escape": 0.0885, "mutant": "K", "mutation": "Q545K", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.15, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "L", "mutation": "Q545L", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.071, "ferret_sera_escape": -0.1957, "mature_H5_site": 546, "mouse_sera_escape": -0.1221, "mutant": "M", "mutation": "Q545M", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.487, "ferret_sera_escape": 0.07356, "mature_H5_site": 546, "mouse_sera_escape": 0.1214, "mutant": "N", "mutation": "Q545N", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.809, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q545P", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 546, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q545Q", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.271, "ferret_sera_escape": 0.0511, "mature_H5_site": 546, "mouse_sera_escape": 0.1845, "mutant": "R", "mutation": "Q545R", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": 0.2185, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2907, "ferret_sera_escape": 0.07921, "mature_H5_site": 546, "mouse_sera_escape": -0.01105, "mutant": "T", "mutation": "Q545T", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": -0.02822, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.59, "ferret_sera_escape": 0.02137, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "V", "mutation": "Q545V", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.499, "ferret_sera_escape": -0.06307, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "W", "mutation": "Q545W", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.085, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "Y", "mutation": "Q545Y", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 547, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C546C", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.035, "ferret_sera_escape": null, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "D", "mutation": "C546D", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.261, "ferret_sera_escape": -0.4003, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "E", "mutation": "C546E", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.31, "ferret_sera_escape": null, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "F", "mutation": "C546F", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.175, "ferret_sera_escape": null, "mature_H5_site": 547, "mouse_sera_escape": -0.4121, "mutant": "G", "mutation": "C546G", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.716, "ferret_sera_escape": -0.1805, "mature_H5_site": 547, "mouse_sera_escape": -0.3831, "mutant": "H", "mutation": "C546H", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": 0.9956, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.731, "ferret_sera_escape": 0.04827, "mature_H5_site": 547, "mouse_sera_escape": -0.1352, "mutant": "I", "mutation": "C546I", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": -0.08578, "wildtype": "C"}, {"a26_usage": 2.68, "cell_entry": -3.956, "ferret_sera_escape": -0.3257, "mature_H5_site": 547, "mouse_sera_escape": -0.3845, "mutant": "K", "mutation": "C546K", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.06454, "ferret_sera_escape": -0.1115, "mature_H5_site": 547, "mouse_sera_escape": -0.2498, "mutant": "L", "mutation": "C546L", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": -0.0209, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.5443, "ferret_sera_escape": null, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "M", "mutation": "C546M", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 2.157, "cell_entry": -5.104, "ferret_sera_escape": 0.04098, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "N", "mutation": "C546N", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": 0.8709, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.825, "ferret_sera_escape": -0.1173, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "P", "mutation": "C546P", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": 0.539, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.482, "ferret_sera_escape": -0.3981, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "R", "mutation": "C546R", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.422, "ferret_sera_escape": null, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "S", "mutation": "C546S", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.131, "ferret_sera_escape": -0.06895, "mature_H5_site": 547, "mouse_sera_escape": -0.2063, "mutant": "T", "mutation": "C546T", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": 0.7328, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.583, "ferret_sera_escape": 0.06324, "mature_H5_site": 547, "mouse_sera_escape": 0.02411, "mutant": "W", "mutation": "C546W", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.469, "ferret_sera_escape": -0.07564, "mature_H5_site": 547, "mouse_sera_escape": -0.1486, "mutant": "Y", "mutation": "C546Y", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": 0.4189, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.986, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "A", "mutation": "R547A", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": -0.1843, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "C", "mutation": "R547C", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.336, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "D", "mutation": "R547D", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "F", "mutation": "R547F", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.049, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "G", "mutation": "R547G", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3383, "ferret_sera_escape": -0.129, "mature_H5_site": 548, "mouse_sera_escape": -0.3507, "mutant": "H", "mutation": "R547H", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.854, "ferret_sera_escape": -0.2341, "mature_H5_site": 548, "mouse_sera_escape": -0.3252, "mutant": "I", "mutation": "R547I", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": -0.03129, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4794, "ferret_sera_escape": 0.0487, "mature_H5_site": 548, "mouse_sera_escape": 0.04011, "mutant": "K", "mutation": "R547K", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": -0.09646, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.203, "ferret_sera_escape": -0.257, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "L", "mutation": "R547L", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.692, "ferret_sera_escape": -0.08179, "mature_H5_site": 548, "mouse_sera_escape": -0.1496, "mutant": "N", "mutation": "R547N", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": 0.009676, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -6.043, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "P", "mutation": "R547P", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.849, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "Q", "mutation": "R547Q", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 548, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R547R", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.223, "ferret_sera_escape": -0.02313, "mature_H5_site": 548, "mouse_sera_escape": -0.182, "mutant": "S", "mutation": "R547S", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7928, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "T", "mutation": "R547T", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7174, "ferret_sera_escape": -0.1016, "mature_H5_site": 548, "mouse_sera_escape": -0.2736, "mutant": "V", "mutation": "R547V", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": -0.007089, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.278, "ferret_sera_escape": -0.09222, "mature_H5_site": 548, "mouse_sera_escape": -0.2382, "mutant": "W", "mutation": "R547W", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": -0.01039, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.693, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R547Y", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": 0.2115, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.143, "ferret_sera_escape": 0.0347, "mature_H5_site": 549, "mouse_sera_escape": -0.07756, "mutant": "F", "mutation": "I548F", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.1837, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.406, "ferret_sera_escape": null, "mature_H5_site": 549, "mouse_sera_escape": -0.2113, "mutant": "H", "mutation": "I548H", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.8306, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 549, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I548I", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.222, "ferret_sera_escape": null, "mature_H5_site": 549, "mouse_sera_escape": null, "mutant": "K", "mutation": "I548K", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.085, "ferret_sera_escape": -0.05205, "mature_H5_site": 549, "mouse_sera_escape": -0.0494, "mutant": "L", "mutation": "I548L", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.06557, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.614, "ferret_sera_escape": 0.03818, "mature_H5_site": 549, "mouse_sera_escape": 0.07939, "mutant": "M", "mutation": "I548M", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.3571, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.338, "ferret_sera_escape": null, "mature_H5_site": 549, "mouse_sera_escape": null, "mutant": "N", "mutation": "I548N", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.374, "ferret_sera_escape": null, "mature_H5_site": 549, "mouse_sera_escape": null, "mutant": "P", "mutation": "I548P", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.575, "ferret_sera_escape": null, "mature_H5_site": 549, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I548Q", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.403, "ferret_sera_escape": null, "mature_H5_site": 549, "mouse_sera_escape": null, "mutant": "R", "mutation": "I548R", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.458, "ferret_sera_escape": -0.1966, "mature_H5_site": 549, "mouse_sera_escape": -0.4688, "mutant": "S", "mutation": "I548S", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.7119, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.991, "ferret_sera_escape": -0.2548, "mature_H5_site": 549, "mouse_sera_escape": -0.6438, "mutant": "T", "mutation": "I548T", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.376, "ferret_sera_escape": -0.06604, "mature_H5_site": 549, "mouse_sera_escape": -0.06642, "mutant": "V", "mutation": "I548V", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.002286, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.622, "ferret_sera_escape": -0.415, "mature_H5_site": 549, "mouse_sera_escape": null, "mutant": "W", "mutation": "I548W", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.527, "ferret_sera_escape": null, "mature_H5_site": 549, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I548Y", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.4683, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.162, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "A", "mutation": "C549A", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 550, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C549C", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.409, "ferret_sera_escape": -0.2411, "mature_H5_site": 550, "mouse_sera_escape": -0.1855, "mutant": "E", "mutation": "C549E", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": -0.03652, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.021, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "F", "mutation": "C549F", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.237, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "G", "mutation": "C549G", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.513, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "H", "mutation": "C549H", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.553, "ferret_sera_escape": -0.02687, "mature_H5_site": 550, "mouse_sera_escape": -0.4756, "mutant": "I", "mutation": "C549I", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": -0.007486, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.61, "ferret_sera_escape": -0.4192, "mature_H5_site": 550, "mouse_sera_escape": -0.1494, "mutant": "K", "mutation": "C549K", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": 0.2909, "wildtype": "C"}, {"a26_usage": 1.224, "cell_entry": -1.981, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "L", "mutation": "C549L", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.611, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "M", "mutation": "C549M", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.514, "ferret_sera_escape": -0.1311, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "N", "mutation": "C549N", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": 0.08776, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.15, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": -0.2507, "mutant": "Q", "mutation": "C549Q", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": 0.1168, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.742, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": -0.6341, "mutant": "R", "mutation": "C549R", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": 0.3262, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.47, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "S", "mutation": "C549S", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.755, "ferret_sera_escape": -0.05122, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "T", "mutation": "C549T", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.071, "ferret_sera_escape": -0.3248, "mature_H5_site": 550, "mouse_sera_escape": -0.5157, "mutant": "W", "mutation": "C549W", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": -0.0148, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.96, "ferret_sera_escape": -0.1463, "mature_H5_site": 550, "mouse_sera_escape": -0.2332, "mutant": "Y", "mutation": "C549Y", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": 0.1515, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.02412, "ferret_sera_escape": -0.04877, "mature_H5_site": 45, "mouse_sera_escape": -0.09587, "mutant": "A", "mutation": "N54aA", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 0.2352, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1681, "ferret_sera_escape": 0.1093, "mature_H5_site": 45, "mouse_sera_escape": 0.05432, "mutant": "D", "mutation": "N54aD", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 1.142, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02728, "ferret_sera_escape": -0.1481, "mature_H5_site": 45, "mouse_sera_escape": 0.05633, "mutant": "G", "mutation": "N54aG", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 1.114, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6608, "ferret_sera_escape": -0.05254, "mature_H5_site": 45, "mouse_sera_escape": -0.001887, "mutant": "H", "mutation": "N54aH", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": -0.09564, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5526, "ferret_sera_escape": 0.03023, "mature_H5_site": 45, "mouse_sera_escape": 0.3592, "mutant": "I", "mutation": "N54aI", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 1.246, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1417, "ferret_sera_escape": 0.2597, "mature_H5_site": 45, "mouse_sera_escape": 0.2502, "mutant": "K", "mutation": "N54aK", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": -0.08534, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2206, "ferret_sera_escape": -0.04947, "mature_H5_site": 45, "mouse_sera_escape": 0.2997, "mutant": "L", "mutation": "N54aL", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 1.565, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4132, "ferret_sera_escape": -0.04749, "mature_H5_site": 45, "mouse_sera_escape": -0.021, "mutant": "M", "mutation": "N54aM", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 1.577, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 45, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N54aN", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.887, "ferret_sera_escape": null, "mature_H5_site": 45, "mouse_sera_escape": null, "mutant": "P", "mutation": "N54aP", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.06754, "ferret_sera_escape": -0.1973, "mature_H5_site": 45, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N54aQ", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": null, "wildtype": "N"}, {"a26_usage": 0.1646, "cell_entry": -1.1, "ferret_sera_escape": null, "mature_H5_site": 45, "mouse_sera_escape": null, "mutant": "R", "mutation": "N54aR", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.05747, "ferret_sera_escape": null, "mature_H5_site": 45, "mouse_sera_escape": null, "mutant": "S", "mutation": "N54aS", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4735, "ferret_sera_escape": -0.03226, "mature_H5_site": 45, "mouse_sera_escape": 0.01329, "mutant": "T", "mutation": "N54aT", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 0.9699, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.427, "ferret_sera_escape": null, "mature_H5_site": 45, "mouse_sera_escape": null, "mutant": "V", "mutation": "N54aV", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.472, "ferret_sera_escape": -0.03987, "mature_H5_site": 45, "mouse_sera_escape": -0.04295, "mutant": "W", "mutation": "N54aW", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 0.1935, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.19, "ferret_sera_escape": 0.004011, "mature_H5_site": 46, "mouse_sera_escape": -0.1486, "mutant": "A", "mutation": "G55A", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.64, "ferret_sera_escape": 0.09657, "mature_H5_site": 46, "mouse_sera_escape": 0.218, "mutant": "C", "mutation": "G55C", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.03427, "ferret_sera_escape": 0.01877, "mature_H5_site": 46, "mouse_sera_escape": -0.01744, "mutant": "D", "mutation": "G55D", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": 0.01511, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4624, "ferret_sera_escape": -0.0467, "mature_H5_site": 46, "mouse_sera_escape": 0.04184, "mutant": "E", "mutation": "G55E", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.05817, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.03283, "ferret_sera_escape": 0.03549, "mature_H5_site": 46, "mouse_sera_escape": 0.06226, "mutant": "F", "mutation": "G55F", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.05752, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 46, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G55G", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.3858, "cell_entry": -0.3432, "ferret_sera_escape": 0.05976, "mature_H5_site": 46, "mouse_sera_escape": 0.005385, "mutant": "H", "mutation": "G55H", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.05903, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4657, "ferret_sera_escape": null, "mature_H5_site": 46, "mouse_sera_escape": null, "mutant": "K", "mutation": "G55K", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": null, "wildtype": "G"}, {"a26_usage": 0.7992, "cell_entry": -0.8, "ferret_sera_escape": -0.002113, "mature_H5_site": 46, "mouse_sera_escape": 0.05505, "mutant": "L", "mutation": "G55L", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.08646, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.07944, "ferret_sera_escape": -0.07824, "mature_H5_site": 46, "mouse_sera_escape": -0.06517, "mutant": "M", "mutation": "G55M", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.03099, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 46, "mouse_sera_escape": null, "mutant": "P", "mutation": "G55P", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.02873, "ferret_sera_escape": null, "mature_H5_site": 46, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G55Q", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.04183, "ferret_sera_escape": 0.062, "mature_H5_site": 46, "mouse_sera_escape": 0.04438, "mutant": "R", "mutation": "G55R", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.08027, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.6783, "ferret_sera_escape": -0.02597, "mature_H5_site": 46, "mouse_sera_escape": 0.05505, "mutant": "T", "mutation": "G55T", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.1702, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 46, "mouse_sera_escape": null, "mutant": "V", "mutation": "G55V", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1528, "ferret_sera_escape": -0.06756, "mature_H5_site": 46, "mouse_sera_escape": 0.143, "mutant": "W", "mutation": "G55W", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.007577, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.234, "ferret_sera_escape": null, "mature_H5_site": 46, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G55Y", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.159, "ferret_sera_escape": -0.2644, "mature_H5_site": 551, "mouse_sera_escape": -0.2386, "mutant": "A", "mutation": "I550A", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": 0.4021, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.053, "ferret_sera_escape": -0.1035, "mature_H5_site": 551, "mouse_sera_escape": -0.01742, "mutant": "C", "mutation": "I550C", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": 0.2266, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.322, "ferret_sera_escape": null, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "D", "mutation": "I550D", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.861, "ferret_sera_escape": null, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "E", "mutation": "I550E", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.556, "ferret_sera_escape": 0.03118, "mature_H5_site": 551, "mouse_sera_escape": -0.03664, "mutant": "F", "mutation": "I550F", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.117, "ferret_sera_escape": -0.334, "mature_H5_site": 551, "mouse_sera_escape": -0.31, "mutant": "G", "mutation": "I550G", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": 0.3258, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 551, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I550I", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.091, "ferret_sera_escape": -0.4243, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "K", "mutation": "I550K", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": 0.4274, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2315, "ferret_sera_escape": -0.1686, "mature_H5_site": 551, "mouse_sera_escape": -0.06272, "mutant": "L", "mutation": "I550L", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": -0.02661, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.441, "ferret_sera_escape": null, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "P", "mutation": "I550P", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.671, "ferret_sera_escape": -0.2406, "mature_H5_site": 551, "mouse_sera_escape": -0.2331, "mutant": "Q", "mutation": "I550Q", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.968, "ferret_sera_escape": null, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "R", "mutation": "I550R", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.457, "ferret_sera_escape": -0.1842, "mature_H5_site": 551, "mouse_sera_escape": -0.3619, "mutant": "S", "mutation": "I550S", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": 0.3478, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.24, "ferret_sera_escape": null, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "T", "mutation": "I550T", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5749, "ferret_sera_escape": 0.02231, "mature_H5_site": 551, "mouse_sera_escape": -0.04674, "mutant": "V", "mutation": "I550V", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": 0.07083, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.091, "ferret_sera_escape": null, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "W", "mutation": "I550W", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.306, "ferret_sera_escape": null, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I550Y", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2791, "ferret_sera_escape": -0.00816, "mature_H5_site": 47, "mouse_sera_escape": -0.01906, "mutant": "A", "mutation": "V56A", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": 0.6075, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.04159, "ferret_sera_escape": -0.1572, "mature_H5_site": 47, "mouse_sera_escape": 0.04327, "mutant": "C", "mutation": "V56C", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.1564, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6607, "ferret_sera_escape": null, "mature_H5_site": 47, "mouse_sera_escape": null, "mutant": "E", "mutation": "V56E", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.597, "ferret_sera_escape": -0.01965, "mature_H5_site": 47, "mouse_sera_escape": 0.01713, "mutant": "F", "mutation": "V56F", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.1139, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6441, "ferret_sera_escape": 0.07279, "mature_H5_site": 47, "mouse_sera_escape": 0.107, "mutant": "G", "mutation": "V56G", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.09259, "wildtype": "V"}, {"a26_usage": 0.2024, "cell_entry": -0.2024, "ferret_sera_escape": 0.06058, "mature_H5_site": 47, "mouse_sera_escape": 0.05137, "mutant": "H", "mutation": "V56H", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.06264, "wildtype": "V"}, {"a26_usage": 0.02382, "cell_entry": 0.07137, "ferret_sera_escape": 0.1043, "mature_H5_site": 47, "mouse_sera_escape": -0.09101, "mutant": "I", "mutation": "V56I", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.1295, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.03821, "ferret_sera_escape": -0.02729, "mature_H5_site": 47, "mouse_sera_escape": -0.01838, "mutant": "K", "mutation": "V56K", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.4008, "wildtype": "V"}, {"a26_usage": 0.00573, "cell_entry": 0.005785, "ferret_sera_escape": -0.04317, "mature_H5_site": 47, "mouse_sera_escape": -0.07839, "mutant": "L", "mutation": "V56L", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.1666, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7313, "ferret_sera_escape": 0.0167, "mature_H5_site": 47, "mouse_sera_escape": 0.03699, "mutant": "N", "mutation": "V56N", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.1717, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 47, "mouse_sera_escape": null, "mutant": "P", "mutation": "V56P", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.00104, "ferret_sera_escape": -0.12, "mature_H5_site": 47, "mouse_sera_escape": -0.1321, "mutant": "Q", "mutation": "V56Q", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.0374, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8235, "ferret_sera_escape": 0.002975, "mature_H5_site": 47, "mouse_sera_escape": -0.03704, "mutant": "R", "mutation": "V56R", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.2486, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.04526, "ferret_sera_escape": -0.04823, "mature_H5_site": 47, "mouse_sera_escape": -0.01716, "mutant": "S", "mutation": "V56S", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": 1.531, "wildtype": "V"}, {"a26_usage": 0.09408, "cell_entry": -1.171, "ferret_sera_escape": -0.2128, "mature_H5_site": 47, "mouse_sera_escape": null, "mutant": "T", "mutation": "V56T", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.0506, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 47, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V56V", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1713, "ferret_sera_escape": -0.06065, "mature_H5_site": 47, "mouse_sera_escape": 0.01732, "mutant": "W", "mutation": "V56W", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.4468, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.06962, "ferret_sera_escape": -0.03541, "mature_H5_site": 47, "mouse_sera_escape": -0.001277, "mutant": "Y", "mutation": "V56Y", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.08799, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.07165, "ferret_sera_escape": -0.01859, "mature_H5_site": 48, "mouse_sera_escape": -0.02194, "mutant": "A", "mutation": "K57A", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 0.5823, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3998, "ferret_sera_escape": null, "mature_H5_site": 48, "mouse_sera_escape": null, "mutant": "C", "mutation": "K57C", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.938, "ferret_sera_escape": null, "mature_H5_site": 48, "mouse_sera_escape": null, "mutant": "D", "mutation": "K57D", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04136, "ferret_sera_escape": 0.04256, "mature_H5_site": 48, "mouse_sera_escape": 0.1967, "mutant": "E", "mutation": "K57E", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 1.773, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.708, "ferret_sera_escape": null, "mature_H5_site": 48, "mouse_sera_escape": null, "mutant": "F", "mutation": "K57F", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1721, "ferret_sera_escape": 0.1041, "mature_H5_site": 48, "mouse_sera_escape": 0.2271, "mutant": "G", "mutation": "K57G", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 1.583, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7405, "ferret_sera_escape": -0.05997, "mature_H5_site": 48, "mouse_sera_escape": 0.01367, "mutant": "H", "mutation": "K57H", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 0.06808, "wildtype": "K"}, {"a26_usage": 0.4927, "cell_entry": -0.5732, "ferret_sera_escape": -0.228, "mature_H5_site": 48, "mouse_sera_escape": 0.09202, "mutant": "I", "mutation": "K57I", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 1.351, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 48, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K57K", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.13, "ferret_sera_escape": -0.09753, "mature_H5_site": 48, "mouse_sera_escape": 0.1495, "mutant": "L", "mutation": "K57L", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 0.7947, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4456, "ferret_sera_escape": null, "mature_H5_site": 48, "mouse_sera_escape": null, "mutant": "N", "mutation": "K57N", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.173, "ferret_sera_escape": 0.1718, "mature_H5_site": 48, "mouse_sera_escape": 0.161, "mutant": "P", "mutation": "K57P", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.00593, "ferret_sera_escape": 0.002733, "mature_H5_site": 48, "mouse_sera_escape": 0.1647, "mutant": "Q", "mutation": "K57Q", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 1.502, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6365, "ferret_sera_escape": 0.02305, "mature_H5_site": 48, "mouse_sera_escape": -0.06856, "mutant": "R", "mutation": "K57R", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 0.7983, "wildtype": "K"}, {"a26_usage": 0.3178, "cell_entry": 0.0466, "ferret_sera_escape": null, "mature_H5_site": 48, "mouse_sera_escape": null, "mutant": "T", "mutation": "K57T", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.621, "ferret_sera_escape": -0.4798, "mature_H5_site": 48, "mouse_sera_escape": 0.2599, "mutant": "W", "mutation": "K57W", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2162, "ferret_sera_escape": -0.0813, "mature_H5_site": 49, "mouse_sera_escape": -0.00979, "mutant": "A", "mutation": "P58A", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "C", "mutation": "P58C", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "D", "mutation": "P58D", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "E", "mutation": "P58E", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "G", "mutation": "P58G", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "H", "mutation": "P58H", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.955, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "I", "mutation": "P58I", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "K", "mutation": "P58K", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.044, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "L", "mutation": "P58L", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.018, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "M", "mutation": "P58M", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "N", "mutation": "P58N", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 49, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P58P", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.016, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P58Q", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.863, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "R", "mutation": "P58R", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.99, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "S", "mutation": "P58S", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.797, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "T", "mutation": "P58T", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "W", "mutation": "P58W", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.733, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "Y", "mutation": "P58Y", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.536, "ferret_sera_escape": -0.0673, "mature_H5_site": 50, "mouse_sera_escape": 0.2377, "mutant": "A", "mutation": "L59A", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.981, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "D", "mutation": "L59D", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "E", "mutation": "L59E", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2665, "ferret_sera_escape": 0.08708, "mature_H5_site": 50, "mouse_sera_escape": 0.3262, "mutant": "F", "mutation": "L59F", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": -0.01653, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.655, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "G", "mutation": "L59G", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.67, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "K", "mutation": "L59K", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 50, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L59L", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.09156, "ferret_sera_escape": 0.1712, "mature_H5_site": 50, "mouse_sera_escape": 0.3182, "mutant": "M", "mutation": "L59M", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": 0.2013, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.686, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "N", "mutation": "L59N", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.032, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "P", "mutation": "L59P", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.495, "ferret_sera_escape": -0.0779, "mature_H5_site": 50, "mouse_sera_escape": 0.3232, "mutant": "Q", "mutation": "L59Q", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": 0.7829, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.378, "ferret_sera_escape": 0.02459, "mature_H5_site": 50, "mouse_sera_escape": 0.414, "mutant": "R", "mutation": "L59R", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.777, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "S", "mutation": "L59S", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.266, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "T", "mutation": "L59T", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5635, "ferret_sera_escape": 0.1626, "mature_H5_site": 50, "mouse_sera_escape": 0.2518, "mutant": "V", "mutation": "L59V", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": -0.333, "wildtype": "L"}, {"a26_usage": 0.22, "cell_entry": -0.2226, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "W", "mutation": "L59W", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0897, "cell_entry": -0.03099, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L59Y", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5858, "ferret_sera_escape": 0.02391, "mature_H5_site": -5, "mouse_sera_escape": -0.08309, "mutant": "A", "mutation": "S6A", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.02374, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.01632, "ferret_sera_escape": 0.008693, "mature_H5_site": -5, "mouse_sera_escape": -0.0207, "mutant": "C", "mutation": "S6C", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.01022, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3197, "ferret_sera_escape": -0.04338, "mature_H5_site": -5, "mouse_sera_escape": 0.05026, "mutant": "D", "mutation": "S6D", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.06467, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.03886, "ferret_sera_escape": -0.03253, "mature_H5_site": -5, "mouse_sera_escape": -0.07238, "mutant": "E", "mutation": "S6E", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.1117, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.778, "ferret_sera_escape": null, "mature_H5_site": -5, "mouse_sera_escape": null, "mutant": "F", "mutation": "S6F", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.569, "ferret_sera_escape": 0.0298, "mature_H5_site": -5, "mouse_sera_escape": 0.04543, "mutant": "H", "mutation": "S6H", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": 0.001495, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.428, "ferret_sera_escape": null, "mature_H5_site": -5, "mouse_sera_escape": null, "mutant": "I", "mutation": "S6I", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.7833, "ferret_sera_escape": 0.00223, "mature_H5_site": -5, "mouse_sera_escape": -0.07554, "mutant": "K", "mutation": "S6K", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.1063, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.873, "ferret_sera_escape": null, "mature_H5_site": -5, "mouse_sera_escape": null, "mutant": "L", "mutation": "S6L", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4491, "ferret_sera_escape": -0.2004, "mature_H5_site": -5, "mouse_sera_escape": -0.03534, "mutant": "M", "mutation": "S6M", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.1886, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.643, "ferret_sera_escape": null, "mature_H5_site": -5, "mouse_sera_escape": null, "mutant": "N", "mutation": "S6N", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3704, "ferret_sera_escape": -0.1131, "mature_H5_site": -5, "mouse_sera_escape": -0.1348, "mutant": "P", "mutation": "S6P", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.1384, "wildtype": "S"}, {"a26_usage": 0.3168, "cell_entry": -0.2005, "ferret_sera_escape": -0.01935, "mature_H5_site": -5, "mouse_sera_escape": 0.003384, "mutant": "Q", "mutation": "S6Q", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.05521, "wildtype": "S"}, {"a26_usage": 0.2977, "cell_entry": -0.149, "ferret_sera_escape": -0.09712, "mature_H5_site": -5, "mouse_sera_escape": -0.01473, "mutant": "R", "mutation": "S6R", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.05971, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -5, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S6S", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06222, "ferret_sera_escape": null, "mature_H5_site": -5, "mouse_sera_escape": null, "mutant": "T", "mutation": "S6T", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1581, "ferret_sera_escape": -0.05078, "mature_H5_site": -5, "mouse_sera_escape": 0.03246, "mutant": "V", "mutation": "S6V", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.3199, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3823, "ferret_sera_escape": null, "mature_H5_site": -5, "mouse_sera_escape": null, "mutant": "W", "mutation": "S6W", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1547, "ferret_sera_escape": null, "mature_H5_site": -5, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S6Y", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.736, "ferret_sera_escape": -0.04662, "mature_H5_site": 51, "mouse_sera_escape": 0.2298, "mutant": "A", "mutation": "I60A", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": 0.04208, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.9248, "ferret_sera_escape": 0.4594, "mature_H5_site": 51, "mouse_sera_escape": 0.4198, "mutant": "C", "mutation": "I60C", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.8294, "ferret_sera_escape": 0.0309, "mature_H5_site": 51, "mouse_sera_escape": 0.2008, "mutant": "F", "mutation": "I60F", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": 0.03614, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.018, "ferret_sera_escape": null, "mature_H5_site": 51, "mouse_sera_escape": null, "mutant": "G", "mutation": "I60G", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.888, "ferret_sera_escape": -0.03126, "mature_H5_site": 51, "mouse_sera_escape": 0.2491, "mutant": "H", "mutation": "I60H", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 51, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I60I", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.875, "ferret_sera_escape": null, "mature_H5_site": 51, "mouse_sera_escape": null, "mutant": "K", "mutation": "I60K", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.206, "ferret_sera_escape": null, "mature_H5_site": 51, "mouse_sera_escape": null, "mutant": "N", "mutation": "I60N", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.579, "ferret_sera_escape": null, "mature_H5_site": 51, "mouse_sera_escape": null, "mutant": "P", "mutation": "I60P", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.633, "ferret_sera_escape": -0.1783, "mature_H5_site": 51, "mouse_sera_escape": null, "mutant": "R", "mutation": "I60R", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.073, "ferret_sera_escape": null, "mature_H5_site": 51, "mouse_sera_escape": null, "mutant": "S", "mutation": "I60S", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3814, "ferret_sera_escape": null, "mature_H5_site": 51, "mouse_sera_escape": null, "mutant": "T", "mutation": "I60T", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.794, "ferret_sera_escape": 0.1144, "mature_H5_site": 51, "mouse_sera_escape": 0.07242, "mutant": "V", "mutation": "I60V", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.9885, "ferret_sera_escape": 0.07788, "mature_H5_site": 51, "mouse_sera_escape": 0.1646, "mutant": "W", "mutation": "I60W", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": -0.06035, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.458, "ferret_sera_escape": -0.007833, "mature_H5_site": 51, "mouse_sera_escape": 0.4154, "mutant": "Y", "mutation": "I60Y", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": -0.09065, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.892, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "A", "mutation": "L61A", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.894, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "D", "mutation": "L61D", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "E", "mutation": "L61E", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.606, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "G", "mutation": "L61G", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.89, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "H", "mutation": "L61H", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "I", "mutation": "L61I", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "K", "mutation": "L61K", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 52, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L61L", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.599, "ferret_sera_escape": -0.2107, "mature_H5_site": 52, "mouse_sera_escape": 0.4235, "mutant": "M", "mutation": "L61M", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": 1.135, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.877, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "N", "mutation": "L61N", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "P", "mutation": "L61P", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.322, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L61Q", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.401, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "R", "mutation": "L61R", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.004, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "T", "mutation": "L61T", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.828, "ferret_sera_escape": -0.3912, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "V", "mutation": "L61V", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": 2.154, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "W", "mutation": "L61W", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.496, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L61Y", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.2103, "cell_entry": -0.3787, "ferret_sera_escape": -0.03482, "mature_H5_site": 53, "mouse_sera_escape": 0.1572, "mutant": "A", "mutation": "K62A", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 0.5095, "wildtype": "K"}, {"a26_usage": 0.3012, "cell_entry": -0.5895, "ferret_sera_escape": null, "mature_H5_site": 53, "mouse_sera_escape": null, "mutant": "C", "mutation": "K62C", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": null, "wildtype": "K"}, {"a26_usage": 0.544, "cell_entry": -0.6194, "ferret_sera_escape": -0.1863, "mature_H5_site": 53, "mouse_sera_escape": 0.1895, "mutant": "E", "mutation": "K62E", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 1.505, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2031, "ferret_sera_escape": -0.2362, "mature_H5_site": 53, "mouse_sera_escape": 0.1205, "mutant": "G", "mutation": "K62G", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 0.2384, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.02072, "ferret_sera_escape": null, "mature_H5_site": 53, "mouse_sera_escape": null, "mutant": "H", "mutation": "K62H", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1461, "ferret_sera_escape": -0.02224, "mature_H5_site": 53, "mouse_sera_escape": 0.7219, "mutant": "I", "mutation": "K62I", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 53, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K62K", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.584, "ferret_sera_escape": -0.1328, "mature_H5_site": 53, "mouse_sera_escape": 0.3492, "mutant": "L", "mutation": "K62L", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2155, "ferret_sera_escape": -0.1998, "mature_H5_site": 53, "mouse_sera_escape": 0.07909, "mutant": "M", "mutation": "K62M", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 0.7379, "wildtype": "K"}, {"a26_usage": 0.1345, "cell_entry": -0.1051, "ferret_sera_escape": -0.06532, "mature_H5_site": 53, "mouse_sera_escape": 0.2143, "mutant": "N", "mutation": "K62N", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": -0.1027, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.724, "ferret_sera_escape": -0.3693, "mature_H5_site": 53, "mouse_sera_escape": 0.6755, "mutant": "P", "mutation": "K62P", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.004185, "ferret_sera_escape": -0.00694, "mature_H5_site": 53, "mouse_sera_escape": 0.1509, "mutant": "R", "mutation": "K62R", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 0.1848, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1897, "ferret_sera_escape": null, "mature_H5_site": 53, "mouse_sera_escape": null, "mutant": "S", "mutation": "K62S", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3188, "ferret_sera_escape": -0.2555, "mature_H5_site": 53, "mouse_sera_escape": 0.2395, "mutant": "T", "mutation": "K62T", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 1.534, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3853, "ferret_sera_escape": -0.1277, "mature_H5_site": 53, "mouse_sera_escape": 0.4231, "mutant": "W", "mutation": "K62W", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 1.067, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5438, "ferret_sera_escape": -0.04776, "mature_H5_site": 53, "mouse_sera_escape": 0.4437, "mutant": "Y", "mutation": "K62Y", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 1.357, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.433, "ferret_sera_escape": -0.1744, "mature_H5_site": 54, "mouse_sera_escape": 0.006536, "mutant": "A", "mutation": "D63A", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": -0.1776, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.06985, "ferret_sera_escape": -0.1425, "mature_H5_site": 54, "mouse_sera_escape": 0.2885, "mutant": "C", "mutation": "D63C", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": 0.07007, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 54, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D63D", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.06502, "ferret_sera_escape": 0.03186, "mature_H5_site": 54, "mouse_sera_escape": 0.06569, "mutant": "E", "mutation": "D63E", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": -0.3004, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.022, "ferret_sera_escape": 0.1418, "mature_H5_site": 54, "mouse_sera_escape": 0.3055, "mutant": "G", "mutation": "D63G", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": -0.03334, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.03997, "ferret_sera_escape": -0.1336, "mature_H5_site": 54, "mouse_sera_escape": -0.03243, "mutant": "H", "mutation": "D63H", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": -0.2683, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.183, "ferret_sera_escape": null, "mature_H5_site": 54, "mouse_sera_escape": null, "mutant": "I", "mutation": "D63I", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5555, "ferret_sera_escape": -0.1182, "mature_H5_site": 54, "mouse_sera_escape": 0.2177, "mutant": "K", "mutation": "D63K", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": 0.4305, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.0177, "ferret_sera_escape": -0.2387, "mature_H5_site": 54, "mouse_sera_escape": -0.02605, "mutant": "M", "mutation": "D63M", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": -0.1317, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1133, "ferret_sera_escape": -0.1989, "mature_H5_site": 54, "mouse_sera_escape": 0.0553, "mutant": "N", "mutation": "D63N", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": -0.1598, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.553, "ferret_sera_escape": null, "mature_H5_site": 54, "mouse_sera_escape": null, "mutant": "P", "mutation": "D63P", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.09643, "ferret_sera_escape": -0.1895, "mature_H5_site": 54, "mouse_sera_escape": -0.04479, "mutant": "Q", "mutation": "D63Q", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5269, "ferret_sera_escape": null, "mature_H5_site": 54, "mouse_sera_escape": null, "mutant": "R", "mutation": "D63R", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": null, "wildtype": "D"}, {"a26_usage": 0.3448, "cell_entry": -0.1572, "ferret_sera_escape": -0.01979, "mature_H5_site": 54, "mouse_sera_escape": 0.00411, "mutant": "S", "mutation": "D63S", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": -0.1181, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.287, "ferret_sera_escape": -0.3556, "mature_H5_site": 54, "mouse_sera_escape": null, "mutant": "V", "mutation": "D63V", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": 0.7025, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2922, "ferret_sera_escape": -0.0433, "mature_H5_site": 54, "mouse_sera_escape": 0.08071, "mutant": "W", "mutation": "D63W", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8444, "ferret_sera_escape": -0.2765, "mature_H5_site": 54, "mouse_sera_escape": 0.0941, "mutant": "Y", "mutation": "D63Y", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": 0.4857, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.022, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "A", "mutation": "C64A", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 55, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C64C", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "D", "mutation": "C64D", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.668, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "E", "mutation": "C64E", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.988, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "F", "mutation": "C64F", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.997, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "G", "mutation": "C64G", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "K", "mutation": "C64K", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "L", "mutation": "C64L", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "M", "mutation": "C64M", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.026, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "N", "mutation": "C64N", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "P", "mutation": "C64P", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C64Q", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.752, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "R", "mutation": "C64R", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.594, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "S", "mutation": "C64S", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "T", "mutation": "C64T", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "V", "mutation": "C64V", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "W", "mutation": "C64W", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C64Y", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -1.616, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "A", "mutation": "S65A", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "C", "mutation": "S65C", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.3, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "D", "mutation": "S65D", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "E", "mutation": "S65E", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "F", "mutation": "S65F", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2333, "ferret_sera_escape": 0.3734, "mature_H5_site": 56, "mouse_sera_escape": 0.4911, "mutant": "G", "mutation": "S65G", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": 1.436, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.855, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "I", "mutation": "S65I", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.632, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "K", "mutation": "S65K", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.701, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "L", "mutation": "S65L", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "M", "mutation": "S65M", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.102, "ferret_sera_escape": -0.1516, "mature_H5_site": 56, "mouse_sera_escape": 0.7722, "mutant": "N", "mutation": "S65N", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": 1.041, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "P", "mutation": "S65P", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "Q", "mutation": "S65Q", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "R", "mutation": "S65R", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 56, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S65S", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.986, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "V", "mutation": "S65V", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.863, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "W", "mutation": "S65W", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.513, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S65Y", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 57, "mouse_sera_escape": null, "mutant": "D", "mutation": "V66D", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.696, "ferret_sera_escape": -0.4908, "mature_H5_site": 57, "mouse_sera_escape": -0.002361, "mutant": "F", "mutation": "V66F", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": 1.273, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.652, "ferret_sera_escape": null, "mature_H5_site": 57, "mouse_sera_escape": null, "mutant": "G", "mutation": "V66G", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5702, "ferret_sera_escape": 0.01875, "mature_H5_site": 57, "mouse_sera_escape": -0.01928, "mutant": "I", "mutation": "V66I", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": -0.1788, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.975, "ferret_sera_escape": null, "mature_H5_site": 57, "mouse_sera_escape": null, "mutant": "K", "mutation": "V66K", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.322, "ferret_sera_escape": -0.3046, "mature_H5_site": 57, "mouse_sera_escape": -0.09018, "mutant": "L", "mutation": "V66L", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": 1.49, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5219, "ferret_sera_escape": -0.2045, "mature_H5_site": 57, "mouse_sera_escape": 0.09376, "mutant": "M", "mutation": "V66M", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": 1.407, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 57, "mouse_sera_escape": null, "mutant": "N", "mutation": "V66N", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 57, "mouse_sera_escape": null, "mutant": "R", "mutation": "V66R", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.577, "ferret_sera_escape": -0.121, "mature_H5_site": 57, "mouse_sera_escape": -0.02639, "mutant": "S", "mutation": "V66S", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": null, "wildtype": "V"}, {"a26_usage": 0.4886, "cell_entry": -0.08569, "ferret_sera_escape": 0.06963, "mature_H5_site": 57, "mouse_sera_escape": 0.1539, "mutant": "T", "mutation": "V66T", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": 0.7787, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 57, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V66V", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.671, "ferret_sera_escape": -0.1499, "mature_H5_site": 57, "mouse_sera_escape": 0.08761, "mutant": "Y", "mutation": "V66Y", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": -0.1587, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 58, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A67A", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2758, "ferret_sera_escape": -0.1438, "mature_H5_site": 58, "mouse_sera_escape": 0.07305, "mutant": "D", "mutation": "A67D", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": 0.7784, "wildtype": "A"}, {"a26_usage": 0.143, "cell_entry": 0.01528, "ferret_sera_escape": -0.2151, "mature_H5_site": 58, "mouse_sera_escape": -0.05378, "mutant": "E", "mutation": "A67E", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": 0.9902, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.007, "ferret_sera_escape": -0.309, "mature_H5_site": 58, "mouse_sera_escape": 0.02903, "mutant": "F", "mutation": "A67F", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.07248, "ferret_sera_escape": 0.1896, "mature_H5_site": 58, "mouse_sera_escape": 0.3088, "mutant": "G", "mutation": "A67G", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": 1.123, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1648, "ferret_sera_escape": 0.1001, "mature_H5_site": 58, "mouse_sera_escape": 0.02667, "mutant": "H", "mutation": "A67H", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": -0.1972, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.615, "ferret_sera_escape": null, "mature_H5_site": 58, "mouse_sera_escape": null, "mutant": "I", "mutation": "A67I", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.442, "ferret_sera_escape": -0.3139, "mature_H5_site": 58, "mouse_sera_escape": -0.1918, "mutant": "K", "mutation": "A67K", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.125, "ferret_sera_escape": -0.2841, "mature_H5_site": 58, "mouse_sera_escape": -0.1758, "mutant": "L", "mutation": "A67L", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": -0.1967, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3121, "ferret_sera_escape": -0.4841, "mature_H5_site": 58, "mouse_sera_escape": -0.2866, "mutant": "M", "mutation": "A67M", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": -0.2438, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.8889, "ferret_sera_escape": -0.3201, "mature_H5_site": 58, "mouse_sera_escape": -0.1738, "mutant": "N", "mutation": "A67N", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": -0.1847, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2518, "ferret_sera_escape": -0.08807, "mature_H5_site": 58, "mouse_sera_escape": -0.003304, "mutant": "Q", "mutation": "A67Q", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": 1.157, "wildtype": "A"}, {"a26_usage": 0.1985, "cell_entry": 0.06757, "ferret_sera_escape": -0.1329, "mature_H5_site": 58, "mouse_sera_escape": -0.1357, "mutant": "R", "mutation": "A67R", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": 0.4634, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2181, "ferret_sera_escape": -0.01612, "mature_H5_site": 58, "mouse_sera_escape": -0.02439, "mutant": "S", "mutation": "A67S", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": -0.2217, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.87, "ferret_sera_escape": 0.0408, "mature_H5_site": 58, "mouse_sera_escape": -0.06765, "mutant": "T", "mutation": "A67T", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.9566, "ferret_sera_escape": -0.1212, "mature_H5_site": 58, "mouse_sera_escape": -0.1128, "mutant": "V", "mutation": "A67V", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": -0.2119, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 58, "mouse_sera_escape": null, "mutant": "W", "mutation": "A67W", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.144, "ferret_sera_escape": null, "mature_H5_site": 58, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A67Y", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "C", "mutation": "G68C", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "D", "mutation": "G68D", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "E", "mutation": "G68E", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.768, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "F", "mutation": "G68F", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 59, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G68G", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.074, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "H", "mutation": "G68H", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.039, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "I", "mutation": "G68I", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "K", "mutation": "G68K", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.01, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "L", "mutation": "G68L", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.885, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "M", "mutation": "G68M", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "N", "mutation": "G68N", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "P", "mutation": "G68P", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "R", "mutation": "G68R", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8814, "ferret_sera_escape": -0.3734, "mature_H5_site": 59, "mouse_sera_escape": 0.3833, "mutant": "S", "mutation": "G68S", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": 1.139, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.266, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "T", "mutation": "G68T", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "V", "mutation": "G68V", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "W", "mutation": "G68W", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G68Y", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.426, "ferret_sera_escape": 0.05604, "mature_H5_site": 60, "mouse_sera_escape": 0.6608, "mutant": "A", "mutation": "W69A", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": 1.962, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "D", "mutation": "W69D", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "E", "mutation": "W69E", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.6777, "cell_entry": -0.6725, "ferret_sera_escape": -0.07382, "mature_H5_site": 60, "mouse_sera_escape": 0.3714, "mutant": "F", "mutation": "W69F", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": 0.8549, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.615, "ferret_sera_escape": null, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "H", "mutation": "W69H", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.392, "ferret_sera_escape": 0.2585, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "I", "mutation": "W69I", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "K", "mutation": "W69K", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.687, "ferret_sera_escape": 0.2357, "mature_H5_site": 60, "mouse_sera_escape": 0.5515, "mutant": "L", "mutation": "W69L", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": 0.8241, "wildtype": "W"}, {"a26_usage": 0.8409, "cell_entry": -0.4942, "ferret_sera_escape": 0.2727, "mature_H5_site": 60, "mouse_sera_escape": 0.3714, "mutant": "M", "mutation": "W69M", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": 0.7177, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.752, "ferret_sera_escape": null, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "N", "mutation": "W69N", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "P", "mutation": "W69P", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "R", "mutation": "W69R", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 60, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W69W", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.06333, "ferret_sera_escape": -0.04663, "mature_H5_site": -4, "mouse_sera_escape": -0.03246, "mutant": "A", "mutation": "L7A", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.0367, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06154, "ferret_sera_escape": -0.1037, "mature_H5_site": -4, "mouse_sera_escape": -0.01014, "mutant": "C", "mutation": "L7C", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": 0.06221, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.361, "ferret_sera_escape": null, "mature_H5_site": -4, "mouse_sera_escape": null, "mutant": "D", "mutation": "L7D", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.682, "ferret_sera_escape": null, "mature_H5_site": -4, "mouse_sera_escape": null, "mutant": "E", "mutation": "L7E", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1975, "ferret_sera_escape": 0.00554, "mature_H5_site": -4, "mouse_sera_escape": 0.04694, "mutant": "F", "mutation": "L7F", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": 0.02108, "wildtype": "L"}, {"a26_usage": 0.1611, "cell_entry": -0.4309, "ferret_sera_escape": -0.0517, "mature_H5_site": -4, "mouse_sera_escape": -0.08819, "mutant": "G", "mutation": "L7G", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.04793, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.852, "ferret_sera_escape": 0.01347, "mature_H5_site": -4, "mouse_sera_escape": -0.08026, "mutant": "H", "mutation": "L7H", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.1645, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06029, "ferret_sera_escape": 0.08019, "mature_H5_site": -4, "mouse_sera_escape": -0.02588, "mutant": "I", "mutation": "L7I", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.08033, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.435, "ferret_sera_escape": 0.02823, "mature_H5_site": -4, "mouse_sera_escape": -0.04386, "mutant": "K", "mutation": "L7K", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.06201, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -4, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L7L", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.08317, "cell_entry": -0.07169, "ferret_sera_escape": -0.2104, "mature_H5_site": -4, "mouse_sera_escape": 0.02169, "mutant": "M", "mutation": "L7M", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": 0.02411, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.061, "ferret_sera_escape": -0.0703, "mature_H5_site": -4, "mouse_sera_escape": -0.07288, "mutant": "N", "mutation": "L7N", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.682, "ferret_sera_escape": -0.07504, "mature_H5_site": -4, "mouse_sera_escape": -0.2655, "mutant": "P", "mutation": "L7P", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.2922, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1336, "ferret_sera_escape": 0.03865, "mature_H5_site": -4, "mouse_sera_escape": -0.1414, "mutant": "Q", "mutation": "L7Q", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.04259, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.316, "ferret_sera_escape": -0.01596, "mature_H5_site": -4, "mouse_sera_escape": 0.04856, "mutant": "R", "mutation": "L7R", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.0473, "wildtype": "L"}, {"a26_usage": 0.5066, "cell_entry": -0.1081, "ferret_sera_escape": 0.02302, "mature_H5_site": -4, "mouse_sera_escape": -0.015, "mutant": "S", "mutation": "L7S", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.1607, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.05344, "ferret_sera_escape": 0.03521, "mature_H5_site": -4, "mouse_sera_escape": -0.08046, "mutant": "T", "mutation": "L7T", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": 0.01666, "wildtype": "L"}, {"a26_usage": 0.1357, "cell_entry": -0.3272, "ferret_sera_escape": -0.01259, "mature_H5_site": -4, "mouse_sera_escape": -0.07177, "mutant": "W", "mutation": "L7W", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.02906, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.918, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "A", "mutation": "L70A", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.004, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "C", "mutation": "L70C", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.81, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "D", "mutation": "L70D", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "E", "mutation": "L70E", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.01501, "ferret_sera_escape": -0.1244, "mature_H5_site": 61, "mouse_sera_escape": -0.09554, "mutant": "F", "mutation": "L70F", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2067, "ferret_sera_escape": -0.06712, "mature_H5_site": 61, "mouse_sera_escape": -0.151, "mutant": "I", "mutation": "L70I", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": 1.535, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.341, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "K", "mutation": "L70K", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 61, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L70L", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1828, "ferret_sera_escape": -0.09763, "mature_H5_site": 61, "mouse_sera_escape": -0.1616, "mutant": "M", "mutation": "L70M", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": -0.3008, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "N", "mutation": "L70N", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.94, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "P", "mutation": "L70P", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L70Q", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "R", "mutation": "L70R", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.93, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "S", "mutation": "L70S", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.236, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "T", "mutation": "L70T", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5242, "ferret_sera_escape": -0.17, "mature_H5_site": 61, "mouse_sera_escape": 0.005747, "mutant": "V", "mutation": "L70V", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": 1.643, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "W", "mutation": "L70W", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L70Y", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "D", "mutation": "L71D", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "E", "mutation": "L71E", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.389, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "F", "mutation": "L71F", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.978, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "G", "mutation": "L71G", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.079, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "H", "mutation": "L71H", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.02275, "ferret_sera_escape": -0.1148, "mature_H5_site": 62, "mouse_sera_escape": -0.04255, "mutant": "I", "mutation": "L71I", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": -0.2741, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "K", "mutation": "L71K", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 62, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L71L", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.05026, "ferret_sera_escape": 0.1284, "mature_H5_site": 62, "mouse_sera_escape": 0.001895, "mutant": "M", "mutation": "L71M", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": -0.05225, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.865, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "N", "mutation": "L71N", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "P", "mutation": "L71P", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.829, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L71Q", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "R", "mutation": "L71R", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.077, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "S", "mutation": "L71S", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.03558, "ferret_sera_escape": -0.01686, "mature_H5_site": 62, "mouse_sera_escape": -0.09367, "mutant": "T", "mutation": "L71T", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": -0.2097, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.293, "ferret_sera_escape": -0.3777, "mature_H5_site": 62, "mouse_sera_escape": -0.06395, "mutant": "V", "mutation": "L71V", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": -0.134, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "W", "mutation": "L71W", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06073, "ferret_sera_escape": -0.304, "mature_H5_site": 62, "mouse_sera_escape": -0.233, "mutant": "Y", "mutation": "L71Y", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": -0.2854, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.013, "ferret_sera_escape": 0.08174, "mature_H5_site": 63, "mouse_sera_escape": -0.1052, "mutant": "A", "mutation": "G72A", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.965, "ferret_sera_escape": -0.3571, "mature_H5_site": 63, "mouse_sera_escape": null, "mutant": "C", "mutation": "G72C", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": -0.0969, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.338, "ferret_sera_escape": -0.3527, "mature_H5_site": 63, "mouse_sera_escape": 0.2, "mutant": "D", "mutation": "G72D", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": 1.808, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.219, "ferret_sera_escape": -0.3176, "mature_H5_site": 63, "mouse_sera_escape": 0.6928, "mutant": "E", "mutation": "G72E", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": 1.529, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.643, "ferret_sera_escape": -0.2867, "mature_H5_site": 63, "mouse_sera_escape": -0.3262, "mutant": "F", "mutation": "G72F", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": 0.3479, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 63, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G72G", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.042, "ferret_sera_escape": -0.09539, "mature_H5_site": 63, "mouse_sera_escape": -0.1862, "mutant": "H", "mutation": "G72H", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": 1.172, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 63, "mouse_sera_escape": null, "mutant": "K", "mutation": "G72K", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2557, "ferret_sera_escape": -0.17, "mature_H5_site": 63, "mouse_sera_escape": -0.3164, "mutant": "L", "mutation": "G72L", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": -0.2503, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2674, "ferret_sera_escape": -0.2161, "mature_H5_site": 63, "mouse_sera_escape": null, "mutant": "M", "mutation": "G72M", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0276, "ferret_sera_escape": 0.174, "mature_H5_site": 63, "mouse_sera_escape": 0.08254, "mutant": "N", "mutation": "G72N", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": -0.1399, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 63, "mouse_sera_escape": null, "mutant": "P", "mutation": "G72P", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.05225, "ferret_sera_escape": 0.1331, "mature_H5_site": 63, "mouse_sera_escape": -0.02593, "mutant": "Q", "mutation": "G72Q", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": 0.2559, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.881, "ferret_sera_escape": -0.5647, "mature_H5_site": 63, "mouse_sera_escape": 0.1157, "mutant": "R", "mutation": "G72R", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": null, "wildtype": "G"}, {"a26_usage": 0.1762, "cell_entry": 0.003275, "ferret_sera_escape": 0.01064, "mature_H5_site": 63, "mouse_sera_escape": -0.02674, "mutant": "S", "mutation": "G72S", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": 0.5386, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3665, "ferret_sera_escape": -0.1575, "mature_H5_site": 63, "mouse_sera_escape": -0.168, "mutant": "T", "mutation": "G72T", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": -0.1205, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.62, "ferret_sera_escape": -0.09771, "mature_H5_site": 63, "mouse_sera_escape": -0.03313, "mutant": "V", "mutation": "G72V", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.663, "ferret_sera_escape": null, "mature_H5_site": 63, "mouse_sera_escape": null, "mutant": "W", "mutation": "G72W", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.662, "ferret_sera_escape": -0.1829, "mature_H5_site": 64, "mouse_sera_escape": 0.4092, "mutant": "C", "mutation": "N73C", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": 1.28, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.149, "ferret_sera_escape": 0.3016, "mature_H5_site": 64, "mouse_sera_escape": 0.626, "mutant": "D", "mutation": "N73D", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": 0.8173, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.567, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "E", "mutation": "N73E", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.424, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "F", "mutation": "N73F", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.495, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "G", "mutation": "N73G", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.006185, "ferret_sera_escape": -0.2072, "mature_H5_site": 64, "mouse_sera_escape": -0.1347, "mutant": "H", "mutation": "N73H", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": 0.3414, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3503, "ferret_sera_escape": -0.3071, "mature_H5_site": 64, "mouse_sera_escape": 0.04362, "mutant": "I", "mutation": "N73I", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.819, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "K", "mutation": "N73K", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6997, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": -0.3946, "mutant": "L", "mutation": "N73L", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 2.421, "cell_entry": -2.942, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "M", "mutation": "N73M", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 64, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N73N", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.492, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "P", "mutation": "N73P", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "R", "mutation": "N73R", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05303, "ferret_sera_escape": 0.2465, "mature_H5_site": 64, "mouse_sera_escape": 0.2993, "mutant": "S", "mutation": "N73S", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.00931, "ferret_sera_escape": 0.1238, "mature_H5_site": 64, "mouse_sera_escape": 0.3714, "mutant": "T", "mutation": "N73T", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": 0.9904, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.06935, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "V", "mutation": "N73V", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "W", "mutation": "N73W", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.344, "ferret_sera_escape": -0.2369, "mature_H5_site": 65, "mouse_sera_escape": -0.1285, "mutant": "A", "mutation": "P74A", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": 0.3172, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "D", "mutation": "P74D", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.69, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "E", "mutation": "P74E", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.409, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "G", "mutation": "P74G", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.422, "ferret_sera_escape": -0.3585, "mature_H5_site": 65, "mouse_sera_escape": 0.1228, "mutant": "H", "mutation": "P74H", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.046, "ferret_sera_escape": -0.7894, "mature_H5_site": 65, "mouse_sera_escape": -0.1107, "mutant": "I", "mutation": "P74I", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1146, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "K", "mutation": "P74K", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.198, "ferret_sera_escape": -0.3777, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "L", "mutation": "P74L", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.6854, "ferret_sera_escape": -0.1324, "mature_H5_site": 65, "mouse_sera_escape": 0.385, "mutant": "M", "mutation": "P74M", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": 1.514, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.696, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "N", "mutation": "P74N", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 65, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P74P", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.642, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P74Q", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5766, "ferret_sera_escape": 0.177, "mature_H5_site": 65, "mouse_sera_escape": 0.4208, "mutant": "R", "mutation": "P74R", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": 0.6363, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5088, "ferret_sera_escape": -0.3128, "mature_H5_site": 65, "mouse_sera_escape": -0.09603, "mutant": "S", "mutation": "P74S", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": -0.1017, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.7262, "ferret_sera_escape": -0.1476, "mature_H5_site": 65, "mouse_sera_escape": 0.05828, "mutant": "T", "mutation": "P74T", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": -0.07082, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.865, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "V", "mutation": "P74V", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "W", "mutation": "P74W", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.927, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "Y", "mutation": "P74Y", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.06545, "ferret_sera_escape": -0.005742, "mature_H5_site": 66, "mouse_sera_escape": -0.04899, "mutant": "A", "mutation": "M75A", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": -0.106, "wildtype": "M"}, {"a26_usage": 0.02184, "cell_entry": 0.02638, "ferret_sera_escape": -0.02638, "mature_H5_site": 66, "mouse_sera_escape": 0.02055, "mutant": "D", "mutation": "M75D", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": -0.09187, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.373, "ferret_sera_escape": 0.04231, "mature_H5_site": 66, "mouse_sera_escape": 0.1749, "mutant": "E", "mutation": "M75E", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": -0.0654, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.05476, "ferret_sera_escape": null, "mature_H5_site": 66, "mouse_sera_escape": null, "mutant": "G", "mutation": "M75G", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.1639, "ferret_sera_escape": -0.1004, "mature_H5_site": 66, "mouse_sera_escape": -0.0841, "mutant": "H", "mutation": "M75H", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.01932, "wildtype": "M"}, {"a26_usage": 0.3286, "cell_entry": 0.01358, "ferret_sera_escape": -0.06841, "mature_H5_site": 66, "mouse_sera_escape": 0.09065, "mutant": "I", "mutation": "M75I", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.6712, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.04086, "ferret_sera_escape": 0.01242, "mature_H5_site": 66, "mouse_sera_escape": 0.01147, "mutant": "L", "mutation": "M75L", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.06988, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 66, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M75M", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.475, "ferret_sera_escape": null, "mature_H5_site": 66, "mouse_sera_escape": null, "mutant": "P", "mutation": "M75P", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.01276, "ferret_sera_escape": 0.00571, "mature_H5_site": 66, "mouse_sera_escape": -0.02447, "mutant": "Q", "mutation": "M75Q", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": -0.0009615, "wildtype": "M"}, {"a26_usage": 0.1558, "cell_entry": -0.3531, "ferret_sera_escape": 0.09155, "mature_H5_site": 66, "mouse_sera_escape": 0.05875, "mutant": "R", "mutation": "M75R", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.2389, "wildtype": "M"}, {"a26_usage": 0.006065, "cell_entry": -0.2357, "ferret_sera_escape": 0.04751, "mature_H5_site": 66, "mouse_sera_escape": 0.08668, "mutant": "T", "mutation": "M75T", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.3516, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.118, "ferret_sera_escape": 0.1301, "mature_H5_site": 66, "mouse_sera_escape": 0.329, "mutant": "V", "mutation": "M75V", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.454, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.03615, "ferret_sera_escape": 0.1724, "mature_H5_site": 66, "mouse_sera_escape": 0.03538, "mutant": "W", "mutation": "M75W", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.01318, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.01911, "ferret_sera_escape": -0.135, "mature_H5_site": 66, "mouse_sera_escape": -0.03256, "mutant": "Y", "mutation": "M75Y", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": -0.002541, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "A", "mutation": "C76A", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 67, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C76C", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "D", "mutation": "C76D", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "E", "mutation": "C76E", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.455, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "F", "mutation": "C76F", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "H", "mutation": "C76H", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "I", "mutation": "C76I", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.722, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "K", "mutation": "C76K", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "L", "mutation": "C76L", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "M", "mutation": "C76M", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "N", "mutation": "C76N", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C76Q", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.729, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "R", "mutation": "C76R", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.05, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "S", "mutation": "C76S", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.785, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "T", "mutation": "C76T", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "V", "mutation": "C76V", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C76Y", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.6153, "ferret_sera_escape": -0.03662, "mature_H5_site": 68, "mouse_sera_escape": 0.3201, "mutant": "A", "mutation": "D77A", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.598, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.362, "ferret_sera_escape": null, "mature_H5_site": 68, "mouse_sera_escape": null, "mutant": "C", "mutation": "D77C", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 68, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D77D", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.1981, "cell_entry": -0.6577, "ferret_sera_escape": -0.03295, "mature_H5_site": 68, "mouse_sera_escape": 0.1682, "mutant": "E", "mutation": "D77E", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.544, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8933, "ferret_sera_escape": 0.2073, "mature_H5_site": 68, "mouse_sera_escape": 0.2451, "mutant": "F", "mutation": "D77F", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.05326, "ferret_sera_escape": -0.05128, "mature_H5_site": 68, "mouse_sera_escape": 0.2024, "mutant": "G", "mutation": "D77G", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.334, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.517, "ferret_sera_escape": -0.05521, "mature_H5_site": 68, "mouse_sera_escape": 0.1575, "mutant": "H", "mutation": "D77H", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.577, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1036, "ferret_sera_escape": -0.02655, "mature_H5_site": 68, "mouse_sera_escape": 0.2202, "mutant": "I", "mutation": "D77I", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.375, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7425, "ferret_sera_escape": -0.0983, "mature_H5_site": 68, "mouse_sera_escape": 0.3103, "mutant": "L", "mutation": "D77L", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.079, "wildtype": "D"}, {"a26_usage": 0.783, "cell_entry": -0.2082, "ferret_sera_escape": 0.08637, "mature_H5_site": 68, "mouse_sera_escape": 0.1315, "mutant": "M", "mutation": "D77M", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.547, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.783, "ferret_sera_escape": -0.1739, "mature_H5_site": 68, "mouse_sera_escape": 0.2067, "mutant": "N", "mutation": "D77N", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.503, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.243, "ferret_sera_escape": 0.3696, "mature_H5_site": 68, "mouse_sera_escape": 0.2876, "mutant": "P", "mutation": "D77P", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.132, "ferret_sera_escape": -0.1025, "mature_H5_site": 68, "mouse_sera_escape": 0.3903, "mutant": "R", "mutation": "D77R", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.303, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.233, "ferret_sera_escape": -0.1561, "mature_H5_site": 68, "mouse_sera_escape": 0.1089, "mutant": "T", "mutation": "D77T", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.757, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6285, "ferret_sera_escape": null, "mature_H5_site": 68, "mouse_sera_escape": null, "mutant": "V", "mutation": "D77V", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.08095, "ferret_sera_escape": -0.05883, "mature_H5_site": 68, "mouse_sera_escape": 0.1731, "mutant": "W", "mutation": "D77W", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 0.5205, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3217, "ferret_sera_escape": 0.135, "mature_H5_site": 68, "mouse_sera_escape": 0.17, "mutant": "Y", "mutation": "D77Y", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 0.6854, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5079, "ferret_sera_escape": null, "mature_H5_site": 69, "mouse_sera_escape": null, "mutant": "C", "mutation": "E78C", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": null, "wildtype": "E"}, {"a26_usage": 0.5123, "cell_entry": -0.1552, "ferret_sera_escape": 0.2454, "mature_H5_site": 69, "mouse_sera_escape": 0.2811, "mutant": "D", "mutation": "E78D", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 2.109, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 69, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E78E", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.04897, "ferret_sera_escape": 0.2216, "mature_H5_site": 69, "mouse_sera_escape": 0.2759, "mutant": "F", "mutation": "E78F", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 1.936, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6919, "ferret_sera_escape": null, "mature_H5_site": 69, "mouse_sera_escape": null, "mutant": "G", "mutation": "E78G", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5219, "ferret_sera_escape": 0.3476, "mature_H5_site": 69, "mouse_sera_escape": 0.3428, "mutant": "K", "mutation": "E78K", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 1.512, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01281, "ferret_sera_escape": 0.1221, "mature_H5_site": 69, "mouse_sera_escape": 0.2911, "mutant": "L", "mutation": "E78L", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 1.736, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.01331, "ferret_sera_escape": 0.2623, "mature_H5_site": 69, "mouse_sera_escape": 0.06854, "mutant": "M", "mutation": "E78M", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 1.066, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1523, "ferret_sera_escape": 0.369, "mature_H5_site": 69, "mouse_sera_escape": 0.2489, "mutant": "N", "mutation": "E78N", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 1.711, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5474, "ferret_sera_escape": 0.1977, "mature_H5_site": 69, "mouse_sera_escape": 0.07269, "mutant": "P", "mutation": "E78P", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 1.358, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.365, "ferret_sera_escape": null, "mature_H5_site": 69, "mouse_sera_escape": null, "mutant": "R", "mutation": "E78R", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7681, "ferret_sera_escape": 0.047, "mature_H5_site": 69, "mouse_sera_escape": 0.3357, "mutant": "T", "mutation": "E78T", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 2.0, "wildtype": "E"}, {"a26_usage": 0.4355, "cell_entry": -0.02172, "ferret_sera_escape": 0.07634, "mature_H5_site": 69, "mouse_sera_escape": 0.1223, "mutant": "W", "mutation": "E78W", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 1.148, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "A", "mutation": "F79A", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "C", "mutation": "F79C", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.691, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "D", "mutation": "F79D", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 70, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F79F", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.645, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "G", "mutation": "F79G", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.777, "ferret_sera_escape": -0.291, "mature_H5_site": 70, "mouse_sera_escape": 0.8872, "mutant": "H", "mutation": "F79H", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": 1.172, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "K", "mutation": "F79K", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.603, "ferret_sera_escape": -0.0318, "mature_H5_site": 70, "mouse_sera_escape": 0.2549, "mutant": "L", "mutation": "F79L", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.373, "ferret_sera_escape": -0.1432, "mature_H5_site": 70, "mouse_sera_escape": 0.4347, "mutant": "N", "mutation": "F79N", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": 1.24, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.009, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "R", "mutation": "F79R", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.91, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "T", "mutation": "F79T", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.807, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "V", "mutation": "F79V", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.07101, "cell_entry": -0.1011, "ferret_sera_escape": -0.05074, "mature_H5_site": 70, "mouse_sera_escape": 0.1443, "mutant": "W", "mutation": "F79W", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": 0.4188, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.05304, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "Y", "mutation": "F79Y", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.1565, "ferret_sera_escape": -0.0036, "mature_H5_site": -3, "mouse_sera_escape": -0.04694, "mutant": "A", "mutation": "V8A", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": -0.01449, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.01557, "ferret_sera_escape": -0.05161, "mature_H5_site": -3, "mouse_sera_escape": -0.08816, "mutant": "C", "mutation": "V8C", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": -0.01971, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "D", "mutation": "V8D", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "E", "mutation": "V8E", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.353, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "F", "mutation": "V8F", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8556, "ferret_sera_escape": -0.1166, "mature_H5_site": -3, "mouse_sera_escape": -0.1394, "mutant": "G", "mutation": "V8G", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": -0.02085, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "H", "mutation": "V8H", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.774, "ferret_sera_escape": -0.2188, "mature_H5_site": -3, "mouse_sera_escape": 0.1289, "mutant": "I", "mutation": "V8I", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": -0.1156, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.255, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "K", "mutation": "V8K", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "L", "mutation": "V8L", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.871, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "M", "mutation": "V8M", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "N", "mutation": "V8N", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "P", "mutation": "V8P", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.988, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V8Q", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.994, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "R", "mutation": "V8R", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1548, "ferret_sera_escape": -0.01651, "mature_H5_site": -3, "mouse_sera_escape": -0.08609, "mutant": "S", "mutation": "V8S", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": -0.04475, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.258, "ferret_sera_escape": 0.06805, "mature_H5_site": -3, "mouse_sera_escape": 0.08082, "mutant": "T", "mutation": "V8T", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": -0.03567, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -3, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V8V", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "W", "mutation": "V8W", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V8Y", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3806, "ferret_sera_escape": 0.6735, "mature_H5_site": 71, "mouse_sera_escape": 0.6624, "mutant": "C", "mutation": "I80C", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": -0.1342, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.00377, "ferret_sera_escape": null, "mature_H5_site": 71, "mouse_sera_escape": null, "mutant": "D", "mutation": "I80D", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": 0.1511, "cell_entry": 0.01899, "ferret_sera_escape": 0.1283, "mature_H5_site": 71, "mouse_sera_escape": 0.2557, "mutant": "E", "mutation": "I80E", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": -0.1354, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.885, "ferret_sera_escape": 0.4988, "mature_H5_site": 71, "mouse_sera_escape": 0.2651, "mutant": "F", "mutation": "I80F", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2, "ferret_sera_escape": null, "mature_H5_site": 71, "mouse_sera_escape": null, "mutant": "G", "mutation": "I80G", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4549, "ferret_sera_escape": 0.1637, "mature_H5_site": 71, "mouse_sera_escape": 0.171, "mutant": "H", "mutation": "I80H", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": -0.08091, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 71, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I80I", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.003725, "ferret_sera_escape": 0.3019, "mature_H5_site": 71, "mouse_sera_escape": 0.6913, "mutant": "K", "mutation": "I80K", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": -0.05519, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03972, "ferret_sera_escape": 0.1242, "mature_H5_site": 71, "mouse_sera_escape": 0.1595, "mutant": "L", "mutation": "I80L", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": -0.2262, "wildtype": "I"}, {"a26_usage": 0.3484, "cell_entry": -0.4484, "ferret_sera_escape": null, "mature_H5_site": 71, "mouse_sera_escape": null, "mutant": "N", "mutation": "I80N", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.04411, "ferret_sera_escape": 0.09186, "mature_H5_site": 71, "mouse_sera_escape": 0.1016, "mutant": "S", "mutation": "I80S", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.9967, "ferret_sera_escape": 0.0979, "mature_H5_site": 71, "mouse_sera_escape": 0.02883, "mutant": "T", "mutation": "I80T", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": -0.08123, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3472, "ferret_sera_escape": -0.007273, "mature_H5_site": 71, "mouse_sera_escape": 0.2241, "mutant": "V", "mutation": "I80V", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": 0.6831, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.755, "ferret_sera_escape": 0.1005, "mature_H5_site": 71, "mouse_sera_escape": -0.07252, "mutant": "W", "mutation": "I80W", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": 0.06834, "cell_entry": -0.8456, "ferret_sera_escape": 0.2098, "mature_H5_site": 71, "mouse_sera_escape": 0.1418, "mutant": "Y", "mutation": "I80Y", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.884, "ferret_sera_escape": 0.1967, "mature_H5_site": 72, "mouse_sera_escape": 0.2311, "mutant": "C", "mutation": "R81C", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": -0.1769, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.09676, "ferret_sera_escape": 0.0621, "mature_H5_site": 72, "mouse_sera_escape": 0.2667, "mutant": "D", "mutation": "R81D", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": -0.06895, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.06783, "ferret_sera_escape": -0.1075, "mature_H5_site": 72, "mouse_sera_escape": 0.07587, "mutant": "E", "mutation": "R81E", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.04221, "ferret_sera_escape": null, "mature_H5_site": 72, "mouse_sera_escape": null, "mutant": "F", "mutation": "R81F", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.02404, "ferret_sera_escape": 0.06069, "mature_H5_site": 72, "mouse_sera_escape": 0.3494, "mutant": "G", "mutation": "R81G", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 1.144, "wildtype": "R"}, {"a26_usage": 0.2186, "cell_entry": 0.03342, "ferret_sera_escape": null, "mature_H5_site": 72, "mouse_sera_escape": null, "mutant": "H", "mutation": "R81H", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7165, "ferret_sera_escape": 0.1269, "mature_H5_site": 72, "mouse_sera_escape": 0.3061, "mutant": "I", "mutation": "R81I", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 1.427, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.04894, "ferret_sera_escape": 0.1492, "mature_H5_site": 72, "mouse_sera_escape": 0.1148, "mutant": "K", "mutation": "R81K", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": -0.08659, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1359, "ferret_sera_escape": 0.06017, "mature_H5_site": 72, "mouse_sera_escape": 0.274, "mutant": "L", "mutation": "R81L", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 1.45, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.01525, "ferret_sera_escape": 0.1394, "mature_H5_site": 72, "mouse_sera_escape": 0.275, "mutant": "M", "mutation": "R81M", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 1.066, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.824, "ferret_sera_escape": null, "mature_H5_site": 72, "mouse_sera_escape": null, "mutant": "P", "mutation": "R81P", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 72, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R81R", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.03213, "ferret_sera_escape": 0.1643, "mature_H5_site": 72, "mouse_sera_escape": 0.26, "mutant": "T", "mutation": "R81T", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 1.511, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.03643, "ferret_sera_escape": 0.03922, "mature_H5_site": 72, "mouse_sera_escape": 0.2774, "mutant": "V", "mutation": "R81V", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 1.127, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.03675, "ferret_sera_escape": 0.1474, "mature_H5_site": 72, "mouse_sera_escape": 0.4148, "mutant": "W", "mutation": "R81W", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 1.483, "wildtype": "R"}, {"a26_usage": 0.005742, "cell_entry": 0.03388, "ferret_sera_escape": 0.2099, "mature_H5_site": 72, "mouse_sera_escape": 0.2893, "mutant": "Y", "mutation": "R81Y", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 0.6215, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2373, "ferret_sera_escape": -0.0518, "mature_H5_site": 73, "mouse_sera_escape": 0.3827, "mutant": "A", "mutation": "V82A", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 1.405, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.412, "ferret_sera_escape": 0.1175, "mature_H5_site": 73, "mouse_sera_escape": 0.258, "mutant": "C", "mutation": "V82C", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 1.141, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.699, "ferret_sera_escape": -0.1723, "mature_H5_site": 73, "mouse_sera_escape": 0.7462, "mutant": "D", "mutation": "V82D", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 2.093, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.892, "ferret_sera_escape": null, "mature_H5_site": 73, "mouse_sera_escape": null, "mutant": "E", "mutation": "V82E", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6677, "ferret_sera_escape": 0.1098, "mature_H5_site": 73, "mouse_sera_escape": 0.2463, "mutant": "F", "mutation": "V82F", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.03844, "ferret_sera_escape": -0.06904, "mature_H5_site": 73, "mouse_sera_escape": 0.2128, "mutant": "I", "mutation": "V82I", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 1.368, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8081, "ferret_sera_escape": null, "mature_H5_site": 73, "mouse_sera_escape": null, "mutant": "K", "mutation": "V82K", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 1.22, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7061, "ferret_sera_escape": -0.09897, "mature_H5_site": 73, "mouse_sera_escape": 0.4504, "mutant": "L", "mutation": "V82L", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 1.816, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.274, "ferret_sera_escape": null, "mature_H5_site": 73, "mouse_sera_escape": null, "mutant": "M", "mutation": "V82M", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.441, "ferret_sera_escape": null, "mature_H5_site": 73, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V82Q", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.937, "ferret_sera_escape": 0.1199, "mature_H5_site": 73, "mouse_sera_escape": 0.5531, "mutant": "S", "mutation": "V82S", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 0.7293, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2484, "ferret_sera_escape": 0.1038, "mature_H5_site": 73, "mouse_sera_escape": 0.1305, "mutant": "T", "mutation": "V82T", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 0.8718, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 73, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V82V", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.046, "ferret_sera_escape": 0.04015, "mature_H5_site": 73, "mouse_sera_escape": 0.3626, "mutant": "Y", "mutation": "V82Y", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 2.21, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.014, "ferret_sera_escape": -0.2447, "mature_H5_site": 74, "mouse_sera_escape": 0.3698, "mutant": "C", "mutation": "P82aC", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": 1.593, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.865, "ferret_sera_escape": null, "mature_H5_site": 74, "mouse_sera_escape": null, "mutant": "F", "mutation": "P82aF", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.474, "ferret_sera_escape": 0.05119, "mature_H5_site": 74, "mouse_sera_escape": 0.2173, "mutant": "G", "mutation": "P82aG", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": 1.374, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.56, "ferret_sera_escape": null, "mature_H5_site": 74, "mouse_sera_escape": null, "mutant": "H", "mutation": "P82aH", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.571, "ferret_sera_escape": null, "mature_H5_site": 74, "mouse_sera_escape": null, "mutant": "K", "mutation": "P82aK", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.52, "ferret_sera_escape": -0.09823, "mature_H5_site": 74, "mouse_sera_escape": 0.5226, "mutant": "L", "mutation": "P82aL", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.397, "ferret_sera_escape": null, "mature_H5_site": 74, "mouse_sera_escape": null, "mutant": "N", "mutation": "P82aN", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 74, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P82aP", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.4053, "ferret_sera_escape": null, "mature_H5_site": 74, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P82aQ", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.891, "ferret_sera_escape": null, "mature_H5_site": 74, "mouse_sera_escape": null, "mutant": "R", "mutation": "P82aR", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.722, "ferret_sera_escape": -0.006763, "mature_H5_site": 74, "mouse_sera_escape": 0.4022, "mutant": "S", "mutation": "P82aS", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": 1.929, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.909, "ferret_sera_escape": 0.05241, "mature_H5_site": 74, "mouse_sera_escape": 0.9441, "mutant": "T", "mutation": "P82aT", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.111, "ferret_sera_escape": null, "mature_H5_site": 74, "mouse_sera_escape": null, "mutant": "V", "mutation": "P82aV", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.255, "ferret_sera_escape": 0.1144, "mature_H5_site": 74, "mouse_sera_escape": 0.3791, "mutant": "W", "mutation": "P82aW", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": 2.235, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.788, "ferret_sera_escape": null, "mature_H5_site": 75, "mouse_sera_escape": null, "mutant": "C", "mutation": "E83C", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.006, "ferret_sera_escape": -0.07149, "mature_H5_site": 75, "mouse_sera_escape": 0.1395, "mutant": "D", "mutation": "E83D", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": 2.221, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 75, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E83E", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.168, "ferret_sera_escape": null, "mature_H5_site": 75, "mouse_sera_escape": null, "mutant": "F", "mutation": "E83F", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.844, "ferret_sera_escape": null, "mature_H5_site": 75, "mouse_sera_escape": null, "mutant": "G", "mutation": "E83G", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5961, "ferret_sera_escape": -0.07813, "mature_H5_site": 75, "mouse_sera_escape": 0.2203, "mutant": "H", "mutation": "E83H", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.2619, "cell_entry": -0.5213, "ferret_sera_escape": 0.08397, "mature_H5_site": 75, "mouse_sera_escape": 0.1894, "mutant": "I", "mutation": "E83I", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": -0.2311, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.105, "ferret_sera_escape": -0.2138, "mature_H5_site": 75, "mouse_sera_escape": 0.6473, "mutant": "K", "mutation": "E83K", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": 1.337, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01189, "ferret_sera_escape": 0.1383, "mature_H5_site": 75, "mouse_sera_escape": 0.0137, "mutant": "L", "mutation": "E83L", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": -0.4333, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1767, "ferret_sera_escape": -0.01532, "mature_H5_site": 75, "mouse_sera_escape": 0.007112, "mutant": "P", "mutation": "E83P", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": -0.1554, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6468, "ferret_sera_escape": -0.004639, "mature_H5_site": 75, "mouse_sera_escape": 0.1346, "mutant": "Q", "mutation": "E83Q", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": 1.527, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5903, "ferret_sera_escape": -0.1331, "mature_H5_site": 75, "mouse_sera_escape": 0.3771, "mutant": "R", "mutation": "E83R", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": 1.605, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.559, "ferret_sera_escape": -0.2933, "mature_H5_site": 75, "mouse_sera_escape": 0.666, "mutant": "S", "mutation": "E83S", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": 1.381, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.08, "ferret_sera_escape": null, "mature_H5_site": 75, "mouse_sera_escape": null, "mutant": "T", "mutation": "E83T", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.612, "ferret_sera_escape": -0.02366, "mature_H5_site": 75, "mouse_sera_escape": -0.05863, "mutant": "V", "mutation": "E83V", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7414, "ferret_sera_escape": null, "mature_H5_site": 75, "mouse_sera_escape": null, "mutant": "W", "mutation": "E83W", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.038, "ferret_sera_escape": null, "mature_H5_site": 75, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E83Y", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.555, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "A", "mutation": "W84A", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "C", "mutation": "W84C", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "D", "mutation": "W84D", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "E", "mutation": "W84E", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "F", "mutation": "W84F", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.6, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "I", "mutation": "W84I", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "K", "mutation": "W84K", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.838, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "L", "mutation": "W84L", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "M", "mutation": "W84M", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.694, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "P", "mutation": "W84P", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W84Q", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "R", "mutation": "W84R", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.733, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "S", "mutation": "W84S", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.732, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "V", "mutation": "W84V", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 76, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W84W", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "Y", "mutation": "W84Y", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.03109, "cell_entry": -0.08904, "ferret_sera_escape": -0.02275, "mature_H5_site": 77, "mouse_sera_escape": 0.1507, "mutant": "A", "mutation": "S85A", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": 0.8468, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.808, "ferret_sera_escape": -0.3724, "mature_H5_site": 77, "mouse_sera_escape": 0.09792, "mutant": "C", "mutation": "S85C", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "F", "mutation": "S85F", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.617, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "H", "mutation": "S85H", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6, "ferret_sera_escape": 0.1465, "mature_H5_site": 77, "mouse_sera_escape": 0.09174, "mutant": "K", "mutation": "S85K", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": -0.1947, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.312, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "L", "mutation": "S85L", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "M", "mutation": "S85M", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.325, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "N", "mutation": "S85N", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6855, "ferret_sera_escape": 0.05342, "mature_H5_site": 77, "mouse_sera_escape": 0.138, "mutant": "P", "mutation": "S85P", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": 1.689, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.579, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "Q", "mutation": "S85Q", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1737, "ferret_sera_escape": -0.1213, "mature_H5_site": 77, "mouse_sera_escape": 0.09699, "mutant": "R", "mutation": "S85R", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": -0.1319, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 77, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S85S", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.9012, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "T", "mutation": "S85T", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.554, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "V", "mutation": "S85V", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.344, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "W", "mutation": "S85W", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S85Y", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y86A", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.055, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y86C", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y86D", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y86E", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1359, "ferret_sera_escape": -0.02704, "mature_H5_site": 78, "mouse_sera_escape": -0.04463, "mutant": "F", "mutation": "Y86F", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y86G", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y86H", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.854, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y86I", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y86K", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.004, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y86M", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y86Q", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": null, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y86R", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y86S", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.774, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y86T", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.701, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y86V", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.846, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y86W", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 78, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y86Y", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "A", "mutation": "I87A", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.622, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "C", "mutation": "I87C", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "E", "mutation": "I87E", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.176, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "F", "mutation": "I87F", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "H", "mutation": "I87H", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 79, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I87I", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "K", "mutation": "I87K", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.216, "ferret_sera_escape": -0.4394, "mature_H5_site": 79, "mouse_sera_escape": 0.6257, "mutant": "L", "mutation": "I87L", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": 1.437, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.832, "ferret_sera_escape": -0.01664, "mature_H5_site": 79, "mouse_sera_escape": 0.1151, "mutant": "M", "mutation": "I87M", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": 1.132, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I87Q", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "R", "mutation": "I87R", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.663, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "S", "mutation": "I87S", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.532, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "T", "mutation": "I87T", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6854, "ferret_sera_escape": -0.02901, "mature_H5_site": 79, "mouse_sera_escape": 0.4797, "mutant": "V", "mutation": "I87V", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": 1.423, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.346, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "W", "mutation": "I87W", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.737, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I87Y", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.4499, "cell_entry": -0.1599, "ferret_sera_escape": 0.1971, "mature_H5_site": 80, "mouse_sera_escape": 0.288, "mutant": "A", "mutation": "V88A", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": 0.0007368, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "D", "mutation": "V88D", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "E", "mutation": "V88E", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "F", "mutation": "V88F", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.121, "ferret_sera_escape": -0.03418, "mature_H5_site": 80, "mouse_sera_escape": 0.07144, "mutant": "H", "mutation": "V88H", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": -0.2429, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.028, "ferret_sera_escape": -0.1252, "mature_H5_site": 80, "mouse_sera_escape": -0.0744, "mutant": "I", "mutation": "V88I", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "K", "mutation": "V88K", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.843, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "L", "mutation": "V88L", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.16, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "M", "mutation": "V88M", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.402, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "N", "mutation": "V88N", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.15, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "P", "mutation": "V88P", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.526, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "R", "mutation": "V88R", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.031, "ferret_sera_escape": -0.01936, "mature_H5_site": 80, "mouse_sera_escape": 0.1696, "mutant": "S", "mutation": "V88S", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": 0.01622, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.033, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "T", "mutation": "V88T", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 80, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V88V", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "W", "mutation": "V88W", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.768, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V88Y", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.947, "ferret_sera_escape": null, "mature_H5_site": 81, "mouse_sera_escape": null, "mutant": "C", "mutation": "E89C", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.651, "ferret_sera_escape": null, "mature_H5_site": 81, "mouse_sera_escape": null, "mutant": "D", "mutation": "E89D", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 81, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E89E", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.272, "ferret_sera_escape": -0.1997, "mature_H5_site": 81, "mouse_sera_escape": 0.3271, "mutant": "F", "mutation": "E89F", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": -0.19, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.956, "ferret_sera_escape": null, "mature_H5_site": 81, "mouse_sera_escape": null, "mutant": "G", "mutation": "E89G", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.008411, "ferret_sera_escape": 0.04595, "mature_H5_site": 81, "mouse_sera_escape": 0.001348, "mutant": "H", "mutation": "E89H", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": -0.04346, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.03879, "ferret_sera_escape": -0.2042, "mature_H5_site": 81, "mouse_sera_escape": 0.2914, "mutant": "I", "mutation": "E89I", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": -0.1547, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.528, "ferret_sera_escape": -0.3108, "mature_H5_site": 81, "mouse_sera_escape": 0.2449, "mutant": "K", "mutation": "E89K", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": 0.1029, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9846, "ferret_sera_escape": -0.4687, "mature_H5_site": 81, "mouse_sera_escape": 0.4642, "mutant": "L", "mutation": "E89L", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": -0.1386, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.703, "ferret_sera_escape": null, "mature_H5_site": 81, "mouse_sera_escape": null, "mutant": "N", "mutation": "E89N", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.072, "ferret_sera_escape": null, "mature_H5_site": 81, "mouse_sera_escape": null, "mutant": "P", "mutation": "E89P", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06451, "ferret_sera_escape": -0.1041, "mature_H5_site": 81, "mouse_sera_escape": 0.3792, "mutant": "Q", "mutation": "E89Q", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": 0.07143, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.333, "ferret_sera_escape": -0.3492, "mature_H5_site": 81, "mouse_sera_escape": 0.1435, "mutant": "R", "mutation": "E89R", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": -0.1462, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1958, "ferret_sera_escape": -0.0895, "mature_H5_site": 81, "mouse_sera_escape": 0.03832, "mutant": "S", "mutation": "E89S", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": 0.168, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2552, "ferret_sera_escape": -0.2829, "mature_H5_site": 81, "mouse_sera_escape": -0.05313, "mutant": "V", "mutation": "E89V", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": -0.1792, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.2, "ferret_sera_escape": -0.4103, "mature_H5_site": 81, "mouse_sera_escape": 0.1816, "mutant": "W", "mutation": "E89W", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": -0.09172, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02409, "ferret_sera_escape": -0.2065, "mature_H5_site": -2, "mouse_sera_escape": -0.05827, "mutant": "A", "mutation": "K9A", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.1208, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2777, "ferret_sera_escape": -0.001903, "mature_H5_site": -2, "mouse_sera_escape": 0.06882, "mutant": "C", "mutation": "K9C", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.07552, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05772, "ferret_sera_escape": -0.08895, "mature_H5_site": -2, "mouse_sera_escape": -0.06519, "mutant": "D", "mutation": "K9D", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.1281, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04559, "ferret_sera_escape": -0.03794, "mature_H5_site": -2, "mouse_sera_escape": -0.11, "mutant": "E", "mutation": "K9E", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.07152, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8641, "ferret_sera_escape": -0.1181, "mature_H5_site": -2, "mouse_sera_escape": 0.0282, "mutant": "F", "mutation": "K9F", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.4066, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.06421, "ferret_sera_escape": 0.04203, "mature_H5_site": -2, "mouse_sera_escape": -0.009954, "mutant": "G", "mutation": "K9G", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.05109, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.0354, "ferret_sera_escape": -0.04165, "mature_H5_site": -2, "mouse_sera_escape": -0.01211, "mutant": "H", "mutation": "K9H", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.04262, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": -2, "mouse_sera_escape": null, "mutant": "I", "mutation": "K9I", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -2, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K9K", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.706, "ferret_sera_escape": null, "mature_H5_site": -2, "mouse_sera_escape": null, "mutant": "L", "mutation": "K9L", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.9799, "ferret_sera_escape": -0.02426, "mature_H5_site": -2, "mouse_sera_escape": 0.02013, "mutant": "M", "mutation": "K9M", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.302, "wildtype": "K"}, {"a26_usage": 0.02526, "cell_entry": -0.1282, "ferret_sera_escape": -0.08313, "mature_H5_site": -2, "mouse_sera_escape": -0.04492, "mutant": "N", "mutation": "K9N", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.1692, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": -2, "mouse_sera_escape": null, "mutant": "P", "mutation": "K9P", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2548, "ferret_sera_escape": 0.003389, "mature_H5_site": -2, "mouse_sera_escape": 0.001331, "mutant": "Q", "mutation": "K9Q", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.1652, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04892, "ferret_sera_escape": 0.05877, "mature_H5_site": -2, "mouse_sera_escape": -0.02869, "mutant": "R", "mutation": "K9R", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.02458, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.01926, "ferret_sera_escape": 0.03878, "mature_H5_site": -2, "mouse_sera_escape": -0.05172, "mutant": "S", "mutation": "K9S", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.03492, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.182, "ferret_sera_escape": -0.1582, "mature_H5_site": -2, "mouse_sera_escape": -0.08793, "mutant": "T", "mutation": "K9T", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": 0.01847, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.785, "ferret_sera_escape": -0.2118, "mature_H5_site": -2, "mouse_sera_escape": -0.03538, "mutant": "V", "mutation": "K9V", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.1962, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.04044, "ferret_sera_escape": -0.06008, "mature_H5_site": -2, "mouse_sera_escape": -0.02081, "mutant": "W", "mutation": "K9W", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.6856, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.257, "ferret_sera_escape": 0.00219, "mature_H5_site": -2, "mouse_sera_escape": 0.008286, "mutant": "Y", "mutation": "K9Y", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.479, "ferret_sera_escape": -0.04282, "mature_H5_site": 82, "mouse_sera_escape": 0.1932, "mutant": "A", "mutation": "R90A", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.931, "ferret_sera_escape": -0.04711, "mature_H5_site": 82, "mouse_sera_escape": 0.4739, "mutant": "C", "mutation": "R90C", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.348, "ferret_sera_escape": -0.06714, "mature_H5_site": 82, "mouse_sera_escape": 0.6008, "mutant": "D", "mutation": "R90D", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.097, "ferret_sera_escape": -0.07236, "mature_H5_site": 82, "mouse_sera_escape": 0.3488, "mutant": "E", "mutation": "R90E", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.427, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.124, "ferret_sera_escape": 0.09127, "mature_H5_site": 82, "mouse_sera_escape": 0.534, "mutant": "F", "mutation": "R90F", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.965, "wildtype": "R"}, {"a26_usage": 0.5904, "cell_entry": -0.1338, "ferret_sera_escape": -0.06523, "mature_H5_site": 82, "mouse_sera_escape": 0.1102, "mutant": "G", "mutation": "R90G", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 0.9196, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.325, "ferret_sera_escape": 0.1455, "mature_H5_site": 82, "mouse_sera_escape": 0.2861, "mutant": "H", "mutation": "R90H", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.257, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3425, "ferret_sera_escape": 0.0349, "mature_H5_site": 82, "mouse_sera_escape": 0.245, "mutant": "I", "mutation": "R90I", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.341, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.05676, "ferret_sera_escape": 0.2348, "mature_H5_site": 82, "mouse_sera_escape": 0.2019, "mutant": "K", "mutation": "R90K", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 0.3, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5606, "ferret_sera_escape": 0.2147, "mature_H5_site": 82, "mouse_sera_escape": 0.4919, "mutant": "L", "mutation": "R90L", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.381, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.07917, "ferret_sera_escape": 0.1774, "mature_H5_site": 82, "mouse_sera_escape": 0.4109, "mutant": "M", "mutation": "R90M", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.559, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.546, "ferret_sera_escape": -0.07824, "mature_H5_site": 82, "mouse_sera_escape": 0.2241, "mutant": "N", "mutation": "R90N", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.383, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.202, "ferret_sera_escape": 0.03246, "mature_H5_site": 82, "mouse_sera_escape": 0.4355, "mutant": "P", "mutation": "R90P", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.609, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.07714, "ferret_sera_escape": 0.04984, "mature_H5_site": 82, "mouse_sera_escape": 0.03498, "mutant": "Q", "mutation": "R90Q", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.214, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 82, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R90R", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2434, "ferret_sera_escape": 0.1207, "mature_H5_site": 82, "mouse_sera_escape": 0.2605, "mutant": "S", "mutation": "R90S", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.006, "ferret_sera_escape": 0.1308, "mature_H5_site": 82, "mouse_sera_escape": 0.2331, "mutant": "T", "mutation": "R90T", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.181, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2636, "ferret_sera_escape": -0.04335, "mature_H5_site": 82, "mouse_sera_escape": 0.2074, "mutant": "V", "mutation": "R90V", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.497, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.9419, "ferret_sera_escape": -0.01502, "mature_H5_site": 82, "mouse_sera_escape": 0.2531, "mutant": "W", "mutation": "R90W", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.533, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.173, "ferret_sera_escape": -0.01533, "mature_H5_site": 82, "mouse_sera_escape": 0.5358, "mutant": "Y", "mutation": "R90Y", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 2.183, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 83, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A91A", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.1046, "cell_entry": -0.04047, "ferret_sera_escape": -0.01384, "mature_H5_site": 83, "mouse_sera_escape": 0.06503, "mutant": "C", "mutation": "A91C", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.3771, "wildtype": "A"}, {"a26_usage": 0.01739, "cell_entry": -0.01268, "ferret_sera_escape": -0.2924, "mature_H5_site": 83, "mouse_sera_escape": 0.02946, "mutant": "D", "mutation": "A91D", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": 0.2697, "wildtype": "A"}, {"a26_usage": 0.02646, "cell_entry": -0.0737, "ferret_sera_escape": -0.04414, "mature_H5_site": 83, "mouse_sera_escape": 0.0889, "mutant": "E", "mutation": "A91E", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": 0.07027, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1452, "ferret_sera_escape": -0.0642, "mature_H5_site": 83, "mouse_sera_escape": -0.07819, "mutant": "F", "mutation": "A91F", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.04268, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1753, "ferret_sera_escape": -0.07769, "mature_H5_site": 83, "mouse_sera_escape": -0.03491, "mutant": "G", "mutation": "A91G", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": 0.6783, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.05037, "ferret_sera_escape": -0.01651, "mature_H5_site": 83, "mouse_sera_escape": 0.03365, "mutant": "H", "mutation": "A91H", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.1954, "wildtype": "A"}, {"a26_usage": 0.2829, "cell_entry": -0.03243, "ferret_sera_escape": 0.003617, "mature_H5_site": 83, "mouse_sera_escape": 0.0395, "mutant": "K", "mutation": "A91K", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.03953, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.624, "ferret_sera_escape": null, "mature_H5_site": 83, "mouse_sera_escape": null, "mutant": "L", "mutation": "A91L", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.0534, "ferret_sera_escape": -0.1375, "mature_H5_site": 83, "mouse_sera_escape": -0.01981, "mutant": "M", "mutation": "A91M", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.2062, "wildtype": "A"}, {"a26_usage": 0.1702, "cell_entry": -0.03413, "ferret_sera_escape": 0.002161, "mature_H5_site": 83, "mouse_sera_escape": -0.03905, "mutant": "P", "mutation": "A91P", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.06868, "ferret_sera_escape": 0.0102, "mature_H5_site": 83, "mouse_sera_escape": 0.1097, "mutant": "Q", "mutation": "A91Q", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": 0.00952, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3265, "ferret_sera_escape": -0.25, "mature_H5_site": 83, "mouse_sera_escape": 0.09561, "mutant": "R", "mutation": "A91R", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.03604, "wildtype": "A"}, {"a26_usage": 0.4829, "cell_entry": -0.1533, "ferret_sera_escape": 0.07202, "mature_H5_site": 83, "mouse_sera_escape": -0.02162, "mutant": "S", "mutation": "A91S", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.03657, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.01106, "ferret_sera_escape": null, "mature_H5_site": 83, "mouse_sera_escape": null, "mutant": "T", "mutation": "A91T", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": null, "wildtype": "A"}, {"a26_usage": 0.07312, "cell_entry": 0.03071, "ferret_sera_escape": 0.02608, "mature_H5_site": 83, "mouse_sera_escape": 0.04753, "mutant": "V", "mutation": "A91V", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.2985, "wildtype": "A"}, {"a26_usage": 0.07088, "cell_entry": 0.03401, "ferret_sera_escape": -0.06244, "mature_H5_site": 83, "mouse_sera_escape": 0.04923, "mutant": "W", "mutation": "A91W", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.2484, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.03381, "ferret_sera_escape": 0.03285, "mature_H5_site": 84, "mouse_sera_escape": -0.06676, "mutant": "A", "mutation": "N92A", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.01158, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04036, "ferret_sera_escape": 0.00243, "mature_H5_site": 84, "mouse_sera_escape": 0.007162, "mutant": "C", "mutation": "N92C", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1521, "ferret_sera_escape": -0.05327, "mature_H5_site": 84, "mouse_sera_escape": 0.09871, "mutant": "E", "mutation": "N92E", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1454, "ferret_sera_escape": 0.05997, "mature_H5_site": 84, "mouse_sera_escape": 0.07683, "mutant": "F", "mutation": "N92F", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.1609, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.06958, "ferret_sera_escape": -0.04046, "mature_H5_site": 84, "mouse_sera_escape": 0.02752, "mutant": "G", "mutation": "N92G", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.8499, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.00283, "ferret_sera_escape": -0.06135, "mature_H5_site": 84, "mouse_sera_escape": 0.09289, "mutant": "I", "mutation": "N92I", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.7655, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2718, "ferret_sera_escape": -0.03656, "mature_H5_site": 84, "mouse_sera_escape": -0.007106, "mutant": "K", "mutation": "N92K", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.2888, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.03568, "ferret_sera_escape": -0.02886, "mature_H5_site": 84, "mouse_sera_escape": -0.07042, "mutant": "L", "mutation": "N92L", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.3527, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3279, "ferret_sera_escape": 0.1347, "mature_H5_site": 84, "mouse_sera_escape": 0.1202, "mutant": "M", "mutation": "N92M", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.1826, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 84, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N92N", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.185, "ferret_sera_escape": 0.1355, "mature_H5_site": 84, "mouse_sera_escape": 0.1025, "mutant": "R", "mutation": "N92R", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.1344, "wildtype": "N"}, {"a26_usage": 1.848, "cell_entry": -0.1077, "ferret_sera_escape": 0.00557, "mature_H5_site": 84, "mouse_sera_escape": 0.09905, "mutant": "S", "mutation": "N92S", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.1109, "wildtype": "N"}, {"a26_usage": 0.6013, "cell_entry": -0.4673, "ferret_sera_escape": 0.1178, "mature_H5_site": 84, "mouse_sera_escape": 0.1485, "mutant": "T", "mutation": "N92T", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.3672, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.53, "ferret_sera_escape": 0.06629, "mature_H5_site": 84, "mouse_sera_escape": 0.01579, "mutant": "V", "mutation": "N92V", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.8143, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04895, "ferret_sera_escape": 0.02039, "mature_H5_site": 84, "mouse_sera_escape": 0.08845, "mutant": "W", "mutation": "N92W", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.377, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1667, "ferret_sera_escape": -0.003991, "mature_H5_site": 84, "mouse_sera_escape": 0.01234, "mutant": "Y", "mutation": "N92Y", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.1971, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.001035, "ferret_sera_escape": 0.03716, "mature_H5_site": 85, "mouse_sera_escape": -0.005503, "mutant": "A", "mutation": "P92aA", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": -0.02773, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.121, "ferret_sera_escape": -0.0925, "mature_H5_site": 85, "mouse_sera_escape": 0.3635, "mutant": "C", "mutation": "P92aC", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 0.9959, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.373, "ferret_sera_escape": null, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "D", "mutation": "P92aD", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.265, "ferret_sera_escape": null, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "E", "mutation": "P92aE", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3433, "ferret_sera_escape": -0.01766, "mature_H5_site": 85, "mouse_sera_escape": 0.05171, "mutant": "F", "mutation": "P92aF", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 1.256, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.684, "ferret_sera_escape": -0.0165, "mature_H5_site": 85, "mouse_sera_escape": 0.8686, "mutant": "G", "mutation": "P92aG", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 0.6992, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.2487, "ferret_sera_escape": -0.1422, "mature_H5_site": 85, "mouse_sera_escape": 0.2346, "mutant": "H", "mutation": "P92aH", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 0.7532, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.926, "ferret_sera_escape": -0.2898, "mature_H5_site": 85, "mouse_sera_escape": 0.6361, "mutant": "I", "mutation": "P92aI", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 1.55, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.15, "ferret_sera_escape": null, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "K", "mutation": "P92aK", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.308, "ferret_sera_escape": null, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "L", "mutation": "P92aL", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.699, "ferret_sera_escape": null, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "M", "mutation": "P92aM", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 1.105, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.482, "ferret_sera_escape": null, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "N", "mutation": "P92aN", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 0.6513, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 85, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P92aP", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.805, "ferret_sera_escape": -0.1126, "mature_H5_site": 85, "mouse_sera_escape": 0.3577, "mutant": "Q", "mutation": "P92aQ", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 1.068, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.353, "ferret_sera_escape": null, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "R", "mutation": "P92aR", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.02319, "ferret_sera_escape": 0.1239, "mature_H5_site": 85, "mouse_sera_escape": 0.2493, "mutant": "S", "mutation": "P92aS", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 0.9196, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.4175, "ferret_sera_escape": 0.03485, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "T", "mutation": "P92aT", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 1.481, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.4852, "ferret_sera_escape": -0.2195, "mature_H5_site": 85, "mouse_sera_escape": 0.2256, "mutant": "V", "mutation": "P92aV", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 1.321, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3186, "ferret_sera_escape": -0.3302, "mature_H5_site": 85, "mouse_sera_escape": 0.03626, "mutant": "W", "mutation": "P92aW", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 0.8628, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5346, "ferret_sera_escape": -0.1678, "mature_H5_site": 85, "mouse_sera_escape": 0.04441, "mutant": "Y", "mutation": "P92aY", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 1.014, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 86, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A93A", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.06434, "ferret_sera_escape": 0.03114, "mature_H5_site": 86, "mouse_sera_escape": 0.2188, "mutant": "C", "mutation": "A93C", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.06722, "wildtype": "A"}, {"a26_usage": 0.06098, "cell_entry": -0.03087, "ferret_sera_escape": -0.02311, "mature_H5_site": 86, "mouse_sera_escape": -0.05883, "mutant": "D", "mutation": "A93D", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.4464, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1596, "ferret_sera_escape": -0.05893, "mature_H5_site": 86, "mouse_sera_escape": 0.01517, "mutant": "E", "mutation": "A93E", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.3244, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.05131, "ferret_sera_escape": 0.1578, "mature_H5_site": 86, "mouse_sera_escape": 0.09836, "mutant": "F", "mutation": "A93F", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.06585, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.04196, "ferret_sera_escape": 0.05988, "mature_H5_site": 86, "mouse_sera_escape": -0.05064, "mutant": "G", "mutation": "A93G", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.04509, "ferret_sera_escape": -0.00097, "mature_H5_site": 86, "mouse_sera_escape": 0.009424, "mutant": "H", "mutation": "A93H", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.1953, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3655, "ferret_sera_escape": -0.007556, "mature_H5_site": 86, "mouse_sera_escape": -0.1184, "mutant": "I", "mutation": "A93I", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.002853, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.09542, "ferret_sera_escape": -0.1032, "mature_H5_site": 86, "mouse_sera_escape": 0.02245, "mutant": "L", "mutation": "A93L", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.2316, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.02594, "ferret_sera_escape": null, "mature_H5_site": 86, "mouse_sera_escape": null, "mutant": "M", "mutation": "A93M", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.00597, "ferret_sera_escape": 0.09649, "mature_H5_site": 86, "mouse_sera_escape": 0.03091, "mutant": "N", "mutation": "A93N", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.009551, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.07659, "ferret_sera_escape": -0.03717, "mature_H5_site": 86, "mouse_sera_escape": -0.1564, "mutant": "P", "mutation": "A93P", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.1338, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.29, "ferret_sera_escape": 0.04962, "mature_H5_site": 86, "mouse_sera_escape": -0.004996, "mutant": "Q", "mutation": "A93Q", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.02205, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2769, "ferret_sera_escape": 0.04242, "mature_H5_site": 86, "mouse_sera_escape": -0.09915, "mutant": "R", "mutation": "A93R", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.07198, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.01831, "ferret_sera_escape": -0.03661, "mature_H5_site": 86, "mouse_sera_escape": 0.08262, "mutant": "S", "mutation": "A93S", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.2433, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.07981, "ferret_sera_escape": 0.18, "mature_H5_site": 86, "mouse_sera_escape": -0.05313, "mutant": "T", "mutation": "A93T", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.068, "wildtype": "A"}, {"a26_usage": 0.08987, "cell_entry": 0.0435, "ferret_sera_escape": -0.1577, "mature_H5_site": 86, "mouse_sera_escape": -0.2204, "mutant": "V", "mutation": "A93V", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.0005824, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.174, "ferret_sera_escape": -0.06061, "mature_H5_site": 86, "mouse_sera_escape": 0.07598, "mutant": "W", "mutation": "A93W", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.1865, "wildtype": "A"}, {"a26_usage": 0.04385, "cell_entry": -0.4142, "ferret_sera_escape": -0.004753, "mature_H5_site": 86, "mouse_sera_escape": -0.003453, "mutant": "Y", "mutation": "A93Y", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.1336, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.0, "ferret_sera_escape": 0.1946, "mature_H5_site": 87, "mouse_sera_escape": 0.1336, "mutant": "C", "mutation": "N94C", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": -0.107, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05408, "ferret_sera_escape": -0.005107, "mature_H5_site": 87, "mouse_sera_escape": 0.0611, "mutant": "D", "mutation": "N94D", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": -0.253, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9141, "ferret_sera_escape": -0.06019, "mature_H5_site": 87, "mouse_sera_escape": 0.07287, "mutant": "G", "mutation": "N94G", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.002635, "ferret_sera_escape": 0.1769, "mature_H5_site": 87, "mouse_sera_escape": 0.07669, "mutant": "H", "mutation": "N94H", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.1637, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4251, "ferret_sera_escape": -0.3339, "mature_H5_site": 87, "mouse_sera_escape": -0.03446, "mutant": "I", "mutation": "N94I", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.2667, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2878, "ferret_sera_escape": 0.1067, "mature_H5_site": 87, "mouse_sera_escape": 0.3909, "mutant": "K", "mutation": "N94K", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.07019, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1805, "ferret_sera_escape": 0.05545, "mature_H5_site": 87, "mouse_sera_escape": 0.2591, "mutant": "L", "mutation": "N94L", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.02268, "wildtype": "N"}, {"a26_usage": 0.1583, "cell_entry": -0.3004, "ferret_sera_escape": 0.1225, "mature_H5_site": 87, "mouse_sera_escape": 0.205, "mutant": "M", "mutation": "N94M", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": -0.01707, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 87, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N94N", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.784, "ferret_sera_escape": null, "mature_H5_site": 87, "mouse_sera_escape": null, "mutant": "P", "mutation": "N94P", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1262, "ferret_sera_escape": 0.175, "mature_H5_site": 87, "mouse_sera_escape": 0.1033, "mutant": "R", "mutation": "N94R", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.002526, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1472, "ferret_sera_escape": -0.02305, "mature_H5_site": 87, "mouse_sera_escape": 0.06187, "mutant": "S", "mutation": "N94S", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": -0.1288, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4122, "ferret_sera_escape": -0.105, "mature_H5_site": 87, "mouse_sera_escape": 0.2665, "mutant": "T", "mutation": "N94T", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.1738, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6813, "ferret_sera_escape": -0.1111, "mature_H5_site": 87, "mouse_sera_escape": 0.1075, "mutant": "V", "mutation": "N94V", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.5225, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.03282, "ferret_sera_escape": -0.385, "mature_H5_site": 87, "mouse_sera_escape": -0.2446, "mutant": "W", "mutation": "N94W", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": -0.05892, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3207, "ferret_sera_escape": 0.04425, "mature_H5_site": 87, "mouse_sera_escape": -0.00509, "mutant": "Y", "mutation": "N94Y", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": -0.04178, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7204, "ferret_sera_escape": 0.1747, "mature_H5_site": 88, "mouse_sera_escape": 0.1787, "mutant": "A", "mutation": "D95A", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": -0.02512, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3233, "ferret_sera_escape": 0.04222, "mature_H5_site": 88, "mouse_sera_escape": 0.07396, "mutant": "C", "mutation": "D95C", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.31, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 88, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D95D", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.02697, "ferret_sera_escape": 0.2668, "mature_H5_site": 88, "mouse_sera_escape": 0.1895, "mutant": "E", "mutation": "D95E", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 1.062, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.243, "ferret_sera_escape": -0.3263, "mature_H5_site": 88, "mouse_sera_escape": 0.2619, "mutant": "F", "mutation": "D95F", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1866, "ferret_sera_escape": 0.2795, "mature_H5_site": 88, "mouse_sera_escape": 0.1125, "mutant": "G", "mutation": "D95G", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4527, "ferret_sera_escape": 0.236, "mature_H5_site": 88, "mouse_sera_escape": 0.1139, "mutant": "H", "mutation": "D95H", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.6422, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.321, "ferret_sera_escape": 0.1267, "mature_H5_site": 88, "mouse_sera_escape": 0.6562, "mutant": "I", "mutation": "D95I", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.9518, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2198, "ferret_sera_escape": 0.3124, "mature_H5_site": 88, "mouse_sera_escape": 0.1555, "mutant": "K", "mutation": "D95K", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.4244, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.247, "ferret_sera_escape": 0.06728, "mature_H5_site": 88, "mouse_sera_escape": 0.5683, "mutant": "L", "mutation": "D95L", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.8676, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7498, "ferret_sera_escape": 0.1562, "mature_H5_site": 88, "mouse_sera_escape": 0.2742, "mutant": "M", "mutation": "D95M", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.6628, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6782, "ferret_sera_escape": -0.09039, "mature_H5_site": 88, "mouse_sera_escape": -0.002238, "mutant": "N", "mutation": "D95N", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.202, "ferret_sera_escape": null, "mature_H5_site": 88, "mouse_sera_escape": null, "mutant": "P", "mutation": "D95P", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5195, "ferret_sera_escape": 0.2371, "mature_H5_site": 88, "mouse_sera_escape": 0.1071, "mutant": "Q", "mutation": "D95Q", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.774, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5123, "ferret_sera_escape": 0.2653, "mature_H5_site": 88, "mouse_sera_escape": 0.1899, "mutant": "R", "mutation": "D95R", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.4291, "wildtype": "D"}, {"a26_usage": 0.1876, "cell_entry": -0.3749, "ferret_sera_escape": 0.5043, "mature_H5_site": 88, "mouse_sera_escape": 0.1399, "mutant": "S", "mutation": "D95S", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.03114, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2005, "ferret_sera_escape": 0.1881, "mature_H5_site": 88, "mouse_sera_escape": 0.08901, "mutant": "T", "mutation": "D95T", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.3492, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.432, "ferret_sera_escape": 0.09108, "mature_H5_site": 88, "mouse_sera_escape": 0.1841, "mutant": "V", "mutation": "D95V", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.417, "ferret_sera_escape": null, "mature_H5_site": 88, "mouse_sera_escape": null, "mutant": "W", "mutation": "D95W", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.03599, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.51, "ferret_sera_escape": null, "mature_H5_site": 88, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D95Y", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1603, "ferret_sera_escape": -0.06225, "mature_H5_site": 89, "mouse_sera_escape": 0.02661, "mutant": "C", "mutation": "L96C", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": -0.2585, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3283, "ferret_sera_escape": null, "mature_H5_site": 89, "mouse_sera_escape": null, "mutant": "D", "mutation": "L96D", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.02372, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4758, "ferret_sera_escape": null, "mature_H5_site": 89, "mouse_sera_escape": null, "mutant": "E", "mutation": "L96E", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4363, "ferret_sera_escape": -1.257, "mature_H5_site": 89, "mouse_sera_escape": -0.6859, "mutant": "F", "mutation": "L96F", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.6679, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1441, "ferret_sera_escape": -0.5612, "mature_H5_site": 89, "mouse_sera_escape": -0.4146, "mutant": "H", "mutation": "L96H", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.2343, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7077, "ferret_sera_escape": 0.2639, "mature_H5_site": 89, "mouse_sera_escape": 0.1538, "mutant": "I", "mutation": "L96I", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": -0.2918, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.036, "ferret_sera_escape": -0.4523, "mature_H5_site": 89, "mouse_sera_escape": -0.3201, "mutant": "K", "mutation": "L96K", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": -0.04678, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 89, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L96L", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.03343, "ferret_sera_escape": -0.3026, "mature_H5_site": 89, "mouse_sera_escape": -0.1258, "mutant": "M", "mutation": "L96M", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.4629, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2566, "ferret_sera_escape": 0.191, "mature_H5_site": 89, "mouse_sera_escape": 0.05342, "mutant": "N", "mutation": "L96N", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": -0.009696, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.31, "ferret_sera_escape": null, "mature_H5_site": 89, "mouse_sera_escape": null, "mutant": "P", "mutation": "L96P", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4283, "ferret_sera_escape": 0.2563, "mature_H5_site": 89, "mouse_sera_escape": 0.1389, "mutant": "Q", "mutation": "L96Q", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.3271, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0235, "ferret_sera_escape": 0.02392, "mature_H5_site": 89, "mouse_sera_escape": 0.04089, "mutant": "R", "mutation": "L96R", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.07256, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.129, "ferret_sera_escape": null, "mature_H5_site": 89, "mouse_sera_escape": null, "mutant": "S", "mutation": "L96S", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.114, "ferret_sera_escape": -0.8503, "mature_H5_site": 89, "mouse_sera_escape": -0.4039, "mutant": "T", "mutation": "L96T", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4146, "ferret_sera_escape": 0.5171, "mature_H5_site": 89, "mouse_sera_escape": 0.1705, "mutant": "V", "mutation": "L96V", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": -0.2321, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9464, "ferret_sera_escape": -1.749, "mature_H5_site": 89, "mouse_sera_escape": -0.8922, "mutant": "W", "mutation": "L96W", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.8274, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.03098, "ferret_sera_escape": -1.324, "mature_H5_site": 89, "mouse_sera_escape": -0.7274, "mutant": "Y", "mutation": "L96Y", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.1603, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 90, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C97C", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "D", "mutation": "C97D", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.088, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "E", "mutation": "C97E", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "F", "mutation": "C97F", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.154, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "G", "mutation": "C97G", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.849, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "H", "mutation": "C97H", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.668, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "I", "mutation": "C97I", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "K", "mutation": "C97K", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.608, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "L", "mutation": "C97L", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.84, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "M", "mutation": "C97M", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "N", "mutation": "C97N", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.897, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "P", "mutation": "C97P", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.228, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C97Q", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "R", "mutation": "C97R", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "S", "mutation": "C97S", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.015, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "T", "mutation": "C97T", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.729, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "V", "mutation": "C97V", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "W", "mutation": "C97W", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C97Y", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.98, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y98A", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.774, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y98C", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.778, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y98D", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.012, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y98E", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.357, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "F", "mutation": "Y98F", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y98G", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.723, "ferret_sera_escape": -0.89, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y98H", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.065, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y98I", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.439, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y98K", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.707, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y98L", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.874, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y98M", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.793, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y98N", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y98P", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.547, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y98Q", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.83, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y98R", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y98T", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.05, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y98W", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 91, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y98Y", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.033, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": -0.2423, "mutant": "A", "mutation": "P99A", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.615, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "C", "mutation": "P99C", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "D", "mutation": "P99D", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "E", "mutation": "P99E", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.339, "ferret_sera_escape": 0.3873, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "G", "mutation": "P99G", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "H", "mutation": "P99H", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.887, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "I", "mutation": "P99I", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "K", "mutation": "P99K", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.388, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "L", "mutation": "P99L", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "M", "mutation": "P99M", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 92, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P99P", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.04, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P99Q", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "R", "mutation": "P99R", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "S", "mutation": "P99S", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.298, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "T", "mutation": "P99T", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "V", "mutation": "P99V", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.175, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "W", "mutation": "P99W", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "Y", "mutation": "P99Y", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}], "negative_condition_colors": null, "pdb": "HEADER VIRAL PROTEIN 24-MAY-13 XXXX \nTITLE STRUCTURE OF A/ANHUI/5/2005 H5 HA \nKEYWDS VIRAL PROTEIN \nEXPDTA X-RAY DIFFRACTION \nAUTHOR H.YANG,D.A.SHORE,P.J.CARNEY,J.C.CHANG,J.STEVENS \nJRNL AUTH D.A.SHORE,H.YANG,A.L.BALISH,S.S.SHEPARD,P.J.CARNEY, \nJRNL AUTH 2 J.C.CHANG,C.T.DAVIS,R.O.DONIS,J.M.VILLANUEVA,A.I.KLIMOV, \nJRNL AUTH 3 J.STEVENS \nJRNL TITL STRUCTURAL AND ANTIGENIC VARIATION AMONG DIVERSE CLADE 2 \nJRNL TITL 2 H5N1 VIRUSES. \nJRNL REF PLOS ONE V. 8 75209 2013 \nJRNL REFN ESSN 1932-6203 \nJRNL PMID 24086467 \nJRNL DOI 10.1371/JOURNAL.PONE.0075209 \nSEQRES 1 A 329 ALA ASP PRO GLY ASP GLN ILE CYS ILE GLY TYR HIS ALA \nSEQRES 2 A 329 ASN ASN SER THR GLU GLN VAL ASP THR ILE MET GLU LYS \nSEQRES 3 A 329 ASN VAL THR VAL THR HIS ALA GLN ASP ILE LEU GLU LYS \nSEQRES 4 A 329 THR HIS ASN GLY LYS LEU CYS ASP LEU ASP GLY VAL LYS \nSEQRES 5 A 329 PRO LEU ILE LEU ARG ASP CYS SER VAL ALA GLY TRP LEU \nSEQRES 6 A 329 LEU GLY ASN PRO MET CYS ASP GLU PHE ILE ASN VAL PRO \nSEQRES 7 A 329 GLU TRP SER TYR ILE VAL GLU LYS ALA ASN PRO ALA ASN \nSEQRES 8 A 329 ASP LEU CYS TYR PRO GLY ASN PHE ASN ASP TYR GLU GLU \nSEQRES 9 A 329 LEU LYS HIS LEU LEU SER ARG ILE ASN HIS PHE GLU LYS \nSEQRES 10 A 329 ILE GLN ILE ILE PRO LYS SER SER TRP SER ASP HIS GLU \nSEQRES 11 A 329 ALA SER SER GLY VAL SER SER ALA CYS PRO TYR GLN GLY \nSEQRES 12 A 329 THR PRO SER PHE PHE ARG ASN VAL VAL TRP LEU ILE LYS \nSEQRES 13 A 329 LYS ASN ASN THR TYR PRO THR ILE LYS ARG SER TYR ASN \nSEQRES 14 A 329 ASN THR ASN GLN GLU ASP LEU LEU ILE LEU TRP GLY ILE \nSEQRES 15 A 329 HIS HIS SER ASN ASP ALA ALA GLU GLN THR LYS LEU TYR \nSEQRES 16 A 329 GLN ASN PRO THR THR TYR ILE SER VAL GLY THR SER THR \nSEQRES 17 A 329 LEU ASN GLN ARG LEU VAL PRO LYS ILE ALA THR ARG SER \nSEQRES 18 A 329 LYS VAL ASN GLY GLN SER GLY ARG MET ASP PHE PHE TRP \nSEQRES 19 A 329 THR ILE LEU LYS PRO ASN ASP ALA ILE ASN PHE GLU SER \nSEQRES 20 A 329 ASN GLY ASN PHE ILE ALA PRO GLU TYR ALA TYR LYS ILE \nSEQRES 21 A 329 VAL LYS LYS GLY ASP SER ALA ILE VAL LYS SER GLU VAL \nSEQRES 22 A 329 GLU TYR GLY ASN CYS ASN THR LYS CYS GLN THR PRO ILE \nSEQRES 23 A 329 GLY ALA ILE ASN SER SER MET PRO PHE HIS ASN ILE HIS \nSEQRES 24 A 329 PRO LEU THR ILE GLY GLU CYS PRO LYS TYR VAL LYS SER \nSEQRES 25 A 329 ASN LYS LEU VAL LEU ALA THR GLY LEU ARG ASN SER PRO \nSEQRES 26 A 329 LEU ARG GLU ARG \nSEQRES 1 B 174 GLY LEU PHE GLY ALA ILE ALA GLY PHE ILE GLU GLY GLY \nSEQRES 2 B 174 TRP GLN GLY MET VAL ASP GLY TRP TYR GLY TYR HIS HIS \nSEQRES 3 B 174 SER ASN GLU GLN GLY SER GLY TYR ALA ALA ASP LYS GLU \nSEQRES 4 B 174 SER THR GLN LYS ALA ILE ASP GLY VAL THR ASN LYS VAL \nSEQRES 5 B 174 ASN SER ILE ILE ASP LYS MET ASN THR GLN PHE GLU ALA \nSEQRES 6 B 174 VAL GLY ARG GLU PHE ASN ASN LEU GLU ARG ARG ILE GLU \nSEQRES 7 B 174 ASN LEU ASN LYS LYS MET GLU ASP GLY PHE LEU ASP VAL \nSEQRES 8 B 174 TRP THR TYR ASN ALA GLU LEU LEU VAL LEU MET GLU ASN \nSEQRES 9 B 174 GLU ARG THR LEU ASP PHE HIS ASP SER ASN VAL LYS ASN \nSEQRES 10 B 174 LEU TYR ASP LYS VAL ARG LEU GLN LEU ARG ASP ASN ALA \nSEQRES 11 B 174 LYS GLU LEU GLY ASN GLY CYS PHE GLU PHE TYR HIS LYS \nSEQRES 12 B 174 CYS ASP ASN GLU CYS MET GLU SER VAL ARG ASN GLY THR \nSEQRES 13 B 174 TYR ASP TYR PRO GLN TYR SER GLU GLU ALA ARG LEU LYS \nSEQRES 14 B 174 ARG GLU GLU ILE SER \nSEQRES 1 C 329 ALA ASP PRO GLY ASP GLN ILE CYS ILE GLY TYR HIS ALA \nSEQRES 2 C 329 ASN ASN SER THR GLU GLN VAL ASP THR ILE MET GLU LYS \nSEQRES 3 C 329 ASN VAL THR VAL THR HIS ALA GLN ASP ILE LEU GLU LYS \nSEQRES 4 C 329 THR HIS ASN GLY LYS LEU CYS ASP LEU ASP GLY VAL LYS \nSEQRES 5 C 329 PRO LEU ILE LEU ARG ASP CYS SER VAL ALA GLY TRP LEU \nSEQRES 6 C 329 LEU GLY ASN PRO MET CYS ASP GLU PHE ILE ASN VAL PRO \nSEQRES 7 C 329 GLU TRP SER TYR ILE VAL GLU LYS ALA ASN PRO ALA ASN \nSEQRES 8 C 329 ASP LEU CYS TYR PRO GLY ASN PHE ASN ASP TYR GLU GLU \nSEQRES 9 C 329 LEU LYS HIS LEU LEU SER ARG ILE ASN HIS PHE GLU LYS \nSEQRES 10 C 329 ILE GLN ILE ILE PRO LYS SER SER TRP SER ASP HIS GLU \nSEQRES 11 C 329 ALA SER SER GLY VAL SER SER ALA CYS PRO TYR GLN GLY \nSEQRES 12 C 329 THR PRO SER PHE PHE ARG ASN VAL VAL TRP LEU ILE LYS \nSEQRES 13 C 329 LYS ASN ASN THR TYR PRO THR ILE LYS ARG SER TYR ASN \nSEQRES 14 C 329 ASN THR ASN GLN GLU ASP LEU LEU ILE LEU TRP GLY ILE \nSEQRES 15 C 329 HIS HIS SER ASN ASP ALA ALA GLU GLN THR LYS LEU TYR \nSEQRES 16 C 329 GLN ASN PRO THR THR TYR ILE SER VAL GLY THR SER THR \nSEQRES 17 C 329 LEU ASN GLN ARG LEU VAL PRO LYS ILE ALA THR ARG SER \nSEQRES 18 C 329 LYS VAL ASN GLY GLN SER GLY ARG MET ASP PHE PHE TRP \nSEQRES 19 C 329 THR ILE LEU LYS PRO ASN ASP ALA ILE ASN PHE GLU SER \nSEQRES 20 C 329 ASN GLY ASN PHE ILE ALA PRO GLU TYR ALA TYR LYS ILE \nSEQRES 21 C 329 VAL LYS LYS GLY ASP SER ALA ILE VAL LYS SER GLU VAL \nSEQRES 22 C 329 GLU TYR GLY ASN CYS ASN THR LYS CYS GLN THR PRO ILE \nSEQRES 23 C 329 GLY ALA ILE ASN SER SER MET PRO PHE HIS ASN ILE HIS \nSEQRES 24 C 329 PRO LEU THR ILE GLY GLU CYS PRO LYS TYR VAL LYS SER \nSEQRES 25 C 329 ASN LYS LEU VAL LEU ALA THR GLY LEU ARG ASN SER PRO \nSEQRES 26 C 329 LEU ARG GLU ARG \nSEQRES 1 D 174 GLY LEU PHE GLY ALA ILE ALA GLY PHE ILE GLU GLY GLY \nSEQRES 2 D 174 TRP GLN GLY MET VAL ASP GLY TRP TYR GLY TYR HIS HIS \nSEQRES 3 D 174 SER ASN GLU GLN GLY SER GLY TYR ALA ALA ASP LYS GLU \nSEQRES 4 D 174 SER THR GLN LYS ALA ILE ASP GLY VAL THR ASN LYS VAL \nSEQRES 5 D 174 ASN SER ILE ILE ASP LYS MET ASN THR GLN PHE GLU ALA \nSEQRES 6 D 174 VAL GLY ARG GLU PHE ASN ASN LEU GLU ARG ARG ILE GLU \nSEQRES 7 D 174 ASN LEU ASN LYS LYS MET GLU ASP GLY PHE LEU ASP VAL \nSEQRES 8 D 174 TRP THR TYR ASN ALA GLU LEU LEU VAL LEU MET GLU ASN \nSEQRES 9 D 174 GLU ARG THR LEU ASP PHE HIS ASP SER ASN VAL LYS ASN \nSEQRES 10 D 174 LEU TYR ASP LYS VAL ARG LEU GLN LEU ARG ASP ASN ALA \nSEQRES 11 D 174 LYS GLU LEU GLY ASN GLY CYS PHE GLU PHE TYR HIS LYS \nSEQRES 12 D 174 CYS ASP ASN GLU CYS MET GLU SER VAL ARG ASN GLY THR \nSEQRES 13 D 174 TYR ASP TYR PRO GLN TYR SER GLU GLU ALA ARG LEU LYS \nSEQRES 14 D 174 ARG GLU GLU ILE SER \nSEQRES 1 E 329 ALA ASP PRO GLY ASP GLN ILE CYS ILE GLY TYR HIS ALA \nSEQRES 2 E 329 ASN ASN SER THR GLU GLN VAL ASP THR ILE MET GLU LYS \nSEQRES 3 E 329 ASN VAL THR VAL THR HIS ALA GLN ASP ILE LEU GLU LYS \nSEQRES 4 E 329 THR HIS ASN GLY LYS LEU CYS ASP LEU ASP GLY VAL LYS \nSEQRES 5 E 329 PRO LEU ILE LEU ARG ASP CYS SER VAL ALA GLY TRP LEU \nSEQRES 6 E 329 LEU GLY ASN PRO MET CYS ASP GLU PHE ILE ASN VAL PRO \nSEQRES 7 E 329 GLU TRP SER TYR ILE VAL GLU LYS ALA ASN PRO ALA ASN \nSEQRES 8 E 329 ASP LEU CYS TYR PRO GLY ASN PHE ASN ASP TYR GLU GLU \nSEQRES 9 E 329 LEU LYS HIS LEU LEU SER ARG ILE ASN HIS PHE GLU LYS \nSEQRES 10 E 329 ILE GLN ILE ILE PRO LYS SER SER TRP SER ASP HIS GLU \nSEQRES 11 E 329 ALA SER SER GLY VAL SER SER ALA CYS PRO TYR GLN GLY \nSEQRES 12 E 329 THR PRO SER PHE PHE ARG ASN VAL VAL TRP LEU ILE LYS \nSEQRES 13 E 329 LYS ASN ASN THR TYR PRO THR ILE LYS ARG SER TYR ASN \nSEQRES 14 E 329 ASN THR ASN GLN GLU ASP LEU LEU ILE LEU TRP GLY ILE \nSEQRES 15 E 329 HIS HIS SER ASN ASP ALA ALA GLU GLN THR LYS LEU TYR \nSEQRES 16 E 329 GLN ASN PRO THR THR TYR ILE SER VAL GLY THR SER THR \nSEQRES 17 E 329 LEU ASN GLN ARG LEU VAL PRO LYS ILE ALA THR ARG SER \nSEQRES 18 E 329 LYS VAL ASN GLY GLN SER GLY ARG MET ASP PHE PHE TRP \nSEQRES 19 E 329 THR ILE LEU LYS PRO ASN ASP ALA ILE ASN PHE GLU SER \nSEQRES 20 E 329 ASN GLY ASN PHE ILE ALA PRO GLU TYR ALA TYR LYS ILE \nSEQRES 21 E 329 VAL LYS LYS GLY ASP SER ALA ILE VAL LYS SER GLU VAL \nSEQRES 22 E 329 GLU TYR GLY ASN CYS ASN THR LYS CYS GLN THR PRO ILE \nSEQRES 23 E 329 GLY ALA ILE ASN SER SER MET PRO PHE HIS ASN ILE HIS \nSEQRES 24 E 329 PRO LEU THR ILE GLY GLU CYS PRO LYS TYR VAL LYS SER \nSEQRES 25 E 329 ASN LYS LEU VAL LEU ALA THR GLY LEU ARG ASN SER PRO \nSEQRES 26 E 329 LEU ARG GLU ARG \nSEQRES 1 F 174 GLY LEU PHE GLY ALA ILE ALA GLY PHE ILE GLU GLY GLY \nSEQRES 2 F 174 TRP GLN GLY MET VAL ASP GLY TRP TYR GLY TYR HIS HIS \nSEQRES 3 F 174 SER ASN GLU GLN GLY SER GLY TYR ALA ALA ASP LYS GLU \nSEQRES 4 F 174 SER THR GLN LYS ALA ILE ASP GLY VAL THR ASN LYS VAL \nSEQRES 5 F 174 ASN SER ILE ILE ASP LYS MET ASN THR GLN PHE GLU ALA \nSEQRES 6 F 174 VAL GLY ARG GLU PHE ASN ASN LEU GLU ARG ARG ILE GLU \nSEQRES 7 F 174 ASN LEU ASN LYS LYS MET GLU ASP GLY PHE LEU ASP VAL \nSEQRES 8 F 174 TRP THR TYR ASN ALA GLU LEU LEU VAL LEU MET GLU ASN \nSEQRES 9 F 174 GLU ARG THR LEU ASP PHE HIS ASP SER ASN VAL LYS ASN \nSEQRES 10 F 174 LEU TYR ASP LYS VAL ARG LEU GLN LEU ARG ASP ASN ALA \nSEQRES 11 F 174 LYS GLU LEU GLY ASN GLY CYS PHE GLU PHE TYR HIS LYS \nSEQRES 12 F 174 CYS ASP ASN GLU CYS MET GLU SER VAL ARG ASN GLY THR \nSEQRES 13 F 174 TYR ASP TYR PRO GLN TYR SER GLU GLU ALA ARG LEU LYS \nSEQRES 14 F 174 ARG GLU GLU ILE SER \nHETNAM NAG 2-ACETAMIDO-2-DEOXY-BETA-D-GLUCOPYRANOSE \nHETSYN NAG N-ACETYL-BETA-D-GLUCOSAMINE; 2-ACETAMIDO-2-DEOXY-BETA- \nHETSYN 2 NAG D-GLUCOSE; 2-ACETAMIDO-2-DEOXY-D-GLUCOSE; 2-ACETAMIDO- \nHETSYN 3 NAG 2-DEOXY-GLUCOSE; N-ACETYL-D-GLUCOSAMINE \nFORMUL 7 NAG 4(C8 H15 N O6) \nFORMUL 11 HOH *155(H2 O) \nHELIX 1 1 SER A 56 LEU A 62 1 7 \nHELIX 2 2 ASN A 64 ILE A 71 5 8 \nHELIX 3 3 ASP A 97 LEU A 105 1 9 \nHELIX 4 4 ASP A 183 GLN A 192 1 10 \nHELIX 5 5 ASP B 37 LYS B 58 1 22 \nHELIX 6 6 GLU B 74 LEU B 126 1 53 \nHELIX 7 7 ASP B 145 ASN B 154 1 10 \nHELIX 8 8 TYR B 159 GLN B 161 5 3 \nHELIX 9 9 TYR B 162 GLU B 171 1 10 \nHELIX 10 10 SER C 56 GLY C 63 1 8 \nHELIX 11 11 ASN C 64 ILE C 71 5 8 \nHELIX 12 12 ASP C 97 LEU C 105 1 9 \nHELIX 13 13 ASP C 183 TYR C 191 1 9 \nHELIX 14 14 ASP D 37 LYS D 58 1 22 \nHELIX 15 15 GLU D 74 LEU D 126 1 53 \nHELIX 16 16 ASP D 145 ASN D 154 1 10 \nHELIX 17 17 TYR D 159 GLN D 161 5 3 \nHELIX 18 18 TYR D 162 GLU D 171 1 10 \nHELIX 19 19 SER E 56 GLY E 63 1 8 \nHELIX 20 20 CYS E 67 ILE E 71 5 5 \nHELIX 21 21 ASP E 97 LEU E 105 1 9 \nHELIX 22 22 PRO E 118 TRP E 122 5 5 \nHELIX 23 23 ASP E 183 TYR E 191 1 9 \nHELIX 24 24 ASP F 37 LYS F 58 1 22 \nHELIX 25 25 GLU F 74 LEU F 126 1 53 \nHELIX 26 26 ASP F 145 ASN F 154 1 10 \nHELIX 27 27 TYR F 159 GLN F 161 5 3 \nHELIX 28 28 TYR F 162 GLU F 171 1 10 \nSHEET 1 A 5 GLY B 31 ALA B 36 0 \nSHEET 2 A 5 TYR B 22 ASN B 28 -1 N TYR B 24 O ALA B 35 \nSHEET 3 A 5 GLN A 2 TYR A 7 -1 N GLN A 2 O SER B 27 \nSHEET 4 A 5 CYS B 137 PHE B 140 -1 O PHE B 138 N ILE A 3 \nSHEET 5 A 5 ALA B 130 GLU B 132 -1 N LYS B 131 O GLU B 139 \nSHEET 1 B 2 GLN A 15 VAL A 16 0 \nSHEET 2 B 2 VAL A 24 THR A 25 -1 O VAL A 24 N VAL A 16 \nSHEET 1 C 2 ALA A 29 ASP A 31 0 \nSHEET 2 C 2 VAL A 312 ALA A 314 -1 O LEU A 313 N GLN A 30 \nSHEET 1 D 3 LEU A 33 GLU A 34 0 \nSHEET 2 D 3 PHE A 291 HIS A 292 1 O PHE A 291 N GLU A 34 \nSHEET 3 D 3 LYS A 304 TYR A 305 1 O LYS A 304 N HIS A 292 \nSHEET 1 E 2 LEU A 41 LEU A 44 0 \nSHEET 2 E 2 TYR A 271 THR A 276 1 O CYS A 274 N ASP A 43 \nSHEET 1 F 3 LEU A 50 ILE A 51 0 \nSHEET 2 F 3 ILE A 79 VAL A 80 1 O VAL A 80 N LEU A 50 \nSHEET 3 F 3 ILE A 264 VAL A 265 1 O VAL A 265 N ILE A 79 \nSHEET 1 G 5 PHE A 111 GLN A 115 0 \nSHEET 2 G 5 TYR A 252 ILE A 256 -1 O ALA A 253 N ILE A 114 \nSHEET 3 G 5 LEU A 172 HIS A 180 -1 N LEU A 173 O TYR A 254 \nSHEET 4 G 5 PHE A 247 PRO A 250 -1 O ILE A 248 N GLY A 177 \nSHEET 5 G 5 VAL A 147 TRP A 149 -1 N VAL A 148 O ALA A 249 \nSHEET 1 H 4 PHE A 111 GLN A 115 0 \nSHEET 2 H 4 TYR A 252 ILE A 256 -1 O ALA A 253 N ILE A 114 \nSHEET 3 H 4 LEU A 172 HIS A 180 -1 N LEU A 173 O TYR A 254 \nSHEET 4 H 4 ARG A 225 LEU A 233 -1 O PHE A 229 N TRP A 176 \nSHEET 1 I 2 HIS A 125 GLU A 126 0 \nSHEET 2 I 2 ILE A 151 LYS A 152 -1 O ILE A 151 N GLU A 126 \nSHEET 1 J 2 SER A 132 PRO A 136 0 \nSHEET 2 J 2 PRO A 141 SER A 142 -1 O SER A 142 N CYS A 135 \nSHEET 1 K 4 ILE A 160 ASN A 165 0 \nSHEET 2 K 4 ALA A 238 SER A 243 -1 O SER A 243 N ILE A 160 \nSHEET 3 K 4 ILE A 198 GLY A 201 -1 N GLY A 201 O ASN A 240 \nSHEET 4 K 4 ASN A 206 LEU A 209 -1 O LEU A 209 N ILE A 198 \nSHEET 1 L 3 GLY A 283 ALA A 284 0 \nSHEET 2 L 3 CYS A 278 THR A 280 -1 N THR A 280 O GLY A 283 \nSHEET 3 L 3 ILE A 299 GLY A 300 -1 O ILE A 299 N GLN A 279 \nSHEET 1 M 5 GLY D 31 ALA D 36 0 \nSHEET 2 M 5 TYR D 22 ASN D 28 -1 N TYR D 24 O ALA D 35 \nSHEET 3 M 5 GLN C 2 TYR C 7 -1 N GLY C 6 O GLY D 23 \nSHEET 4 M 5 CYS D 137 PHE D 140 -1 O PHE D 138 N ILE C 3 \nSHEET 5 M 5 ALA D 130 GLU D 132 -1 N LYS D 131 O GLU D 139 \nSHEET 1 N 2 GLN C 15 VAL C 16 0 \nSHEET 2 N 2 VAL C 24 THR C 25 -1 O VAL C 24 N VAL C 16 \nSHEET 1 O 2 ALA C 29 ASP C 31 0 \nSHEET 2 O 2 VAL C 312 ALA C 314 -1 O LEU C 313 N GLN C 30 \nSHEET 1 P 3 LEU C 33 GLU C 34 0 \nSHEET 2 P 3 PHE C 291 HIS C 292 1 O PHE C 291 N GLU C 34 \nSHEET 3 P 3 LYS C 304 TYR C 305 1 O LYS C 304 N HIS C 292 \nSHEET 1 Q 2 LEU C 41 LEU C 44 0 \nSHEET 2 Q 2 TYR C 271 THR C 276 1 O CYS C 274 N ASP C 43 \nSHEET 1 R 3 LEU C 50 ILE C 51 0 \nSHEET 2 R 3 ILE C 79 GLU C 81 1 O VAL C 80 N LEU C 50 \nSHEET 3 R 3 ILE C 264 LYS C 266 1 O VAL C 265 N GLU C 81 \nSHEET 1 S 5 PHE C 111 GLN C 115 0 \nSHEET 2 S 5 TYR C 252 ILE C 256 -1 O ALA C 253 N ILE C 114 \nSHEET 3 S 5 LEU C 172 HIS C 180 -1 N LEU C 173 O TYR C 254 \nSHEET 4 S 5 PHE C 247 PRO C 250 -1 O ILE C 248 N GLY C 177 \nSHEET 5 S 5 VAL C 147 TRP C 149 -1 N VAL C 148 O ALA C 249 \nSHEET 1 T 4 PHE C 111 GLN C 115 0 \nSHEET 2 T 4 TYR C 252 ILE C 256 -1 O ALA C 253 N ILE C 114 \nSHEET 3 T 4 LEU C 172 HIS C 180 -1 N LEU C 173 O TYR C 254 \nSHEET 4 T 4 ARG C 225 LEU C 233 -1 O PHE C 229 N TRP C 176 \nSHEET 1 U 2 HIS C 125 GLU C 126 0 \nSHEET 2 U 2 ILE C 151 LYS C 152 -1 O ILE C 151 N GLU C 126 \nSHEET 1 V 2 SER C 132 PRO C 136 0 \nSHEET 2 V 2 PRO C 141 SER C 142 -1 O SER C 142 N CYS C 135 \nSHEET 1 W 4 ILE C 160 ASN C 165 0 \nSHEET 2 W 4 ALA C 238 SER C 243 -1 O SER C 243 N ILE C 160 \nSHEET 3 W 4 ILE C 198 GLY C 201 -1 N GLY C 201 O ASN C 240 \nSHEET 4 W 4 ASN C 206 LEU C 209 -1 O LEU C 209 N ILE C 198 \nSHEET 1 X 3 GLY C 283 ALA C 284 0 \nSHEET 2 X 3 CYS C 278 THR C 280 -1 N THR C 280 O GLY C 283 \nSHEET 3 X 3 ILE C 299 GLY C 300 -1 O ILE C 299 N GLN C 279 \nSHEET 1 Y 5 GLY F 31 ALA F 36 0 \nSHEET 2 Y 5 TYR F 22 ASN F 28 -1 N TYR F 24 O ALA F 35 \nSHEET 3 Y 5 GLN E 2 TYR E 7 -1 N GLN E 2 O SER F 27 \nSHEET 4 Y 5 CYS F 137 PHE F 140 -1 O PHE F 138 N ILE E 3 \nSHEET 5 Y 5 ALA F 130 GLU F 132 -1 N LYS F 131 O GLU F 139 \nSHEET 1 Z 2 GLN E 15 VAL E 16 0 \nSHEET 2 Z 2 VAL E 24 THR E 25 -1 O VAL E 24 N VAL E 16 \nSHEET 1 AA 2 ALA E 29 ASP E 31 0 \nSHEET 2 AA 2 VAL E 312 ALA E 314 -1 O LEU E 313 N GLN E 30 \nSHEET 1 AB 3 LEU E 33 GLU E 34 0 \nSHEET 2 AB 3 PHE E 291 HIS E 292 1 O PHE E 291 N GLU E 34 \nSHEET 3 AB 3 LYS E 304 TYR E 305 1 O LYS E 304 N HIS E 292 \nSHEET 1 AC 2 LEU E 41 LEU E 44 0 \nSHEET 2 AC 2 TYR E 271 THR E 276 1 O CYS E 274 N ASP E 43 \nSHEET 1 AD 3 LEU E 50 ILE E 51 0 \nSHEET 2 AD 3 ILE E 79 VAL E 80 1 O VAL E 80 N LEU E 50 \nSHEET 3 AD 3 ILE E 264 VAL E 265 1 O VAL E 265 N ILE E 79 \nSHEET 1 AE 5 PHE E 111 GLN E 115 0 \nSHEET 2 AE 5 TYR E 252 ILE E 256 -1 O ALA E 253 N ILE E 114 \nSHEET 3 AE 5 LEU E 172 HIS E 180 -1 N LEU E 173 O TYR E 254 \nSHEET 4 AE 5 PHE E 247 PRO E 250 -1 O ILE E 248 N GLY E 177 \nSHEET 5 AE 5 VAL E 147 TRP E 149 -1 N VAL E 148 O ALA E 249 \nSHEET 1 AF 4 PHE E 111 GLN E 115 0 \nSHEET 2 AF 4 TYR E 252 ILE E 256 -1 O ALA E 253 N ILE E 114 \nSHEET 3 AF 4 LEU E 172 HIS E 180 -1 N LEU E 173 O TYR E 254 \nSHEET 4 AF 4 ARG E 225 LEU E 233 -1 O PHE E 229 N TRP E 176 \nSHEET 1 AG 2 HIS E 125 GLU E 126 0 \nSHEET 2 AG 2 ILE E 151 LYS E 152 -1 O ILE E 151 N GLU E 126 \nSHEET 1 AH 2 SER E 132 PRO E 136 0 \nSHEET 2 AH 2 PRO E 141 SER E 142 -1 O SER E 142 N CYS E 135 \nSHEET 1 AI 4 ILE E 160 ASN E 165 0 \nSHEET 2 AI 4 ALA E 238 SER E 243 -1 O PHE E 241 N ARG E 162 \nSHEET 3 AI 4 ILE E 198 GLY E 201 -1 N GLY E 201 O ASN E 240 \nSHEET 4 AI 4 ASN E 206 LEU E 209 -1 O LEU E 209 N ILE E 198 \nSHEET 1 AJ 3 GLY E 283 ALA E 284 0 \nSHEET 2 AJ 3 CYS E 278 THR E 280 -1 N THR E 280 O GLY E 283 \nSHEET 3 AJ 3 ILE E 299 GLY E 300 -1 O ILE E 299 N GLN E 279 \nSSBOND 1 CYS A 4 CYS B 137 1555 1555 2.05 \nSSBOND 2 CYS A 42 CYS A 274 1555 1555 2.04 \nSSBOND 3 CYS A 55 CYS A 67 1555 1555 2.01 \nSSBOND 4 CYS A 90 CYS A 135 1555 1555 2.02 \nSSBOND 5 CYS A 278 CYS A 302 1555 1555 2.03 \nSSBOND 6 CYS B 144 CYS B 148 1555 1555 2.06 \nSSBOND 7 CYS C 4 CYS D 137 1555 1555 2.07 \nSSBOND 8 CYS C 42 CYS C 274 1555 1555 2.04 \nSSBOND 9 CYS C 55 CYS C 67 1555 1555 2.03 \nSSBOND 10 CYS C 90 CYS C 135 1555 1555 2.05 \nSSBOND 11 CYS C 278 CYS C 302 1555 1555 2.05 \nSSBOND 12 CYS D 144 CYS D 148 1555 1555 2.04 \nSSBOND 13 CYS E 4 CYS F 137 1555 1555 2.02 \nSSBOND 14 CYS E 42 CYS E 274 1555 1555 2.08 \nSSBOND 15 CYS E 55 CYS E 67 1555 1555 2.03 \nSSBOND 16 CYS E 90 CYS E 135 1555 1555 2.03 \nSSBOND 17 CYS E 278 CYS E 302 1555 1555 2.08 \nSSBOND 18 CYS F 144 CYS F 148 1555 1555 2.06 \nLINK ND2 ASN A 165 C1 NAG A 401 1555 1555 1.46 \nLINK ND2 ASN B 154 C1 NAG B 201 1555 1555 1.45 \nLINK ND2 ASN D 154 C1 NAG D 201 1555 1555 1.46 \nLINK ND2 ASN E 165 C1 NAG E 401 1555 1555 1.44 \nCISPEP 1 VAL A 257 LYS A 258 0 15.39 \nCISPEP 2 VAL C 257 LYS C 258 0 13.75 \nCISPEP 3 VAL E 257 LYS E 258 0 10.40 \nCRYST1 114.372 114.372 134.890 90.00 90.00 120.00 P 3 9 \nORIGX1 1.000000 0.000000 0.000000 0.00000 \nORIGX2 0.000000 1.000000 0.000000 0.00000 \nORIGX3 0.000000 0.000000 1.000000 0.00000 \nSCALE1 0.008743 0.005048 0.000000 0.00000 \nSCALE2 0.000000 0.010096 0.000000 0.00000 \nSCALE3 0.000000 0.000000 0.007413 0.00000 \nMTRIX1 1 1.000000 0.000000 0.000000 0.00000 1 \nMTRIX2 1 0.000000 1.000000 0.000000 0.00000 1 \nMTRIX3 1 0.000000 0.000000 1.000000 0.00000 1 \nMTRIX1 2 -0.493840 -0.869547 -0.003120 57.20964 1 \nMTRIX2 2 -0.869551 0.493843 -0.000016 33.16819 1 \nMTRIX3 2 0.001555 0.002705 -0.999995 -14.45997 1 \nMTRIX1 3 -0.152916 0.988204 0.008384 42.31437 1 \nMTRIX2 3 -0.988239 -0.152915 -0.000832 51.06919 1 \nMTRIX3 3 0.000460 -0.008412 0.999965 25.02433 1 \nMODEL 1 \nATOM 1 N PRO A -1 16.518 15.021 33.812 1.00108.74 N \nANISOU 1 N PRO A -1 13644 13962 13711 -3983 -1018 181 N \nATOM 2 CA PRO A -1 15.417 14.440 33.040 1.00107.88 C \nANISOU 2 CA PRO A -1 13518 13817 13656 -3861 -1014 198 C \nATOM 3 C PRO A -1 15.488 12.899 33.107 1.00112.82 C \nANISOU 3 C PRO A -1 14031 14488 14346 -3841 -1113 272 C \nATOM 4 O PRO A -1 15.678 12.359 34.202 1.00118.90 O \nANISOU 4 O PRO A -1 14761 15326 15088 -3913 -1170 308 O \nATOM 5 CB PRO A -1 15.690 14.975 31.636 1.00101.66 C \nANISOU 5 CB PRO A -1 12763 12951 12912 -3793 -964 163 C \nATOM 6 CG PRO A -1 17.191 14.936 31.560 1.00104.61 C \nANISOU 6 CG PRO A -1 13094 13350 13303 -3869 -1001 171 C \nATOM 7 CD PRO A -1 17.688 15.291 32.955 1.00106.32 C \nANISOU 7 CD PRO A -1 13326 13631 13440 -3997 -1015 167 C \nATOM 8 N GLY A 0 15.332 12.204 31.973 1.00102.11 N \nANISOU 8 N GLY A 0 12632 13095 13071 -3746 -1132 293 N \nATOM 9 CA GLY A 0 15.599 10.768 31.903 1.00 89.42 C \nANISOU 9 CA GLY A 0 10930 11519 11529 -3726 -1226 361 C \nATOM 10 C GLY A 0 16.242 10.421 30.578 1.00 79.86 C \nANISOU 10 C GLY A 0 9680 10264 10401 -3657 -1239 366 C \nATOM 11 O GLY A 0 16.192 11.208 29.641 1.00 73.60 O \nANISOU 11 O GLY A 0 8934 9413 9619 -3611 -1172 320 O \nATOM 12 N ASP A 1 16.844 9.237 30.515 1.00 76.06 N \nANISOU 12 N ASP A 1 9117 9808 9973 -3648 -1324 421 N \nATOM 13 CA ASP A 1 17.537 8.781 29.313 1.00 76.02 C \nANISOU 13 CA ASP A 1 9067 9771 10046 -3582 -1346 430 C \nATOM 14 C ASP A 1 16.538 8.578 28.209 1.00 72.75 C \nANISOU 14 C ASP A 1 8670 9292 9681 -3475 -1313 423 C \nATOM 15 O ASP A 1 15.358 8.348 28.463 1.00 79.13 O \nANISOU 15 O ASP A 1 9497 10097 10471 -3450 -1304 433 O \nATOM 16 CB ASP A 1 18.302 7.472 29.566 1.00 76.89 C \nANISOU 16 CB ASP A 1 9092 9925 10199 -3584 -1449 495 C \nATOM 17 CG ASP A 1 19.290 7.573 30.712 1.00 77.18 C \nANISOU 17 CG ASP A 1 9101 10039 10185 -3688 -1489 509 C \nATOM 18 OD1 ASP A 1 19.705 8.701 31.093 1.00 79.02 O \nANISOU 18 OD1 ASP A 1 9375 10290 10361 -3763 -1437 463 O \nATOM 19 OD2 ASP A 1 19.656 6.508 31.224 1.00 76.73 O \nANISOU 19 OD2 ASP A 1 8986 10024 10142 -3696 -1573 566 O \nATOM 20 N GLN A 2 17.019 8.638 26.977 1.00 73.15 N \nANISOU 20 N GLN A 2 8707 9298 9789 -3414 -1298 407 N \nATOM 21 CA GLN A 2 16.152 8.561 25.812 1.00 68.19 C \nANISOU 21 CA GLN A 2 8096 8606 9206 -3312 -1260 395 C \nATOM 22 C GLN A 2 16.748 7.741 24.695 1.00 65.93 C \nANISOU 22 C GLN A 2 7752 8293 9004 -3243 -1301 418 C \nATOM 23 O GLN A 2 17.939 7.833 24.441 1.00 72.46 O \nANISOU 23 O GLN A 2 8547 9134 9850 -3264 -1318 413 O \nATOM 24 CB GLN A 2 15.868 9.969 25.288 1.00 67.85 C \nANISOU 24 CB GLN A 2 8133 8516 9130 -3299 -1160 329 C \nATOM 25 CG GLN A 2 14.845 10.734 26.117 1.00 69.48 C \nANISOU 25 CG GLN A 2 8410 8731 9258 -3326 -1106 302 C \nATOM 26 CD GLN A 2 14.368 11.987 25.426 1.00 65.59 C \nANISOU 26 CD GLN A 2 8003 8178 8739 -3282 -1008 241 C \nATOM 27 OE1 GLN A 2 14.484 12.121 24.205 1.00 59.84 O \nANISOU 27 OE1 GLN A 2 7279 7399 8061 -3215 -981 225 O \nATOM 28 NE2 GLN A 2 13.859 12.932 26.210 1.00 66.69 N \nANISOU 28 NE2 GLN A 2 8217 8324 8798 -3321 -953 206 N \nATOM 29 N ILE A 3 15.908 6.985 23.994 1.00 63.89 N \nANISOU 29 N ILE A 3 7482 8001 8793 -3162 -1313 439 N \nATOM 30 CA ILE A 3 16.275 6.459 22.689 1.00 60.05 C \nANISOU 30 CA ILE A 3 6961 7472 8383 -3081 -1327 445 C \nATOM 31 C ILE A 3 15.267 6.938 21.677 1.00 60.33 C \nANISOU 31 C ILE A 3 7039 7450 8432 -3006 -1257 411 C \nATOM 32 O ILE A 3 14.092 7.059 21.989 1.00 63.82 O \nANISOU 32 O ILE A 3 7515 7895 8840 -2996 -1229 409 O \nATOM 33 CB ILE A 3 16.437 4.924 22.695 1.00 57.90 C \nANISOU 33 CB ILE A 3 6627 7209 8161 -3052 -1421 507 C \nATOM 34 CG1 ILE A 3 17.252 4.495 21.484 1.00 57.67 C \nANISOU 34 CG1 ILE A 3 6557 7149 8205 -2984 -1439 508 C \nATOM 35 CG2 ILE A 3 15.085 4.224 22.699 1.00 58.66 C \nANISOU 35 CG2 ILE A 3 6737 7290 8259 -3016 -1431 534 C \nATOM 36 CD1 ILE A 3 17.940 3.172 21.654 1.00 56.73 C \nANISOU 36 CD1 ILE A 3 6379 7050 8126 -2969 -1535 564 C \nATOM 37 N CYS A 4 15.722 7.175 20.451 1.00 66.68 N \nANISOU 37 N CYS A 4 7838 8211 9285 -2950 -1229 387 N \nATOM 38 CA CYS A 4 14.839 7.666 19.354 1.00 68.22 C \nANISOU 38 CA CYS A 4 8074 8351 9496 -2871 -1161 354 C \nATOM 39 C CYS A 4 14.941 6.833 18.070 1.00 66.44 C \nANISOU 39 C CYS A 4 7806 8088 9352 -2786 -1186 371 C \nATOM 40 O CYS A 4 15.971 6.268 17.766 1.00 63.02 O \nANISOU 40 O CYS A 4 7322 7659 8963 -2783 -1234 388 O \nATOM 41 CB CYS A 4 15.148 9.116 19.046 1.00 68.04 C \nANISOU 41 CB CYS A 4 8113 8301 9438 -2886 -1078 295 C \nATOM 42 SG CYS A 4 14.910 10.244 20.454 1.00 72.81 S \nANISOU 42 SG CYS A 4 8788 8937 9940 -2979 -1034 266 S \nATOM 43 N ILE A 5 13.835 6.731 17.338 1.00 72.56 N \nANISOU 43 N ILE A 5 8599 8830 10141 -2715 -1154 366 N \nATOM 44 CA ILE A 5 13.835 6.092 16.024 1.00 67.14 C \nANISOU 44 CA ILE A 5 7882 8102 9526 -2634 -1165 374 C \nATOM 45 C ILE A 5 13.760 7.161 14.990 1.00 62.66 C \nANISOU 45 C ILE A 5 7355 7489 8962 -2588 -1084 323 C \nATOM 46 O ILE A 5 12.931 8.045 15.079 1.00 64.50 O \nANISOU 46 O ILE A 5 7645 7715 9148 -2579 -1019 293 O \nATOM 47 CB ILE A 5 12.651 5.132 15.852 1.00 73.95 C \nANISOU 47 CB ILE A 5 8733 8963 10403 -2590 -1191 408 C \nATOM 48 CG1 ILE A 5 12.552 4.184 17.057 1.00 81.95 C \nANISOU 48 CG1 ILE A 5 9723 10022 11395 -2648 -1266 458 C \nATOM 49 CG2 ILE A 5 12.804 4.319 14.577 1.00 71.79 C \nANISOU 49 CG2 ILE A 5 8426 8648 10204 -2515 -1215 420 C \nATOM 50 CD1 ILE A 5 13.823 3.424 17.403 1.00 84.12 C \nANISOU 50 CD1 ILE A 5 9952 10309 11701 -2678 -1343 491 C \nATOM 51 N GLY A 6 14.661 7.099 14.021 1.00 66.85 N \nANISOU 51 N GLY A 6 7860 7994 9546 -2558 -1087 312 N \nATOM 52 CA GLY A 6 14.773 8.148 13.008 1.00 68.04 C \nANISOU 52 CA GLY A 6 8051 8100 9699 -2523 -1012 263 C \nATOM 53 C GLY A 6 15.334 7.627 11.691 1.00 69.78 C \nANISOU 53 C GLY A 6 8229 8289 9993 -2460 -1027 265 C \nATOM 54 O GLY A 6 15.523 6.411 11.511 1.00 67.75 O \nANISOU 54 O GLY A 6 7915 8041 9788 -2433 -1095 303 O \nATOM 55 N TYR A 7 15.638 8.553 10.782 1.00 68.78 N \nANISOU 55 N TYR A 7 8135 8127 9871 -2439 -965 222 N \nATOM 56 CA TYR A 7 16.085 8.185 9.436 1.00 69.70 C \nANISOU 56 CA TYR A 7 8216 8213 10053 -2375 -969 217 C \nATOM 57 C TYR A 7 17.058 9.194 8.808 1.00 78.28 C \nANISOU 57 C TYR A 7 9324 9284 11134 -2397 -921 174 C \nATOM 58 O TYR A 7 17.287 10.279 9.331 1.00 82.04 O \nANISOU 58 O TYR A 7 9857 9763 11553 -2459 -876 145 O \nATOM 59 CB TYR A 7 14.881 7.955 8.514 1.00 65.47 C \nANISOU 59 CB TYR A 7 7695 7638 9542 -2288 -940 218 C \nATOM 60 CG TYR A 7 13.932 9.139 8.370 1.00 64.07 C \nANISOU 60 CG TYR A 7 7597 7434 9313 -2268 -855 182 C \nATOM 61 CD1 TYR A 7 14.075 10.036 7.325 1.00 66.90 C \nANISOU 61 CD1 TYR A 7 7996 7747 9675 -2232 -791 142 C \nATOM 62 CD2 TYR A 7 12.885 9.335 9.249 1.00 60.43 C \nANISOU 62 CD2 TYR A 7 7170 6993 8796 -2279 -840 188 C \nATOM 63 CE1 TYR A 7 13.204 11.085 7.157 1.00 68.07 C \nANISOU 63 CE1 TYR A 7 8222 7867 9774 -2202 -715 111 C \nATOM 64 CE2 TYR A 7 12.015 10.401 9.099 1.00 65.66 C \nANISOU 64 CE2 TYR A 7 7906 7634 9408 -2248 -763 154 C \nATOM 65 CZ TYR A 7 12.181 11.271 8.043 1.00 68.68 C \nANISOU 65 CZ TYR A 7 8332 7966 9796 -2206 -701 117 C \nATOM 66 OH TYR A 7 11.342 12.353 7.881 1.00 76.12 O \nANISOU 66 OH TYR A 7 9355 8882 10685 -2166 -624 84 O \nATOM 67 N HIS A 8 17.635 8.802 7.683 1.00 80.73 N \nANISOU 67 N HIS A 8 9591 9578 11502 -2350 -932 172 N \nATOM 68 CA HIS A 8 18.655 9.591 7.013 1.00 81.79 C \nANISOU 68 CA HIS A 8 9733 9708 11637 -2373 -896 135 C \nATOM 69 C HIS A 8 18.142 10.946 6.552 1.00 85.24 C \nANISOU 69 C HIS A 8 10264 10094 12031 -2370 -805 90 C \nATOM 70 O HIS A 8 16.978 11.103 6.186 1.00 95.04 O \nANISOU 70 O HIS A 8 11547 11295 13269 -2309 -768 86 O \nATOM 71 CB HIS A 8 19.199 8.805 5.829 1.00 83.51 C \nANISOU 71 CB HIS A 8 9884 9919 11926 -2309 -926 143 C \nATOM 72 CG HIS A 8 20.552 9.243 5.358 1.00 94.32 C \nANISOU 72 CG HIS A 8 11226 11313 13298 -2347 -919 117 C \nATOM 73 ND1 HIS A 8 20.858 10.547 5.043 1.00 95.94 N \nANISOU 73 ND1 HIS A 8 11492 11500 13461 -2391 -849 73 N \nATOM 74 CD2 HIS A 8 21.677 8.529 5.110 1.00 99.29 C \nANISOU 74 CD2 HIS A 8 11772 11989 13964 -2344 -973 130 C \nATOM 75 CE1 HIS A 8 22.111 10.622 4.640 1.00 99.71 C \nANISOU 75 CE1 HIS A 8 11923 12016 13947 -2424 -860 60 C \nATOM 76 NE2 HIS A 8 22.631 9.409 4.673 1.00 98.21 N \nANISOU 76 NE2 HIS A 8 11640 11870 13804 -2392 -935 93 N \nATOM 77 N ALA A 9 19.010 11.943 6.622 1.00 85.74 N \nANISOU 77 N ALA A 9 10362 10161 12054 -2440 -769 57 N \nATOM 78 CA ALA A 9 18.755 13.232 5.988 1.00 91.53 C \nANISOU 78 CA ALA A 9 11189 10838 12750 -2437 -684 12 C \nATOM 79 C ALA A 9 20.056 13.719 5.370 1.00 94.22 C \nANISOU 79 C ALA A 9 11518 11190 13091 -2487 -671 -14 C \nATOM 80 O ALA A 9 21.132 13.266 5.751 1.00 97.60 O \nANISOU 80 O ALA A 9 11875 11680 13527 -2543 -722 -2 O \nATOM 81 CB ALA A 9 18.228 14.253 6.982 1.00 92.44 C \nANISOU 81 CB ALA A 9 11401 10939 12783 -2489 -637 -8 C \nATOM 82 N ASN A 10 19.941 14.609 4.390 1.00 88.75 N \nANISOU 82 N ASN A 10 10892 10441 12388 -2465 -604 -49 N \nATOM 83 CA ASN A 10 21.103 15.247 3.791 1.00 87.25 C \nANISOU 83 CA ASN A 10 10708 10258 12185 -2524 -581 -79 C \nATOM 84 C ASN A 10 20.744 16.612 3.170 1.00 93.65 C \nANISOU 84 C ASN A 10 11643 10993 12947 -2526 -492 -122 C \nATOM 85 O ASN A 10 19.696 17.188 3.465 1.00100.06 O \nANISOU 85 O ASN A 10 12544 11753 13720 -2495 -447 -131 O \nATOM 86 CB ASN A 10 21.861 14.308 2.830 1.00 76.62 C \nANISOU 86 CB ASN A 10 9253 8947 10913 -2482 -627 -66 C \nATOM 87 CG ASN A 10 21.032 13.880 1.615 1.00 81.72 C \nANISOU 87 CG ASN A 10 9892 9539 11618 -2365 -612 -61 C \nATOM 88 OD1 ASN A 10 20.071 14.541 1.239 1.00 84.90 O \nANISOU 88 OD1 ASN A 10 10379 9879 12001 -2322 -554 -77 O \nATOM 89 ND2 ASN A 10 21.438 12.779 0.968 1.00 70.36 N \nANISOU 89 ND2 ASN A 10 8355 8130 10249 -2312 -665 -40 N \nATOM 90 N ASN A 11 21.638 17.133 2.348 1.00102.82 N \nANISOU 90 N ASN A 11 12812 12150 14103 -2563 -466 -148 N \nATOM 91 CA ASN A 11 21.475 18.446 1.731 1.00112.57 C \nANISOU 91 CA ASN A 11 14172 13312 15287 -2577 -384 -189 C \nATOM 92 C ASN A 11 21.015 18.320 0.275 1.00117.73 C \nANISOU 92 C ASN A 11 14824 13916 15993 -2474 -358 -193 C \nATOM 93 O ASN A 11 20.905 19.316 -0.443 1.00120.99 O \nANISOU 93 O ASN A 11 15333 14266 16372 -2472 -293 -223 O \nATOM 94 CB ASN A 11 22.793 19.231 1.820 1.00113.91 C \nANISOU 94 CB ASN A 11 14367 13512 15403 -2706 -368 -218 C \nATOM 95 CG ASN A 11 24.001 18.415 1.369 1.00110.15 C \nANISOU 95 CG ASN A 11 13756 13120 14975 -2731 -424 -206 C \nATOM 96 OD1 ASN A 11 23.864 17.336 0.779 1.00 99.60 O \nANISOU 96 OD1 ASN A 11 12323 11804 13718 -2641 -467 -181 O \nATOM 97 ND2 ASN A 11 25.198 18.924 1.663 1.00109.74 N \nANISOU 97 ND2 ASN A 11 13700 13123 14872 -2853 -423 -225 N \nATOM 98 N SER A 12 20.758 17.084 -0.147 1.00118.09 N \nANISOU 98 N SER A 12 14763 13989 16117 -2391 -410 -161 N \nATOM 99 CA SER A 12 20.288 16.789 -1.496 1.00111.27 C \nANISOU 99 CA SER A 12 13883 13087 15309 -2291 -394 -161 C \nATOM 100 C SER A 12 19.043 17.597 -1.814 1.00106.06 C \nANISOU 100 C SER A 12 13335 12348 14616 -2225 -326 -175 C \nATOM 101 O SER A 12 18.191 17.807 -0.945 1.00108.41 O \nANISOU 101 O SER A 12 13683 12633 14876 -2214 -315 -169 O \nATOM 102 CB SER A 12 19.995 15.293 -1.642 1.00113.56 C \nANISOU 102 CB SER A 12 14055 13414 15678 -2214 -463 -122 C \nATOM 103 OG SER A 12 19.128 15.056 -2.720 1.00121.50 O \nANISOU 103 OG SER A 12 15064 14374 16725 -2110 -441 -119 O \nATOM 104 N THR A 13 18.956 18.045 -3.062 1.00 99.86 N \nANISOU 104 N THR A 13 12587 11515 13842 -2179 -281 -194 N \nATOM 105 CA THR A 13 17.843 18.880 -3.524 1.00 98.16 C \nANISOU 105 CA THR A 13 12482 11224 13591 -2107 -213 -209 C \nATOM 106 C THR A 13 17.087 18.224 -4.687 1.00 91.16 C \nANISOU 106 C THR A 13 11547 10322 12768 -1989 -215 -195 C \nATOM 107 O THR A 13 16.189 18.821 -5.260 1.00 86.71 O \nANISOU 107 O THR A 13 11059 9704 12182 -1917 -162 -205 O \nATOM 108 CB THR A 13 18.359 20.235 -4.013 1.00 98.65 C \nANISOU 108 CB THR A 13 12661 11229 13593 -2161 -146 -249 C \nATOM 109 OG1 THR A 13 19.414 19.998 -4.946 1.00103.60 O \nANISOU 109 OG1 THR A 13 13225 11879 14259 -2193 -160 -256 O \nATOM 110 CG2 THR A 13 18.878 21.065 -2.861 1.00101.45 C \nANISOU 110 CG2 THR A 13 13093 11583 13869 -2275 -130 -267 C \nATOM 111 N GLU A 14 17.464 17.002 -5.027 1.00 88.48 N \nANISOU 111 N GLU A 14 11084 10032 12503 -1969 -277 -171 N \nATOM 112 CA GLU A 14 16.789 16.250 -6.066 1.00 93.03 C \nANISOU 112 CA GLU A 14 11606 10600 13140 -1865 -286 -155 C \nATOM 113 C GLU A 14 15.335 16.013 -5.663 1.00 95.31 C \nANISOU 113 C GLU A 14 11914 10882 13418 -1790 -281 -135 C \nATOM 114 O GLU A 14 15.034 15.483 -4.585 1.00 96.87 O \nANISOU 114 O GLU A 14 12081 11115 13609 -1809 -320 -113 O \nATOM 115 CB GLU A 14 17.479 14.914 -6.331 1.00 94.45 C \nANISOU 115 CB GLU A 14 11656 10834 13396 -1862 -359 -133 C \nATOM 116 CG GLU A 14 18.901 15.049 -6.864 1.00 99.20 C \nANISOU 116 CG GLU A 14 12222 11459 14012 -1923 -366 -152 C \nATOM 117 CD GLU A 14 19.695 13.755 -6.777 1.00 97.35 C \nANISOU 117 CD GLU A 14 11861 11289 13837 -1927 -444 -129 C \nATOM 118 OE1 GLU A 14 19.481 12.989 -5.821 1.00 87.98 O \nANISOU 118 OE1 GLU A 14 10633 10135 12662 -1930 -495 -101 O \nATOM 119 OE2 GLU A 14 20.533 13.502 -7.665 1.00 98.69 O \nANISOU 119 OE2 GLU A 14 11977 11479 14042 -1925 -453 -139 O \nATOM 120 N GLN A 15 14.441 16.467 -6.527 1.00 87.84 N \nANISOU 120 N GLN A 15 11020 9892 12462 -1708 -230 -144 N \nATOM 121 CA GLN A 15 13.026 16.298 -6.326 1.00 82.06 C \nANISOU 121 CA GLN A 15 10301 9163 11715 -1628 -219 -128 C \nATOM 122 C GLN A 15 12.528 15.083 -7.099 1.00 84.99 C \nANISOU 122 C GLN A 15 10576 9561 12155 -1557 -258 -101 C \nATOM 123 O GLN A 15 13.221 14.536 -7.956 1.00 86.16 O \nANISOU 123 O GLN A 15 10664 9712 12361 -1556 -282 -101 O \nATOM 124 CB GLN A 15 12.286 17.539 -6.751 1.00 80.23 C \nANISOU 124 CB GLN A 15 10186 8875 11422 -1575 -139 -152 C \nATOM 125 CG GLN A 15 12.428 18.682 -5.772 1.00 90.71 C \nANISOU 125 CG GLN A 15 11624 10174 12669 -1633 -100 -175 C \nATOM 126 CD GLN A 15 11.778 19.960 -6.280 1.00 94.03 C \nANISOU 126 CD GLN A 15 12175 10528 13026 -1573 -19 -201 C \nATOM 127 OE1 GLN A 15 11.161 19.973 -7.350 1.00 90.17 O \nANISOU 127 OE1 GLN A 15 11688 10021 12553 -1483 7 -199 O \nATOM 128 NE2 GLN A 15 11.902 21.035 -5.508 1.00 93.41 N \nANISOU 128 NE2 GLN A 15 12209 10411 12870 -1620 21 -224 N \nATOM 129 N VAL A 16 11.307 14.674 -6.785 1.00 78.41 N \nANISOU 129 N VAL A 16 9730 8751 11310 -1500 -264 -80 N \nATOM 130 CA VAL A 16 10.742 13.448 -7.319 1.00 70.53 C \nANISOU 130 CA VAL A 16 8645 7785 10368 -1446 -306 -52 C \nATOM 131 C VAL A 16 9.255 13.559 -7.235 1.00 72.90 C \nANISOU 131 C VAL A 16 8968 8102 10628 -1375 -278 -42 C \nATOM 132 O VAL A 16 8.733 14.246 -6.359 1.00 80.06 O \nANISOU 132 O VAL A 16 9935 9014 11471 -1380 -250 -48 O \nATOM 133 CB VAL A 16 11.245 12.234 -6.517 1.00 73.84 C \nANISOU 133 CB VAL A 16 8980 8248 10828 -1501 -387 -23 C \nATOM 134 CG1 VAL A 16 10.112 11.312 -6.126 1.00 75.37 C \nANISOU 134 CG1 VAL A 16 9131 8483 11023 -1466 -420 9 C \nATOM 135 CG2 VAL A 16 12.316 11.493 -7.287 1.00 69.16 C \nANISOU 135 CG2 VAL A 16 8318 7653 10305 -1513 -427 -22 C \nATOM 136 N ASP A 17 8.565 12.931 -8.171 1.00 73.77 N \nANISOU 136 N ASP A 17 9033 8226 10771 -1306 -283 -29 N \nATOM 137 CA ASP A 17 7.095 13.008 -8.170 1.00 79.02 C \nANISOU 137 CA ASP A 17 9709 8923 11392 -1234 -256 -19 C \nATOM 138 C ASP A 17 6.342 11.744 -7.765 1.00 71.97 C \nANISOU 138 C ASP A 17 8738 8093 10516 -1233 -312 17 C \nATOM 139 O ASP A 17 6.902 10.636 -7.713 1.00 67.50 O \nANISOU 139 O ASP A 17 8103 7536 10006 -1274 -375 37 O \nATOM 140 CB ASP A 17 6.609 13.453 -9.541 1.00 87.52 C \nANISOU 140 CB ASP A 17 10808 9976 12470 -1150 -206 -32 C \nATOM 141 CG ASP A 17 6.770 14.933 -9.745 1.00 88.39 C \nANISOU 141 CG ASP A 17 11026 10030 12527 -1130 -134 -64 C \nATOM 142 OD1 ASP A 17 7.915 15.426 -9.833 1.00 93.76 O \nANISOU 142 OD1 ASP A 17 11741 10663 13219 -1186 -127 -85 O \nATOM 143 OD2 ASP A 17 5.725 15.609 -9.807 1.00 89.54 O \nANISOU 143 OD2 ASP A 17 11224 10182 12614 -1058 -85 -70 O \nATOM 144 N THR A 18 5.063 11.980 -7.480 1.00 66.87 N \nANISOU 144 N THR A 18 8107 7488 9812 -1184 -284 24 N \nATOM 145 CA THR A 18 4.141 10.993 -6.957 1.00 66.87 C \nANISOU 145 CA THR A 18 8046 7558 9803 -1186 -326 56 C \nATOM 146 C THR A 18 2.749 11.341 -7.481 1.00 70.20 C \nANISOU 146 C THR A 18 8476 8024 10174 -1098 -278 55 C \nATOM 147 O THR A 18 2.461 12.501 -7.830 1.00 72.57 O \nANISOU 147 O THR A 18 8845 8301 10429 -1038 -212 31 O \nATOM 148 CB THR A 18 4.170 11.032 -5.404 1.00 68.47 C \nANISOU 148 CB THR A 18 8262 7789 9966 -1252 -349 64 C \nATOM 149 OG1 THR A 18 5.349 10.372 -4.927 1.00 76.74 O \nANISOU 149 OG1 THR A 18 9277 8816 11064 -1333 -408 75 O \nATOM 150 CG2 THR A 18 2.997 10.363 -4.780 1.00 74.10 C \nANISOU 150 CG2 THR A 18 8933 8581 10641 -1248 -372 92 C \nATOM 151 N ILE A 19 1.872 10.348 -7.509 1.00 75.39 N \nANISOU 151 N ILE A 19 9067 8747 10831 -1090 -312 84 N \nATOM 152 CA ILE A 19 0.471 10.535 -7.965 1.00 82.57 C \nANISOU 152 CA ILE A 19 9967 9721 11685 -1011 -274 88 C \nATOM 153 C ILE A 19 -0.319 11.525 -7.118 1.00 86.42 C \nANISOU 153 C ILE A 19 10506 10248 12083 -975 -226 76 C \nATOM 154 O ILE A 19 -1.249 12.135 -7.605 1.00 94.85 O \nANISOU 154 O ILE A 19 11592 11350 13098 -889 -174 67 O \nATOM 155 CB ILE A 19 -0.293 9.195 -8.091 1.00 83.86 C \nANISOU 155 CB ILE A 19 10047 9956 11861 -1028 -324 121 C \nATOM 156 CG1 ILE A 19 -0.350 8.497 -6.748 1.00 93.97 C \nANISOU 156 CG1 ILE A 19 11301 11277 13125 -1108 -378 145 C \nATOM 157 CG2 ILE A 19 0.393 8.279 -9.096 1.00 79.08 C \nANISOU 157 CG2 ILE A 19 9400 9307 11339 -1044 -363 129 C \nATOM 158 CD1 ILE A 19 -1.642 8.756 -6.023 1.00 99.86 C \nANISOU 158 CD1 ILE A 19 12042 12118 13783 -1086 -355 153 C \nATOM 159 N MET A 20 0.080 11.696 -5.862 1.00 92.36 N \nANISOU 159 N MET A 20 11284 10996 12815 -1038 -242 75 N \nATOM 160 CA MET A 20 -0.584 12.605 -4.921 1.00 91.38 C \nANISOU 160 CA MET A 20 11212 10906 12603 -1013 -200 62 C \nATOM 161 C MET A 20 0.252 13.815 -4.544 1.00 89.12 C \nANISOU 161 C MET A 20 11023 10539 12298 -1024 -160 29 C \nATOM 162 O MET A 20 -0.265 14.754 -3.941 1.00 88.33 O \nANISOU 162 O MET A 20 10987 10451 12123 -986 -113 12 O \nATOM 163 CB MET A 20 -0.931 11.865 -3.624 1.00 96.50 C \nANISOU 163 CB MET A 20 11816 11624 13227 -1083 -249 87 C \nATOM 164 CG MET A 20 -2.187 11.027 -3.683 1.00 94.25 C \nANISOU 164 CG MET A 20 11455 11443 12911 -1064 -269 114 C \nATOM 165 SD MET A 20 -2.379 10.214 -2.096 1.00105.99 S \nANISOU 165 SD MET A 20 12903 12999 14371 -1164 -329 143 S \nATOM 166 CE MET A 20 -3.773 9.152 -2.447 1.00114.92 C \nANISOU 166 CE MET A 20 13945 14249 15472 -1150 -353 175 C \nATOM 167 N GLU A 21 1.545 13.774 -4.841 1.00 91.25 N \nANISOU 167 N GLU A 21 11307 10733 12632 -1079 -179 21 N \nATOM 168 CA GLU A 21 2.456 14.855 -4.446 1.00 95.53 C \nANISOU 168 CA GLU A 21 11940 11201 13156 -1111 -146 -9 C \nATOM 169 C GLU A 21 3.468 15.180 -5.544 1.00 81.26 C \nANISOU 169 C GLU A 21 10159 9314 11402 -1112 -131 -27 C \nATOM 170 O GLU A 21 4.061 14.289 -6.133 1.00 69.74 O \nANISOU 170 O GLU A 21 8633 7848 10016 -1141 -176 -13 O \nATOM 171 CB GLU A 21 3.201 14.490 -3.155 1.00107.67 C \nANISOU 171 CB GLU A 21 13464 12743 14701 -1217 -195 -1 C \nATOM 172 CG GLU A 21 2.405 14.676 -1.873 1.00115.80 C \nANISOU 172 CG GLU A 21 14509 13833 15658 -1226 -190 4 C \nATOM 173 CD GLU A 21 3.263 14.529 -0.620 1.00122.34 C \nANISOU 173 CD GLU A 21 15341 14654 16488 -1333 -230 7 C \nATOM 174 OE1 GLU A 21 3.588 15.564 -0.001 1.00126.19 O \nANISOU 174 OE1 GLU A 21 15913 15106 16926 -1353 -192 -19 O \nATOM 175 OE2 GLU A 21 3.628 13.386 -0.258 1.00114.17 O \nANISOU 175 OE2 GLU A 21 14229 13649 15503 -1397 -300 37 O \nATOM 176 N LYS A 22 3.669 16.468 -5.771 1.00 83.38 N \nANISOU 176 N LYS A 22 10531 9521 11628 -1082 -68 -59 N \nATOM 177 CA LYS A 22 4.558 16.959 -6.795 1.00 92.47 C \nANISOU 177 CA LYS A 22 11723 10598 12814 -1083 -44 -79 C \nATOM 178 C LYS A 22 5.720 17.677 -6.113 1.00102.06 C \nANISOU 178 C LYS A 22 13009 11755 14014 -1172 -37 -102 C \nATOM 179 O LYS A 22 5.533 18.329 -5.091 1.00109.16 O \nANISOU 179 O LYS A 22 13973 12654 14850 -1191 -16 -114 O \nATOM 180 CB LYS A 22 3.771 17.883 -7.743 1.00103.61 C \nANISOU 180 CB LYS A 22 13204 11984 14180 -972 26 -96 C \nATOM 181 CG LYS A 22 4.609 18.848 -8.611 1.00110.35 C \nANISOU 181 CG LYS A 22 14146 12746 15036 -972 71 -125 C \nATOM 182 CD LYS A 22 5.135 18.134 -9.860 1.00110.72 C \nANISOU 182 CD LYS A 22 14121 12784 15164 -973 46 -116 C \nATOM 183 CE LYS A 22 6.046 18.989 -10.759 1.00105.57 C \nANISOU 183 CE LYS A 22 13544 12048 14518 -985 85 -143 C \nATOM 184 NZ LYS A 22 7.148 18.165 -11.356 1.00 97.45 N \nANISOU 184 NZ LYS A 22 12435 11016 13575 -1050 38 -138 N \nATOM 185 N ASN A 23 6.920 17.545 -6.683 1.00110.43 N \nANISOU 185 N ASN A 23 14055 12775 15130 -1229 -55 -110 N \nATOM 186 CA ASN A 23 8.122 18.267 -6.215 1.00110.96 C \nANISOU 186 CA ASN A 23 14187 12793 15181 -1320 -45 -134 C \nATOM 187 C ASN A 23 8.499 17.899 -4.782 1.00105.13 C \nANISOU 187 C ASN A 23 13422 12091 14431 -1408 -90 -124 C \nATOM 188 O ASN A 23 8.568 18.746 -3.902 1.00 99.02 O \nANISOU 188 O ASN A 23 12731 11297 13594 -1445 -61 -142 O \nATOM 189 CB ASN A 23 7.976 19.797 -6.373 1.00107.65 C \nANISOU 189 CB ASN A 23 13914 12304 14685 -1290 35 -168 C \nATOM 190 CG ASN A 23 7.906 20.250 -7.831 1.00114.09 C \nANISOU 190 CG ASN A 23 14766 13072 15513 -1221 78 -180 C \nATOM 191 OD1 ASN A 23 6.920 20.872 -8.250 1.00123.92 O \nANISOU 191 OD1 ASN A 23 16073 14301 16711 -1122 129 -186 O \nATOM 192 ND2 ASN A 23 8.950 19.962 -8.606 1.00113.90 N \nANISOU 192 ND2 ASN A 23 14702 13027 15546 -1269 58 -184 N \nATOM 193 N VAL A 24 8.726 16.610 -4.565 1.00106.45 N \nANISOU 193 N VAL A 24 13477 12311 14660 -1441 -161 -94 N \nATOM 194 CA VAL A 24 9.065 16.088 -3.235 1.00 97.07 C \nANISOU 194 CA VAL A 24 12251 11164 13468 -1521 -212 -78 C \nATOM 195 C VAL A 24 10.551 15.817 -3.109 1.00 85.94 C \nANISOU 195 C VAL A 24 10807 9748 12100 -1615 -252 -81 C \nATOM 196 O VAL A 24 11.085 14.935 -3.788 1.00 77.13 O \nANISOU 196 O VAL A 24 9610 8642 11053 -1615 -295 -67 O \nATOM 197 CB VAL A 24 8.297 14.787 -2.941 1.00 98.85 C \nANISOU 197 CB VAL A 24 12379 11456 13725 -1498 -269 -39 C \nATOM 198 CG1 VAL A 24 8.851 14.094 -1.699 1.00 96.83 C \nANISOU 198 CG1 VAL A 24 12075 11238 13477 -1587 -332 -19 C \nATOM 199 CG2 VAL A 24 6.820 15.106 -2.785 1.00 97.62 C \nANISOU 199 CG2 VAL A 24 12252 11327 13510 -1420 -230 -37 C \nATOM 200 N THR A 25 11.210 16.570 -2.227 1.00 82.14 N \nANISOU 200 N THR A 25 10386 9253 11572 -1694 -239 -99 N \nATOM 201 CA THR A 25 12.655 16.506 -2.112 1.00 77.97 C \nANISOU 201 CA THR A 25 9832 8725 11068 -1788 -269 -106 C \nATOM 202 C THR A 25 13.062 15.164 -1.519 1.00 75.38 C \nANISOU 202 C THR A 25 9390 8457 10792 -1826 -353 -71 C \nATOM 203 O THR A 25 12.438 14.681 -0.582 1.00 75.32 O \nANISOU 203 O THR A 25 9361 8488 10770 -1829 -382 -49 O \nATOM 204 CB THR A 25 13.195 17.670 -1.275 1.00 73.10 C \nANISOU 204 CB THR A 25 9314 8084 10378 -1869 -232 -135 C \nATOM 205 OG1 THR A 25 12.419 18.849 -1.535 1.00 78.39 O \nANISOU 205 OG1 THR A 25 10104 8696 10984 -1816 -155 -162 O \nATOM 206 CG2 THR A 25 14.653 17.932 -1.607 1.00 67.26 C \nANISOU 206 CG2 THR A 25 8568 7335 9652 -1954 -238 -153 C \nATOM 207 N VAL A 26 14.098 14.556 -2.079 1.00 71.56 N \nANISOU 207 N VAL A 26 8837 7985 10367 -1851 -392 -66 N \nATOM 208 CA VAL A 26 14.470 13.208 -1.695 1.00 72.27 C \nANISOU 208 CA VAL A 26 8822 8127 10511 -1868 -474 -32 C \nATOM 209 C VAL A 26 15.961 13.134 -1.388 1.00 80.10 C \nANISOU 209 C VAL A 26 9776 9144 11514 -1953 -508 -37 C \nATOM 210 O VAL A 26 16.721 14.032 -1.747 1.00 84.30 O \nANISOU 210 O VAL A 26 10352 9657 12023 -1995 -469 -68 O \nATOM 211 CB VAL A 26 14.049 12.185 -2.787 1.00 75.81 C \nANISOU 211 CB VAL A 26 9203 8574 11028 -1786 -499 -12 C \nATOM 212 CG1 VAL A 26 15.229 11.727 -3.653 1.00 76.72 C \nANISOU 212 CG1 VAL A 26 9257 8692 11202 -1794 -527 -17 C \nATOM 213 CG2 VAL A 26 13.342 10.993 -2.168 1.00 76.17 C \nANISOU 213 CG2 VAL A 26 9189 8657 11093 -1768 -558 28 C \nATOM 214 N THR A 27 16.360 12.058 -0.713 1.00 80.37 N \nANISOU 214 N THR A 27 9730 9228 11579 -1980 -582 -5 N \nATOM 215 CA THR A 27 17.709 11.889 -0.239 1.00 74.19 C \nANISOU 215 CA THR A 27 8901 8487 10800 -2057 -623 -5 C \nATOM 216 C THR A 27 18.602 11.289 -1.329 1.00 78.11 C \nANISOU 216 C THR A 27 9325 8994 11360 -2030 -649 -6 C \nATOM 217 O THR A 27 19.713 11.764 -1.538 1.00 79.94 O \nANISOU 217 O THR A 27 9549 9244 11581 -2083 -640 -28 O \nATOM 218 CB THR A 27 17.695 11.126 1.089 1.00 76.71 C \nANISOU 218 CB THR A 27 9180 8855 11113 -2097 -686 29 C \nATOM 219 OG1 THR A 27 18.606 11.732 2.009 1.00 87.66 O \nANISOU 219 OG1 THR A 27 10581 10274 12451 -2195 -688 17 O \nATOM 220 CG2 THR A 27 17.998 9.655 0.938 1.00 73.22 C \nANISOU 220 CG2 THR A 27 8640 8443 10736 -2062 -765 66 C \nATOM 221 N HIS A 28 18.107 10.277 -2.042 1.00 84.49 N \nANISOU 221 N HIS A 28 10083 9793 12227 -1949 -679 15 N \nATOM 222 CA HIS A 28 18.805 9.668 -3.183 1.00 80.07 C \nANISOU 222 CA HIS A 28 9459 9237 11728 -1908 -700 12 C \nATOM 223 C HIS A 28 17.777 9.373 -4.272 1.00 82.77 C \nANISOU 223 C HIS A 28 9810 9535 12105 -1816 -676 14 C \nATOM 224 O HIS A 28 16.648 8.954 -3.995 1.00 71.41 O \nANISOU 224 O HIS A 28 8384 8085 10665 -1779 -684 36 O \nATOM 225 CB HIS A 28 19.508 8.348 -2.816 1.00 81.45 C \nANISOU 225 CB HIS A 28 9541 9459 11946 -1905 -785 44 C \nATOM 226 CG HIS A 28 20.639 8.475 -1.841 1.00 88.38 C \nANISOU 226 CG HIS A 28 10390 10395 12796 -1988 -818 46 C \nATOM 227 ND1 HIS A 28 21.859 7.859 -2.037 1.00 89.12 N \nANISOU 227 ND1 HIS A 28 10404 10540 12920 -1993 -866 50 N \nATOM 228 CD2 HIS A 28 20.725 9.100 -0.644 1.00 91.11 C \nANISOU 228 CD2 HIS A 28 10772 10762 13082 -2067 -811 44 C \nATOM 229 CE1 HIS A 28 22.652 8.124 -1.012 1.00 91.86 C \nANISOU 229 CE1 HIS A 28 10737 10942 13226 -2073 -887 52 C \nATOM 230 NE2 HIS A 28 21.989 8.876 -0.155 1.00 91.06 N \nANISOU 230 NE2 HIS A 28 10707 10822 13071 -2123 -854 48 N \nATOM 231 N ALA A 29 18.197 9.536 -5.520 1.00 89.36 N \nANISOU 231 N ALA A 29 10633 10352 12969 -1783 -651 -7 N \nATOM 232 CA ALA A 29 17.316 9.306 -6.643 1.00 91.12 C \nANISOU 232 CA ALA A 29 10862 10536 13224 -1699 -627 -8 C \nATOM 233 C ALA A 29 18.083 8.829 -7.874 1.00 93.60 C \nANISOU 233 C ALA A 29 11119 10851 13594 -1663 -639 -18 C \nATOM 234 O ALA A 29 19.300 8.977 -7.948 1.00 98.89 O \nANISOU 234 O ALA A 29 11756 11551 14266 -1705 -650 -33 O \nATOM 235 CB ALA A 29 16.540 10.578 -6.945 1.00 88.96 C \nANISOU 235 CB ALA A 29 10682 10220 12901 -1688 -546 -33 C \nATOM 236 N GLN A 30 17.357 8.243 -8.825 1.00 92.96 N \nANISOU 236 N GLN A 30 11023 10744 13552 -1586 -638 -11 N \nATOM 237 CA GLN A 30 17.919 7.868 -10.122 1.00 89.35 C \nANISOU 237 CA GLN A 30 10521 10282 13145 -1543 -640 -24 C \nATOM 238 C GLN A 30 17.114 8.475 -11.274 1.00 94.69 C \nANISOU 238 C GLN A 30 11244 10915 13819 -1489 -576 -43 C \nATOM 239 O GLN A 30 15.917 8.241 -11.416 1.00 92.94 O \nANISOU 239 O GLN A 30 11043 10674 13597 -1441 -566 -28 O \nATOM 240 CB GLN A 30 17.980 6.360 -10.290 1.00 84.39 C \nANISOU 240 CB GLN A 30 9823 9667 12575 -1497 -710 3 C \nATOM 241 CG GLN A 30 19.303 5.748 -9.897 1.00 84.48 C \nANISOU 241 CG GLN A 30 9768 9724 12608 -1524 -768 9 C \nATOM 242 CD GLN A 30 19.530 4.389 -10.552 1.00 82.37 C \nANISOU 242 CD GLN A 30 9438 9456 12402 -1459 -824 24 C \nATOM 243 OE1 GLN A 30 19.625 4.285 -11.773 1.00 88.05 O \nANISOU 243 OE1 GLN A 30 10142 10159 13153 -1411 -804 6 O \nATOM 244 NE2 GLN A 30 19.641 3.347 -9.742 1.00 78.42 N \nANISOU 244 NE2 GLN A 30 8908 8972 11915 -1457 -893 57 N \nATOM 245 N ASP A 31 17.784 9.291 -12.073 1.00 95.43 N \nANISOU 245 N ASP A 31 11355 10998 13905 -1503 -532 -75 N \nATOM 246 CA ASP A 31 17.246 9.722 -13.348 1.00 93.72 C \nANISOU 246 CA ASP A 31 11169 10744 13697 -1447 -479 -92 C \nATOM 247 C ASP A 31 17.416 8.523 -14.262 1.00 85.58 C \nANISOU 247 C ASP A 31 10061 9722 12733 -1390 -521 -83 C \nATOM 248 O ASP A 31 18.502 7.936 -14.317 1.00 90.46 O \nANISOU 248 O ASP A 31 10615 10372 13382 -1406 -563 -85 O \nATOM 249 CB ASP A 31 18.011 10.941 -13.897 1.00 91.48 C \nANISOU 249 CB ASP A 31 10930 10447 13381 -1489 -423 -128 C \nATOM 250 CG ASP A 31 17.336 11.572 -15.119 1.00 93.00 C \nANISOU 250 CG ASP A 31 11173 10594 13568 -1433 -361 -145 C \nATOM 251 OD1 ASP A 31 16.113 11.425 -15.288 1.00 94.87 O \nANISOU 251 OD1 ASP A 31 11433 10809 13804 -1371 -347 -130 O \nATOM 252 OD2 ASP A 31 18.027 12.230 -15.931 1.00 99.73 O \nANISOU 252 OD2 ASP A 31 12042 11436 14413 -1453 -326 -172 O \nATOM 253 N ILE A 32 16.348 8.165 -14.962 1.00 75.45 N \nANISOU 253 N ILE A 32 8785 8415 11468 -1322 -508 -73 N \nATOM 254 CA ILE A 32 16.419 7.122 -15.991 1.00 74.12 C \nANISOU 254 CA ILE A 32 8558 8247 11360 -1265 -538 -69 C \nATOM 255 C ILE A 32 16.246 7.679 -17.430 1.00 76.04 C \nANISOU 255 C ILE A 32 8819 8464 11610 -1223 -482 -94 C \nATOM 256 O ILE A 32 16.666 7.058 -18.378 1.00 68.42 O \nANISOU 256 O ILE A 32 7805 7500 10690 -1189 -498 -101 O \nATOM 257 CB ILE A 32 15.391 6.004 -15.708 1.00 75.54 C \nANISOU 257 CB ILE A 32 8719 8425 11558 -1227 -580 -35 C \nATOM 258 CG1 ILE A 32 13.970 6.579 -15.488 1.00 68.92 C \nANISOU 258 CG1 ILE A 32 7939 7574 10675 -1209 -537 -27 C \nATOM 259 CG2 ILE A 32 15.852 5.177 -14.514 1.00 75.50 C \nANISOU 259 CG2 ILE A 32 8680 8446 11561 -1264 -649 -10 C \nATOM 260 CD1 ILE A 32 12.922 5.528 -15.200 1.00 60.33 C \nANISOU 260 CD1 ILE A 32 6833 6496 9595 -1183 -576 6 C \nATOM 261 N LEU A 33 15.616 8.849 -17.574 1.00 79.05 N \nANISOU 261 N LEU A 33 9274 8819 11944 -1221 -417 -107 N \nATOM 262 CA LEU A 33 15.525 9.559 -18.865 1.00 78.69 C \nANISOU 262 CA LEU A 33 9258 8746 11895 -1188 -359 -130 C \nATOM 263 C LEU A 33 16.835 10.183 -19.363 1.00 76.79 C \nANISOU 263 C LEU A 33 9015 8510 11654 -1234 -340 -161 C \nATOM 264 O LEU A 33 17.360 11.134 -18.781 1.00 84.27 O \nANISOU 264 O LEU A 33 10009 9454 12555 -1297 -315 -175 O \nATOM 265 CB LEU A 33 14.474 10.664 -18.771 1.00 82.59 C \nANISOU 265 CB LEU A 33 9842 9210 12330 -1169 -297 -133 C \nATOM 266 CG LEU A 33 14.207 11.481 -20.028 1.00 79.39 C \nANISOU 266 CG LEU A 33 9482 8772 11911 -1128 -234 -154 C \nATOM 267 CD1 LEU A 33 13.507 10.645 -21.053 1.00 81.35 C \nANISOU 267 CD1 LEU A 33 9684 9026 12201 -1056 -244 -143 C \nATOM 268 CD2 LEU A 33 13.370 12.700 -19.723 1.00 84.77 C \nANISOU 268 CD2 LEU A 33 10263 9422 12522 -1115 -173 -158 C \nATOM 269 N GLU A 34 17.362 9.656 -20.456 1.00 80.36 N \nANISOU 269 N GLU A 34 9412 8971 12151 -1206 -350 -172 N \nATOM 270 CA GLU A 34 18.605 10.198 -21.053 1.00 79.29 C \nANISOU 270 CA GLU A 34 9263 8849 12012 -1249 -331 -203 C \nATOM 271 C GLU A 34 18.293 11.396 -21.933 1.00 71.49 C \nANISOU 271 C GLU A 34 8353 7822 10989 -1243 -257 -224 C \nATOM 272 O GLU A 34 17.338 11.366 -22.684 1.00 70.67 O \nANISOU 272 O GLU A 34 8269 7690 10892 -1178 -232 -218 O \nATOM 273 CB GLU A 34 19.317 9.139 -21.867 1.00 83.60 C \nANISOU 273 CB GLU A 34 9719 9427 12619 -1216 -372 -208 C \nATOM 274 CG GLU A 34 20.546 9.649 -22.589 1.00 88.35 C \nANISOU 274 CG GLU A 34 10298 10054 13216 -1256 -351 -240 C \nATOM 275 CD GLU A 34 21.563 10.212 -21.630 1.00 97.59 C \nANISOU 275 CD GLU A 34 11471 11263 14347 -1346 -358 -249 C \nATOM 276 OE1 GLU A 34 21.806 9.529 -20.612 1.00108.34 O \nANISOU 276 OE1 GLU A 34 12791 12655 15719 -1359 -412 -230 O \nATOM 277 OE2 GLU A 34 22.110 11.307 -21.895 1.00 89.27 O \nANISOU 277 OE2 GLU A 34 10460 10209 13249 -1405 -312 -274 O \nATOM 278 N LYS A 35 19.071 12.468 -21.800 1.00 67.54 N \nANISOU 278 N LYS A 35 7900 7319 10442 -1315 -222 -247 N \nATOM 279 CA LYS A 35 18.750 13.740 -22.467 1.00 69.50 C \nANISOU 279 CA LYS A 35 8245 7519 10643 -1317 -150 -265 C \nATOM 280 C LYS A 35 19.888 14.355 -23.293 1.00 73.33 C \nANISOU 280 C LYS A 35 8733 8016 11115 -1372 -122 -296 C \nATOM 281 O LYS A 35 19.708 15.391 -23.906 1.00 70.62 O \nANISOU 281 O LYS A 35 8473 7629 10731 -1379 -64 -311 O \nATOM 282 CB LYS A 35 18.280 14.748 -21.430 1.00 70.11 C \nANISOU 282 CB LYS A 35 8424 7563 10653 -1354 -117 -263 C \nATOM 283 CG LYS A 35 16.875 14.495 -20.906 1.00 73.32 C \nANISOU 283 CG LYS A 35 8856 7949 11054 -1287 -119 -237 C \nATOM 284 CD LYS A 35 16.577 15.285 -19.630 1.00 73.99 C \nANISOU 284 CD LYS A 35 9022 8016 11076 -1329 -101 -234 C \nATOM 285 CE LYS A 35 17.339 14.694 -18.447 1.00 72.43 C \nANISOU 285 CE LYS A 35 8766 7865 10889 -1397 -159 -225 C \nATOM 286 NZ LYS A 35 17.253 15.550 -17.251 1.00 74.90 N \nANISOU 286 NZ LYS A 35 9159 8161 11136 -1454 -139 -228 N \nATOM 287 N THR A 36 21.046 13.709 -23.324 1.00 74.68 N \nANISOU 287 N THR A 36 8811 8246 11316 -1409 -165 -305 N \nATOM 288 CA THR A 36 22.216 14.301 -23.928 1.00 76.50 C \nANISOU 288 CA THR A 36 9035 8505 11525 -1477 -142 -334 C \nATOM 289 C THR A 36 22.680 13.504 -25.111 1.00 82.70 C \nANISOU 289 C THR A 36 9730 9327 12366 -1432 -161 -344 C \nATOM 290 O THR A 36 22.645 12.281 -25.078 1.00 93.31 O \nANISOU 290 O THR A 36 10987 10700 13767 -1376 -214 -330 O \nATOM 291 CB THR A 36 23.381 14.380 -22.906 1.00 80.83 C \nANISOU 291 CB THR A 36 9551 9115 12048 -1574 -172 -341 C \nATOM 292 OG1 THR A 36 22.877 14.780 -21.629 1.00 87.60 O \nANISOU 292 OG1 THR A 36 10472 9946 12866 -1604 -172 -326 O \nATOM 293 CG2 THR A 36 24.442 15.382 -23.349 1.00 83.00 C \nANISOU 293 CG2 THR A 36 9854 9411 12269 -1669 -133 -373 C \nATOM 294 N HIS A 37 23.177 14.191 -26.138 1.00 84.03 N \nANISOU 294 N HIS A 37 9920 9493 12514 -1459 -118 -369 N \nATOM 295 CA HIS A 37 23.785 13.529 -27.293 1.00 75.86 C \nANISOU 295 CA HIS A 37 8798 8502 11525 -1428 -132 -384 C \nATOM 296 C HIS A 37 24.993 14.277 -27.773 1.00 77.47 C \nANISOU 296 C HIS A 37 8998 8749 11687 -1516 -105 -416 C \nATOM 297 O HIS A 37 25.101 15.474 -27.542 1.00 78.25 O \nANISOU 297 O HIS A 37 9192 8819 11720 -1592 -59 -426 O \nATOM 298 CB HIS A 37 22.762 13.423 -28.410 1.00 74.18 C \nANISOU 298 CB HIS A 37 8611 8236 11339 -1340 -104 -380 C \nATOM 299 CG HIS A 37 22.251 14.734 -28.906 1.00 67.63 C \nANISOU 299 CG HIS A 37 7900 7343 10454 -1358 -33 -388 C \nATOM 300 ND1 HIS A 37 22.722 15.317 -30.058 1.00 65.45 N \nANISOU 300 ND1 HIS A 37 7641 7067 10161 -1380 7 -411 N \nATOM 301 CD2 HIS A 37 21.264 15.535 -28.453 1.00 68.45 C \nANISOU 301 CD2 HIS A 37 8113 7381 10515 -1346 4 -375 C \nATOM 302 CE1 HIS A 37 22.056 16.429 -30.288 1.00 69.90 C \nANISOU 302 CE1 HIS A 37 8325 7561 10673 -1382 65 -411 C \nATOM 303 NE2 HIS A 37 21.172 16.594 -29.319 1.00 72.47 N \nANISOU 303 NE2 HIS A 37 8709 7847 10981 -1359 65 -390 N \nATOM 304 N ASN A 38 25.881 13.587 -28.485 1.00 77.50 N \nANISOU 304 N ASN A 38 8899 8823 11727 -1506 -131 -431 N \nATOM 305 CA ASN A 38 27.163 14.180 -28.905 1.00 72.29 C \nANISOU 305 CA ASN A 38 8214 8228 11025 -1597 -113 -462 C \nATOM 306 C ASN A 38 27.096 15.045 -30.158 1.00 76.18 C \nANISOU 306 C ASN A 38 8769 8687 11491 -1613 -51 -482 C \nATOM 307 O ASN A 38 28.120 15.457 -30.685 1.00 81.37 O \nANISOU 307 O ASN A 38 9400 9402 12116 -1685 -35 -509 O \nATOM 308 CB ASN A 38 28.226 13.089 -29.073 1.00 70.63 C \nANISOU 308 CB ASN A 38 7860 8121 10856 -1579 -168 -472 C \nATOM 309 CG ASN A 38 28.150 12.394 -30.401 1.00 71.46 C \nANISOU 309 CG ASN A 38 7905 8233 11014 -1496 -170 -482 C \nATOM 310 OD1 ASN A 38 27.120 12.418 -31.068 1.00 81.12 O \nANISOU 310 OD1 ASN A 38 9181 9382 12260 -1432 -144 -474 O \nATOM 311 ND2 ASN A 38 29.235 11.760 -30.790 1.00 65.50 N \nANISOU 311 ND2 ASN A 38 7039 7572 10276 -1494 -200 -501 N \nATOM 312 N GLY A 39 25.891 15.303 -30.644 1.00 80.17 N \nANISOU 312 N GLY A 39 9352 9104 12004 -1547 -18 -470 N \nATOM 313 CA GLY A 39 25.667 16.209 -31.773 1.00 73.42 C \nANISOU 313 CA GLY A 39 8575 8203 11118 -1556 44 -484 C \nATOM 314 C GLY A 39 26.309 15.798 -33.083 1.00 68.53 C \nANISOU 314 C GLY A 39 7875 7636 10527 -1540 44 -505 C \nATOM 315 O GLY A 39 26.322 16.593 -34.016 1.00 65.38 O \nANISOU 315 O GLY A 39 7536 7210 10094 -1565 94 -520 O \nATOM 316 N LYS A 40 26.868 14.584 -33.161 1.00 70.71 N \nANISOU 316 N LYS A 40 8020 7987 10860 -1499 -10 -509 N \nATOM 317 CA LYS A 40 27.616 14.150 -34.364 1.00 71.54 C \nANISOU 317 CA LYS A 40 8038 8155 10989 -1486 -12 -534 C \nATOM 318 C LYS A 40 27.091 12.850 -34.922 1.00 69.08 C \nANISOU 318 C LYS A 40 7649 7841 10757 -1366 -49 -524 C \nATOM 319 O LYS A 40 26.411 12.129 -34.233 1.00 92.50 O \nANISOU 319 O LYS A 40 10607 10779 13760 -1307 -85 -500 O \nATOM 320 CB LYS A 40 29.117 13.988 -34.066 1.00 69.88 C \nANISOU 320 CB LYS A 40 7733 8060 10759 -1562 -40 -556 C \nATOM 321 CG LYS A 40 29.857 15.287 -33.821 1.00 71.60 C \nANISOU 321 CG LYS A 40 8016 8299 10891 -1699 0 -574 C \nATOM 322 CD LYS A 40 29.794 16.213 -35.019 1.00 76.80 C \nANISOU 322 CD LYS A 40 8746 8923 11511 -1733 62 -591 C \nATOM 323 CE LYS A 40 29.475 17.644 -34.599 1.00 82.52 C \nANISOU 323 CE LYS A 40 9626 9571 12158 -1822 115 -588 C \nATOM 324 NZ LYS A 40 29.245 18.530 -35.785 1.00 89.51 N \nANISOU 324 NZ LYS A 40 10598 10404 13007 -1841 176 -599 N \nATOM 325 N LEU A 41 27.434 12.557 -36.169 1.00 58.71 N \nANISOU 325 N LEU A 41 6282 6559 9465 -1337 -39 -545 N \nATOM 326 CA LEU A 41 27.192 11.276 -36.747 1.00 55.01 C \nANISOU 326 CA LEU A 41 5732 6103 9067 -1235 -77 -543 C \nATOM 327 C LEU A 41 28.445 10.426 -36.554 1.00 60.81 C \nANISOU 327 C LEU A 41 6344 6942 9821 -1238 -127 -561 C \nATOM 328 O LEU A 41 29.551 10.849 -36.861 1.00 62.15 O \nANISOU 328 O LEU A 41 6471 7188 9954 -1305 -115 -588 O \nATOM 329 CB LEU A 41 26.873 11.363 -38.238 1.00 51.69 C \nANISOU 329 CB LEU A 41 5318 5662 8659 -1196 -40 -557 C \nATOM 330 CG LEU A 41 25.668 12.211 -38.644 1.00 53.22 C \nANISOU 330 CG LEU A 41 5629 5763 8831 -1182 13 -542 C \nATOM 331 CD1 LEU A 41 25.388 12.009 -40.122 1.00 52.82 C \nANISOU 331 CD1 LEU A 41 5561 5705 8803 -1129 37 -554 C \nATOM 332 CD2 LEU A 41 24.419 11.917 -37.830 1.00 50.58 C \nANISOU 332 CD2 LEU A 41 5343 5360 8514 -1125 -2 -507 C \nATOM 333 N CYS A 42 28.251 9.218 -36.033 1.00 63.73 N \nANISOU 333 N CYS A 42 6657 7314 10242 -1163 -185 -545 N \nATOM 334 CA CYS A 42 29.368 8.363 -35.650 1.00 72.51 C \nANISOU 334 CA CYS A 42 7660 8521 11371 -1152 -239 -556 C \nATOM 335 C CYS A 42 29.270 6.989 -36.263 1.00 68.05 C \nANISOU 335 C CYS A 42 7023 7961 10871 -1042 -280 -559 C \nATOM 336 O CYS A 42 28.219 6.628 -36.807 1.00 71.39 O \nANISOU 336 O CYS A 42 7486 8310 11329 -978 -271 -547 O \nATOM 337 CB CYS A 42 29.417 8.249 -34.122 1.00 78.66 C \nANISOU 337 CB CYS A 42 8445 9304 12138 -1180 -277 -532 C \nATOM 338 SG CYS A 42 29.304 9.819 -33.246 1.00 98.90 S \nANISOU 338 SG CYS A 42 11115 11838 14624 -1305 -230 -525 S \nATOM 339 N ASP A 43 30.341 6.212 -36.120 1.00 64.35 N \nANISOU 339 N ASP A 43 6454 7582 10413 -1018 -325 -573 N \nATOM 340 CA ASP A 43 30.293 4.811 -36.516 1.00 75.14 C \nANISOU 340 CA ASP A 43 7761 8949 11840 -907 -372 -574 C \nATOM 341 C ASP A 43 29.273 4.059 -35.669 1.00 77.96 C \nANISOU 341 C ASP A 43 8164 9226 12233 -854 -411 -536 C \nATOM 342 O ASP A 43 28.812 4.577 -34.656 1.00 86.10 O \nANISOU 342 O ASP A 43 9252 10221 13242 -903 -408 -511 O \nATOM 343 CB ASP A 43 31.645 4.152 -36.364 1.00 75.10 C \nANISOU 343 CB ASP A 43 7645 9058 11833 -887 -416 -594 C \nATOM 344 CG ASP A 43 32.710 4.864 -37.154 1.00 83.21 C \nANISOU 344 CG ASP A 43 8617 10182 12817 -946 -379 -632 C \nATOM 345 OD1 ASP A 43 32.339 5.838 -37.851 1.00 90.38 O \nANISOU 345 OD1 ASP A 43 9583 11056 13701 -1002 -320 -641 O \nATOM 346 OD2 ASP A 43 33.892 4.460 -37.094 1.00 78.93 O \nANISOU 346 OD2 ASP A 43 7975 9752 12262 -936 -409 -652 O \nATOM 347 N LEU A 44 28.886 2.873 -36.123 1.00 78.04 N \nANISOU 347 N LEU A 44 8153 9204 12295 -758 -444 -532 N \nATOM 348 CA LEU A 44 28.239 1.889 -35.263 1.00 78.33 C \nANISOU 348 CA LEU A 44 8211 9186 12363 -705 -497 -499 C \nATOM 349 C LEU A 44 29.181 0.717 -35.097 1.00 82.47 C \nANISOU 349 C LEU A 44 8654 9769 12911 -637 -559 -508 C \nATOM 350 O LEU A 44 29.513 0.046 -36.087 1.00 86.28 O \nANISOU 350 O LEU A 44 9092 10270 13419 -570 -565 -532 O \nATOM 351 CB LEU A 44 26.932 1.351 -35.861 1.00 78.90 C \nANISOU 351 CB LEU A 44 8339 9168 12472 -648 -491 -485 C \nATOM 352 CG LEU A 44 25.646 2.171 -35.753 1.00 77.92 C \nANISOU 352 CG LEU A 44 8305 8969 12330 -686 -447 -462 C \nATOM 353 CD1 LEU A 44 24.459 1.387 -36.324 1.00 60.88 C \nANISOU 353 CD1 LEU A 44 6182 6741 10208 -622 -453 -448 C \nATOM 354 CD2 LEU A 44 25.395 2.559 -34.304 1.00 79.31 C \nANISOU 354 CD2 LEU A 44 8521 9133 12482 -737 -462 -433 C \nATOM 355 N ASP A 45 29.554 0.425 -33.853 1.00 80.61 N \nANISOU 355 N ASP A 45 8404 9558 12667 -647 -605 -487 N \nATOM 356 CA ASP A 45 30.297 -0.799 -33.547 1.00 90.22 C \nANISOU 356 CA ASP A 45 9557 10817 13906 -568 -671 -487 C \nATOM 357 C ASP A 45 31.526 -0.892 -34.432 1.00 84.94 C \nANISOU 357 C ASP A 45 8795 10249 13230 -540 -666 -528 C \nATOM 358 O ASP A 45 31.727 -1.889 -35.120 1.00 82.09 O \nANISOU 358 O ASP A 45 8401 9888 12900 -447 -691 -543 O \nATOM 359 CB ASP A 45 29.408 -2.042 -33.759 1.00 97.87 C \nANISOU 359 CB ASP A 45 10566 11696 14924 -478 -707 -469 C \nATOM 360 CG ASP A 45 27.970 -1.841 -33.248 1.00102.52 C \nANISOU 360 CG ASP A 45 11250 12185 15517 -510 -695 -433 C \nATOM 361 OD1 ASP A 45 27.791 -1.266 -32.151 1.00 93.69 O \nANISOU 361 OD1 ASP A 45 10159 11065 14372 -573 -696 -410 O \nATOM 362 OD2 ASP A 45 27.031 -2.261 -33.959 1.00111.66 O \nANISOU 362 OD2 ASP A 45 12452 13273 16702 -473 -684 -430 O \nATOM 363 N GLY A 46 32.306 0.190 -34.454 1.00 80.99 N \nANISOU 363 N GLY A 46 8259 9832 12682 -624 -630 -549 N \nATOM 364 CA GLY A 46 33.540 0.266 -35.244 1.00 77.84 C \nANISOU 364 CA GLY A 46 7765 9549 12263 -617 -620 -590 C \nATOM 365 C GLY A 46 33.381 0.277 -36.753 1.00 80.35 C \nANISOU 365 C GLY A 46 8077 9854 12599 -585 -580 -620 C \nATOM 366 O GLY A 46 34.369 0.157 -37.481 1.00 81.20 O \nANISOU 366 O GLY A 46 8101 10057 12694 -563 -576 -655 O \nATOM 367 N VAL A 47 32.139 0.398 -37.228 1.00 85.68 N \nANISOU 367 N VAL A 47 8837 10418 13301 -581 -550 -607 N \nATOM 368 CA VAL A 47 31.850 0.453 -38.665 1.00 81.17 C \nANISOU 368 CA VAL A 47 8270 9826 12746 -555 -509 -633 C \nATOM 369 C VAL A 47 31.259 1.794 -39.111 1.00 81.80 C \nANISOU 369 C VAL A 47 8416 9870 12797 -645 -440 -634 C \nATOM 370 O VAL A 47 30.142 2.152 -38.758 1.00 85.16 O \nANISOU 370 O VAL A 47 8927 10204 13226 -668 -423 -606 O \nATOM 371 CB VAL A 47 30.886 -0.676 -39.093 1.00 82.91 C \nANISOU 371 CB VAL A 47 8531 9950 13021 -458 -534 -621 C \nATOM 372 CG1 VAL A 47 30.486 -0.515 -40.554 1.00 81.30 C \nANISOU 372 CG1 VAL A 47 8338 9722 12829 -442 -487 -645 C \nATOM 373 CG2 VAL A 47 31.534 -2.040 -38.852 1.00 78.85 C \nANISOU 373 CG2 VAL A 47 7961 9467 12533 -358 -600 -625 C \nATOM 374 N LYS A 48 32.016 2.494 -39.949 1.00 80.05 N \nANISOU 374 N LYS A 48 8151 9721 12542 -691 -399 -668 N \nATOM 375 CA LYS A 48 31.649 3.812 -40.429 1.00 75.42 C \nANISOU 375 CA LYS A 48 7627 9110 11920 -779 -333 -672 C \nATOM 376 C LYS A 48 30.375 3.740 -41.261 1.00 74.19 C \nANISOU 376 C LYS A 48 7542 8850 11795 -738 -304 -662 C \nATOM 377 O LYS A 48 30.045 2.665 -41.793 1.00 79.50 O \nANISOU 377 O LYS A 48 8196 9496 12516 -646 -330 -665 O \nATOM 378 CB LYS A 48 32.784 4.360 -41.269 1.00 75.07 C \nANISOU 378 CB LYS A 48 7515 9173 11837 -827 -302 -712 C \nATOM 379 CG LYS A 48 32.686 5.828 -41.642 1.00 80.20 C \nANISOU 379 CG LYS A 48 8227 9814 12433 -937 -236 -719 C \nATOM 380 CD LYS A 48 34.005 6.345 -42.227 1.00 83.56 C \nANISOU 380 CD LYS A 48 8575 10366 12809 -1002 -214 -757 C \nATOM 381 CE LYS A 48 33.742 7.417 -43.277 1.00 85.67 C \nANISOU 381 CE LYS A 48 8901 10608 13043 -1069 -147 -771 C \nATOM 382 NZ LYS A 48 33.110 8.632 -42.693 1.00 87.11 N \nANISOU 382 NZ LYS A 48 9200 10713 13184 -1160 -108 -747 N \nATOM 383 N PRO A 49 29.624 4.864 -41.332 1.00 61.62 N \nANISOU 383 N PRO A 49 6037 7200 10174 -803 -252 -649 N \nATOM 384 CA PRO A 49 28.483 4.860 -42.223 1.00 59.03 C \nANISOU 384 CA PRO A 49 5767 6791 9869 -764 -222 -642 C \nATOM 385 C PRO A 49 28.848 5.314 -43.604 1.00 66.71 C \nANISOU 385 C PRO A 49 6721 7798 10828 -778 -176 -674 C \nATOM 386 O PRO A 49 30.011 5.605 -43.890 1.00 77.54 O \nANISOU 386 O PRO A 49 8029 9260 12172 -819 -169 -704 O \nATOM 387 CB PRO A 49 27.543 5.875 -41.604 1.00 58.26 C \nANISOU 387 CB PRO A 49 5774 6622 9742 -819 -188 -612 C \nATOM 388 CG PRO A 49 28.428 6.797 -40.847 1.00 57.39 C \nANISOU 388 CG PRO A 49 5662 6564 9578 -914 -178 -618 C \nATOM 389 CD PRO A 49 29.591 5.994 -40.392 1.00 55.42 C \nANISOU 389 CD PRO A 49 5312 6404 9340 -898 -230 -633 C \nATOM 390 N LEU A 50 27.856 5.336 -44.476 1.00 68.84 N \nANISOU 390 N LEU A 50 7038 8002 11115 -743 -147 -668 N \nATOM 391 CA LEU A 50 28.060 5.737 -45.843 1.00 69.08 C \nANISOU 391 CA LEU A 50 7058 8057 11134 -752 -104 -696 C \nATOM 392 C LEU A 50 27.481 7.112 -46.046 1.00 66.84 C \nANISOU 392 C LEU A 50 6867 7726 10804 -821 -43 -684 C \nATOM 393 O LEU A 50 26.262 7.264 -46.220 1.00 75.30 O \nANISOU 393 O LEU A 50 8009 8717 11883 -792 -24 -660 O \nATOM 394 CB LEU A 50 27.393 4.738 -46.790 1.00 76.64 C \nANISOU 394 CB LEU A 50 8001 8979 12141 -661 -114 -700 C \nATOM 395 CG LEU A 50 27.407 5.114 -48.278 1.00 79.56 C \nANISOU 395 CG LEU A 50 8365 9362 12501 -663 -67 -725 C \nATOM 396 CD1 LEU A 50 28.820 5.245 -48.785 1.00 86.25 C \nANISOU 396 CD1 LEU A 50 9130 10315 13327 -695 -61 -765 C \nATOM 397 CD2 LEU A 50 26.683 4.070 -49.097 1.00 82.63 C \nANISOU 397 CD2 LEU A 50 8745 9714 12938 -575 -80 -727 C \nATOM 398 N ILE A 51 28.332 8.134 -46.024 1.00 60.37 N \nANISOU 398 N ILE A 51 6052 6957 9931 -912 -13 -700 N \nATOM 399 CA ILE A 51 27.852 9.502 -46.220 1.00 57.64 C \nANISOU 399 CA ILE A 51 5808 6560 9533 -980 46 -689 C \nATOM 400 C ILE A 51 27.874 9.874 -47.681 1.00 62.46 C \nANISOU 400 C ILE A 51 6421 7179 10131 -983 90 -710 C \nATOM 401 O ILE A 51 28.933 10.100 -48.248 1.00 73.30 O \nANISOU 401 O ILE A 51 7740 8631 11478 -1031 102 -741 O \nATOM 402 CB ILE A 51 28.607 10.546 -45.391 1.00 62.41 C \nANISOU 402 CB ILE A 51 6444 7195 10075 -1090 61 -691 C \nATOM 403 CG1 ILE A 51 28.629 10.201 -43.877 1.00 58.48 C \nANISOU 403 CG1 ILE A 51 5941 6694 9586 -1092 16 -670 C \nATOM 404 CG2 ILE A 51 27.916 11.892 -45.522 1.00 71.53 C \nANISOU 404 CG2 ILE A 51 7726 8274 11177 -1145 119 -676 C \nATOM 405 CD1 ILE A 51 29.857 9.442 -43.449 1.00 61.05 C \nANISOU 405 CD1 ILE A 51 6151 7123 9922 -1094 -32 -690 C \nATOM 406 N LEU A 52 26.702 9.872 -48.325 1.00 65.42 N \nANISOU 406 N LEU A 52 6852 7480 10523 -929 112 -693 N \nATOM 407 CA LEU A 52 26.561 10.532 -49.627 1.00 69.17 C \nANISOU 407 CA LEU A 52 7360 7949 10974 -944 164 -706 C \nATOM 408 C LEU A 52 26.367 12.005 -49.254 1.00 74.12 C \nANISOU 408 C LEU A 52 8100 8529 11532 -1027 210 -690 C \nATOM 409 O LEU A 52 25.486 12.351 -48.432 1.00 97.83 O \nANISOU 409 O LEU A 52 11183 11461 14527 -1016 213 -658 O \nATOM 410 CB LEU A 52 25.369 9.997 -50.422 1.00 67.42 C \nANISOU 410 CB LEU A 52 7155 7671 10789 -856 169 -692 C \nATOM 411 CG LEU A 52 25.156 8.579 -50.982 1.00 59.80 C \nANISOU 411 CG LEU A 52 6111 6721 9888 -765 132 -702 C \nATOM 412 CD1 LEU A 52 26.016 7.557 -50.314 1.00 58.22 C \nANISOU 412 CD1 LEU A 52 5822 6576 9722 -745 76 -717 C \nATOM 413 CD2 LEU A 52 23.683 8.187 -50.862 1.00 56.12 C \nANISOU 413 CD2 LEU A 52 5696 6179 9447 -698 126 -668 C \nATOM 414 N ARG A 53 27.200 12.879 -49.765 1.00 61.50 N \nANISOU 414 N ARG A 53 6515 6970 9882 -1112 246 -712 N \nATOM 415 CA ARG A 53 27.227 14.192 -49.168 1.00 65.20 C \nANISOU 415 CA ARG A 53 7091 7399 10282 -1201 281 -699 C \nATOM 416 C ARG A 53 26.110 15.018 -49.751 1.00 58.81 C \nANISOU 416 C ARG A 53 6401 6498 9446 -1180 330 -677 C \nATOM 417 O ARG A 53 25.198 15.374 -49.039 1.00 59.12 O \nANISOU 417 O ARG A 53 6524 6464 9477 -1156 336 -647 O \nATOM 418 CB ARG A 53 28.637 14.884 -49.191 1.00 67.81 C \nANISOU 418 CB ARG A 53 7400 7812 10553 -1323 296 -729 C \nATOM 419 CG ARG A 53 29.286 15.068 -50.549 1.00 75.18 C \nANISOU 419 CG ARG A 53 8295 8804 11467 -1356 325 -759 C \nATOM 420 CD ARG A 53 30.575 15.888 -50.458 1.00 71.51 C \nANISOU 420 CD ARG A 53 7824 8417 10930 -1491 343 -784 C \nATOM 421 NE ARG A 53 31.649 15.103 -49.850 1.00 68.90 N \nANISOU 421 NE ARG A 53 7365 8198 10617 -1503 296 -806 N \nATOM 422 CZ ARG A 53 32.335 15.453 -48.759 1.00 80.26 C \nANISOU 422 CZ ARG A 53 8802 9677 12016 -1585 281 -806 C \nATOM 423 NH1 ARG A 53 32.078 16.609 -48.137 1.00 83.18 N \nANISOU 423 NH1 ARG A 53 9299 9979 12325 -1669 313 -789 N \nATOM 424 NH2 ARG A 53 33.303 14.661 -48.286 1.00 78.88 N \nANISOU 424 NH2 ARG A 53 8500 9614 11858 -1582 236 -825 N \nATOM 425 N ASP A 54 26.206 15.348 -51.023 1.00 58.64 N \nANISOU 425 N ASP A 54 6386 6486 9407 -1189 365 -691 N \nATOM 426 CA ASP A 54 25.149 16.071 -51.705 1.00 62.14 C \nANISOU 426 CA ASP A 54 6936 6849 9826 -1157 410 -669 C \nATOM 427 C ASP A 54 24.522 15.175 -52.750 1.00 59.54 C \nANISOU 427 C ASP A 54 6545 6526 9551 -1061 402 -670 C \nATOM 428 O ASP A 54 23.705 15.619 -53.534 1.00 59.26 O \nANISOU 428 O ASP A 54 6575 6442 9499 -1026 437 -656 O \nATOM 429 CB ASP A 54 25.730 17.328 -52.356 1.00 70.55 C \nANISOU 429 CB ASP A 54 8079 7912 10815 -1255 462 -682 C \nATOM 430 CG ASP A 54 25.787 18.489 -51.396 1.00 81.97 C \nANISOU 430 CG ASP A 54 9646 9304 12193 -1335 485 -668 C \nATOM 431 OD1 ASP A 54 24.803 18.644 -50.621 1.00 85.96 O \nANISOU 431 OD1 ASP A 54 10224 9735 12702 -1283 484 -638 O \nATOM 432 OD2 ASP A 54 26.805 19.230 -51.415 1.00 81.82 O \nANISOU 432 OD2 ASP A 54 9650 9320 12115 -1450 505 -688 O \nATOM 433 N CYS A 55 24.920 13.902 -52.751 1.00 63.62 N \nANISOU 433 N CYS A 55 6940 7104 10130 -1017 356 -688 N \nATOM 434 CA CYS A 55 24.369 12.900 -53.670 1.00 66.71 C \nANISOU 434 CA CYS A 55 7268 7503 10575 -927 342 -692 C \nATOM 435 C CYS A 55 23.192 12.101 -53.075 1.00 51.29 C \nANISOU 435 C CYS A 55 5319 5501 8668 -838 311 -662 C \nATOM 436 O CYS A 55 23.136 11.867 -51.871 1.00 43.03 O \nANISOU 436 O CYS A 55 4275 4443 7633 -838 280 -648 O \nATOM 437 CB CYS A 55 25.483 11.974 -54.171 1.00 69.45 C \nANISOU 437 CB CYS A 55 7488 7943 10956 -927 313 -731 C \nATOM 438 SG CYS A 55 26.505 12.820 -55.388 1.00 75.47 S \nANISOU 438 SG CYS A 55 8245 8767 11665 -1012 360 -765 S \nATOM 439 N SER A 56 22.259 11.722 -53.928 1.00 48.75 N \nANISOU 439 N SER A 56 5000 5156 8368 -769 320 -652 N \nATOM 440 CA SER A 56 21.139 10.845 -53.526 1.00 55.29 C \nANISOU 440 CA SER A 56 5819 5950 9237 -688 289 -627 C \nATOM 441 C SER A 56 21.398 9.420 -53.895 1.00 54.32 C \nANISOU 441 C SER A 56 5595 5870 9175 -638 246 -648 C \nATOM 442 O SER A 56 22.315 9.128 -54.676 1.00 69.05 O \nANISOU 442 O SER A 56 7395 7788 11051 -652 246 -682 O \nATOM 443 CB SER A 56 19.858 11.289 -54.217 1.00 57.07 C \nANISOU 443 CB SER A 56 6112 6130 9441 -641 326 -602 C \nATOM 444 OG SER A 56 19.935 10.990 -55.598 1.00 61.85 O \nANISOU 444 OG SER A 56 6677 6764 10059 -621 341 -621 O \nATOM 445 N VAL A 57 20.560 8.521 -53.396 1.00 53.50 N \nANISOU 445 N VAL A 57 5479 5740 9107 -579 211 -628 N \nATOM 446 CA VAL A 57 20.754 7.067 -53.674 1.00 46.53 C \nANISOU 446 CA VAL A 57 4512 4886 8282 -528 165 -646 C \nATOM 447 C VAL A 57 20.737 6.754 -55.159 1.00 43.40 C \nANISOU 447 C VAL A 57 4081 4513 7896 -501 185 -669 C \nATOM 448 O VAL A 57 21.581 5.972 -55.697 1.00 48.93 O \nANISOU 448 O VAL A 57 4706 5259 8626 -488 165 -703 O \nATOM 449 CB VAL A 57 19.718 6.217 -52.982 1.00 41.07 C \nANISOU 449 CB VAL A 57 3829 4157 7617 -477 129 -617 C \nATOM 450 CG1 VAL A 57 19.779 4.806 -53.467 1.00 37.55 C \nANISOU 450 CG1 VAL A 57 3319 3728 7222 -426 90 -635 C \nATOM 451 CG2 VAL A 57 19.943 6.224 -51.482 1.00 41.39 C \nANISOU 451 CG2 VAL A 57 3882 4186 7658 -501 97 -601 C \nATOM 452 N ALA A 58 19.877 7.455 -55.871 1.00 37.79 N \nANISOU 452 N ALA A 58 3427 3776 7155 -495 228 -652 N \nATOM 453 CA ALA A 58 19.834 7.270 -57.316 1.00 34.55 C \nANISOU 453 CA ALA A 58 2989 3389 6749 -475 252 -672 C \nATOM 454 C ALA A 58 21.044 7.831 -58.014 1.00 35.15 C \nANISOU 454 C ALA A 58 3038 3513 6806 -526 277 -707 C \nATOM 455 O ALA A 58 21.711 7.153 -58.808 1.00 35.21 O \nANISOU 455 O ALA A 58 2974 3568 6838 -514 267 -741 O \nATOM 456 CB ALA A 58 18.592 7.881 -57.859 1.00 34.81 C \nANISOU 456 CB ALA A 58 3088 3387 6751 -452 290 -643 C \nATOM 457 N GLY A 59 21.345 9.102 -57.711 1.00 39.95 N \nANISOU 457 N GLY A 59 3707 4109 7363 -589 311 -698 N \nATOM 458 CA GLY A 59 22.643 9.746 -58.149 1.00 40.19 C \nANISOU 458 CA GLY A 59 3716 4193 7363 -661 334 -730 C \nATOM 459 C GLY A 59 23.878 8.887 -57.907 1.00 36.07 C \nANISOU 459 C GLY A 59 3091 3739 6873 -668 294 -767 C \nATOM 460 O GLY A 59 24.681 8.734 -58.763 1.00 34.26 O \nANISOU 460 O GLY A 59 2804 3570 6643 -682 302 -801 O \nATOM 461 N TRP A 60 23.926 8.228 -56.778 1.00 35.57 N \nANISOU 461 N TRP A 60 3006 3670 6840 -647 248 -758 N \nATOM 462 CA TRP A 60 25.008 7.342 -56.443 1.00 37.68 C \nANISOU 462 CA TRP A 60 3180 4000 7137 -638 205 -788 C \nATOM 463 C TRP A 60 24.981 6.074 -57.247 1.00 43.88 C \nANISOU 463 C TRP A 60 3896 4807 7971 -564 180 -811 C \nATOM 464 O TRP A 60 26.012 5.664 -57.808 1.00 44.98 O \nANISOU 464 O TRP A 60 3957 5018 8116 -562 173 -850 O \nATOM 465 CB TRP A 60 25.004 7.022 -54.933 1.00 38.49 C \nANISOU 465 CB TRP A 60 3287 4083 7254 -635 163 -767 C \nATOM 466 CG TRP A 60 25.768 5.776 -54.558 1.00 39.91 C \nANISOU 466 CG TRP A 60 3376 4309 7476 -591 107 -789 C \nATOM 467 CD1 TRP A 60 26.982 5.416 -54.988 1.00 43.25 C \nANISOU 467 CD1 TRP A 60 3714 4816 7902 -594 97 -829 C \nATOM 468 CD2 TRP A 60 25.393 4.813 -53.585 1.00 40.79 C \nANISOU 468 CD2 TRP A 60 3482 4390 7628 -539 55 -771 C \nATOM 469 NE1 TRP A 60 27.396 4.238 -54.393 1.00 47.19 N \nANISOU 469 NE1 TRP A 60 4152 5337 8440 -537 40 -838 N \nATOM 470 CE2 TRP A 60 26.402 3.825 -53.559 1.00 43.83 C \nANISOU 470 CE2 TRP A 60 3779 4836 8040 -503 14 -801 C \nATOM 471 CE3 TRP A 60 24.280 4.658 -52.771 1.00 40.17 C \nANISOU 471 CE3 TRP A 60 3463 4239 7560 -518 39 -732 C \nATOM 472 CZ2 TRP A 60 26.314 2.695 -52.793 1.00 45.83 C \nANISOU 472 CZ2 TRP A 60 4010 5070 8332 -444 -42 -793 C \nATOM 473 CZ3 TRP A 60 24.192 3.516 -51.987 1.00 42.54 C \nANISOU 473 CZ3 TRP A 60 3738 4525 7900 -468 -17 -723 C \nATOM 474 CH2 TRP A 60 25.202 2.565 -51.982 1.00 46.73 C \nANISOU 474 CH2 TRP A 60 4190 5107 8457 -432 -57 -752 C \nATOM 475 N LEU A 61 23.806 5.426 -57.339 1.00 48.90 N \nANISOU 475 N LEU A 61 4559 5385 8636 -502 168 -789 N \nATOM 476 CA LEU A 61 23.767 4.087 -58.003 1.00 40.09 C \nANISOU 476 CA LEU A 61 3385 4281 7567 -431 138 -811 C \nATOM 477 C LEU A 61 23.877 4.218 -59.497 1.00 41.42 C \nANISOU 477 C LEU A 61 3531 4481 7725 -429 175 -838 C \nATOM 478 O LEU A 61 24.463 3.355 -60.156 1.00 48.33 O \nANISOU 478 O LEU A 61 4340 5398 8626 -391 158 -874 O \nATOM 479 CB LEU A 61 22.533 3.311 -57.620 1.00 37.98 C \nANISOU 479 CB LEU A 61 3154 3950 7328 -378 111 -781 C \nATOM 480 CG LEU A 61 22.453 2.805 -56.195 1.00 38.55 C \nANISOU 480 CG LEU A 61 3234 3995 7419 -366 64 -759 C \nATOM 481 CD1 LEU A 61 21.138 2.059 -55.993 1.00 36.18 C \nANISOU 481 CD1 LEU A 61 2972 3636 7140 -322 42 -730 C \nATOM 482 CD2 LEU A 61 23.602 1.867 -55.895 1.00 40.12 C \nANISOU 482 CD2 LEU A 61 3359 4238 7647 -339 18 -790 C \nATOM 483 N LEU A 62 23.359 5.286 -60.054 1.00 38.39 N \nANISOU 483 N LEU A 62 3204 4078 7303 -466 224 -822 N \nATOM 484 CA LEU A 62 23.468 5.449 -61.526 1.00 46.23 C \nANISOU 484 CA LEU A 62 4178 5103 8284 -467 260 -847 C \nATOM 485 C LEU A 62 24.757 6.158 -61.959 1.00 49.07 C \nANISOU 485 C LEU A 62 4501 5534 8609 -532 286 -879 C \nATOM 486 O LEU A 62 24.970 6.382 -63.134 1.00 43.42 O \nANISOU 486 O LEU A 62 3768 4853 7878 -543 317 -901 O \nATOM 487 CB LEU A 62 22.249 6.245 -62.040 1.00 43.82 C \nANISOU 487 CB LEU A 62 3953 4747 7949 -471 303 -813 C \nATOM 488 CG LEU A 62 20.893 5.655 -61.807 1.00 39.28 C \nANISOU 488 CG LEU A 62 3412 4118 7396 -414 286 -781 C \nATOM 489 CD1 LEU A 62 19.845 6.663 -62.132 1.00 37.53 C \nANISOU 489 CD1 LEU A 62 3269 3859 7133 -422 329 -745 C \nATOM 490 CD2 LEU A 62 20.750 4.436 -62.677 1.00 40.11 C \nANISOU 490 CD2 LEU A 62 3463 4240 7539 -361 266 -805 C \nATOM 491 N GLY A 63 25.533 6.628 -60.985 1.00 55.29 N \nANISOU 491 N GLY A 63 5285 6344 9378 -582 276 -879 N \nATOM 492 CA GLY A 63 26.815 7.256 -61.247 1.00 57.27 C \nANISOU 492 CA GLY A 63 5495 6674 9590 -653 295 -910 C \nATOM 493 C GLY A 63 26.713 8.669 -61.780 1.00 60.84 C \nANISOU 493 C GLY A 63 6021 7114 9982 -731 352 -899 C \nATOM 494 O GLY A 63 27.401 9.034 -62.722 1.00 57.30 O \nANISOU 494 O GLY A 63 5542 6725 9505 -773 381 -927 O \nATOM 495 N ASN A 64 25.840 9.476 -61.200 1.00 64.41 N \nANISOU 495 N ASN A 64 6573 7489 10411 -749 370 -857 N \nATOM 496 CA ASN A 64 25.814 10.896 -61.536 1.00 65.85 C \nANISOU 496 CA ASN A 64 6842 7651 10528 -826 423 -845 C \nATOM 497 C ASN A 64 27.265 11.415 -61.430 1.00 63.41 C \nANISOU 497 C ASN A 64 6493 7423 10178 -920 430 -876 C \nATOM 498 O ASN A 64 27.898 11.205 -60.416 1.00 57.59 O \nANISOU 498 O ASN A 64 5720 6715 9446 -941 400 -881 O \nATOM 499 CB ASN A 64 24.878 11.646 -60.567 1.00 64.44 C \nANISOU 499 CB ASN A 64 6773 7383 10327 -830 432 -799 C \nATOM 500 CG ASN A 64 24.832 13.153 -60.810 1.00 61.36 C \nANISOU 500 CG ASN A 64 6492 6959 9865 -906 485 -784 C \nATOM 501 OD1 ASN A 64 25.850 13.811 -60.867 1.00 67.28 O \nANISOU 501 OD1 ASN A 64 7241 7752 10570 -994 503 -804 O \nATOM 502 ND2 ASN A 64 23.636 13.706 -60.889 1.00 59.44 N \nANISOU 502 ND2 ASN A 64 6345 6637 9603 -871 511 -747 N \nATOM 503 N PRO A 65 27.749 12.144 -62.454 1.00 62.05 N \nANISOU 503 N PRO A 65 6330 7287 9958 -982 472 -894 N \nATOM 504 CA PRO A 65 29.115 12.638 -62.597 1.00 66.49 C \nANISOU 504 CA PRO A 65 6849 7942 10473 -1080 484 -927 C \nATOM 505 C PRO A 65 29.683 13.415 -61.403 1.00 71.44 C \nANISOU 505 C PRO A 65 7519 8571 11055 -1168 482 -917 C \nATOM 506 O PRO A 65 30.913 13.490 -61.227 1.00 77.49 O \nANISOU 506 O PRO A 65 8217 9434 11792 -1239 475 -947 O \nATOM 507 CB PRO A 65 29.035 13.561 -63.803 1.00 64.14 C \nANISOU 507 CB PRO A 65 6609 7639 10123 -1134 538 -928 C \nATOM 508 CG PRO A 65 27.913 13.063 -64.599 1.00 59.21 C \nANISOU 508 CG PRO A 65 5999 6961 9538 -1040 543 -914 C \nATOM 509 CD PRO A 65 26.910 12.583 -63.580 1.00 62.75 C \nANISOU 509 CD PRO A 65 6480 7331 10031 -964 512 -880 C \nATOM 510 N MET A 66 28.798 13.954 -60.576 1.00 69.01 N \nANISOU 510 N MET A 66 7316 8164 10739 -1163 487 -877 N \nATOM 511 CA MET A 66 29.191 14.707 -59.396 1.00 68.48 C \nANISOU 511 CA MET A 66 7305 8085 10630 -1242 487 -865 C \nATOM 512 C MET A 66 29.266 13.840 -58.159 1.00 63.34 C \nANISOU 512 C MET A 66 6596 7444 10027 -1196 433 -860 C \nATOM 513 O MET A 66 29.557 14.298 -57.076 1.00 72.96 O \nANISOU 513 O MET A 66 7848 8654 11218 -1252 425 -850 O \nATOM 514 CB MET A 66 28.227 15.870 -59.222 1.00 76.72 C \nANISOU 514 CB MET A 66 8506 9016 11629 -1264 526 -825 C \nATOM 515 CG MET A 66 28.187 16.727 -60.507 1.00 89.60 C \nANISOU 515 CG MET A 66 10199 10637 13207 -1309 579 -829 C \nATOM 516 SD MET A 66 27.568 18.408 -60.333 1.00115.98 S \nANISOU 516 SD MET A 66 13738 13867 16463 -1375 633 -792 S \nATOM 517 CE MET A 66 25.788 18.137 -60.559 1.00123.35 C \nANISOU 517 CE MET A 66 14733 14696 17439 -1234 637 -750 C \nATOM 518 N CYS A 67 29.057 12.552 -58.337 1.00 67.35 N \nANISOU 518 N CYS A 67 7014 7971 10604 -1096 395 -870 N \nATOM 519 CA CYS A 67 29.021 11.586 -57.244 1.00 60.23 C \nANISOU 519 CA CYS A 67 6061 7070 9754 -1038 341 -863 C \nATOM 520 C CYS A 67 30.210 10.629 -57.347 1.00 57.63 C \nANISOU 520 C CYS A 67 5594 6855 9449 -1022 304 -904 C \nATOM 521 O CYS A 67 30.293 9.651 -56.611 1.00 51.53 O \nANISOU 521 O CYS A 67 4764 6094 8722 -961 255 -903 O \nATOM 522 CB CYS A 67 27.673 10.815 -57.303 1.00 56.76 C \nANISOU 522 CB CYS A 67 5645 6549 9373 -928 324 -836 C \nATOM 523 SG CYS A 67 26.196 11.863 -57.128 1.00 61.86 S \nANISOU 523 SG CYS A 67 6444 7073 9989 -927 364 -787 S \nATOM 524 N ASP A 68 31.152 10.968 -58.208 1.00 63.28 N \nANISOU 524 N ASP A 68 6260 7658 10126 -1080 329 -937 N \nATOM 525 CA ASP A 68 32.350 10.134 -58.428 1.00 71.76 C \nANISOU 525 CA ASP A 68 7198 8857 11212 -1064 299 -980 C \nATOM 526 C ASP A 68 33.065 9.624 -57.188 1.00 73.29 C \nANISOU 526 C ASP A 68 7327 9104 11415 -1059 251 -984 C \nATOM 527 O ASP A 68 33.676 8.561 -57.230 1.00 70.50 O \nANISOU 527 O ASP A 68 6867 8824 11095 -992 212 -1010 O \nATOM 528 CB ASP A 68 33.349 10.851 -59.321 1.00 78.87 C \nANISOU 528 CB ASP A 68 8063 9853 12049 -1157 337 -1013 C \nATOM 529 CG ASP A 68 33.135 10.541 -60.779 1.00 79.49 C \nANISOU 529 CG ASP A 68 8116 9943 12143 -1114 360 -1034 C \nATOM 530 OD1 ASP A 68 32.471 11.352 -61.464 1.00 82.21 O \nANISOU 530 OD1 ASP A 68 8551 10224 12462 -1148 404 -1017 O \nATOM 531 OD2 ASP A 68 33.629 9.486 -61.235 1.00 84.84 O \nANISOU 531 OD2 ASP A 68 8685 10694 12856 -1043 333 -1067 O \nATOM 532 N GLU A 69 32.992 10.363 -56.089 1.00 75.05 N \nANISOU 532 N GLU A 69 7617 9292 11607 -1126 252 -958 N \nATOM 533 CA GLU A 69 33.619 9.907 -54.852 1.00 72.76 C \nANISOU 533 CA GLU A 69 7270 9051 11324 -1124 205 -957 C \nATOM 534 C GLU A 69 33.035 8.622 -54.315 1.00 76.33 C \nANISOU 534 C GLU A 69 7694 9457 11852 -1001 153 -943 C \nATOM 535 O GLU A 69 33.522 8.068 -53.324 1.00 67.01 O \nANISOU 535 O GLU A 69 6461 8315 10684 -981 108 -942 O \nATOM 536 CB GLU A 69 33.545 10.991 -53.780 1.00 76.02 C \nANISOU 536 CB GLU A 69 7774 9424 11687 -1223 220 -930 C \nATOM 537 CG GLU A 69 32.179 11.582 -53.535 1.00 80.19 C \nANISOU 537 CG GLU A 69 8439 9808 12221 -1213 244 -889 C \nATOM 538 CD GLU A 69 32.172 12.588 -52.387 1.00 92.21 C \nANISOU 538 CD GLU A 69 10049 11293 13692 -1305 255 -865 C \nATOM 539 OE1 GLU A 69 32.715 12.285 -51.276 1.00 74.16 O \nANISOU 539 OE1 GLU A 69 7719 9051 11407 -1319 217 -864 O \nATOM 540 OE2 GLU A 69 31.628 13.698 -52.629 1.00101.36 O \nANISOU 540 OE2 GLU A 69 11326 12379 14806 -1361 302 -849 O \nATOM 541 N PHE A 70 31.938 8.175 -54.936 1.00 86.21 N \nANISOU 541 N PHE A 70 8986 10620 13148 -922 158 -930 N \nATOM 542 CA PHE A 70 31.216 6.965 -54.480 1.00 80.85 C \nANISOU 542 CA PHE A 70 8299 9883 12538 -812 111 -913 C \nATOM 543 C PHE A 70 31.222 5.927 -55.582 1.00 83.94 C \nANISOU 543 C PHE A 70 8626 10296 12970 -723 101 -941 C \nATOM 544 O PHE A 70 30.342 5.051 -55.638 1.00 83.07 O \nANISOU 544 O PHE A 70 8534 10116 12911 -638 78 -927 O \nATOM 545 CB PHE A 70 29.772 7.290 -54.045 1.00 76.85 C \nANISOU 545 CB PHE A 70 7905 9248 12044 -798 122 -868 C \nATOM 546 CG PHE A 70 29.664 8.482 -53.123 1.00 67.09 C \nANISOU 546 CG PHE A 70 6752 7979 10759 -888 144 -842 C \nATOM 547 CD1 PHE A 70 30.173 8.422 -51.816 1.00 60.56 C \nANISOU 547 CD1 PHE A 70 5908 7178 9926 -915 110 -833 C \nATOM 548 CD2 PHE A 70 29.070 9.672 -53.573 1.00 62.31 C \nANISOU 548 CD2 PHE A 70 6246 7318 10111 -944 198 -826 C \nATOM 549 CE1 PHE A 70 30.071 9.522 -50.950 1.00 59.80 C \nANISOU 549 CE1 PHE A 70 5893 7049 9781 -1000 130 -811 C \nATOM 550 CE2 PHE A 70 28.990 10.778 -52.734 1.00 62.29 C \nANISOU 550 CE2 PHE A 70 6329 7280 10059 -1024 220 -805 C \nATOM 551 CZ PHE A 70 29.495 10.698 -51.412 1.00 61.54 C \nANISOU 551 CZ PHE A 70 6216 7210 9958 -1055 186 -798 C \nATOM 552 N ILE A 71 32.228 6.032 -56.455 1.00 84.95 N \nANISOU 552 N ILE A 71 8680 10526 13072 -749 118 -981 N \nATOM 553 CA ILE A 71 32.371 5.116 -57.554 1.00 83.54 C \nANISOU 553 CA ILE A 71 8436 10381 12926 -671 112 -1014 C \nATOM 554 C ILE A 71 32.630 3.690 -57.019 1.00 87.10 C \nANISOU 554 C ILE A 71 8822 10846 13426 -565 50 -1023 C \nATOM 555 O ILE A 71 32.212 2.731 -57.640 1.00 89.58 O \nANISOU 555 O ILE A 71 9124 11129 13783 -478 35 -1033 O \nATOM 556 CB ILE A 71 33.482 5.550 -58.538 1.00 88.90 C \nANISOU 556 CB ILE A 71 9041 11178 13558 -724 143 -1057 C \nATOM 557 CG1 ILE A 71 33.434 4.714 -59.818 1.00 89.04 C \nANISOU 557 CG1 ILE A 71 9010 11216 13607 -644 146 -1089 C \nATOM 558 CG2 ILE A 71 34.862 5.393 -57.900 1.00 97.13 C \nANISOU 558 CG2 ILE A 71 9985 12348 14573 -747 115 -1082 C \nATOM 559 CD1 ILE A 71 34.294 5.274 -60.938 1.00 90.94 C \nANISOU 559 CD1 ILE A 71 9195 11560 13799 -704 187 -1128 C \nATOM 560 N ASN A 72 33.314 3.549 -55.882 1.00 84.62 N \nANISOU 560 N ASN A 72 8470 10578 13104 -574 14 -1019 N \nATOM 561 CA ASN A 72 33.609 2.215 -55.326 1.00 86.61 C \nANISOU 561 CA ASN A 72 8667 10843 13399 -471 -47 -1025 C \nATOM 562 C ASN A 72 33.778 2.223 -53.823 1.00 86.19 C \nANISOU 562 C ASN A 72 8622 10785 13343 -488 -85 -998 C \nATOM 563 O ASN A 72 34.856 2.047 -53.284 1.00 93.92 O \nANISOU 563 O ASN A 72 9522 11862 14300 -490 -112 -1014 O \nATOM 564 CB ASN A 72 34.788 1.562 -56.042 1.00 86.21 C \nANISOU 564 CB ASN A 72 8500 10914 13342 -420 -59 -1076 C \nATOM 565 CG ASN A 72 34.345 0.412 -56.907 1.00 89.59 C \nANISOU 565 CG ASN A 72 8923 11300 13819 -309 -73 -1094 C \nATOM 566 OD1 ASN A 72 33.704 -0.537 -56.430 1.00108.30 O \nANISOU 566 OD1 ASN A 72 11329 13587 16234 -230 -113 -1075 O \nATOM 567 ND2 ASN A 72 34.662 0.479 -58.183 1.00 91.89 N \nANISOU 567 ND2 ASN A 72 9173 11644 14096 -307 -41 -1130 N \nATOM 568 N VAL A 73 32.655 2.441 -53.164 1.00 89.20 N \nANISOU 568 N VAL A 73 9098 11052 13741 -500 -86 -955 N \nATOM 569 CA VAL A 73 32.615 2.528 -51.722 1.00 82.56 C \nANISOU 569 CA VAL A 73 8282 10190 12897 -522 -118 -923 C \nATOM 570 C VAL A 73 32.843 1.146 -51.081 1.00 78.32 C \nANISOU 570 C VAL A 73 7700 9655 12401 -420 -184 -923 C \nATOM 571 O VAL A 73 32.608 0.118 -51.711 1.00 67.51 O \nANISOU 571 O VAL A 73 6318 8261 11072 -328 -203 -937 O \nATOM 572 CB VAL A 73 31.269 3.142 -51.233 1.00 80.74 C \nANISOU 572 CB VAL A 73 8168 9837 12670 -558 -98 -878 C \nATOM 573 CG1 VAL A 73 31.067 4.535 -51.808 1.00 82.94 C \nANISOU 573 CG1 VAL A 73 8502 10108 12902 -653 -34 -877 C \nATOM 574 CG2 VAL A 73 30.076 2.243 -51.553 1.00 77.31 C \nANISOU 574 CG2 VAL A 73 7780 9304 12288 -473 -114 -861 C \nATOM 575 N PRO A 74 33.255 1.132 -49.807 1.00 80.98 N \nANISOU 575 N PRO A 74 8024 10016 12728 -437 -219 -905 N \nATOM 576 CA PRO A 74 33.358 -0.084 -49.020 1.00 80.10 C \nANISOU 576 CA PRO A 74 7891 9892 12652 -346 -284 -895 C \nATOM 577 C PRO A 74 32.200 -0.260 -48.073 1.00 82.69 C \nANISOU 577 C PRO A 74 8310 10102 13007 -342 -305 -848 C \nATOM 578 O PRO A 74 31.247 0.507 -48.114 1.00 84.95 O \nANISOU 578 O PRO A 74 8676 10316 13287 -398 -268 -825 O \nATOM 579 CB PRO A 74 34.652 0.132 -48.232 1.00 86.45 C \nANISOU 579 CB PRO A 74 8614 10817 13418 -379 -306 -906 C \nATOM 580 CG PRO A 74 34.767 1.612 -48.071 1.00 86.55 C \nANISOU 580 CG PRO A 74 8653 10855 13376 -512 -257 -900 C \nATOM 581 CD PRO A 74 33.909 2.267 -49.131 1.00 87.25 C \nANISOU 581 CD PRO A 74 8810 10875 13466 -547 -200 -901 C \nATOM 582 N GLU A 75 32.293 -1.282 -47.227 1.00 86.70 N \nANISOU 582 N GLU A 75 8807 10594 13541 -273 -364 -834 N \nATOM 583 CA GLU A 75 31.197 -1.678 -46.345 1.00 84.61 C \nANISOU 583 CA GLU A 75 8624 10219 13303 -258 -392 -791 C \nATOM 584 C GLU A 75 30.724 -0.549 -45.439 1.00 83.01 C \nANISOU 584 C GLU A 75 8479 9988 13072 -357 -369 -758 C \nATOM 585 O GLU A 75 31.501 0.322 -45.089 1.00 97.18 O \nANISOU 585 O GLU A 75 10241 11857 14825 -429 -352 -765 O \nATOM 586 CB GLU A 75 31.655 -2.864 -45.518 1.00 83.48 C \nANISOU 586 CB GLU A 75 8451 10086 13182 -178 -461 -784 C \nATOM 587 CG GLU A 75 30.615 -3.412 -44.565 1.00 91.48 C \nANISOU 587 CG GLU A 75 9544 10993 14220 -160 -497 -739 C \nATOM 588 CD GLU A 75 31.097 -4.660 -43.857 1.00101.19 C \nANISOU 588 CD GLU A 75 10751 12227 15470 -73 -567 -734 C \nATOM 589 OE1 GLU A 75 32.119 -5.246 -44.299 1.00 98.84 O \nANISOU 589 OE1 GLU A 75 10380 12004 15172 -5 -586 -767 O \nATOM 590 OE2 GLU A 75 30.427 -5.055 -42.868 1.00116.84 O \nANISOU 590 OE2 GLU A 75 12791 14137 17464 -71 -602 -695 O \nATOM 591 N TRP A 76 29.451 -0.579 -45.041 1.00 75.90 N \nANISOU 591 N TRP A 76 7665 8984 12189 -360 -369 -721 N \nATOM 592 CA TRP A 76 28.890 0.484 -44.210 1.00 70.83 C \nANISOU 592 CA TRP A 76 7087 8308 11519 -445 -345 -690 C \nATOM 593 C TRP A 76 27.876 0.005 -43.166 1.00 74.52 C \nANISOU 593 C TRP A 76 7619 8691 12007 -427 -379 -648 C \nATOM 594 O TRP A 76 27.215 -1.008 -43.350 1.00 84.77 O \nANISOU 594 O TRP A 76 8938 9932 13340 -361 -407 -638 O \nATOM 595 CB TRP A 76 28.241 1.566 -45.091 1.00 70.33 C \nANISOU 595 CB TRP A 76 7075 8214 11434 -498 -277 -693 C \nATOM 596 CG TRP A 76 26.937 1.091 -45.779 1.00 65.53 C \nANISOU 596 CG TRP A 76 6522 7520 10856 -448 -268 -679 C \nATOM 597 CD1 TRP A 76 25.731 0.973 -45.210 1.00 58.45 C \nANISOU 597 CD1 TRP A 76 5695 6543 9970 -442 -275 -643 C \nATOM 598 CD2 TRP A 76 26.780 0.676 -47.143 1.00 54.58 C \nANISOU 598 CD2 TRP A 76 5117 6131 9489 -402 -249 -704 C \nATOM 599 NE1 TRP A 76 24.839 0.496 -46.113 1.00 56.48 N \nANISOU 599 NE1 TRP A 76 5471 6247 9743 -398 -264 -642 N \nATOM 600 CE2 TRP A 76 25.462 0.316 -47.314 1.00 56.28 C \nANISOU 600 CE2 TRP A 76 5395 6265 9725 -373 -248 -679 C \nATOM 601 CE3 TRP A 76 27.638 0.575 -48.221 1.00 49.71 C \nANISOU 601 CE3 TRP A 76 4437 5580 8871 -385 -234 -745 C \nATOM 602 CZ2 TRP A 76 24.967 -0.122 -48.534 1.00 56.17 C \nANISOU 602 CZ2 TRP A 76 5383 6230 9729 -331 -231 -694 C \nATOM 603 CZ3 TRP A 76 27.162 0.154 -49.416 1.00 50.61 C \nANISOU 603 CZ3 TRP A 76 4554 5669 9005 -341 -217 -760 C \nATOM 604 CH2 TRP A 76 25.847 -0.203 -49.570 1.00 52.81 C \nANISOU 604 CH2 TRP A 76 4897 5864 9304 -314 -216 -735 C \nATOM 605 N SER A 77 27.719 0.795 -42.101 1.00 71.33 N \nANISOU 605 N SER A 77 7252 8278 11574 -495 -373 -623 N \nATOM 606 CA SER A 77 26.785 0.502 -41.038 1.00 72.43 C \nANISOU 606 CA SER A 77 7450 8347 11722 -492 -401 -582 C \nATOM 607 C SER A 77 25.385 1.081 -41.325 1.00 67.20 C \nANISOU 607 C SER A 77 6872 7608 11055 -512 -359 -560 C \nATOM 608 O SER A 77 24.393 0.369 -41.218 1.00 70.95 O \nANISOU 608 O SER A 77 7383 8021 11553 -472 -379 -538 O \nATOM 609 CB SER A 77 27.341 1.016 -39.706 1.00 78.18 C \nANISOU 609 CB SER A 77 8173 9110 12421 -551 -418 -567 C \nATOM 610 OG SER A 77 27.563 2.420 -39.716 1.00 81.24 O \nANISOU 610 OG SER A 77 8582 9523 12762 -640 -365 -574 O \nATOM 611 N TYR A 78 25.324 2.344 -41.738 1.00 64.36 N \nANISOU 611 N TYR A 78 6540 7255 10659 -573 -300 -568 N \nATOM 612 CA TYR A 78 24.070 2.961 -42.235 1.00 64.38 C \nANISOU 612 CA TYR A 78 6617 7195 10651 -581 -254 -551 C \nATOM 613 C TYR A 78 24.369 4.010 -43.294 1.00 59.79 C \nANISOU 613 C TYR A 78 6041 6637 10039 -619 -193 -576 C \nATOM 614 O TYR A 78 25.505 4.218 -43.634 1.00 64.05 O \nANISOU 614 O TYR A 78 6527 7242 10567 -644 -188 -605 O \nATOM 615 CB TYR A 78 23.258 3.575 -41.094 1.00 69.85 C \nANISOU 615 CB TYR A 78 7380 7843 11318 -619 -248 -516 C \nATOM 616 CG TYR A 78 24.000 4.672 -40.333 1.00 73.98 C \nANISOU 616 CG TYR A 78 7915 8399 11796 -699 -230 -519 C \nATOM 617 CD1 TYR A 78 23.680 6.007 -40.548 1.00 78.78 C \nANISOU 617 CD1 TYR A 78 8588 8986 12359 -753 -170 -518 C \nATOM 618 CD2 TYR A 78 25.006 4.367 -39.424 1.00 69.12 C \nANISOU 618 CD2 TYR A 78 7250 7833 11179 -720 -271 -523 C \nATOM 619 CE1 TYR A 78 24.341 7.008 -39.882 1.00 78.76 C \nANISOU 619 CE1 TYR A 78 8608 9008 12310 -832 -152 -522 C \nATOM 620 CE2 TYR A 78 25.665 5.351 -38.739 1.00 78.22 C \nANISOU 620 CE2 TYR A 78 8414 9020 12287 -800 -254 -526 C \nATOM 621 CZ TYR A 78 25.335 6.675 -38.978 1.00 84.91 C \nANISOU 621 CZ TYR A 78 9332 9841 13089 -860 -194 -527 C \nATOM 622 OH TYR A 78 25.979 7.665 -38.292 1.00 89.70 O \nANISOU 622 OH TYR A 78 9962 10476 13645 -947 -176 -531 O \nATOM 623 N ILE A 79 23.336 4.621 -43.863 1.00 55.85 N \nANISOU 623 N ILE A 79 5606 6089 9526 -621 -149 -564 N \nATOM 624 CA ILE A 79 23.496 5.545 -44.971 1.00 49.94 C \nANISOU 624 CA ILE A 79 4872 5354 8750 -650 -92 -584 C \nATOM 625 C ILE A 79 22.865 6.850 -44.569 1.00 56.21 C \nANISOU 625 C ILE A 79 5756 6106 9495 -701 -46 -563 C \nATOM 626 O ILE A 79 21.809 6.887 -43.981 1.00 67.96 O \nANISOU 626 O ILE A 79 7298 7543 10980 -683 -48 -532 O \nATOM 627 CB ILE A 79 22.840 5.026 -46.276 1.00 51.42 C \nANISOU 627 CB ILE A 79 5052 5522 8962 -591 -77 -592 C \nATOM 628 CG1 ILE A 79 23.574 3.746 -46.795 1.00 51.56 C \nANISOU 628 CG1 ILE A 79 4985 5581 9025 -537 -119 -619 C \nATOM 629 CG2 ILE A 79 22.853 6.102 -47.375 1.00 50.58 C \nANISOU 629 CG2 ILE A 79 4976 5421 8821 -623 -15 -606 C \nATOM 630 CD1 ILE A 79 22.810 2.984 -47.857 1.00 49.26 C \nANISOU 630 CD1 ILE A 79 4690 5262 8763 -475 -117 -623 C \nATOM 631 N VAL A 80 23.549 7.934 -44.878 1.00 56.68 N \nANISOU 631 N VAL A 80 5835 6190 9512 -766 -5 -580 N \nATOM 632 CA VAL A 80 23.044 9.232 -44.504 1.00 53.74 C \nANISOU 632 CA VAL A 80 5559 5772 9085 -816 40 -563 C \nATOM 633 C VAL A 80 22.921 10.061 -45.754 1.00 48.98 C \nANISOU 633 C VAL A 80 4996 5160 8453 -829 96 -575 C \nATOM 634 O VAL A 80 23.859 10.137 -46.538 1.00 40.49 O \nANISOU 634 O VAL A 80 3875 4137 7374 -858 107 -605 O \nATOM 635 CB VAL A 80 23.937 9.924 -43.426 1.00 59.73 C \nANISOU 635 CB VAL A 80 6332 6558 9806 -900 36 -566 C \nATOM 636 CG1 VAL A 80 25.326 9.291 -43.377 1.00 59.03 C \nANISOU 636 CG1 VAL A 80 6140 6556 9734 -920 -1 -595 C \nATOM 637 CG2 VAL A 80 24.003 11.440 -43.619 1.00 54.63 C \nANISOU 637 CG2 VAL A 80 5777 5887 9092 -974 97 -569 C \nATOM 638 N GLU A 81 21.753 10.681 -45.894 1.00 46.50 N \nANISOU 638 N GLU A 81 4768 4783 8116 -807 131 -551 N \nATOM 639 CA GLU A 81 21.383 11.404 -47.074 1.00 53.06 C \nANISOU 639 CA GLU A 81 5647 5595 8920 -802 184 -555 C \nATOM 640 C GLU A 81 20.829 12.692 -46.585 1.00 56.55 C \nANISOU 640 C GLU A 81 6205 5980 9302 -834 226 -534 C \nATOM 641 O GLU A 81 20.413 12.782 -45.425 1.00 72.75 O \nANISOU 641 O GLU A 81 8293 8005 11345 -835 211 -513 O \nATOM 642 CB GLU A 81 20.302 10.617 -47.814 1.00 56.46 C \nANISOU 642 CB GLU A 81 6058 6008 9387 -715 178 -542 C \nATOM 643 CG GLU A 81 20.116 10.989 -49.278 1.00 53.56 C \nANISOU 643 CG GLU A 81 5703 5641 9007 -701 220 -554 C \nATOM 644 CD GLU A 81 19.030 10.163 -49.937 1.00 47.54 C \nANISOU 644 CD GLU A 81 4918 4868 8278 -620 211 -541 C \nATOM 645 OE1 GLU A 81 18.138 9.732 -49.187 1.00 40.79 O \nANISOU 645 OE1 GLU A 81 4076 3989 7434 -582 188 -514 O \nATOM 646 OE2 GLU A 81 19.027 10.027 -51.185 1.00 42.65 O \nANISOU 646 OE2 GLU A 81 4274 4264 7665 -600 230 -556 O \nATOM 647 N LYS A 82 20.865 13.716 -47.392 1.00 58.93 N \nANISOU 647 N LYS A 82 6571 6262 9557 -862 278 -540 N \nATOM 648 CA LYS A 82 20.303 14.975 -46.949 1.00 72.32 C \nANISOU 648 CA LYS A 82 8393 7895 11190 -884 320 -520 C \nATOM 649 C LYS A 82 18.841 14.910 -47.284 1.00 74.24 C \nANISOU 649 C LYS A 82 8676 8096 11436 -794 334 -492 C \nATOM 650 O LYS A 82 18.382 13.944 -47.904 1.00 84.02 O \nANISOU 650 O LYS A 82 9845 9357 12721 -731 314 -491 O \nATOM 651 CB LYS A 82 20.988 16.167 -47.619 1.00 81.91 C \nANISOU 651 CB LYS A 82 9675 9101 12344 -959 370 -538 C \nATOM 652 CG LYS A 82 22.518 16.069 -47.499 1.00 86.38 C \nANISOU 652 CG LYS A 82 10175 9736 12911 -1051 353 -570 C \nATOM 653 CD LYS A 82 23.204 17.277 -46.877 1.00 89.80 C \nANISOU 653 CD LYS A 82 10696 10153 13272 -1158 380 -576 C \nATOM 654 CE LYS A 82 24.604 16.900 -46.372 1.00 89.84 C \nANISOU 654 CE LYS A 82 10609 10242 13283 -1238 347 -603 C \nATOM 655 NZ LYS A 82 24.572 16.115 -45.088 1.00 89.87 N \nANISOU 655 NZ LYS A 82 10559 10262 13325 -1215 295 -592 N \nATOM 656 N ALA A 83 18.099 15.923 -46.879 1.00 77.01 N \nANISOU 656 N ALA A 83 9140 8389 11732 -786 370 -470 N \nATOM 657 CA ALA A 83 16.667 15.953 -47.160 1.00 78.31 C \nANISOU 657 CA ALA A 83 9344 8523 11888 -696 387 -441 C \nATOM 658 C ALA A 83 16.423 16.252 -48.648 1.00 78.77 C \nANISOU 658 C ALA A 83 9416 8579 11933 -666 424 -446 C \nATOM 659 O ALA A 83 15.569 15.614 -49.274 1.00 71.15 O \nANISOU 659 O ALA A 83 8410 7630 10994 -592 418 -434 O \nATOM 660 CB ALA A 83 15.989 16.985 -46.292 1.00 82.82 C \nANISOU 660 CB ALA A 83 10033 9035 12398 -688 415 -419 C \nATOM 661 N ASN A 84 17.175 17.207 -49.206 1.00 81.27 N \nANISOU 661 N ASN A 84 9791 8880 12207 -728 462 -462 N \nATOM 662 CA ASN A 84 17.098 17.542 -50.638 1.00 88.11 C \nANISOU 662 CA ASN A 84 10673 9747 13058 -712 498 -468 C \nATOM 663 C ASN A 84 18.471 17.583 -51.320 1.00 86.62 C \nANISOU 663 C ASN A 84 10440 9598 12873 -796 501 -503 C \nATOM 664 O ASN A 84 19.013 18.670 -51.574 1.00 93.94 O \nANISOU 664 O ASN A 84 11451 10499 13742 -863 540 -511 O \nATOM 665 CB ASN A 84 16.411 18.896 -50.848 1.00 99.95 C \nANISOU 665 CB ASN A 84 12318 11178 14481 -693 553 -447 C \nATOM 666 CG ASN A 84 14.923 18.865 -50.553 1.00101.26 C \nANISOU 666 CG ASN A 84 12519 11320 14636 -590 558 -412 C \nATOM 667 OD1 ASN A 84 14.429 18.009 -49.832 1.00109.47 O \nANISOU 667 OD1 ASN A 84 13494 12383 15715 -552 520 -402 O \nATOM 668 ND2 ASN A 84 14.203 19.817 -51.117 1.00110.90 N \nANISOU 668 ND2 ASN A 84 13842 12496 15798 -544 604 -394 N \nATOM 669 N PRO A 85 19.052 16.404 -51.599 1.00 81.09 N \nANISOU 669 N PRO A 85 9610 8963 12236 -795 461 -525 N \nATOM 670 CA PRO A 85 20.361 16.303 -52.246 1.00 73.66 C \nANISOU 670 CA PRO A 85 8609 8078 11302 -866 460 -561 C \nATOM 671 C PRO A 85 20.386 17.021 -53.554 1.00 71.71 C \nANISOU 671 C PRO A 85 8408 7822 11017 -879 507 -567 C \nATOM 672 O PRO A 85 19.453 16.892 -54.348 1.00 74.50 O \nANISOU 672 O PRO A 85 8772 8159 11377 -806 522 -552 O \nATOM 673 CB PRO A 85 20.533 14.795 -52.476 1.00 73.98 C \nANISOU 673 CB PRO A 85 8511 8178 11419 -818 410 -576 C \nATOM 674 CG PRO A 85 19.333 14.125 -51.886 1.00 74.51 C \nANISOU 674 CG PRO A 85 8574 8218 11518 -736 384 -547 C \nATOM 675 CD PRO A 85 18.655 15.119 -51.006 1.00 78.92 C \nANISOU 675 CD PRO A 85 9246 8714 12025 -739 408 -518 C \nATOM 676 N ALA A 86 21.443 17.782 -53.787 1.00 75.69 N \nANISOU 676 N ALA A 86 8942 8341 11477 -975 530 -589 N \nATOM 677 CA ALA A 86 21.542 18.573 -55.010 1.00 78.23 C \nANISOU 677 CA ALA A 86 9320 8651 11752 -1001 577 -595 C \nATOM 678 C ALA A 86 21.879 17.706 -56.225 1.00 79.05 C \nANISOU 678 C ALA A 86 9311 8822 11901 -978 567 -619 C \nATOM 679 O ALA A 86 21.629 18.095 -57.367 1.00 85.29 O \nANISOU 679 O ALA A 86 10134 9605 12669 -967 601 -618 O \nATOM 680 CB ALA A 86 22.575 19.674 -54.846 1.00 81.05 C \nANISOU 680 CB ALA A 86 9750 9004 12040 -1124 606 -610 C \nATOM 681 N ASN A 87 22.430 16.525 -55.980 1.00 69.72 N \nANISOU 681 N ASN A 87 8002 7708 10782 -966 520 -640 N \nATOM 682 CA ASN A 87 22.874 15.657 -57.041 1.00 67.26 C \nANISOU 682 CA ASN A 87 7582 7464 10512 -945 507 -668 C \nATOM 683 C ASN A 87 22.068 14.362 -57.108 1.00 70.42 C \nANISOU 683 C ASN A 87 7905 7868 10981 -842 470 -661 C \nATOM 684 O ASN A 87 22.491 13.312 -56.646 1.00 68.35 O \nANISOU 684 O ASN A 87 7550 7648 10770 -823 424 -676 O \nATOM 685 CB ASN A 87 24.343 15.340 -56.838 1.00 75.95 C \nANISOU 685 CB ASN A 87 8592 8647 11618 -1019 485 -706 C \nATOM 686 CG ASN A 87 25.202 16.588 -56.825 1.00 70.63 C \nANISOU 686 CG ASN A 87 7989 7980 10869 -1137 521 -716 C \nATOM 687 OD1 ASN A 87 25.036 17.483 -57.661 1.00 63.42 O \nANISOU 687 OD1 ASN A 87 7155 7037 9905 -1167 567 -712 O \nATOM 688 ND2 ASN A 87 26.158 16.629 -55.905 1.00 69.58 N \nANISOU 688 ND2 ASN A 87 7825 7891 10723 -1208 501 -731 N \nATOM 689 N ASP A 88 20.898 14.453 -57.724 1.00 70.49 N \nANISOU 689 N ASP A 88 7959 7837 10988 -776 491 -637 N \nATOM 690 CA ASP A 88 19.997 13.340 -57.849 1.00 61.21 C \nANISOU 690 CA ASP A 88 6728 6663 9866 -686 461 -626 C \nATOM 691 C ASP A 88 20.053 12.828 -59.290 1.00 61.48 C \nANISOU 691 C ASP A 88 6702 6737 9920 -660 470 -647 C \nATOM 692 O ASP A 88 21.126 12.485 -59.839 1.00 56.82 O \nANISOU 692 O ASP A 88 6040 6205 9344 -697 464 -684 O \nATOM 693 CB ASP A 88 18.592 13.812 -57.468 1.00 73.38 C \nANISOU 693 CB ASP A 88 8357 8141 11382 -630 477 -583 C \nATOM 694 CG ASP A 88 17.622 12.662 -57.179 1.00 80.61 C \nANISOU 694 CG ASP A 88 9221 9060 12347 -551 440 -567 C \nATOM 695 OD1 ASP A 88 18.018 11.467 -57.202 1.00 92.05 O \nANISOU 695 OD1 ASP A 88 10576 10549 13852 -538 398 -587 O \nATOM 696 OD2 ASP A 88 16.448 12.971 -56.953 1.00 80.03 O \nANISOU 696 OD2 ASP A 88 9205 8951 12251 -502 453 -533 O \nATOM 697 N LEU A 89 18.911 12.769 -59.942 1.00 55.22 N \nANISOU 697 N LEU A 89 5935 5921 9124 -597 486 -625 N \nATOM 698 CA LEU A 89 18.911 12.577 -61.379 1.00 53.39 C \nANISOU 698 CA LEU A 89 5669 5721 8895 -582 506 -641 C \nATOM 699 C LEU A 89 19.351 13.897 -62.019 1.00 50.38 C \nANISOU 699 C LEU A 89 5363 5328 8450 -643 558 -643 C \nATOM 700 O LEU A 89 19.206 14.957 -61.466 1.00 54.28 O \nANISOU 700 O LEU A 89 5954 5774 8894 -672 582 -622 O \nATOM 701 CB LEU A 89 17.508 12.165 -61.902 1.00 47.51 C \nANISOU 701 CB LEU A 89 4931 4961 8160 -500 509 -615 C \nATOM 702 CG LEU A 89 16.862 11.000 -61.169 1.00 46.50 C \nANISOU 702 CG LEU A 89 4754 4834 8081 -447 462 -604 C \nATOM 703 CD1 LEU A 89 15.503 10.668 -61.763 1.00 41.47 C \nANISOU 703 CD1 LEU A 89 4122 4193 7440 -378 469 -579 C \nATOM 704 CD2 LEU A 89 17.807 9.763 -61.172 1.00 43.06 C \nANISOU 704 CD2 LEU A 89 4215 4443 7705 -454 418 -643 C \nATOM 705 N CYS A 90 19.841 13.803 -63.223 1.00 55.37 N \nANISOU 705 N CYS A 90 5953 6002 9081 -661 574 -669 N \nATOM 706 CA CYS A 90 20.267 14.963 -63.967 1.00 60.82 C \nANISOU 706 CA CYS A 90 6712 6687 9711 -722 622 -672 C \nATOM 707 C CYS A 90 19.401 15.159 -65.204 1.00 61.07 C \nANISOU 707 C CYS A 90 6772 6709 9724 -674 653 -656 C \nATOM 708 O CYS A 90 19.439 16.186 -65.894 1.00 74.54 O \nANISOU 708 O CYS A 90 8555 8396 11372 -707 696 -648 O \nATOM 709 CB CYS A 90 21.727 14.761 -64.353 1.00 62.18 C \nANISOU 709 CB CYS A 90 6807 6931 9888 -796 616 -718 C \nATOM 710 SG CYS A 90 22.144 13.279 -65.285 1.00 70.46 S \nANISOU 710 SG CYS A 90 7708 8061 11002 -754 586 -759 S \nATOM 711 N TYR A 91 18.650 14.136 -65.524 1.00 57.38 N \nANISOU 711 N TYR A 91 6240 6259 9302 -598 630 -653 N \nATOM 712 CA TYR A 91 17.578 14.286 -66.443 1.00 59.22 C \nANISOU 712 CA TYR A 91 6505 6480 9516 -541 655 -629 C \nATOM 713 C TYR A 91 16.322 14.136 -65.601 1.00 55.15 C \nANISOU 713 C TYR A 91 6023 5925 9004 -470 641 -590 C \nATOM 714 O TYR A 91 16.271 13.278 -64.730 1.00 62.43 O \nANISOU 714 O TYR A 91 6894 6853 9972 -452 600 -593 O \nATOM 715 CB TYR A 91 17.666 13.200 -67.503 1.00 57.43 C \nANISOU 715 CB TYR A 91 6176 6312 9334 -515 641 -658 C \nATOM 716 CG TYR A 91 17.468 13.678 -68.916 1.00 56.27 C \nANISOU 716 CG TYR A 91 6049 6180 9151 -515 681 -657 C \nATOM 717 CD1 TYR A 91 18.464 14.415 -69.584 1.00 49.98 C \nANISOU 717 CD1 TYR A 91 5271 5401 8318 -589 711 -679 C \nATOM 718 CD2 TYR A 91 16.300 13.322 -69.633 1.00 48.12 C \nANISOU 718 CD2 TYR A 91 5011 5152 8119 -445 686 -636 C \nATOM 719 CE1 TYR A 91 18.271 14.814 -70.910 1.00 53.69 C \nANISOU 719 CE1 TYR A 91 5759 5887 8755 -590 746 -678 C \nATOM 720 CE2 TYR A 91 16.103 13.704 -70.988 1.00 54.47 C \nANISOU 720 CE2 TYR A 91 5828 5976 8891 -443 721 -635 C \nATOM 721 CZ TYR A 91 17.076 14.436 -71.615 1.00 58.73 C \nANISOU 721 CZ TYR A 91 6390 6527 9398 -513 750 -656 C \nATOM 722 OH TYR A 91 16.847 14.824 -72.921 1.00 69.93 O \nANISOU 722 OH TYR A 91 7826 7963 10782 -510 784 -652 O \nATOM 723 N PRO A 92 15.316 14.977 -65.832 1.00 51.57 N \nANISOU 723 N PRO A 92 5659 5436 8500 -430 674 -552 N \nATOM 724 CA PRO A 92 14.063 14.812 -65.087 1.00 50.97 C \nANISOU 724 CA PRO A 92 5606 5336 8421 -357 661 -515 C \nATOM 725 C PRO A 92 13.293 13.532 -65.478 1.00 44.32 C \nANISOU 725 C PRO A 92 4674 4541 7626 -299 632 -516 C \nATOM 726 O PRO A 92 13.361 13.091 -66.606 1.00 48.35 O \nANISOU 726 O PRO A 92 5134 5089 8149 -294 637 -533 O \nATOM 727 CB PRO A 92 13.243 16.058 -65.477 1.00 50.16 C \nANISOU 727 CB PRO A 92 5619 5196 8246 -322 708 -478 C \nATOM 728 CG PRO A 92 13.759 16.451 -66.827 1.00 51.28 C \nANISOU 728 CG PRO A 92 5766 5354 8365 -354 740 -494 C \nATOM 729 CD PRO A 92 15.152 15.863 -66.986 1.00 55.64 C \nANISOU 729 CD PRO A 92 6236 5944 8962 -432 720 -543 C \nATOM 730 N GLY A 93 12.601 12.927 -64.527 1.00 38.26 N \nANISOU 730 N GLY A 93 3887 3769 6879 -261 600 -498 N \nATOM 731 CA GLY A 93 11.963 11.665 -64.780 1.00 39.91 C \nANISOU 731 CA GLY A 93 4015 4019 7129 -221 569 -501 C \nATOM 732 C GLY A 93 11.684 10.889 -63.536 1.00 43.49 C \nANISOU 732 C GLY A 93 4440 4466 7616 -210 525 -493 C \nATOM 733 O GLY A 93 11.981 11.328 -62.425 1.00 45.79 O \nANISOU 733 O GLY A 93 4772 4725 7903 -231 518 -486 O \nATOM 734 N ASN A 94 11.057 9.730 -63.721 1.00 45.00 N \nANISOU 734 N ASN A 94 4568 4691 7839 -180 495 -494 N \nATOM 735 CA ASN A 94 10.704 8.884 -62.609 1.00 51.33 C \nANISOU 735 CA ASN A 94 5344 5490 8671 -171 451 -485 C \nATOM 736 C ASN A 94 11.757 7.796 -62.352 1.00 52.85 C \nANISOU 736 C ASN A 94 5468 5684 8926 -204 408 -523 C \nATOM 737 O ASN A 94 12.273 7.156 -63.278 1.00 70.53 O \nANISOU 737 O ASN A 94 7656 7949 11195 -212 403 -555 O \nATOM 738 CB ASN A 94 9.353 8.211 -62.926 1.00 60.33 C \nANISOU 738 CB ASN A 94 6457 6665 9799 -124 442 -461 C \nATOM 739 CG ASN A 94 8.741 7.514 -61.719 1.00 74.23 C \nANISOU 739 CG ASN A 94 8206 8423 11573 -115 402 -442 C \nATOM 740 OD1 ASN A 94 8.498 6.294 -61.762 1.00 69.04 O \nANISOU 740 OD1 ASN A 94 7496 7787 10948 -116 366 -451 O \nATOM 741 ND2 ASN A 94 8.524 8.264 -60.626 1.00 81.60 N \nANISOU 741 ND2 ASN A 94 9195 9330 12481 -109 408 -418 N \nATOM 742 N PHE A 95 12.031 7.532 -61.090 1.00 51.55 N \nANISOU 742 N PHE A 95 5306 5499 8784 -219 375 -519 N \nATOM 743 CA PHE A 95 12.750 6.339 -60.705 1.00 36.28 C \nANISOU 743 CA PHE A 95 3311 3568 6906 -233 326 -547 C \nATOM 744 C PHE A 95 11.749 5.374 -60.139 1.00 34.40 C \nANISOU 744 C PHE A 95 3058 3331 6680 -206 290 -526 C \nATOM 745 O PHE A 95 11.331 5.477 -58.975 1.00 38.15 O \nANISOU 745 O PHE A 95 3560 3788 7147 -205 274 -500 O \nATOM 746 CB PHE A 95 13.815 6.650 -59.702 1.00 40.50 C \nANISOU 746 CB PHE A 95 3852 4082 7454 -271 312 -559 C \nATOM 747 CG PHE A 95 14.895 5.620 -59.595 1.00 37.50 C \nANISOU 747 CG PHE A 95 3406 3716 7126 -285 271 -595 C \nATOM 748 CD1 PHE A 95 16.177 5.955 -59.827 1.00 46.25 C \nANISOU 748 CD1 PHE A 95 4492 4841 8241 -321 279 -627 C \nATOM 749 CD2 PHE A 95 14.638 4.367 -59.150 1.00 38.92 C \nANISOU 749 CD2 PHE A 95 3551 3892 7343 -263 223 -596 C \nATOM 750 CE1 PHE A 95 17.211 5.015 -59.729 1.00 49.79 C \nANISOU 750 CE1 PHE A 95 4875 5311 8734 -324 242 -662 C \nATOM 751 CE2 PHE A 95 15.658 3.400 -59.006 1.00 43.63 C \nANISOU 751 CE2 PHE A 95 4093 4497 7986 -265 183 -630 C \nATOM 752 CZ PHE A 95 16.958 3.725 -59.322 1.00 45.16 C \nANISOU 752 CZ PHE A 95 4257 4716 8187 -291 193 -664 C \nATOM 753 N ASN A 96 11.341 4.381 -60.949 1.00 33.07 N \nANISOU 753 N ASN A 96 2848 3187 6530 -188 276 -537 N \nATOM 754 CA ASN A 96 10.345 3.379 -60.555 1.00 33.01 C \nANISOU 754 CA ASN A 96 2829 3186 6528 -172 242 -518 C \nATOM 755 C ASN A 96 10.698 2.630 -59.253 1.00 33.89 C \nANISOU 755 C ASN A 96 2934 3270 6673 -186 191 -517 C \nATOM 756 O ASN A 96 11.844 2.284 -58.995 1.00 45.85 O \nANISOU 756 O ASN A 96 4425 4768 8225 -201 168 -546 O \nATOM 757 CB ASN A 96 10.127 2.412 -61.680 1.00 36.62 C \nANISOU 757 CB ASN A 96 3246 3668 7000 -163 235 -538 C \nATOM 758 CG ASN A 96 8.754 1.765 -61.629 1.00 41.93 C \nANISOU 758 CG ASN A 96 3919 4363 7650 -151 221 -510 C \nATOM 759 OD1 ASN A 96 7.722 2.470 -61.628 1.00 38.89 O \nANISOU 759 OD1 ASN A 96 3558 4004 7215 -134 248 -476 O \nATOM 760 ND2 ASN A 96 8.722 0.420 -61.528 1.00 45.59 N \nANISOU 760 ND2 ASN A 96 4359 4820 8144 -160 177 -524 N \nATOM 761 N ASP A 97 9.685 2.405 -58.419 1.00 36.12 N \nANISOU 761 N ASP A 97 3235 3552 6937 -180 173 -484 N \nATOM 762 CA ASP A 97 9.786 1.768 -57.099 1.00 31.35 C \nANISOU 762 CA ASP A 97 2633 2923 6354 -194 126 -474 C \nATOM 763 C ASP A 97 11.042 2.190 -56.385 1.00 32.58 C \nANISOU 763 C ASP A 97 2793 3052 6534 -213 118 -491 C \nATOM 764 O ASP A 97 11.762 1.383 -55.826 1.00 40.77 O \nANISOU 764 O ASP A 97 3809 4072 7611 -222 75 -507 O \nATOM 765 CB ASP A 97 9.718 0.245 -57.229 1.00 32.25 C \nANISOU 765 CB ASP A 97 2719 3033 6503 -196 79 -488 C \nATOM 766 CG ASP A 97 8.373 -0.257 -57.672 1.00 36.04 C \nANISOU 766 CG ASP A 97 3198 3543 6950 -191 80 -467 C \nATOM 767 OD1 ASP A 97 7.319 0.040 -57.021 1.00 33.92 O \nANISOU 767 OD1 ASP A 97 2951 3294 6643 -191 83 -430 O \nATOM 768 OD2 ASP A 97 8.346 -0.939 -58.670 1.00 45.68 O \nANISOU 768 OD2 ASP A 97 4399 4776 8183 -188 78 -488 O \nATOM 769 N TYR A 98 11.269 3.483 -56.332 1.00 33.33 N \nANISOU 769 N TYR A 98 2920 3144 6601 -220 158 -484 N \nATOM 770 CA TYR A 98 12.424 4.080 -55.615 1.00 33.40 C \nANISOU 770 CA TYR A 98 2938 3132 6619 -249 157 -497 C \nATOM 771 C TYR A 98 12.496 3.748 -54.204 1.00 35.19 C \nANISOU 771 C TYR A 98 3172 3340 6858 -262 117 -483 C \nATOM 772 O TYR A 98 13.534 3.318 -53.716 1.00 44.12 O \nANISOU 772 O TYR A 98 4277 4464 8024 -279 86 -503 O \nATOM 773 CB TYR A 98 12.405 5.634 -55.815 1.00 33.46 C \nANISOU 773 CB TYR A 98 2999 3135 6579 -258 212 -486 C \nATOM 774 CG TYR A 98 13.708 6.292 -55.464 1.00 40.52 C \nANISOU 774 CG TYR A 98 3900 4018 7476 -299 220 -508 C \nATOM 775 CD1 TYR A 98 14.942 5.594 -55.577 1.00 36.40 C \nANISOU 775 CD1 TYR A 98 3321 3511 6998 -319 191 -544 C \nATOM 776 CD2 TYR A 98 13.737 7.618 -54.988 1.00 41.16 C \nANISOU 776 CD2 TYR A 98 4048 4078 7513 -321 255 -492 C \nATOM 777 CE1 TYR A 98 16.140 6.205 -55.193 1.00 37.65 C \nANISOU 777 CE1 TYR A 98 3479 3674 7154 -363 196 -563 C \nATOM 778 CE2 TYR A 98 14.933 8.215 -54.633 1.00 44.18 C \nANISOU 778 CE2 TYR A 98 4438 4455 7893 -370 261 -512 C \nATOM 779 CZ TYR A 98 16.124 7.515 -54.778 1.00 41.44 C \nANISOU 779 CZ TYR A 98 4025 4134 7587 -394 232 -547 C \nATOM 780 OH TYR A 98 17.299 8.154 -54.467 1.00 47.79 O \nANISOU 780 OH TYR A 98 4833 4946 8381 -448 240 -567 O \nATOM 781 N GLU A 99 11.352 3.941 -53.507 1.00 36.43 N \nANISOU 781 N GLU A 99 3364 3494 6985 -251 118 -446 N \nATOM 782 CA GLU A 99 11.299 3.795 -52.041 1.00 36.32 C \nANISOU 782 CA GLU A 99 3365 3461 6972 -267 85 -426 C \nATOM 783 C GLU A 99 11.473 2.343 -51.654 1.00 36.83 C \nANISOU 783 C GLU A 99 3392 3520 7080 -269 26 -433 C \nATOM 784 O GLU A 99 12.039 2.044 -50.617 1.00 45.25 O \nANISOU 784 O GLU A 99 4456 4569 8167 -286 -10 -433 O \nATOM 785 CB GLU A 99 9.998 4.329 -51.495 1.00 37.33 C \nANISOU 785 CB GLU A 99 3535 3596 7052 -251 102 -387 C \nATOM 786 CG GLU A 99 9.769 5.801 -51.730 1.00 37.12 C \nANISOU 786 CG GLU A 99 3561 3567 6976 -240 159 -377 C \nATOM 787 CD GLU A 99 9.346 6.118 -53.137 1.00 45.73 C \nANISOU 787 CD GLU A 99 4651 4680 8046 -212 198 -381 C \nATOM 788 OE1 GLU A 99 8.930 5.196 -53.885 1.00 43.44 O \nANISOU 788 OE1 GLU A 99 4319 4415 7773 -198 184 -386 O \nATOM 789 OE2 GLU A 99 9.421 7.319 -53.515 1.00 58.19 O \nANISOU 789 OE2 GLU A 99 6275 6248 9588 -205 245 -378 O \nATOM 790 N GLU A 100 11.073 1.451 -52.533 1.00 35.41 N \nANISOU 790 N GLU A 100 3188 3353 6915 -252 16 -442 N \nATOM 791 CA GLU A 100 11.277 0.005 -52.270 1.00 37.89 C \nANISOU 791 CA GLU A 100 3477 3652 7268 -252 -41 -452 C \nATOM 792 C GLU A 100 12.683 -0.373 -52.420 1.00 36.62 C \nANISOU 792 C GLU A 100 3285 3481 7150 -251 -61 -488 C \nATOM 793 O GLU A 100 13.249 -1.092 -51.579 1.00 50.09 O \nANISOU 793 O GLU A 100 4982 5167 8883 -255 -107 -492 O \nATOM 794 CB GLU A 100 10.390 -0.826 -53.208 1.00 43.53 C \nANISOU 794 CB GLU A 100 4181 4381 7976 -239 -43 -451 C \nATOM 795 CG GLU A 100 8.927 -0.909 -52.761 1.00 41.40 C \nANISOU 795 CG GLU A 100 3934 4130 7665 -245 -45 -412 C \nATOM 796 CD GLU A 100 8.742 -1.910 -51.669 1.00 44.03 C \nANISOU 796 CD GLU A 100 4277 4442 8011 -264 -101 -397 C \nATOM 797 OE1 GLU A 100 9.493 -2.937 -51.721 1.00 49.52 O \nANISOU 797 OE1 GLU A 100 4960 5107 8747 -264 -140 -420 O \nATOM 798 OE2 GLU A 100 7.892 -1.638 -50.755 1.00 34.34 O \nANISOU 798 OE2 GLU A 100 3071 3227 6749 -277 -104 -363 O \nATOM 799 N LEU A 101 13.315 0.165 -53.442 1.00 37.39 N \nANISOU 799 N LEU A 101 3363 3596 7249 -246 -25 -516 N \nATOM 800 CA LEU A 101 14.852 0.092 -53.589 1.00 38.64 C \nANISOU 800 CA LEU A 101 3482 3760 7438 -249 -35 -554 C \nATOM 801 C LEU A 101 15.569 0.649 -52.372 1.00 39.59 C \nANISOU 801 C LEU A 101 3610 3875 7557 -275 -47 -547 C \nATOM 802 O LEU A 101 16.395 -0.011 -51.768 1.00 40.24 O \nANISOU 802 O LEU A 101 3667 3954 7668 -272 -89 -560 O \nATOM 803 CB LEU A 101 15.315 0.842 -54.807 1.00 33.86 C \nANISOU 803 CB LEU A 101 2861 3181 6822 -251 13 -579 C \nATOM 804 CG LEU A 101 16.790 0.771 -55.075 1.00 37.64 C \nANISOU 804 CG LEU A 101 3293 3682 7324 -256 7 -619 C \nATOM 805 CD1 LEU A 101 17.347 -0.666 -55.037 1.00 40.88 C \nANISOU 805 CD1 LEU A 101 3665 4089 7778 -223 -46 -643 C \nATOM 806 CD2 LEU A 101 17.131 1.424 -56.417 1.00 35.79 C \nANISOU 806 CD2 LEU A 101 3044 3479 7076 -261 55 -644 C \nATOM 807 N LYS A 102 15.229 1.869 -52.013 1.00 37.69 N \nANISOU 807 N LYS A 102 3408 3633 7278 -299 -10 -526 N \nATOM 808 CA LYS A 102 15.767 2.482 -50.813 1.00 40.86 C \nANISOU 808 CA LYS A 102 3827 4028 7671 -330 -18 -517 C \nATOM 809 C LYS A 102 15.610 1.553 -49.591 1.00 42.17 C \nANISOU 809 C LYS A 102 3991 4176 7858 -327 -75 -499 C \nATOM 810 O LYS A 102 16.487 1.410 -48.727 1.00 45.62 O \nANISOU 810 O LYS A 102 4411 4613 8309 -343 -105 -504 O \nATOM 811 CB LYS A 102 15.051 3.816 -50.525 1.00 41.20 C \nANISOU 811 CB LYS A 102 3930 4061 7663 -348 28 -490 C \nATOM 812 CG LYS A 102 15.839 5.048 -50.950 1.00 45.48 C \nANISOU 812 CG LYS A 102 4490 4613 8180 -380 74 -507 C \nATOM 813 CD LYS A 102 14.933 6.272 -50.990 1.00 46.81 C \nANISOU 813 CD LYS A 102 4729 4763 8294 -380 124 -481 C \nATOM 814 CE LYS A 102 15.748 7.518 -51.044 1.00 47.93 C \nANISOU 814 CE LYS A 102 4906 4902 8403 -424 163 -493 C \nATOM 815 NZ LYS A 102 16.313 7.803 -49.717 1.00 48.21 N \nANISOU 815 NZ LYS A 102 4958 4927 8433 -464 143 -488 N \nATOM 816 N HIS A 103 14.449 0.954 -49.463 1.00 39.58 N \nANISOU 816 N HIS A 103 3682 3833 7525 -310 -90 -474 N \nATOM 817 CA HIS A 103 14.178 0.120 -48.281 1.00 35.63 C \nANISOU 817 CA HIS A 103 3188 3312 7036 -314 -142 -452 C \nATOM 818 C HIS A 103 15.028 -1.157 -48.384 1.00 38.16 C \nANISOU 818 C HIS A 103 3471 3625 7402 -293 -192 -477 C \nATOM 819 O HIS A 103 15.438 -1.755 -47.442 1.00 33.51 O \nANISOU 819 O HIS A 103 2879 3022 6831 -296 -238 -471 O \nATOM 820 CB HIS A 103 12.725 -0.276 -48.225 1.00 32.71 C \nANISOU 820 CB HIS A 103 2845 2938 6646 -307 -146 -421 C \nATOM 821 CG HIS A 103 12.423 -1.200 -47.117 1.00 32.27 C \nANISOU 821 CG HIS A 103 2800 2863 6599 -316 -200 -400 C \nATOM 822 ND1 HIS A 103 12.144 -2.536 -47.312 1.00 31.62 N \nANISOU 822 ND1 HIS A 103 2712 2764 6536 -305 -242 -401 N \nATOM 823 CD2 HIS A 103 12.351 -0.990 -45.783 1.00 33.33 C \nANISOU 823 CD2 HIS A 103 2954 2987 6721 -338 -220 -376 C \nATOM 824 CE1 HIS A 103 11.941 -3.122 -46.143 1.00 33.11 C \nANISOU 824 CE1 HIS A 103 2919 2934 6726 -321 -287 -378 C \nATOM 825 NE2 HIS A 103 12.023 -2.194 -45.199 1.00 33.28 N \nANISOU 825 NE2 HIS A 103 2954 2963 6730 -341 -274 -362 N \nATOM 826 N LEU A 104 15.306 -1.573 -49.566 1.00 39.07 N \nANISOU 826 N LEU A 104 3561 3750 7535 -269 -183 -505 N \nATOM 827 CA LEU A 104 16.138 -2.733 -49.714 1.00 45.13 C \nANISOU 827 CA LEU A 104 4297 4510 8341 -241 -228 -531 C \nATOM 828 C LEU A 104 17.570 -2.494 -49.213 1.00 52.71 C \nANISOU 828 C LEU A 104 5220 5491 9316 -244 -242 -552 C \nATOM 829 O LEU A 104 18.189 -3.389 -48.619 1.00 54.75 O \nANISOU 829 O LEU A 104 5464 5740 9599 -223 -292 -558 O \nATOM 830 CB LEU A 104 16.143 -3.040 -51.191 1.00 46.51 C \nANISOU 830 CB LEU A 104 4451 4696 8524 -216 -205 -560 C \nATOM 831 CG LEU A 104 16.905 -4.248 -51.647 1.00 50.41 C \nANISOU 831 CG LEU A 104 4917 5183 9054 -176 -242 -593 C \nATOM 832 CD1 LEU A 104 16.356 -5.510 -51.041 1.00 50.33 C \nANISOU 832 CD1 LEU A 104 4940 5128 9055 -163 -296 -576 C \nATOM 833 CD2 LEU A 104 16.823 -4.288 -53.167 1.00 52.08 C \nANISOU 833 CD2 LEU A 104 5110 5412 9266 -158 -208 -622 C \nATOM 834 N LEU A 105 18.069 -1.270 -49.390 1.00 54.01 N \nANISOU 834 N LEU A 105 5374 5686 9460 -272 -198 -562 N \nATOM 835 CA LEU A 105 19.364 -0.890 -48.813 1.00 55.08 C \nANISOU 835 CA LEU A 105 5476 5853 9598 -290 -208 -578 C \nATOM 836 C LEU A 105 19.396 -0.751 -47.342 1.00 57.60 C \nANISOU 836 C LEU A 105 5815 6161 9910 -315 -236 -551 C \nATOM 837 O LEU A 105 20.232 -0.007 -46.804 1.00 73.55 O \nANISOU 837 O LEU A 105 7820 8209 11915 -349 -228 -557 O \nATOM 838 CB LEU A 105 19.815 0.457 -49.329 1.00 52.18 C \nANISOU 838 CB LEU A 105 5106 5520 9202 -328 -152 -592 C \nATOM 839 CG LEU A 105 19.855 0.583 -50.865 1.00 55.53 C \nANISOU 839 CG LEU A 105 5511 5964 9626 -313 -113 -620 C \nATOM 840 CD1 LEU A 105 20.246 1.981 -51.199 1.00 56.67 C \nANISOU 840 CD1 LEU A 105 5665 6133 9733 -361 -60 -627 C \nATOM 841 CD2 LEU A 105 20.792 -0.402 -51.550 1.00 56.80 C \nANISOU 841 CD2 LEU A 105 5610 6154 9819 -272 -139 -659 C \nATOM 842 N SER A 106 18.515 -1.446 -46.668 1.00 55.02 N \nANISOU 842 N SER A 106 5522 5796 9589 -305 -270 -521 N \nATOM 843 CA SER A 106 18.383 -1.230 -45.254 1.00 56.99 C \nANISOU 843 CA SER A 106 5795 6033 9826 -333 -292 -492 C \nATOM 844 C SER A 106 18.650 -2.552 -44.645 1.00 54.76 C \nANISOU 844 C SER A 106 5502 5732 9572 -303 -357 -488 C \nATOM 845 O SER A 106 18.577 -2.709 -43.439 1.00 48.73 O \nANISOU 845 O SER A 106 4756 4955 8805 -319 -391 -463 O \nATOM 846 CB SER A 106 16.973 -0.770 -44.930 1.00 56.32 C \nANISOU 846 CB SER A 106 5764 5922 9711 -352 -271 -456 C \nATOM 847 OG SER A 106 16.052 -1.481 -45.716 1.00 60.13 O \nANISOU 847 OG SER A 106 6257 6388 10199 -325 -271 -452 O \nATOM 848 N ARG A 107 18.903 -3.521 -45.518 1.00 53.75 N \nANISOU 848 N ARG A 107 5353 5599 9472 -258 -375 -512 N \nATOM 849 CA ARG A 107 19.206 -4.846 -45.063 1.00 65.00 C \nANISOU 849 CA ARG A 107 6776 6998 10922 -219 -437 -511 C \nATOM 850 C ARG A 107 20.508 -5.231 -45.755 1.00 58.91 C \nANISOU 850 C ARG A 107 5948 6261 10173 -175 -446 -554 C \nATOM 851 O ARG A 107 21.011 -6.322 -45.629 1.00 56.89 O \nANISOU 851 O ARG A 107 5684 5992 9939 -127 -494 -564 O \nATOM 852 CB ARG A 107 18.023 -5.795 -45.418 1.00 73.17 C \nANISOU 852 CB ARG A 107 7857 7984 11960 -205 -453 -496 C \nATOM 853 CG ARG A 107 17.400 -6.522 -44.180 1.00 82.78 C \nANISOU 853 CG ARG A 107 9120 9160 13174 -219 -504 -457 C \nATOM 854 CD ARG A 107 18.498 -6.883 -43.131 1.00 90.52 C \nANISOU 854 CD ARG A 107 10080 10144 14168 -203 -553 -457 C \nATOM 855 NE ARG A 107 19.015 -8.260 -42.968 1.00 88.76 N \nANISOU 855 NE ARG A 107 9866 9889 13970 -151 -614 -464 N \nATOM 856 CZ ARG A 107 19.058 -9.218 -43.899 1.00 97.36 C \nANISOU 856 CZ ARG A 107 10964 10951 15075 -104 -627 -487 C \nATOM 857 NH1 ARG A 107 18.576 -9.044 -45.128 1.00 93.23 N \nANISOU 857 NH1 ARG A 107 10440 10434 14551 -104 -585 -506 N \nATOM 858 NH2 ARG A 107 19.582 -10.407 -43.580 1.00107.09 N \nANISOU 858 NH2 ARG A 107 12214 12150 16324 -54 -684 -491 N \nATOM 859 N ILE A 108 21.055 -4.259 -46.453 1.00 53.21 N \nANISOU 859 N ILE A 108 5189 5587 9440 -193 -398 -578 N \nATOM 860 CA ILE A 108 22.277 -4.422 -47.173 1.00 50.85 C \nANISOU 860 CA ILE A 108 4829 5339 9154 -159 -397 -621 C \nATOM 861 C ILE A 108 23.324 -3.572 -46.510 1.00 53.56 C \nANISOU 861 C ILE A 108 5131 5741 9480 -195 -391 -627 C \nATOM 862 O ILE A 108 23.000 -2.549 -45.922 1.00 52.39 O \nANISOU 862 O ILE A 108 5009 5593 9306 -254 -365 -605 O \nATOM 863 CB ILE A 108 22.189 -3.942 -48.595 1.00 45.27 C \nANISOU 863 CB ILE A 108 4106 4653 8441 -161 -345 -648 C \nATOM 864 CG1 ILE A 108 21.206 -4.821 -49.360 1.00 41.89 C \nANISOU 864 CG1 ILE A 108 3713 4175 8027 -127 -350 -646 C \nATOM 865 CG2 ILE A 108 23.579 -3.989 -49.234 1.00 47.31 C \nANISOU 865 CG2 ILE A 108 4292 4979 8706 -134 -342 -693 C \nATOM 866 CD1 ILE A 108 21.098 -4.496 -50.850 1.00 41.63 C \nANISOU 866 CD1 ILE A 108 3663 4162 7990 -122 -301 -674 C \nATOM 867 N ASN A 109 24.561 -4.048 -46.594 1.00 52.11 N \nANISOU 867 N ASN A 109 4886 5608 9307 -156 -417 -656 N \nATOM 868 CA ASN A 109 25.657 -3.511 -45.850 1.00 54.08 C \nANISOU 868 CA ASN A 109 5087 5922 9537 -184 -425 -662 C \nATOM 869 C ASN A 109 26.848 -3.153 -46.710 1.00 55.86 C \nANISOU 869 C ASN A 109 5238 6235 9753 -180 -401 -707 C \nATOM 870 O ASN A 109 27.674 -2.304 -46.311 1.00 63.78 O \nANISOU 870 O ASN A 109 6202 7304 10726 -232 -386 -714 O \nATOM 871 CB ASN A 109 26.135 -4.554 -44.879 1.00 60.08 C \nANISOU 871 CB ASN A 109 5835 6678 10314 -134 -492 -652 C \nATOM 872 CG ASN A 109 25.484 -4.453 -43.521 1.00 63.67 C \nANISOU 872 CG ASN A 109 6341 7087 10762 -171 -517 -608 C \nATOM 873 OD1 ASN A 109 25.327 -5.467 -42.806 1.00 71.56 O \nANISOU 873 OD1 ASN A 109 7364 8048 11778 -131 -572 -588 O \nATOM 874 ND2 ASN A 109 25.138 -3.247 -43.128 1.00 57.63 N \nANISOU 874 ND2 ASN A 109 5599 6328 9969 -247 -478 -591 N \nATOM 875 N HIS A 110 26.938 -3.825 -47.864 1.00 51.91 N \nANISOU 875 N HIS A 110 4715 5736 9271 -122 -397 -737 N \nATOM 876 CA HIS A 110 28.047 -3.661 -48.790 1.00 58.65 C \nANISOU 876 CA HIS A 110 5492 6675 10115 -108 -377 -782 C \nATOM 877 C HIS A 110 27.769 -4.185 -50.212 1.00 54.24 C \nANISOU 877 C HIS A 110 4932 6103 9575 -59 -357 -811 C \nATOM 878 O HIS A 110 27.101 -5.190 -50.398 1.00 47.31 O \nANISOU 878 O HIS A 110 4095 5158 8725 -4 -383 -805 O \nATOM 879 CB HIS A 110 29.317 -4.263 -48.208 1.00 66.69 C \nANISOU 879 CB HIS A 110 6442 7766 11134 -61 -423 -799 C \nATOM 880 CG HIS A 110 30.535 -4.042 -49.050 1.00 71.38 C \nANISOU 880 CG HIS A 110 6946 8468 11709 -50 -403 -847 C \nATOM 881 ND1 HIS A 110 31.508 -5.015 -49.212 1.00 75.44 N \nANISOU 881 ND1 HIS A 110 7393 9038 12231 38 -442 -877 N \nATOM 882 CD2 HIS A 110 30.951 -2.964 -49.757 1.00 69.97 C \nANISOU 882 CD2 HIS A 110 6732 8354 11499 -116 -350 -868 C \nATOM 883 CE1 HIS A 110 32.465 -4.546 -49.988 1.00 76.01 C \nANISOU 883 CE1 HIS A 110 7387 9215 12279 26 -412 -916 C \nATOM 884 NE2 HIS A 110 32.154 -3.305 -50.330 1.00 77.29 N \nANISOU 884 NE2 HIS A 110 7567 9382 12416 -72 -356 -912 N \nATOM 885 N PHE A 111 28.250 -3.433 -51.198 1.00 55.28 N \nANISOU 885 N PHE A 111 5022 6296 9687 -90 -309 -841 N \nATOM 886 CA PHE A 111 28.089 -3.727 -52.591 1.00 61.01 C \nANISOU 886 CA PHE A 111 5737 7020 10421 -57 -283 -871 C \nATOM 887 C PHE A 111 29.389 -4.134 -53.242 1.00 73.40 C \nANISOU 887 C PHE A 111 7218 8682 11988 -8 -290 -920 C \nATOM 888 O PHE A 111 30.465 -3.987 -52.666 1.00 89.25 O \nANISOU 888 O PHE A 111 9164 10769 13978 -12 -307 -932 O \nATOM 889 CB PHE A 111 27.679 -2.455 -53.306 1.00 69.28 C \nANISOU 889 CB PHE A 111 6805 8077 11443 -133 -218 -869 C \nATOM 890 CG PHE A 111 26.189 -2.201 -53.317 1.00 64.47 C \nANISOU 890 CG PHE A 111 6282 7378 10837 -157 -198 -832 C \nATOM 891 CD1 PHE A 111 25.299 -3.245 -53.228 1.00 65.93 C \nANISOU 891 CD1 PHE A 111 6509 7489 11050 -106 -230 -816 C \nATOM 892 CD2 PHE A 111 25.708 -0.915 -53.447 1.00 60.48 C \nANISOU 892 CD2 PHE A 111 5813 6866 10300 -229 -147 -815 C \nATOM 893 CE1 PHE A 111 23.953 -3.007 -53.248 1.00 68.32 C \nANISOU 893 CE1 PHE A 111 6881 7727 11350 -129 -212 -783 C \nATOM 894 CE2 PHE A 111 24.358 -0.663 -53.439 1.00 62.20 C \nANISOU 894 CE2 PHE A 111 6104 7014 10517 -243 -130 -781 C \nATOM 895 CZ PHE A 111 23.468 -1.710 -53.369 1.00 64.41 C \nANISOU 895 CZ PHE A 111 6416 7233 10825 -193 -161 -765 C \nATOM 896 N GLU A 112 29.293 -4.650 -54.461 1.00 73.60 N \nANISOU 896 N GLU A 112 7234 8705 12026 39 -275 -951 N \nATOM 897 CA GLU A 112 30.470 -4.796 -55.323 1.00 71.37 C \nANISOU 897 CA GLU A 112 6864 8523 11733 74 -266 -1002 C \nATOM 898 C GLU A 112 30.106 -4.504 -56.787 1.00 65.48 C \nANISOU 898 C GLU A 112 6120 7778 10983 60 -215 -1026 C \nATOM 899 O GLU A 112 29.545 -5.326 -57.494 1.00 63.54 O \nANISOU 899 O GLU A 112 5902 7478 10760 115 -221 -1037 O \nATOM 900 CB GLU A 112 31.144 -6.162 -55.155 1.00 72.80 C \nANISOU 900 CB GLU A 112 7010 8717 11934 185 -321 -1025 C \nATOM 901 CG GLU A 112 32.539 -6.217 -55.785 1.00 85.59 C \nANISOU 901 CG GLU A 112 8524 10464 13532 222 -315 -1077 C \nATOM 902 CD GLU A 112 33.235 -7.574 -55.653 1.00 87.10 C \nANISOU 902 CD GLU A 112 8682 10672 13739 347 -370 -1102 C \nATOM 903 OE1 GLU A 112 32.845 -8.359 -54.776 1.00 98.71 O \nANISOU 903 OE1 GLU A 112 10206 12066 15232 394 -418 -1075 O \nATOM 904 OE2 GLU A 112 34.173 -7.845 -56.426 1.00 81.47 O \nANISOU 904 OE2 GLU A 112 7892 10051 13013 400 -364 -1150 O \nATOM 905 N LYS A 113 30.373 -3.275 -57.184 1.00 62.54 N \nANISOU 905 N LYS A 113 5725 7461 10575 -22 -165 -1032 N \nATOM 906 CA LYS A 113 30.124 -2.787 -58.532 1.00 61.71 C \nANISOU 906 CA LYS A 113 5620 7370 10459 -49 -113 -1052 C \nATOM 907 C LYS A 113 30.845 -3.656 -59.566 1.00 64.66 C \nANISOU 907 C LYS A 113 5927 7800 10841 27 -119 -1104 C \nATOM 908 O LYS A 113 32.038 -3.788 -59.536 1.00 66.74 O \nANISOU 908 O LYS A 113 6109 8160 11088 50 -131 -1136 O \nATOM 909 CB LYS A 113 30.605 -1.361 -58.599 1.00 59.59 C \nANISOU 909 CB LYS A 113 5331 7166 10143 -150 -67 -1052 C \nATOM 910 CG LYS A 113 30.293 -0.591 -59.854 1.00 62.14 C \nANISOU 910 CG LYS A 113 5667 7497 10444 -198 -9 -1063 C \nATOM 911 CD LYS A 113 31.175 0.665 -59.791 1.00 71.61 C \nANISOU 911 CD LYS A 113 6834 8784 11591 -294 26 -1072 C \nATOM 912 CE LYS A 113 30.803 1.756 -60.765 1.00 71.75 C \nANISOU 912 CE LYS A 113 6888 8798 11575 -367 87 -1070 C \nATOM 913 NZ LYS A 113 29.745 2.542 -60.116 1.00 75.41 N \nANISOU 913 NZ LYS A 113 7451 9170 12033 -415 102 -1021 N \nATOM 914 N ILE A 114 30.071 -4.284 -60.440 1.00 73.59 N \nANISOU 914 N ILE A 114 7095 8870 11995 70 -113 -1111 N \nATOM 915 CA ILE A 114 30.581 -5.203 -61.452 1.00 73.58 C \nANISOU 915 CA ILE A 114 7048 8905 12004 149 -119 -1160 C \nATOM 916 C ILE A 114 30.246 -4.701 -62.833 1.00 76.16 C \nANISOU 916 C ILE A 114 7374 9246 12318 114 -65 -1179 C \nATOM 917 O ILE A 114 29.067 -4.314 -63.098 1.00 77.02 O \nANISOU 917 O ILE A 114 7554 9280 12430 72 -39 -1148 O \nATOM 918 CB ILE A 114 29.886 -6.589 -61.377 1.00 85.37 C \nANISOU 918 CB ILE A 114 8599 10303 13537 235 -161 -1156 C \nATOM 919 CG1 ILE A 114 30.383 -7.370 -60.176 1.00 90.48 C \nANISOU 919 CG1 ILE A 114 9241 10941 14198 296 -221 -1147 C \nATOM 920 CG2 ILE A 114 30.177 -7.403 -62.639 1.00 86.45 C \nANISOU 920 CG2 ILE A 114 8707 10460 13679 306 -155 -1206 C \nATOM 921 CD1 ILE A 114 29.729 -8.729 -60.066 1.00 88.91 C \nANISOU 921 CD1 ILE A 114 9110 10641 14030 375 -265 -1142 C \nATOM 922 N GLN A 115 31.212 -4.796 -63.744 1.00 70.34 N \nANISOU 922 N GLN A 115 6559 8603 11564 138 -48 -1229 N \nATOM 923 CA GLN A 115 30.886 -4.549 -65.155 1.00 69.84 C \nANISOU 923 CA GLN A 115 6495 8549 11492 119 -2 -1252 C \nATOM 924 C GLN A 115 30.113 -5.732 -65.751 1.00 70.34 C \nANISOU 924 C GLN A 115 6605 8532 11588 195 -19 -1262 C \nATOM 925 O GLN A 115 30.576 -6.863 -65.715 1.00 69.79 O \nANISOU 925 O GLN A 115 6516 8465 11537 286 -57 -1290 O \nATOM 926 CB GLN A 115 32.105 -4.290 -65.961 1.00 67.21 C \nANISOU 926 CB GLN A 115 6066 8343 11128 117 22 -1302 C \nATOM 927 CG GLN A 115 31.797 -3.596 -67.264 1.00 69.55 C \nANISOU 927 CG GLN A 115 6365 8660 11403 62 78 -1315 C \nATOM 928 CD GLN A 115 33.028 -3.424 -68.126 1.00 67.72 C \nANISOU 928 CD GLN A 115 6033 8562 11137 61 101 -1369 C \nATOM 929 OE1 GLN A 115 33.846 -4.336 -68.205 1.00 75.43 O \nANISOU 929 OE1 GLN A 115 6946 9595 12120 146 72 -1410 O \nATOM 930 NE2 GLN A 115 33.175 -2.251 -68.744 1.00 61.37 N \nANISOU 930 NE2 GLN A 115 5215 7809 10292 -35 152 -1370 N \nATOM 931 N ILE A 116 28.921 -5.458 -66.275 1.00 72.32 N \nANISOU 931 N ILE A 116 6923 8714 11844 157 8 -1237 N \nATOM 932 CA ILE A 116 27.945 -6.493 -66.592 1.00 67.44 C \nANISOU 932 CA ILE A 116 6366 8004 11252 208 -11 -1232 C \nATOM 933 C ILE A 116 27.811 -6.675 -68.094 1.00 65.60 C \nANISOU 933 C ILE A 116 6121 7793 11013 218 24 -1269 C \nATOM 934 O ILE A 116 27.598 -7.794 -68.587 1.00 65.52 O \nANISOU 934 O ILE A 116 6130 7744 11021 284 5 -1293 O \nATOM 935 CB ILE A 116 26.594 -6.183 -65.879 1.00 70.09 C \nANISOU 935 CB ILE A 116 6790 8247 11596 160 -14 -1172 C \nATOM 936 CG1 ILE A 116 25.973 -7.452 -65.354 1.00 72.44 C \nANISOU 936 CG1 ILE A 116 7146 8457 11922 219 -63 -1160 C \nATOM 937 CG2 ILE A 116 25.615 -5.336 -66.699 1.00 67.51 C \nANISOU 937 CG2 ILE A 116 6497 7904 11250 97 37 -1152 C \nATOM 938 CD1 ILE A 116 26.731 -7.969 -64.158 1.00 71.30 C \nANISOU 938 CD1 ILE A 116 6985 8314 11790 264 -114 -1158 C \nATOM 939 N ILE A 117 27.899 -5.566 -68.819 1.00 62.30 N \nANISOU 939 N ILE A 117 5675 7430 10566 150 75 -1271 N \nATOM 940 CA ILE A 117 28.041 -5.562 -70.279 1.00 66.78 C \nANISOU 940 CA ILE A 117 6210 8043 11119 153 113 -1310 C \nATOM 941 C ILE A 117 28.838 -4.307 -70.665 1.00 78.62 C \nANISOU 941 C ILE A 117 7651 9641 12580 82 157 -1322 C \nATOM 942 O ILE A 117 28.317 -3.176 -70.598 1.00 85.19 O \nANISOU 942 O ILE A 117 8518 10459 13390 2 189 -1285 O \nATOM 943 CB ILE A 117 26.696 -5.625 -71.061 1.00 61.46 C \nANISOU 943 CB ILE A 117 5602 7300 10448 133 136 -1291 C \nATOM 944 CG1 ILE A 117 25.601 -4.835 -70.378 1.00 62.49 C \nANISOU 944 CG1 ILE A 117 5801 7369 10573 72 145 -1228 C \nATOM 945 CG2 ILE A 117 26.235 -7.068 -71.186 1.00 61.72 C \nANISOU 945 CG2 ILE A 117 5673 7266 10510 208 99 -1306 C \nATOM 946 CD1 ILE A 117 24.262 -4.834 -71.086 1.00 60.78 C \nANISOU 946 CD1 ILE A 117 5642 7100 10353 52 168 -1205 C \nATOM 947 N PRO A 118 30.107 -4.511 -71.074 1.00 85.28 N \nANISOU 947 N PRO A 118 8407 10584 13410 111 157 -1373 N \nATOM 948 CA PRO A 118 31.057 -3.439 -71.346 1.00 80.21 C \nANISOU 948 CA PRO A 118 7699 10050 12725 43 192 -1389 C \nATOM 949 C PRO A 118 30.577 -2.422 -72.369 1.00 78.19 C \nANISOU 949 C PRO A 118 7466 9804 12439 -37 249 -1380 C \nATOM 950 O PRO A 118 29.857 -2.763 -73.311 1.00 90.78 O \nANISOU 950 O PRO A 118 9089 11361 14043 -19 265 -1386 O \nATOM 951 CB PRO A 118 32.280 -4.184 -71.888 1.00 82.27 C \nANISOU 951 CB PRO A 118 7866 10413 12979 112 181 -1453 C \nATOM 952 CG PRO A 118 32.171 -5.561 -71.342 1.00 80.41 C \nANISOU 952 CG PRO A 118 7650 10118 12785 221 127 -1460 C \nATOM 953 CD PRO A 118 30.705 -5.845 -71.318 1.00 82.31 C \nANISOU 953 CD PRO A 118 7993 10226 13054 217 123 -1421 C \nATOM 954 N LYS A 119 31.014 -1.188 -72.173 1.00 73.71 N \nANISOU 954 N LYS A 119 6886 9288 11832 -127 278 -1366 N \nATOM 955 CA LYS A 119 30.609 -0.027 -72.954 1.00 72.76 C \nANISOU 955 CA LYS A 119 6799 9172 11675 -214 332 -1349 C \nATOM 956 C LYS A 119 31.208 -0.088 -74.337 1.00 74.88 C \nANISOU 956 C LYS A 119 7004 9527 11920 -215 362 -1399 C \nATOM 957 O LYS A 119 30.698 0.521 -75.291 1.00 83.96 O \nANISOU 957 O LYS A 119 8184 10669 13048 -262 404 -1391 O \nATOM 958 CB LYS A 119 31.063 1.259 -72.234 1.00 72.11 C \nANISOU 958 CB LYS A 119 6727 9121 11552 -310 349 -1323 C \nATOM 959 CG LYS A 119 30.596 2.565 -72.854 1.00 76.56 C \nANISOU 959 CG LYS A 119 7347 9670 12071 -403 403 -1298 C \nATOM 960 CD LYS A 119 31.347 3.761 -72.252 1.00 79.50 C \nANISOU 960 CD LYS A 119 7719 10093 12392 -503 420 -1286 C \nATOM 961 CE LYS A 119 30.898 5.086 -72.868 1.00 81.55 C \nANISOU 961 CE LYS A 119 8050 10331 12604 -595 474 -1260 C \nATOM 962 NZ LYS A 119 29.695 5.606 -72.168 1.00 93.01 N \nANISOU 962 NZ LYS A 119 9612 11665 14063 -603 476 -1200 N \nATOM 963 N SER A 120 32.303 -0.825 -74.451 1.00 78.87 N \nANISOU 963 N SER A 120 7420 10121 12427 -161 342 -1450 N \nATOM 964 CA SER A 120 33.018 -0.967 -75.724 1.00 73.77 C \nANISOU 964 CA SER A 120 6699 9574 11756 -154 369 -1504 C \nATOM 965 C SER A 120 32.458 -2.145 -76.567 1.00 70.95 C \nANISOU 965 C SER A 120 6353 9171 11435 -63 359 -1531 C \nATOM 966 O SER A 120 32.848 -2.329 -77.711 1.00 79.61 O \nANISOU 966 O SER A 120 7400 10333 12514 -53 383 -1574 O \nATOM 967 CB SER A 120 34.504 -1.110 -75.439 1.00 69.62 C \nANISOU 967 CB SER A 120 6068 9180 11206 -141 354 -1548 C \nATOM 968 OG SER A 120 34.705 -1.907 -74.281 1.00 73.20 O \nANISOU 968 OG SER A 120 6514 9607 11692 -66 301 -1543 O \nATOM 969 N SER A 121 31.494 -2.888 -76.036 1.00 62.73 N \nANISOU 969 N SER A 121 5381 8015 10438 -8 327 -1503 N \nATOM 970 CA SER A 121 30.831 -3.941 -76.807 1.00 65.36 C \nANISOU 970 CA SER A 121 5742 8293 10799 62 320 -1523 C \nATOM 971 C SER A 121 29.854 -3.399 -77.844 1.00 61.08 C \nANISOU 971 C SER A 121 5247 7717 10243 8 364 -1505 C \nATOM 972 O SER A 121 29.595 -4.044 -78.835 1.00 70.96 O \nANISOU 972 O SER A 121 6496 8965 11500 45 372 -1534 O \nATOM 973 CB SER A 121 30.073 -4.865 -75.877 1.00 66.20 C \nANISOU 973 CB SER A 121 5914 8290 10950 124 272 -1496 C \nATOM 974 OG SER A 121 28.855 -4.242 -75.528 1.00 77.55 O \nANISOU 974 OG SER A 121 7434 9641 12391 66 283 -1436 O \nATOM 975 N TRP A 122 29.306 -2.217 -77.610 1.00 63.73 N \nANISOU 975 N TRP A 122 5629 8027 10557 -77 390 -1456 N \nATOM 976 CA TRP A 122 28.284 -1.609 -78.495 1.00 66.18 C \nANISOU 976 CA TRP A 122 5993 8301 10850 -125 430 -1429 C \nATOM 977 C TRP A 122 28.974 -1.130 -79.768 1.00 70.67 C \nANISOU 977 C TRP A 122 6504 8967 11380 -164 473 -1468 C \nATOM 978 O TRP A 122 29.221 0.067 -79.979 1.00 80.89 O \nANISOU 978 O TRP A 122 7800 10302 12633 -247 510 -1453 O \nATOM 979 CB TRP A 122 27.521 -0.447 -77.784 1.00 65.17 C \nANISOU 979 CB TRP A 122 5938 8116 10706 -195 445 -1364 C \nATOM 980 CG TRP A 122 26.915 -0.830 -76.443 1.00 57.49 C \nANISOU 980 CG TRP A 122 5017 7058 9767 -164 404 -1325 C \nATOM 981 CD1 TRP A 122 27.310 -0.415 -75.238 1.00 57.99 C \nANISOU 981 CD1 TRP A 122 5086 7118 9831 -185 385 -1303 C \nATOM 982 CD2 TRP A 122 25.865 -1.762 -76.224 1.00 54.09 C \nANISOU 982 CD2 TRP A 122 4636 6544 9372 -110 376 -1307 C \nATOM 983 NE1 TRP A 122 26.583 -1.031 -74.257 1.00 57.28 N \nANISOU 983 NE1 TRP A 122 5044 6946 9776 -144 346 -1273 N \nATOM 984 CE2 TRP A 122 25.692 -1.879 -74.848 1.00 52.15 C \nANISOU 984 CE2 TRP A 122 4422 6246 9147 -99 339 -1274 C \nATOM 985 CE3 TRP A 122 25.085 -2.547 -77.070 1.00 56.64 C \nANISOU 985 CE3 TRP A 122 4980 6835 9708 -75 377 -1317 C \nATOM 986 CZ2 TRP A 122 24.727 -2.707 -74.275 1.00 53.09 C \nANISOU 986 CZ2 TRP A 122 4594 6282 9297 -58 305 -1249 C \nATOM 987 CZ3 TRP A 122 24.118 -3.383 -76.497 1.00 56.12 C \nANISOU 987 CZ3 TRP A 122 4967 6685 9670 -36 342 -1292 C \nATOM 988 CH2 TRP A 122 23.949 -3.435 -75.109 1.00 55.26 C \nANISOU 988 CH2 TRP A 122 4890 6525 9579 -29 307 -1258 C \nATOM 989 N SER A 123 29.259 -2.088 -80.634 1.00 72.74 N \nANISOU 989 N SER A 123 6722 9263 11653 -104 470 -1519 N \nATOM 990 CA SER A 123 29.950 -1.843 -81.905 1.00 80.01 C \nANISOU 990 CA SER A 123 7579 10281 12538 -129 507 -1565 C \nATOM 991 C SER A 123 29.095 -1.161 -82.965 1.00 88.82 C \nANISOU 991 C SER A 123 8739 11380 13629 -186 552 -1543 C \nATOM 992 O SER A 123 29.625 -0.433 -83.803 1.00 99.52 O \nANISOU 992 O SER A 123 10058 12813 14942 -244 590 -1560 O \nATOM 993 CB SER A 123 30.439 -3.167 -82.467 1.00 81.84 C \nANISOU 993 CB SER A 123 7759 10547 12791 -36 487 -1627 C \nATOM 994 OG SER A 123 30.833 -3.996 -81.397 1.00 92.97 O \nANISOU 994 OG SER A 123 9158 11934 14233 37 438 -1635 O \nATOM 995 N ASP A 124 27.781 -1.401 -82.940 1.00 93.21 N \nANISOU 995 N ASP A 124 9371 11838 14207 -171 546 -1504 N \nATOM 996 CA ASP A 124 26.894 -0.933 -84.013 1.00 90.10 C \nANISOU 996 CA ASP A 124 9015 11430 13789 -210 585 -1485 C \nATOM 997 C ASP A 124 26.054 0.267 -83.586 1.00 86.91 C \nANISOU 997 C ASP A 124 8685 10973 13363 -273 604 -1417 C \nATOM 998 O ASP A 124 25.223 0.778 -84.364 1.00 83.48 O \nANISOU 998 O ASP A 124 8291 10523 12905 -304 636 -1391 O \nATOM 999 CB ASP A 124 25.999 -2.085 -84.484 1.00 90.61 C \nANISOU 999 CB ASP A 124 9106 11439 13883 -149 568 -1494 C \nATOM 1000 CG ASP A 124 26.796 -3.356 -84.772 1.00 97.37 C \nANISOU 1000 CG ASP A 124 9905 12330 14762 -73 544 -1561 C \nATOM 1001 OD1 ASP A 124 27.818 -3.264 -85.485 1.00102.63 O \nANISOU 1001 OD1 ASP A 124 10500 13090 15406 -78 563 -1610 O \nATOM 1002 OD2 ASP A 124 26.424 -4.434 -84.270 1.00 95.48 O \nANISOU 1002 OD2 ASP A 124 9693 12026 14558 -9 505 -1565 O \nATOM 1003 N HIS A 125 26.263 0.719 -82.353 1.00 75.71 N \nANISOU 1003 N HIS A 125 7288 9530 11950 -290 586 -1388 N \nATOM 1004 CA HIS A 125 25.539 1.869 -81.863 1.00 73.12 C \nANISOU 1004 CA HIS A 125 7033 9150 11597 -344 605 -1326 C \nATOM 1005 C HIS A 125 26.543 2.862 -81.311 1.00 73.17 C \nANISOU 1005 C HIS A 125 7025 9203 11572 -409 616 -1325 C \nATOM 1006 O HIS A 125 27.646 2.506 -80.885 1.00 69.97 O \nANISOU 1006 O HIS A 125 6555 8855 11175 -399 596 -1362 O \nATOM 1007 CB HIS A 125 24.565 1.483 -80.754 1.00 71.18 C \nANISOU 1007 CB HIS A 125 6847 8812 11386 -306 570 -1283 C \nATOM 1008 CG HIS A 125 23.606 0.398 -81.126 1.00 67.26 C \nANISOU 1008 CG HIS A 125 6367 8271 10919 -248 552 -1284 C \nATOM 1009 ND1 HIS A 125 23.968 -0.935 -81.163 1.00 61.50 N \nANISOU 1009 ND1 HIS A 125 5596 7546 10226 -185 519 -1329 N \nATOM 1010 CD2 HIS A 125 22.279 0.446 -81.411 1.00 69.94 C \nANISOU 1010 CD2 HIS A 125 6762 8560 11251 -245 562 -1245 C \nATOM 1011 CE1 HIS A 125 22.914 -1.651 -81.521 1.00 69.89 C \nANISOU 1011 CE1 HIS A 125 6694 8560 11301 -154 510 -1319 C \nATOM 1012 NE2 HIS A 125 21.871 -0.843 -81.662 1.00 70.44 N \nANISOU 1012 NE2 HIS A 125 6818 8602 11346 -191 535 -1268 N \nATOM 1013 N GLU A 126 26.148 4.120 -81.322 1.00 71.70 N \nANISOU 1013 N GLU A 126 6904 8994 11345 -475 649 -1282 N \nATOM 1014 CA GLU A 126 27.001 5.173 -80.832 1.00 70.90 C \nANISOU 1014 CA GLU A 126 6806 8929 11205 -551 664 -1276 C \nATOM 1015 C GLU A 126 26.782 5.375 -79.329 1.00 74.15 C \nANISOU 1015 C GLU A 126 7264 9277 11633 -548 636 -1238 C \nATOM 1016 O GLU A 126 25.880 6.091 -78.922 1.00 78.04 O \nANISOU 1016 O GLU A 126 7842 9696 12111 -564 647 -1186 O \nATOM 1017 CB GLU A 126 26.732 6.472 -81.591 1.00 68.36 C \nANISOU 1017 CB GLU A 126 6543 8606 10823 -627 715 -1249 C \nATOM 1018 CG GLU A 126 27.807 7.513 -81.379 1.00 74.35 C \nANISOU 1018 CG GLU A 126 7299 9422 11530 -721 736 -1256 C \nATOM 1019 CD GLU A 126 29.164 6.972 -81.770 1.00 76.82 C \nANISOU 1019 CD GLU A 126 7497 9850 11839 -729 729 -1320 C \nATOM 1020 OE1 GLU A 126 29.968 6.817 -80.832 1.00 87.42 O \nANISOU 1020 OE1 GLU A 126 8800 11226 13190 -735 704 -1335 O \nATOM 1021 OE2 GLU A 126 29.399 6.668 -82.981 1.00 73.42 O \nANISOU 1021 OE2 GLU A 126 7017 9482 11399 -725 748 -1356 O \nATOM 1022 N ALA A 127 27.660 4.778 -78.523 1.00 82.80 N \nANISOU 1022 N ALA A 127 8300 10407 12753 -526 601 -1266 N \nATOM 1023 CA ALA A 127 27.585 4.853 -77.060 1.00 86.86 C \nANISOU 1023 CA ALA A 127 8846 10872 13285 -522 571 -1237 C \nATOM 1024 C ALA A 127 28.043 6.203 -76.501 1.00 89.41 C \nANISOU 1024 C ALA A 127 9210 11204 13557 -615 594 -1213 C \nATOM 1025 O ALA A 127 27.348 6.834 -75.705 1.00 81.18 O \nANISOU 1025 O ALA A 127 8251 10087 12508 -632 595 -1164 O \nATOM 1026 CB ALA A 127 28.392 3.714 -76.429 1.00 80.60 C \nANISOU 1026 CB ALA A 127 7973 10117 12532 -462 524 -1275 C \nATOM 1027 N SER A 128 29.213 6.645 -76.951 1.00110.04 N \nANISOU 1027 N SER A 128 11768 13913 16129 -678 614 -1248 N \nATOM 1028 CA SER A 128 29.898 7.814 -76.369 1.00116.37 C \nANISOU 1028 CA SER A 128 12597 14741 16878 -777 631 -1235 C \nATOM 1029 C SER A 128 29.135 9.145 -76.476 1.00110.26 C \nANISOU 1029 C SER A 128 11943 13894 16056 -844 671 -1185 C \nATOM 1030 O SER A 128 29.442 10.093 -75.727 1.00100.42 O \nANISOU 1030 O SER A 128 10749 12634 14770 -917 681 -1163 O \nATOM 1031 CB SER A 128 31.269 7.973 -77.023 1.00119.22 C \nANISOU 1031 CB SER A 128 12869 15233 17197 -836 648 -1286 C \nATOM 1032 OG SER A 128 31.124 8.283 -78.399 1.00120.95 O \nANISOU 1032 OG SER A 128 13092 15478 17386 -862 687 -1298 O \nATOM 1033 N SER A 129 28.154 9.208 -77.385 1.00 98.09 N \nANISOU 1033 N SER A 129 10448 12306 14515 -816 694 -1166 N \nATOM 1034 CA SER A 129 27.306 10.398 -77.521 1.00 97.01 C \nANISOU 1034 CA SER A 129 10431 12095 14335 -858 730 -1115 C \nATOM 1035 C SER A 129 26.138 10.360 -76.535 1.00 91.46 C \nANISOU 1035 C SER A 129 9803 11286 13660 -802 711 -1065 C \nATOM 1036 O SER A 129 25.219 11.175 -76.598 1.00 73.18 O \nANISOU 1036 O SER A 129 7588 8902 11316 -808 736 -1020 O \nATOM 1037 CB SER A 129 26.786 10.548 -78.939 1.00104.37 C \nANISOU 1037 CB SER A 129 11377 13032 15247 -853 764 -1115 C \nATOM 1038 OG SER A 129 25.595 11.314 -78.945 1.00113.76 O \nANISOU 1038 OG SER A 129 12679 14131 16413 -845 786 -1059 O \nATOM 1039 N GLY A 130 26.180 9.397 -75.628 1.00 91.36 N \nANISOU 1039 N GLY A 130 9744 11267 13703 -745 666 -1074 N \nATOM 1040 CA GLY A 130 25.214 9.337 -74.568 1.00 87.03 C \nANISOU 1040 CA GLY A 130 9257 10631 13178 -702 644 -1030 C \nATOM 1041 C GLY A 130 25.418 10.444 -73.569 1.00 78.69 C \nANISOU 1041 C GLY A 130 8275 9540 12082 -767 654 -1001 C \nATOM 1042 O GLY A 130 25.703 10.165 -72.405 1.00 75.64 O \nANISOU 1042 O GLY A 130 7876 9144 11719 -761 622 -999 O \nATOM 1043 N VAL A 131 25.235 11.690 -74.023 1.00 71.60 N \nANISOU 1043 N VAL A 131 7463 8618 11123 -827 698 -977 N \nATOM 1044 CA VAL A 131 25.625 12.874 -73.244 1.00 65.95 C \nANISOU 1044 CA VAL A 131 6828 7877 10355 -909 715 -956 C \nATOM 1045 C VAL A 131 24.596 13.997 -73.399 1.00 61.88 C \nANISOU 1045 C VAL A 131 6446 7274 9791 -915 752 -905 C \nATOM 1046 O VAL A 131 23.927 14.099 -74.427 1.00 56.66 O \nANISOU 1046 O VAL A 131 5808 6602 9119 -886 776 -894 O \nATOM 1047 CB VAL A 131 27.025 13.349 -73.695 1.00 66.10 C \nANISOU 1047 CB VAL A 131 6803 7985 10328 -1009 734 -995 C \nATOM 1048 CG1 VAL A 131 27.271 14.824 -73.347 1.00 73.34 C \nANISOU 1048 CG1 VAL A 131 7832 8866 11168 -1111 769 -970 C \nATOM 1049 CG2 VAL A 131 28.096 12.467 -73.079 1.00 61.14 C \nANISOU 1049 CG2 VAL A 131 6060 7437 9735 -1007 695 -1037 C \nATOM 1050 N SER A 132 24.473 14.844 -72.390 1.00 62.28 N \nANISOU 1050 N SER A 132 6587 7265 9810 -949 758 -875 N \nATOM 1051 CA SER A 132 23.545 15.978 -72.468 1.00 77.03 C \nANISOU 1051 CA SER A 132 8594 9048 11626 -950 793 -827 C \nATOM 1052 C SER A 132 23.908 17.117 -71.511 1.00 77.12 C \nANISOU 1052 C SER A 132 8707 9012 11581 -1027 808 -808 C \nATOM 1053 O SER A 132 24.558 16.915 -70.493 1.00 62.42 O \nANISOU 1053 O SER A 132 6813 7167 9735 -1058 782 -822 O \nATOM 1054 CB SER A 132 22.101 15.496 -72.191 1.00 87.12 C \nANISOU 1054 CB SER A 132 9894 10266 12940 -840 778 -790 C \nATOM 1055 OG SER A 132 21.168 16.575 -72.188 1.00 93.84 O \nANISOU 1055 OG SER A 132 10878 11040 13738 -826 811 -742 O \nATOM 1056 N SER A 133 23.428 18.307 -71.851 1.00 93.04 N \nANISOU 1056 N SER A 133 10855 10965 13532 -1052 849 -775 N \nATOM 1057 CA SER A 133 23.672 19.538 -71.066 1.00 93.25 C \nANISOU 1057 CA SER A 133 11008 10931 13493 -1127 870 -754 C \nATOM 1058 C SER A 133 22.888 19.525 -69.757 1.00 89.94 C \nANISOU 1058 C SER A 133 10640 10440 13094 -1068 850 -722 C \nATOM 1059 O SER A 133 23.273 20.183 -68.793 1.00 79.48 O \nANISOU 1059 O SER A 133 9383 9080 11735 -1127 852 -716 O \nATOM 1060 CB SER A 133 23.257 20.781 -71.865 1.00 93.82 C \nANISOU 1060 CB SER A 133 11218 10943 13485 -1155 920 -725 C \nATOM 1061 OG SER A 133 23.451 20.591 -73.257 1.00106.53 O \nANISOU 1061 OG SER A 133 12778 12609 15090 -1164 938 -743 O \nATOM 1062 N ALA A 134 21.769 18.792 -69.737 1.00 95.63 N \nANISOU 1062 N ALA A 134 11331 11140 13864 -954 831 -702 N \nATOM 1063 CA ALA A 134 20.951 18.643 -68.518 1.00 86.44 C \nANISOU 1063 CA ALA A 134 10201 9919 12723 -890 809 -672 C \nATOM 1064 C ALA A 134 21.764 17.998 -67.389 1.00 77.21 C \nANISOU 1064 C ALA A 134 8955 8785 11597 -923 768 -697 C \nATOM 1065 O ALA A 134 21.497 18.219 -66.203 1.00 70.52 O \nANISOU 1065 O ALA A 134 8157 7891 10748 -916 755 -678 O \nATOM 1066 CB ALA A 134 19.710 17.831 -68.814 1.00 75.39 C \nANISOU 1066 CB ALA A 134 8761 8515 11368 -774 794 -652 C \nATOM 1067 N CYS A 135 22.763 17.213 -67.782 1.00 79.24 N \nANISOU 1067 N CYS A 135 9091 9128 11889 -956 748 -741 N \nATOM 1068 CA CYS A 135 23.657 16.537 -66.848 1.00 88.59 C \nANISOU 1068 CA CYS A 135 10189 10361 13111 -985 708 -769 C \nATOM 1069 C CYS A 135 25.095 17.069 -66.961 1.00 92.71 C \nANISOU 1069 C CYS A 135 10691 10945 13588 -1104 721 -802 C \nATOM 1070 O CYS A 135 25.922 16.517 -67.681 1.00 90.21 O \nANISOU 1070 O CYS A 135 10273 10715 13287 -1126 715 -841 O \nATOM 1071 CB CYS A 135 23.643 15.017 -67.110 1.00 85.79 C \nANISOU 1071 CB CYS A 135 9698 10064 12836 -910 667 -794 C \nATOM 1072 SG CYS A 135 24.005 13.959 -65.694 1.00103.82 S \nANISOU 1072 SG CYS A 135 11900 12367 15181 -882 607 -805 S \nATOM 1073 N PRO A 136 25.404 18.132 -66.220 1.00102.37 N \nANISOU 1073 N PRO A 136 12014 12130 14754 -1184 739 -789 N \nATOM 1074 CA PRO A 136 26.760 18.632 -66.186 1.00109.90 C \nANISOU 1074 CA PRO A 136 12949 13148 15659 -1307 749 -819 C \nATOM 1075 C PRO A 136 27.689 17.732 -65.376 1.00109.56 C \nANISOU 1075 C PRO A 136 12781 13188 15660 -1319 703 -851 C \nATOM 1076 O PRO A 136 27.234 16.896 -64.601 1.00123.73 O \nANISOU 1076 O PRO A 136 14531 14966 17515 -1240 665 -842 O \nATOM 1077 CB PRO A 136 26.609 20.010 -65.517 1.00116.42 C \nANISOU 1077 CB PRO A 136 13936 13890 16410 -1379 780 -789 C \nATOM 1078 CG PRO A 136 25.147 20.326 -65.574 1.00117.29 C \nANISOU 1078 CG PRO A 136 14150 13893 16521 -1285 796 -744 C \nATOM 1079 CD PRO A 136 24.493 18.992 -65.450 1.00115.07 C \nANISOU 1079 CD PRO A 136 13761 13631 16328 -1166 755 -744 C \nATOM 1080 N TYR A 137 28.984 17.926 -65.567 1.00110.05 N \nANISOU 1080 N TYR A 137 12787 13343 15685 -1420 708 -886 N \nATOM 1081 CA TYR A 137 30.025 17.215 -64.834 1.00110.16 C \nANISOU 1081 CA TYR A 137 12682 13452 15723 -1442 668 -918 C \nATOM 1082 C TYR A 137 30.984 18.229 -64.233 1.00116.15 C \nANISOU 1082 C TYR A 137 13489 14240 16404 -1583 685 -925 C \nATOM 1083 O TYR A 137 30.966 18.521 -63.031 1.00121.73 O \nANISOU 1083 O TYR A 137 14242 14909 17100 -1608 671 -908 O \nATOM 1084 CB TYR A 137 30.799 16.270 -65.769 1.00103.23 C \nANISOU 1084 CB TYR A 137 11655 12693 14876 -1421 654 -964 C \nATOM 1085 CG TYR A 137 32.186 15.851 -65.283 1.00 93.84 C \nANISOU 1085 CG TYR A 137 10345 11630 13680 -1476 626 -1003 C \nATOM 1086 CD1 TYR A 137 32.458 15.662 -63.930 1.00 95.50 C \nANISOU 1086 CD1 TYR A 137 10541 11844 13903 -1481 592 -997 C \nATOM 1087 CD2 TYR A 137 33.218 15.633 -66.190 1.00 95.91 C \nANISOU 1087 CD2 TYR A 137 10506 12017 13920 -1519 634 -1047 C \nATOM 1088 CE1 TYR A 137 33.718 15.279 -63.498 1.00 93.12 C \nANISOU 1088 CE1 TYR A 137 10125 11666 13590 -1526 566 -1032 C \nATOM 1089 CE2 TYR A 137 34.482 15.245 -65.769 1.00 94.89 C \nANISOU 1089 CE2 TYR A 137 10259 12016 13778 -1562 609 -1084 C \nATOM 1090 CZ TYR A 137 34.721 15.066 -64.422 1.00 93.61 C \nANISOU 1090 CZ TYR A 137 10084 11855 13628 -1564 574 -1075 C \nATOM 1091 OH TYR A 137 35.959 14.676 -64.000 1.00 95.91 O \nANISOU 1091 OH TYR A 137 10255 12281 13903 -1601 548 -1109 O \nATOM 1092 N GLN A 138 31.850 18.739 -65.089 1.00105.69 N \nANISOU 1092 N GLN A 138 12148 12990 15020 -1681 713 -951 N \nATOM 1093 CA GLN A 138 32.786 19.743 -64.693 1.00100.73 C \nANISOU 1093 CA GLN A 138 11569 12398 14305 -1830 734 -959 C \nATOM 1094 C GLN A 138 32.524 20.886 -65.664 1.00 97.92 C \nANISOU 1094 C GLN A 138 11342 11987 13877 -1900 788 -945 C \nATOM 1095 O GLN A 138 33.443 21.388 -66.332 1.00 87.06 O \nANISOU 1095 O GLN A 138 9952 10692 12437 -2013 813 -970 O \nATOM 1096 CB GLN A 138 34.191 19.170 -64.805 1.00 97.01 C \nANISOU 1096 CB GLN A 138 10940 12094 13827 -1886 712 -1008 C \nATOM 1097 CG GLN A 138 35.209 19.901 -63.979 1.00 97.74 C \nANISOU 1097 CG GLN A 138 11049 12244 13845 -2029 715 -1018 C \nATOM 1098 CD GLN A 138 35.174 19.563 -62.502 1.00 88.57 C \nANISOU 1098 CD GLN A 138 9874 11064 12715 -2001 676 -1006 C \nATOM 1099 OE1 GLN A 138 35.311 18.407 -62.108 1.00 85.11 O \nANISOU 1099 OE1 GLN A 138 9311 10680 12347 -1909 631 -1019 O \nATOM 1100 NE2 GLN A 138 35.057 20.583 -61.674 1.00 90.71 N \nANISOU 1100 NE2 GLN A 138 10276 11262 12928 -2088 694 -981 N \nATOM 1101 N GLY A 139 31.252 21.296 -65.728 1.00 92.23 N \nANISOU 1101 N GLY A 139 10747 11131 13164 -1830 806 -904 N \nATOM 1102 CA GLY A 139 30.779 22.279 -66.696 1.00 95.76 C \nANISOU 1102 CA GLY A 139 11324 11509 13552 -1862 855 -884 C \nATOM 1103 C GLY A 139 30.401 21.616 -68.012 1.00104.82 C \nANISOU 1103 C GLY A 139 12398 12687 14742 -1780 860 -893 C \nATOM 1104 O GLY A 139 29.336 21.878 -68.582 1.00114.48 O \nANISOU 1104 O GLY A 139 13705 13823 15968 -1710 881 -862 O \nATOM 1105 N THR A 140 31.291 20.756 -68.496 1.00105.65 N \nANISOU 1105 N THR A 140 12344 12922 14876 -1788 840 -937 N \nATOM 1106 CA THR A 140 31.088 20.024 -69.734 1.00111.10 C \nANISOU 1106 CA THR A 140 12949 13658 15607 -1716 841 -954 C \nATOM 1107 C THR A 140 29.787 19.225 -69.666 1.00108.80 C \nANISOU 1107 C THR A 140 12652 13289 15397 -1561 820 -929 C \nATOM 1108 O THR A 140 29.395 18.770 -68.592 1.00111.94 O \nANISOU 1108 O THR A 140 13042 13649 15841 -1501 788 -915 O \nATOM 1109 CB THR A 140 32.239 19.026 -69.994 1.00113.46 C \nANISOU 1109 CB THR A 140 13064 14110 15936 -1725 814 -1008 C \nATOM 1110 OG1 THR A 140 32.250 18.038 -68.957 1.00124.97 O \nANISOU 1110 OG1 THR A 140 14436 15583 17463 -1648 764 -1014 O \nATOM 1111 CG2 THR A 140 33.598 19.721 -70.034 1.00115.31 C \nANISOU 1111 CG2 THR A 140 13280 14447 16086 -1883 831 -1037 C \nATOM 1112 N PRO A 141 29.117 19.052 -70.815 1.00105.42 N \nANISOU 1112 N PRO A 141 12228 12844 14983 -1500 838 -922 N \nATOM 1113 CA PRO A 141 27.968 18.168 -70.838 1.00108.41 C \nANISOU 1113 CA PRO A 141 12582 13173 15438 -1360 816 -904 C \nATOM 1114 C PRO A 141 28.379 16.712 -70.632 1.00109.79 C \nANISOU 1114 C PRO A 141 12597 13428 15691 -1294 768 -940 C \nATOM 1115 O PRO A 141 29.203 16.192 -71.377 1.00119.55 O \nANISOU 1115 O PRO A 141 13726 14764 16933 -1312 765 -982 O \nATOM 1116 CB PRO A 141 27.393 18.366 -72.246 1.00104.30 C \nANISOU 1116 CB PRO A 141 12090 12639 14900 -1334 848 -896 C \nATOM 1117 CG PRO A 141 28.527 18.843 -73.070 1.00100.54 C \nANISOU 1117 CG PRO A 141 11587 12247 14365 -1447 874 -929 C \nATOM 1118 CD PRO A 141 29.367 19.664 -72.134 1.00106.28 C \nANISOU 1118 CD PRO A 141 12367 12980 15036 -1562 879 -931 C \nATOM 1119 N SER A 142 27.831 16.079 -69.602 1.00110.56 N \nANISOU 1119 N SER A 142 12682 13482 15843 -1218 732 -923 N \nATOM 1120 CA SER A 142 28.116 14.668 -69.314 1.00 98.64 C \nANISOU 1120 CA SER A 142 11040 12032 14409 -1145 684 -952 C \nATOM 1121 C SER A 142 26.797 13.917 -69.086 1.00 85.82 C \nANISOU 1121 C SER A 142 9429 10332 12846 -1026 661 -923 C \nATOM 1122 O SER A 142 25.731 14.342 -69.556 1.00 80.42 O \nANISOU 1122 O SER A 142 8827 9580 12149 -992 686 -891 O \nATOM 1123 CB SER A 142 29.087 14.558 -68.136 1.00 99.38 C \nANISOU 1123 CB SER A 142 11086 12174 14501 -1194 654 -968 C \nATOM 1124 OG SER A 142 28.437 15.012 -66.969 1.00105.97 O \nANISOU 1124 OG SER A 142 12014 12918 15333 -1188 648 -929 O \nATOM 1125 N PHE A 143 26.880 12.811 -68.360 1.00 77.68 N \nANISOU 1125 N PHE A 143 8319 9319 11877 -965 614 -935 N \nATOM 1126 CA PHE A 143 25.773 11.885 -68.186 1.00 69.93 C \nANISOU 1126 CA PHE A 143 7330 8286 10955 -858 587 -916 C \nATOM 1127 C PHE A 143 26.157 10.813 -67.184 1.00 61.66 C \nANISOU 1127 C PHE A 143 6205 7261 9963 -816 533 -931 C \nATOM 1128 O PHE A 143 27.302 10.650 -66.879 1.00 59.83 O \nANISOU 1128 O PHE A 143 5906 7100 9727 -855 518 -962 O \nATOM 1129 CB PHE A 143 25.434 11.237 -69.508 1.00 63.84 C \nANISOU 1129 CB PHE A 143 6510 7539 10206 -806 595 -934 C \nATOM 1130 CG PHE A 143 24.190 10.417 -69.470 1.00 61.83 C \nANISOU 1130 CG PHE A 143 6263 7231 10000 -710 574 -911 C \nATOM 1131 CD1 PHE A 143 22.933 11.029 -69.499 1.00 61.68 C \nANISOU 1131 CD1 PHE A 143 6339 7136 9959 -686 597 -864 C \nATOM 1132 CD2 PHE A 143 24.256 9.035 -69.424 1.00 60.18 C \nANISOU 1132 CD2 PHE A 143 5967 7047 9852 -643 532 -935 C \nATOM 1133 CE1 PHE A 143 21.765 10.265 -69.502 1.00 51.67 C \nANISOU 1133 CE1 PHE A 143 5071 5832 8729 -603 578 -843 C \nATOM 1134 CE2 PHE A 143 23.096 8.276 -69.416 1.00 52.19 C \nANISOU 1134 CE2 PHE A 143 4965 5987 8877 -566 514 -914 C \nATOM 1135 CZ PHE A 143 21.859 8.887 -69.445 1.00 48.32 C \nANISOU 1135 CZ PHE A 143 4562 5434 8364 -550 536 -868 C \nATOM 1136 N PHE A 144 25.180 10.114 -66.653 1.00 55.82 N \nANISOU 1136 N PHE A 144 5478 6463 9268 -738 505 -906 N \nATOM 1137 CA PHE A 144 25.428 9.032 -65.705 1.00 57.88 C \nANISOU 1137 CA PHE A 144 5675 6735 9581 -691 451 -916 C \nATOM 1138 C PHE A 144 26.582 8.155 -66.176 1.00 57.64 C \nANISOU 1138 C PHE A 144 5529 6798 9574 -680 430 -968 C \nATOM 1139 O PHE A 144 26.738 7.899 -67.373 1.00 58.92 O \nANISOU 1139 O PHE A 144 5652 7001 9737 -668 447 -995 O \nATOM 1140 CB PHE A 144 24.172 8.147 -65.544 1.00 58.15 C \nANISOU 1140 CB PHE A 144 5724 6708 9663 -602 426 -891 C \nATOM 1141 CG PHE A 144 22.946 8.883 -65.044 1.00 49.70 C \nANISOU 1141 CG PHE A 144 4757 5556 8571 -596 444 -840 C \nATOM 1142 CD1 PHE A 144 21.826 9.084 -65.879 1.00 44.33 C \nANISOU 1142 CD1 PHE A 144 4123 4841 7879 -562 471 -817 C \nATOM 1143 CD2 PHE A 144 22.937 9.383 -63.774 1.00 44.60 C \nANISOU 1143 CD2 PHE A 144 4159 4875 7912 -623 433 -816 C \nATOM 1144 CE1 PHE A 144 20.714 9.778 -65.409 1.00 52.12 C \nANISOU 1144 CE1 PHE A 144 5201 5762 8839 -549 487 -771 C \nATOM 1145 CE2 PHE A 144 21.839 10.052 -63.278 1.00 48.27 C \nANISOU 1145 CE2 PHE A 144 4718 5269 8354 -612 449 -771 C \nATOM 1146 CZ PHE A 144 20.724 10.263 -64.083 1.00 54.92 C \nANISOU 1146 CZ PHE A 144 5605 6080 9183 -572 476 -748 C \nATOM 1147 N ARG A 145 27.385 7.701 -65.228 1.00 53.10 N \nANISOU 1147 N ARG A 145 4901 6260 9016 -681 393 -983 N \nATOM 1148 CA ARG A 145 28.561 6.896 -65.539 1.00 53.25 C \nANISOU 1148 CA ARG A 145 4807 6376 9050 -664 370 -1032 C \nATOM 1149 C ARG A 145 28.300 5.413 -65.570 1.00 49.47 C \nANISOU 1149 C ARG A 145 4275 5887 8633 -560 326 -1046 C \nATOM 1150 O ARG A 145 29.068 4.680 -66.183 1.00 53.55 O \nANISOU 1150 O ARG A 145 4708 6476 9164 -527 314 -1090 O \nATOM 1151 CB ARG A 145 29.653 7.195 -64.524 1.00 57.78 C \nANISOU 1151 CB ARG A 145 5345 7008 9600 -719 352 -1041 C \nATOM 1152 CG ARG A 145 30.111 8.652 -64.567 1.00 68.12 C \nANISOU 1152 CG ARG A 145 6705 8340 10839 -837 396 -1035 C \nATOM 1153 CD ARG A 145 31.417 8.852 -63.836 1.00 79.87 C \nANISOU 1153 CD ARG A 145 8131 9919 12296 -900 381 -1057 C \nATOM 1154 NE ARG A 145 31.750 10.266 -63.695 1.00 92.62 N \nANISOU 1154 NE ARG A 145 9813 11540 13838 -1021 421 -1045 N \nATOM 1155 CZ ARG A 145 32.324 11.025 -64.632 1.00 98.78 C \nANISOU 1155 CZ ARG A 145 10592 12378 14563 -1102 462 -1065 C \nATOM 1156 NH1 ARG A 145 32.634 10.531 -65.839 1.00101.66 N \nANISOU 1156 NH1 ARG A 145 10884 12806 14936 -1072 472 -1100 N \nATOM 1157 NH2 ARG A 145 32.590 12.298 -64.361 1.00 93.39 N \nANISOU 1157 NH2 ARG A 145 9984 11688 13810 -1217 495 -1052 N \nATOM 1158 N ASN A 146 27.228 4.966 -64.895 1.00 44.55 N \nANISOU 1158 N ASN A 146 3705 5177 8045 -510 302 -1011 N \nATOM 1159 CA ASN A 146 27.001 3.538 -64.697 1.00 42.09 C \nANISOU 1159 CA ASN A 146 3356 4847 7789 -420 254 -1021 C \nATOM 1160 C ASN A 146 26.037 2.950 -65.719 1.00 42.18 C \nANISOU 1160 C ASN A 146 3386 4819 7822 -368 263 -1021 C \nATOM 1161 O ASN A 146 25.577 1.799 -65.617 1.00 35.93 O \nANISOU 1161 O ASN A 146 2586 3993 7071 -299 228 -1023 O \nATOM 1162 CB ASN A 146 26.464 3.267 -63.332 1.00 43.14 C \nANISOU 1162 CB ASN A 146 3530 4917 7944 -401 217 -985 C \nATOM 1163 CG ASN A 146 27.496 3.288 -62.285 1.00 42.23 C \nANISOU 1163 CG ASN A 146 3374 4848 7823 -422 189 -993 C \nATOM 1164 OD1 ASN A 146 28.633 2.960 -62.549 1.00 50.07 O \nANISOU 1164 OD1 ASN A 146 4286 5924 8813 -417 179 -1033 O \nATOM 1165 ND2 ASN A 146 27.115 3.760 -61.072 1.00 47.67 N \nANISOU 1165 ND2 ASN A 146 4118 5489 8505 -451 178 -955 N \nATOM 1166 N VAL A 147 25.727 3.759 -66.716 1.00 42.98 N \nANISOU 1166 N VAL A 147 3514 4925 7890 -407 312 -1018 N \nATOM 1167 CA VAL A 147 24.621 3.511 -67.592 1.00 42.38 C \nANISOU 1167 CA VAL A 147 3472 4807 7823 -374 328 -1006 C \nATOM 1168 C VAL A 147 24.863 4.244 -68.906 1.00 46.55 C \nANISOU 1168 C VAL A 147 3994 5380 8314 -415 378 -1024 C \nATOM 1169 O VAL A 147 25.329 5.372 -68.929 1.00 60.91 O \nANISOU 1169 O VAL A 147 5833 7222 10088 -484 411 -1019 O \nATOM 1170 CB VAL A 147 23.351 3.985 -66.849 1.00 44.27 C \nANISOU 1170 CB VAL A 147 3799 4965 8056 -376 331 -950 C \nATOM 1171 CG1 VAL A 147 22.651 5.144 -67.536 1.00 42.60 C \nANISOU 1171 CG1 VAL A 147 3653 4734 7800 -414 383 -924 C \nATOM 1172 CG2 VAL A 147 22.407 2.808 -66.613 1.00 44.14 C \nANISOU 1172 CG2 VAL A 147 3791 4899 8081 -309 294 -937 C \nATOM 1173 N VAL A 148 24.594 3.562 -70.008 1.00 50.00 N \nANISOU 1173 N VAL A 148 4403 5830 8766 -374 384 -1047 N \nATOM 1174 CA VAL A 148 24.889 4.064 -71.327 1.00 46.31 C \nANISOU 1174 CA VAL A 148 3917 5411 8267 -406 427 -1069 C \nATOM 1175 C VAL A 148 23.635 4.505 -72.089 1.00 45.32 C \nANISOU 1175 C VAL A 148 3856 5240 8123 -405 460 -1037 C \nATOM 1176 O VAL A 148 22.697 3.729 -72.255 1.00 41.59 O \nANISOU 1176 O VAL A 148 3395 4728 7677 -352 444 -1026 O \nATOM 1177 CB VAL A 148 25.603 2.993 -72.156 1.00 41.66 C \nANISOU 1177 CB VAL A 148 3242 4884 7702 -361 413 -1125 C \nATOM 1178 CG1 VAL A 148 26.143 3.619 -73.422 1.00 43.15 C \nANISOU 1178 CG1 VAL A 148 3403 5140 7852 -407 458 -1152 C \nATOM 1179 CG2 VAL A 148 26.696 2.371 -71.327 1.00 43.40 C \nANISOU 1179 CG2 VAL A 148 3399 5147 7944 -339 373 -1154 C \nATOM 1180 N TRP A 149 23.692 5.702 -72.640 1.00 42.57 N \nANISOU 1180 N TRP A 149 3545 4905 7726 -465 506 -1025 N \nATOM 1181 CA TRP A 149 22.626 6.231 -73.486 1.00 42.92 C \nANISOU 1181 CA TRP A 149 3647 4918 7744 -464 541 -996 C \nATOM 1182 C TRP A 149 22.935 6.021 -74.925 1.00 48.44 C \nANISOU 1182 C TRP A 149 4299 5672 8433 -467 565 -1032 C \nATOM 1183 O TRP A 149 23.627 6.832 -75.553 1.00 57.95 O \nANISOU 1183 O TRP A 149 5499 6921 9597 -525 599 -1046 O \nATOM 1184 CB TRP A 149 22.488 7.735 -73.246 1.00 40.77 C \nANISOU 1184 CB TRP A 149 3457 4618 7416 -526 579 -960 C \nATOM 1185 CG TRP A 149 21.393 8.386 -73.975 1.00 42.16 C \nANISOU 1185 CG TRP A 149 3701 4760 7558 -518 614 -924 C \nATOM 1186 CD1 TRP A 149 20.630 7.843 -74.928 1.00 43.79 C \nANISOU 1186 CD1 TRP A 149 3893 4971 7774 -475 620 -924 C \nATOM 1187 CD2 TRP A 149 20.959 9.754 -73.842 1.00 43.35 C \nANISOU 1187 CD2 TRP A 149 3949 4868 7653 -556 651 -882 C \nATOM 1188 NE1 TRP A 149 19.726 8.770 -75.391 1.00 44.14 N \nANISOU 1188 NE1 TRP A 149 4013 4986 7773 -479 656 -884 N \nATOM 1189 CE2 TRP A 149 19.922 9.951 -74.738 1.00 44.23 C \nANISOU 1189 CE2 TRP A 149 4097 4965 7744 -524 676 -858 C \nATOM 1190 CE3 TRP A 149 21.361 10.824 -73.048 1.00 47.20 C \nANISOU 1190 CE3 TRP A 149 4502 5330 8103 -612 664 -864 C \nATOM 1191 CZ2 TRP A 149 19.234 11.152 -74.830 1.00 48.25 C \nANISOU 1191 CZ2 TRP A 149 4705 5430 8197 -535 712 -814 C \nATOM 1192 CZ3 TRP A 149 20.707 12.023 -73.168 1.00 47.45 C \nANISOU 1192 CZ3 TRP A 149 4637 5312 8079 -629 701 -823 C \nATOM 1193 CH2 TRP A 149 19.658 12.178 -74.043 1.00 49.34 C \nANISOU 1193 CH2 TRP A 149 4911 5535 8300 -586 724 -798 C \nATOM 1194 N LEU A 150 22.475 4.900 -75.468 1.00 47.86 N \nANISOU 1194 N LEU A 150 4190 5599 8394 -408 547 -1049 N \nATOM 1195 CA LEU A 150 22.878 4.479 -76.826 1.00 44.09 C \nANISOU 1195 CA LEU A 150 3656 5181 7915 -403 564 -1092 C \nATOM 1196 C LEU A 150 22.155 5.312 -77.835 1.00 48.92 C \nANISOU 1196 C LEU A 150 4316 5789 8484 -429 609 -1067 C \nATOM 1197 O LEU A 150 21.015 5.713 -77.602 1.00 67.14 O \nANISOU 1197 O LEU A 150 6690 8041 10779 -417 617 -1019 O \nATOM 1198 CB LEU A 150 22.620 3.001 -77.025 1.00 46.03 C \nANISOU 1198 CB LEU A 150 3859 5421 8208 -333 529 -1119 C \nATOM 1199 CG LEU A 150 23.386 2.060 -76.106 1.00 50.59 C \nANISOU 1199 CG LEU A 150 4390 6005 8827 -296 482 -1147 C \nATOM 1200 CD1 LEU A 150 22.931 0.627 -76.331 1.00 57.50 C \nANISOU 1200 CD1 LEU A 150 5249 6856 9743 -227 449 -1167 C \nATOM 1201 CD2 LEU A 150 24.882 2.152 -76.352 1.00 58.25 C \nANISOU 1201 CD2 LEU A 150 5287 7059 9787 -319 487 -1196 C \nATOM 1202 N ILE A 151 22.807 5.585 -78.956 1.00 49.54 N \nANISOU 1202 N ILE A 151 4358 5929 8536 -462 639 -1099 N \nATOM 1203 CA ILE A 151 22.182 6.238 -80.096 1.00 52.16 C \nANISOU 1203 CA ILE A 151 4726 6265 8828 -482 681 -1082 C \nATOM 1204 C ILE A 151 22.633 5.580 -81.386 1.00 51.48 C \nANISOU 1204 C ILE A 151 4569 6244 8746 -474 691 -1132 C \nATOM 1205 O ILE A 151 23.497 4.729 -81.369 1.00 49.78 O \nANISOU 1205 O ILE A 151 4281 6073 8561 -454 668 -1181 O \nATOM 1206 CB ILE A 151 22.408 7.755 -80.152 1.00 58.08 C \nANISOU 1206 CB ILE A 151 5540 7011 9518 -554 721 -1054 C \nATOM 1207 CG1 ILE A 151 23.875 8.111 -80.380 1.00 68.44 C \nANISOU 1207 CG1 ILE A 151 6801 8396 10807 -620 733 -1097 C \nATOM 1208 CG2 ILE A 151 21.889 8.401 -78.890 1.00 56.04 C \nANISOU 1208 CG2 ILE A 151 5359 6682 9252 -557 713 -1005 C \nATOM 1209 CD1 ILE A 151 24.085 9.467 -81.030 1.00 76.96 C \nANISOU 1209 CD1 ILE A 151 7937 9487 11817 -699 781 -1081 C \nATOM 1210 N LYS A 152 21.989 5.962 -82.487 1.00 55.38 N \nANISOU 1210 N LYS A 152 5088 6744 9208 -483 724 -1118 N \nATOM 1211 CA LYS A 152 22.240 5.347 -83.776 1.00 56.67 C \nANISOU 1211 CA LYS A 152 5192 6966 9373 -474 736 -1162 C \nATOM 1212 C LYS A 152 23.618 5.622 -84.333 1.00 69.78 C \nANISOU 1212 C LYS A 152 6793 8708 11012 -524 754 -1210 C \nATOM 1213 O LYS A 152 24.171 6.722 -84.171 1.00 73.36 O \nANISOU 1213 O LYS A 152 7274 9176 11424 -591 778 -1197 O \nATOM 1214 CB LYS A 152 21.184 5.817 -84.785 1.00 50.98 C \nANISOU 1214 CB LYS A 152 4517 6236 8618 -477 769 -1129 C \nATOM 1215 CG LYS A 152 21.231 7.260 -85.149 1.00 49.04 C \nANISOU 1215 CG LYS A 152 4330 5991 8311 -538 812 -1098 C \nATOM 1216 CD LYS A 152 20.103 7.604 -86.111 1.00 54.03 C \nANISOU 1216 CD LYS A 152 5005 6613 8909 -525 839 -1064 C \nATOM 1217 CE LYS A 152 20.139 9.052 -86.592 1.00 53.46 C \nANISOU 1217 CE LYS A 152 5003 6539 8770 -582 883 -1032 C \nATOM 1218 NZ LYS A 152 19.459 9.182 -87.919 1.00 58.12 N \nANISOU 1218 NZ LYS A 152 5601 7155 9328 -576 912 -1021 N \nATOM 1219 N LYS A 153 24.156 4.617 -85.017 1.00 82.99 N \nANISOU 1219 N LYS A 153 8387 10436 12708 -494 744 -1266 N \nATOM 1220 CA LYS A 153 25.414 4.736 -85.744 1.00 83.60 C \nANISOU 1220 CA LYS A 153 8394 10609 12762 -534 763 -1318 C \nATOM 1221 C LYS A 153 25.084 4.712 -87.230 1.00 83.52 C \nANISOU 1221 C LYS A 153 8372 10633 12726 -542 795 -1332 C \nATOM 1222 O LYS A 153 24.293 3.889 -87.674 1.00 79.91 O \nANISOU 1222 O LYS A 153 7916 10152 12295 -489 786 -1335 O \nATOM 1223 CB LYS A 153 26.325 3.580 -85.382 1.00 87.87 C \nANISOU 1223 CB LYS A 153 8850 11192 13343 -483 727 -1374 C \nATOM 1224 CG LYS A 153 27.790 3.858 -85.632 1.00 91.94 C \nANISOU 1224 CG LYS A 153 9291 11812 13830 -528 739 -1421 C \nATOM 1225 CD LYS A 153 28.603 2.596 -85.368 1.00100.23 C \nANISOU 1225 CD LYS A 153 10255 12908 14920 -457 703 -1478 C \nATOM 1226 CE LYS A 153 29.984 2.908 -84.818 1.00 98.34 C \nANISOU 1226 CE LYS A 153 9952 12755 14660 -492 697 -1507 C \nATOM 1227 NZ LYS A 153 30.486 1.801 -83.956 1.00101.96 N \nANISOU 1227 NZ LYS A 153 10360 13218 15164 -410 649 -1535 N \nATOM 1228 N ASN A 154 25.697 5.612 -87.995 1.00 87.02 N \nANISOU 1228 N ASN A 154 8808 11137 13117 -613 834 -1341 N \nATOM 1229 CA ASN A 154 25.185 5.969 -89.315 1.00 82.84 C \nANISOU 1229 CA ASN A 154 8297 10626 12553 -636 870 -1334 C \nATOM 1230 C ASN A 154 23.752 6.404 -89.104 1.00 80.70 C \nANISOU 1230 C ASN A 154 8119 10267 12276 -617 875 -1267 C \nATOM 1231 O ASN A 154 23.455 7.024 -88.079 1.00 83.62 O \nANISOU 1231 O ASN A 154 8552 10578 12644 -626 867 -1224 O \nATOM 1232 CB ASN A 154 25.297 4.806 -90.303 1.00 84.47 C \nANISOU 1232 CB ASN A 154 8430 10882 12782 -589 865 -1389 C \nATOM 1233 CG ASN A 154 26.688 4.682 -90.884 1.00 88.00 C \nANISOU 1233 CG ASN A 154 8788 11437 13210 -620 877 -1453 C \nATOM 1234 OD1 ASN A 154 26.897 4.808 -92.101 1.00 82.64 O \nANISOU 1234 OD1 ASN A 154 8080 10820 12500 -649 907 -1477 O \nATOM 1235 ND2 ASN A 154 27.653 4.413 -90.015 1.00 87.90 N \nANISOU 1235 ND2 ASN A 154 8728 11455 13216 -612 852 -1480 N \nATOM 1236 N ASN A 155 22.867 6.111 -90.044 1.00 72.98 N \nANISOU 1236 N ASN A 155 7151 9285 11294 -592 887 -1259 N \nATOM 1237 CA ASN A 155 21.451 6.225 -89.757 1.00 79.64 C \nANISOU 1237 CA ASN A 155 8064 10056 12139 -555 882 -1201 C \nATOM 1238 C ASN A 155 20.837 4.844 -89.506 1.00 73.88 C \nANISOU 1238 C ASN A 155 7305 9302 11464 -483 845 -1216 C \nATOM 1239 O ASN A 155 20.063 4.313 -90.306 1.00 71.20 O \nANISOU 1239 O ASN A 155 6960 8969 11123 -458 850 -1217 O \nATOM 1240 CB ASN A 155 20.770 6.986 -90.874 1.00 86.10 C \nANISOU 1240 CB ASN A 155 8925 10886 12905 -580 922 -1170 C \nATOM 1241 CG ASN A 155 21.286 8.399 -90.979 1.00 89.12 C \nANISOU 1241 CG ASN A 155 9359 11274 13229 -652 956 -1148 C \nATOM 1242 OD1 ASN A 155 22.135 8.818 -90.187 1.00 81.04 O \nANISOU 1242 OD1 ASN A 155 8339 10248 12204 -689 950 -1155 O \nATOM 1243 ND2 ASN A 155 20.789 9.138 -91.958 1.00 97.75 N \nANISOU 1243 ND2 ASN A 155 10495 12375 14270 -676 991 -1120 N \nATOM 1244 N THR A 156 21.255 4.245 -88.403 1.00 63.08 N \nANISOU 1244 N THR A 156 5919 7910 10140 -455 808 -1231 N \nATOM 1245 CA THR A 156 20.867 2.885 -88.088 1.00 70.55 C \nANISOU 1245 CA THR A 156 6839 8830 11135 -393 770 -1251 C \nATOM 1246 C THR A 156 20.963 2.546 -86.583 1.00 72.45 C \nANISOU 1246 C THR A 156 7094 9018 11415 -364 729 -1239 C \nATOM 1247 O THR A 156 22.035 2.606 -85.985 1.00 67.73 O \nANISOU 1247 O THR A 156 6465 8441 10830 -375 718 -1263 O \nATOM 1248 CB THR A 156 21.714 1.880 -88.859 1.00 70.27 C \nANISOU 1248 CB THR A 156 6727 8853 11119 -373 764 -1323 C \nATOM 1249 OG1 THR A 156 21.784 2.291 -90.223 1.00 83.70 O \nANISOU 1249 OG1 THR A 156 8410 10611 12780 -408 804 -1337 O \nATOM 1250 CG2 THR A 156 21.088 0.478 -88.778 1.00 75.58 C \nANISOU 1250 CG2 THR A 156 7395 9491 11833 -311 730 -1340 C \nATOM 1251 N TYR A 157 19.821 2.179 -86.003 1.00 69.12 N \nANISOU 1251 N TYR A 157 6716 8535 11009 -331 708 -1200 N \nATOM 1252 CA TYR A 157 19.767 1.633 -84.652 1.00 57.87 C \nANISOU 1252 CA TYR A 157 5304 7059 9625 -298 665 -1190 C \nATOM 1253 C TYR A 157 19.286 0.168 -84.812 1.00 60.10 C \nANISOU 1253 C TYR A 157 5570 7323 9942 -248 634 -1215 C \nATOM 1254 O TYR A 157 18.104 -0.127 -84.740 1.00 56.32 O \nANISOU 1254 O TYR A 157 5128 6809 9461 -234 625 -1182 O \nATOM 1255 CB TYR A 157 18.826 2.471 -83.781 1.00 51.99 C \nANISOU 1255 CB TYR A 157 4631 6260 8863 -306 667 -1122 C \nATOM 1256 CG TYR A 157 18.882 2.151 -82.269 1.00 43.14 C \nANISOU 1256 CG TYR A 157 3526 5088 7777 -285 627 -1107 C \nATOM 1257 CD1 TYR A 157 19.263 3.092 -81.371 1.00 40.66 C \nANISOU 1257 CD1 TYR A 157 3241 4756 7451 -313 631 -1082 C \nATOM 1258 CD2 TYR A 157 18.523 0.901 -81.773 1.00 37.98 C \nANISOU 1258 CD2 TYR A 157 2863 4403 7164 -240 585 -1118 C \nATOM 1259 CE1 TYR A 157 19.344 2.816 -80.025 1.00 39.26 C \nANISOU 1259 CE1 TYR A 157 3077 4538 7304 -296 595 -1069 C \nATOM 1260 CE2 TYR A 157 18.552 0.621 -80.416 1.00 35.86 C \nANISOU 1260 CE2 TYR A 157 2612 4088 6924 -223 548 -1102 C \nATOM 1261 CZ TYR A 157 18.977 1.565 -79.558 1.00 36.45 C \nANISOU 1261 CZ TYR A 157 2708 4152 6989 -249 553 -1079 C \nATOM 1262 OH TYR A 157 19.035 1.310 -78.200 1.00 35.95 O \nANISOU 1262 OH TYR A 157 2660 4048 6953 -234 517 -1063 O \nATOM 1263 N PRO A 158 20.218 -0.747 -85.066 1.00 62.35 N \nANISOU 1263 N PRO A 158 5801 7636 10254 -222 617 -1275 N \nATOM 1264 CA PRO A 158 19.805 -2.128 -85.200 1.00 58.68 C \nANISOU 1264 CA PRO A 158 5333 7144 9817 -176 587 -1300 C \nATOM 1265 C PRO A 158 19.242 -2.647 -83.906 1.00 54.77 C \nANISOU 1265 C PRO A 158 4880 6579 9352 -150 545 -1270 C \nATOM 1266 O PRO A 158 19.515 -2.086 -82.838 1.00 57.90 O \nANISOU 1266 O PRO A 158 5289 6955 9755 -157 534 -1244 O \nATOM 1267 CB PRO A 158 21.144 -2.871 -85.556 1.00 63.23 C \nANISOU 1267 CB PRO A 158 5846 7765 10415 -146 577 -1373 C \nATOM 1268 CG PRO A 158 22.246 -1.985 -85.083 1.00 59.38 C \nANISOU 1268 CG PRO A 158 5325 7317 9918 -172 587 -1377 C \nATOM 1269 CD PRO A 158 21.698 -0.590 -85.190 1.00 65.97 C \nANISOU 1269 CD PRO A 158 6199 8153 10714 -232 623 -1323 C \nATOM 1270 N THR A 159 18.527 -3.760 -83.978 1.00 52.84 N \nANISOU 1270 N THR A 159 4656 6298 9122 -122 520 -1276 N \nATOM 1271 CA THR A 159 17.849 -4.263 -82.803 1.00 48.72 C \nANISOU 1271 CA THR A 159 4180 5712 8621 -105 480 -1243 C \nATOM 1272 C THR A 159 18.803 -4.943 -81.849 1.00 54.89 C \nANISOU 1272 C THR A 159 4946 6466 9442 -66 440 -1271 C \nATOM 1273 O THR A 159 19.504 -5.842 -82.237 1.00 67.55 O \nANISOU 1273 O THR A 159 6524 8080 11064 -29 426 -1325 O \nATOM 1274 CB THR A 159 16.666 -5.144 -83.182 1.00 39.32 C \nANISOU 1274 CB THR A 159 3023 4493 7422 -102 469 -1234 C \nATOM 1275 OG1 THR A 159 15.700 -4.296 -83.820 1.00 37.96 O \nANISOU 1275 OG1 THR A 159 2864 4350 7208 -138 505 -1193 O \nATOM 1276 CG2 THR A 159 16.021 -5.728 -81.967 1.00 36.71 C \nANISOU 1276 CG2 THR A 159 2739 4100 7111 -90 426 -1203 C \nATOM 1277 N ILE A 160 18.822 -4.460 -80.600 1.00 59.82 N \nANISOU 1277 N ILE A 160 5592 7062 10077 -71 422 -1234 N \nATOM 1278 CA ILE A 160 19.709 -4.936 -79.568 1.00 51.68 C \nANISOU 1278 CA ILE A 160 4547 6010 9079 -37 384 -1252 C \nATOM 1279 C ILE A 160 19.134 -6.159 -78.923 1.00 60.84 C \nANISOU 1279 C ILE A 160 5750 7103 10264 -3 338 -1248 C \nATOM 1280 O ILE A 160 17.946 -6.193 -78.600 1.00 68.12 O \nANISOU 1280 O ILE A 160 6720 7986 11176 -23 331 -1205 O \nATOM 1281 CB ILE A 160 19.909 -3.866 -78.501 1.00 46.27 C \nANISOU 1281 CB ILE A 160 3870 5320 8389 -65 386 -1212 C \nATOM 1282 CG1 ILE A 160 20.746 -2.698 -79.095 1.00 43.67 C \nANISOU 1282 CG1 ILE A 160 3501 5059 8033 -104 429 -1224 C \nATOM 1283 CG2 ILE A 160 20.666 -4.409 -77.280 1.00 47.93 C \nANISOU 1283 CG2 ILE A 160 4072 5505 8633 -31 341 -1223 C \nATOM 1284 CD1 ILE A 160 20.740 -1.430 -78.241 1.00 42.86 C \nANISOU 1284 CD1 ILE A 160 3423 4949 7912 -146 442 -1179 C \nATOM 1285 N LYS A 161 19.991 -7.159 -78.718 1.00 59.70 N \nANISOU 1285 N LYS A 161 5589 6948 10148 49 305 -1294 N \nATOM 1286 CA LYS A 161 19.603 -8.410 -78.109 1.00 64.07 C \nANISOU 1286 CA LYS A 161 6190 7431 10723 85 258 -1295 C \nATOM 1287 C LYS A 161 20.816 -8.898 -77.342 1.00 60.12 C \nANISOU 1287 C LYS A 161 5664 6928 10252 139 223 -1326 C \nATOM 1288 O LYS A 161 21.772 -9.391 -77.903 1.00 76.59 O \nANISOU 1288 O LYS A 161 7710 9046 12344 184 222 -1380 O \nATOM 1289 CB LYS A 161 19.159 -9.407 -79.175 1.00 72.61 C \nANISOU 1289 CB LYS A 161 7291 8499 11796 98 260 -1329 C \nATOM 1290 CG LYS A 161 17.780 -9.990 -78.929 1.00 78.94 C \nANISOU 1290 CG LYS A 161 8164 9242 12589 73 241 -1293 C \nATOM 1291 CD LYS A 161 17.326 -10.805 -80.132 1.00 81.26 C \nANISOU 1291 CD LYS A 161 8476 9536 12866 72 252 -1326 C \nATOM 1292 CE LYS A 161 15.940 -11.403 -79.891 1.00 88.49 C \nANISOU 1292 CE LYS A 161 9459 10401 13763 36 233 -1290 C \nATOM 1293 NZ LYS A 161 15.973 -12.480 -78.859 1.00 91.04 N \nANISOU 1293 NZ LYS A 161 9838 10645 14107 65 179 -1290 N \nATOM 1294 N ARG A 162 20.773 -8.696 -76.043 1.00 58.57 N \nANISOU 1294 N ARG A 162 5488 6698 10069 136 196 -1289 N \nATOM 1295 CA ARG A 162 21.872 -8.992 -75.142 1.00 56.09 C \nANISOU 1295 CA ARG A 162 5147 6386 9777 183 162 -1307 C \nATOM 1296 C ARG A 162 21.276 -9.650 -73.915 1.00 52.39 C \nANISOU 1296 C ARG A 162 4742 5836 9327 195 113 -1272 C \nATOM 1297 O ARG A 162 20.181 -9.264 -73.473 1.00 55.95 O \nANISOU 1297 O ARG A 162 5238 6254 9768 148 116 -1221 O \nATOM 1298 CB ARG A 162 22.618 -7.686 -74.708 1.00 53.98 C \nANISOU 1298 CB ARG A 162 4828 6180 9501 148 184 -1293 C \nATOM 1299 CG ARG A 162 23.112 -6.840 -75.860 1.00 58.85 C \nANISOU 1299 CG ARG A 162 5390 6878 10092 117 235 -1319 C \nATOM 1300 CD ARG A 162 24.382 -7.423 -76.500 1.00 64.55 C \nANISOU 1300 CD ARG A 162 6046 7661 10818 171 233 -1386 C \nATOM 1301 NE ARG A 162 25.461 -7.339 -75.527 1.00 67.61 N \nANISOU 1301 NE ARG A 162 6393 8080 11216 195 207 -1394 N \nATOM 1302 CZ ARG A 162 26.429 -6.447 -75.537 1.00 62.70 C \nANISOU 1302 CZ ARG A 162 5707 7542 10575 166 229 -1406 C \nATOM 1303 NH1 ARG A 162 26.509 -5.556 -76.504 1.00 62.02 N \nANISOU 1303 NH1 ARG A 162 5592 7513 10458 111 278 -1413 N \nATOM 1304 NH2 ARG A 162 27.324 -6.483 -74.573 1.00 63.82 N \nANISOU 1304 NH2 ARG A 162 5814 7710 10724 189 201 -1411 N \nATOM 1305 N SER A 163 22.045 -10.539 -73.300 1.00 46.57 N \nANISOU 1305 N SER A 163 4006 5076 8612 258 70 -1297 N \nATOM 1306 CA SER A 163 21.590 -11.174 -72.082 1.00 50.94 C \nANISOU 1306 CA SER A 163 4620 5554 9182 270 22 -1264 C \nATOM 1307 C SER A 163 22.735 -11.527 -71.178 1.00 46.18 C \nANISOU 1307 C SER A 163 3991 4956 8598 329 -16 -1281 C \nATOM 1308 O SER A 163 23.834 -11.700 -71.634 1.00 58.49 O \nANISOU 1308 O SER A 163 5494 6568 10160 380 -13 -1329 O \nATOM 1309 CB SER A 163 20.740 -12.426 -72.410 1.00 59.30 C \nANISOU 1309 CB SER A 163 5754 6537 10239 285 -2 -1271 C \nATOM 1310 OG SER A 163 21.530 -13.599 -72.453 1.00 64.41 O \nANISOU 1310 OG SER A 163 6414 7157 10901 365 -36 -1317 O \nATOM 1311 N TYR A 164 22.460 -11.616 -69.886 1.00 42.60 N \nANISOU 1311 N TYR A 164 3576 4455 8157 323 -52 -1241 N \nATOM 1312 CA TYR A 164 23.471 -11.791 -68.856 1.00 44.65 C \nANISOU 1312 CA TYR A 164 3809 4724 8432 371 -89 -1246 C \nATOM 1313 C TYR A 164 23.048 -12.841 -67.884 1.00 51.85 C \nANISOU 1313 C TYR A 164 4797 5546 9358 401 -145 -1224 C \nATOM 1314 O TYR A 164 21.968 -12.743 -67.288 1.00 54.46 O \nANISOU 1314 O TYR A 164 5184 5823 9684 349 -153 -1176 O \nATOM 1315 CB TYR A 164 23.734 -10.495 -68.098 1.00 41.38 C \nANISOU 1315 CB TYR A 164 3353 4359 8012 318 -72 -1212 C \nATOM 1316 CG TYR A 164 24.736 -10.663 -66.966 1.00 44.08 C \nANISOU 1316 CG TYR A 164 3666 4715 8365 360 -112 -1214 C \nATOM 1317 CD1 TYR A 164 26.103 -10.771 -67.239 1.00 43.32 C \nANISOU 1317 CD1 TYR A 164 3495 4696 8269 415 -114 -1262 C \nATOM 1318 CD2 TYR A 164 24.315 -10.752 -65.614 1.00 38.07 C \nANISOU 1318 CD2 TYR A 164 2952 3899 7614 346 -149 -1168 C \nATOM 1319 CE1 TYR A 164 27.028 -10.935 -66.210 1.00 43.91 C \nANISOU 1319 CE1 TYR A 164 3538 4795 8350 456 -151 -1262 C \nATOM 1320 CE2 TYR A 164 25.216 -10.934 -64.621 1.00 40.67 C \nANISOU 1320 CE2 TYR A 164 3254 4244 7952 385 -186 -1169 C \nATOM 1321 CZ TYR A 164 26.590 -11.039 -64.926 1.00 45.72 C \nANISOU 1321 CZ TYR A 164 3816 4965 8590 443 -188 -1217 C \nATOM 1322 OH TYR A 164 27.557 -11.228 -63.923 1.00 54.81 O \nANISOU 1322 OH TYR A 164 4932 6146 9746 487 -226 -1218 O \nATOM 1323 N ASN A 165 23.902 -13.844 -67.726 1.00 58.16 N \nANISOU 1323 N ASN A 165 5599 6331 10170 487 -183 -1260 N \nATOM 1324 CA ASN A 165 23.649 -14.909 -66.799 1.00 68.71 C \nANISOU 1324 CA ASN A 165 7012 7579 11517 525 -239 -1243 C \nATOM 1325 C ASN A 165 24.486 -14.629 -65.556 1.00 64.12 C \nANISOU 1325 C ASN A 165 6394 7024 10946 550 -270 -1227 C \nATOM 1326 O ASN A 165 25.689 -14.752 -65.584 1.00 71.22 O \nANISOU 1326 O ASN A 165 7233 7980 11848 617 -279 -1263 O \nATOM 1327 CB ASN A 165 23.989 -16.262 -67.456 1.00 77.89 C \nANISOU 1327 CB ASN A 165 8216 8697 12680 610 -263 -1292 C \nATOM 1328 CG ASN A 165 23.503 -17.458 -66.661 1.00 84.11 C \nANISOU 1328 CG ASN A 165 9110 9375 13472 638 -319 -1273 C \nATOM 1329 OD1 ASN A 165 23.202 -17.330 -65.475 1.00 88.32 O \nANISOU 1329 OD1 ASN A 165 9670 9875 14011 611 -348 -1227 O \nATOM 1330 ND2 ASN A 165 23.442 -18.632 -67.311 1.00 91.58 N \nANISOU 1330 ND2 ASN A 165 10123 10261 14413 691 -335 -1309 N \nATOM 1331 N ASN A 166 23.825 -14.242 -64.471 1.00 55.69 N \nANISOU 1331 N ASN A 166 5360 5921 9880 495 -285 -1172 N \nATOM 1332 CA ASN A 166 24.487 -14.094 -63.194 1.00 57.53 C \nANISOU 1332 CA ASN A 166 5572 6165 10122 515 -319 -1152 C \nATOM 1333 C ASN A 166 25.238 -15.404 -62.826 1.00 64.29 C \nANISOU 1333 C ASN A 166 6457 6983 10988 620 -375 -1178 C \nATOM 1334 O ASN A 166 24.661 -16.376 -62.363 1.00 60.67 O \nANISOU 1334 O ASN A 166 6088 6431 10533 637 -416 -1161 O \nATOM 1335 CB ASN A 166 23.478 -13.708 -62.114 1.00 54.10 C \nANISOU 1335 CB ASN A 166 5189 5681 9685 443 -332 -1089 C \nATOM 1336 CG ASN A 166 24.118 -13.359 -60.769 1.00 51.96 C \nANISOU 1336 CG ASN A 166 4891 5430 9420 448 -362 -1065 C \nATOM 1337 OD1 ASN A 166 25.327 -13.362 -60.626 1.00 60.18 O \nANISOU 1337 OD1 ASN A 166 5870 6530 10465 503 -373 -1093 O \nATOM 1338 ND2 ASN A 166 23.286 -13.161 -59.752 1.00 46.96 N \nANISOU 1338 ND2 ASN A 166 4307 4750 8786 395 -378 -1013 N \nATOM 1339 N THR A 167 26.550 -15.388 -63.024 1.00 67.26 N \nANISOU 1339 N THR A 167 6754 7437 11364 689 -376 -1219 N \nATOM 1340 CA THR A 167 27.391 -16.525 -62.698 1.00 64.52 C \nANISOU 1340 CA THR A 167 6423 7070 11022 802 -426 -1246 C \nATOM 1341 C THR A 167 27.816 -16.556 -61.226 1.00 70.27 C \nANISOU 1341 C THR A 167 7150 7794 11756 821 -472 -1213 C \nATOM 1342 O THR A 167 28.593 -17.423 -60.843 1.00 76.53 O \nANISOU 1342 O THR A 167 7949 8579 12550 921 -516 -1231 O \nATOM 1343 CB THR A 167 28.643 -16.533 -63.566 1.00 57.89 C \nANISOU 1343 CB THR A 167 5492 6330 10175 877 -407 -1308 C \nATOM 1344 OG1 THR A 167 29.416 -15.342 -63.361 1.00 61.48 O \nANISOU 1344 OG1 THR A 167 5838 6903 10620 838 -380 -1307 O \nATOM 1345 CG2 THR A 167 28.298 -16.608 -65.007 1.00 56.47 C \nANISOU 1345 CG2 THR A 167 5315 6153 9988 867 -365 -1344 C \nATOM 1346 N ASN A 168 27.313 -15.623 -60.415 1.00 67.87 N \nANISOU 1346 N ASN A 168 6840 7497 11453 730 -463 -1164 N \nATOM 1347 CA ASN A 168 27.772 -15.468 -59.029 1.00 66.08 C \nANISOU 1347 CA ASN A 168 6598 7282 11228 737 -501 -1132 C \nATOM 1348 C ASN A 168 26.796 -16.072 -58.065 1.00 67.43 C \nANISOU 1348 C ASN A 168 6874 7341 11406 714 -543 -1084 C \nATOM 1349 O ASN A 168 25.758 -16.552 -58.495 1.00 74.47 O \nANISOU 1349 O ASN A 168 7846 8153 12298 686 -540 -1075 O \nATOM 1350 CB ASN A 168 27.948 -13.996 -58.708 1.00 68.60 C \nANISOU 1350 CB ASN A 168 6841 7686 11538 650 -464 -1112 C \nATOM 1351 CG ASN A 168 28.862 -13.290 -59.695 1.00 74.53 C \nANISOU 1351 CG ASN A 168 7490 8553 12276 653 -418 -1158 C \nATOM 1352 OD1 ASN A 168 30.085 -13.420 -59.624 1.00 99.43 O \nANISOU 1352 OD1 ASN A 168 10570 11788 15421 717 -432 -1189 O \nATOM 1353 ND2 ASN A 168 28.279 -12.515 -60.606 1.00 65.83 N \nANISOU 1353 ND2 ASN A 168 6380 7465 11167 582 -363 -1160 N \nATOM 1354 N GLN A 169 27.141 -16.070 -56.783 1.00 71.45 N \nANISOU 1354 N GLN A 169 7382 7850 11917 723 -583 -1053 N \nATOM 1355 CA GLN A 169 26.297 -16.672 -55.740 1.00 80.00 C \nANISOU 1355 CA GLN A 169 8563 8831 13003 702 -627 -1006 C \nATOM 1356 C GLN A 169 25.569 -15.612 -54.957 1.00 77.17 C \nANISOU 1356 C GLN A 169 8199 8481 12641 594 -609 -956 C \nATOM 1357 O GLN A 169 24.947 -15.902 -53.928 1.00 76.03 O \nANISOU 1357 O GLN A 169 8119 8272 12496 566 -644 -912 O \nATOM 1358 CB GLN A 169 27.109 -17.561 -54.768 1.00 84.06 C \nANISOU 1358 CB GLN A 169 9095 9324 13519 793 -692 -1002 C \nATOM 1359 CG GLN A 169 27.397 -18.963 -55.267 1.00 87.69 C \nANISOU 1359 CG GLN A 169 9619 9721 13979 902 -727 -1036 C \nATOM 1360 CD GLN A 169 28.580 -18.999 -56.197 1.00 90.56 C \nANISOU 1360 CD GLN A 169 9897 10173 14339 991 -708 -1096 C \nATOM 1361 OE1 GLN A 169 29.733 -18.935 -55.752 1.00 91.86 O \nANISOU 1361 OE1 GLN A 169 9989 10416 14499 1059 -728 -1110 O \nATOM 1362 NE2 GLN A 169 28.309 -19.122 -57.494 1.00 85.41 N \nANISOU 1362 NE2 GLN A 169 9251 9516 13686 992 -671 -1133 N \nATOM 1363 N GLU A 170 25.634 -14.385 -55.454 1.00 73.73 N \nANISOU 1363 N GLU A 170 7692 8122 12199 534 -554 -962 N \nATOM 1364 CA GLU A 170 24.940 -13.286 -54.810 1.00 71.37 C \nANISOU 1364 CA GLU A 170 7392 7832 11892 436 -530 -918 C \nATOM 1365 C GLU A 170 23.920 -12.675 -55.724 1.00 65.72 C \nANISOU 1365 C GLU A 170 6691 7109 11169 368 -477 -914 C \nATOM 1366 O GLU A 170 24.129 -12.547 -56.922 1.00 73.81 O \nANISOU 1366 O GLU A 170 7683 8169 12191 381 -441 -951 O \nATOM 1367 CB GLU A 170 25.925 -12.203 -54.374 1.00 76.45 C \nANISOU 1367 CB GLU A 170 7946 8575 12528 416 -512 -922 C \nATOM 1368 CG GLU A 170 27.064 -12.704 -53.486 1.00 79.79 C \nANISOU 1368 CG GLU A 170 8334 9028 12953 484 -562 -928 C \nATOM 1369 CD GLU A 170 28.278 -13.101 -54.275 1.00 80.74 C \nANISOU 1369 CD GLU A 170 8386 9219 13072 571 -562 -983 C \nATOM 1370 OE1 GLU A 170 28.120 -13.400 -55.470 1.00 85.57 O \nANISOU 1370 OE1 GLU A 170 9003 9824 13687 594 -537 -1016 O \nATOM 1371 OE2 GLU A 170 29.383 -13.123 -53.699 1.00 90.42 O \nANISOU 1371 OE2 GLU A 170 9551 10514 14292 616 -588 -993 O \nATOM 1372 N ASP A 171 22.803 -12.282 -55.140 1.00 58.88 N \nANISOU 1372 N ASP A 171 5875 6203 10295 297 -472 -868 N \nATOM 1373 CA ASP A 171 21.844 -11.449 -55.835 1.00 55.83 C \nANISOU 1373 CA ASP A 171 5493 5827 9894 229 -419 -856 C \nATOM 1374 C ASP A 171 22.576 -10.256 -56.368 1.00 55.95 C \nANISOU 1374 C ASP A 171 5429 5929 9902 209 -369 -877 C \nATOM 1375 O ASP A 171 23.401 -9.675 -55.661 1.00 51.57 O \nANISOU 1375 O ASP A 171 4828 5421 9345 204 -374 -875 O \nATOM 1376 CB ASP A 171 20.749 -10.979 -54.871 1.00 55.63 C \nANISOU 1376 CB ASP A 171 5513 5768 9856 160 -421 -801 C \nATOM 1377 CG ASP A 171 19.968 -12.147 -54.250 1.00 62.06 C \nANISOU 1377 CG ASP A 171 6410 6499 10671 165 -471 -775 C \nATOM 1378 OD1 ASP A 171 19.966 -13.259 -54.821 1.00 78.24 O \nANISOU 1378 OD1 ASP A 171 8496 8505 12726 209 -493 -798 O \nATOM 1379 OD2 ASP A 171 19.343 -11.958 -53.198 1.00 62.22 O \nANISOU 1379 OD2 ASP A 171 6463 6496 10681 122 -488 -732 O \nATOM 1380 N LEU A 172 22.309 -9.857 -57.609 1.00 59.69 N \nANISOU 1380 N LEU A 172 5885 6427 10367 193 -322 -899 N \nATOM 1381 CA LEU A 172 22.854 -8.572 -58.051 1.00 57.72 C \nANISOU 1381 CA LEU A 172 5573 6255 10104 157 -272 -911 C \nATOM 1382 C LEU A 172 21.816 -7.567 -58.570 1.00 54.67 C \nANISOU 1382 C LEU A 172 5207 5869 9696 90 -219 -887 C \nATOM 1383 O LEU A 172 20.815 -7.922 -59.178 1.00 48.71 O \nANISOU 1383 O LEU A 172 4493 5078 8938 83 -209 -880 O \nATOM 1384 CB LEU A 172 24.028 -8.742 -58.998 1.00 59.51 C \nANISOU 1384 CB LEU A 172 5732 6546 10334 205 -260 -966 C \nATOM 1385 CG LEU A 172 23.919 -9.467 -60.306 1.00 62.51 C \nANISOU 1385 CG LEU A 172 6114 6917 10720 246 -248 -1004 C \nATOM 1386 CD1 LEU A 172 23.638 -8.518 -61.435 1.00 69.36 C \nANISOU 1386 CD1 LEU A 172 6957 7828 11569 198 -187 -1014 C \nATOM 1387 CD2 LEU A 172 25.243 -10.159 -60.588 1.00 66.19 C \nANISOU 1387 CD2 LEU A 172 6526 7430 11196 326 -271 -1053 C \nATOM 1388 N LEU A 173 22.082 -6.293 -58.276 1.00 50.63 N \nANISOU 1388 N LEU A 173 4670 5402 9167 40 -186 -875 N \nATOM 1389 CA LEU A 173 21.140 -5.239 -58.547 1.00 45.02 C \nANISOU 1389 CA LEU A 173 3987 4688 8431 -17 -140 -846 C \nATOM 1390 C LEU A 173 21.504 -4.597 -59.847 1.00 45.13 C \nANISOU 1390 C LEU A 173 3963 4754 8431 -28 -89 -877 C \nATOM 1391 O LEU A 173 22.558 -4.007 -59.944 1.00 34.78 O \nANISOU 1391 O LEU A 173 2602 3500 7112 -39 -74 -900 O \nATOM 1392 CB LEU A 173 21.146 -4.232 -57.405 1.00 43.40 C \nANISOU 1392 CB LEU A 173 3794 4488 8209 -65 -134 -812 C \nATOM 1393 CG LEU A 173 20.595 -2.825 -57.701 1.00 43.76 C \nANISOU 1393 CG LEU A 173 3859 4548 8221 -122 -77 -792 C \nATOM 1394 CD1 LEU A 173 19.044 -2.868 -57.847 1.00 40.19 C \nANISOU 1394 CD1 LEU A 173 3464 4052 7756 -130 -66 -756 C \nATOM 1395 CD2 LEU A 173 21.026 -1.879 -56.617 1.00 39.27 C \nANISOU 1395 CD2 LEU A 173 3293 3992 7635 -164 -74 -772 C \nATOM 1396 N ILE A 174 20.575 -4.698 -60.841 1.00 46.52 N \nANISOU 1396 N ILE A 174 4163 4914 8599 -31 -63 -876 N \nATOM 1397 CA ILE A 174 20.777 -4.117 -62.184 1.00 36.24 C \nANISOU 1397 CA ILE A 174 2831 3657 7281 -43 -13 -903 C \nATOM 1398 C ILE A 174 19.783 -2.965 -62.386 1.00 39.09 C \nANISOU 1398 C ILE A 174 3229 4014 7610 -93 33 -866 C \nATOM 1399 O ILE A 174 18.696 -2.991 -61.894 1.00 45.82 O \nANISOU 1399 O ILE A 174 4129 4827 8454 -103 26 -828 O \nATOM 1400 CB ILE A 174 20.571 -5.154 -63.272 1.00 33.26 C \nANISOU 1400 CB ILE A 174 2449 3270 6916 -2 -19 -933 C \nATOM 1401 CG1 ILE A 174 21.295 -6.491 -62.882 1.00 32.31 C \nANISOU 1401 CG1 ILE A 174 2317 3132 6828 60 -74 -961 C \nATOM 1402 CG2 ILE A 174 21.039 -4.654 -64.613 1.00 30.96 C \nANISOU 1402 CG2 ILE A 174 2116 3036 6612 -9 27 -968 C \nATOM 1403 CD1 ILE A 174 21.121 -7.571 -63.929 1.00 31.16 C \nANISOU 1403 CD1 ILE A 174 2179 2969 6692 103 -80 -994 C \nATOM 1404 N LEU A 175 20.208 -1.916 -63.077 1.00 44.03 N \nANISOU 1404 N LEU A 175 3833 4684 8211 -123 79 -878 N \nATOM 1405 CA LEU A 175 19.411 -0.746 -63.316 1.00 42.29 C \nANISOU 1405 CA LEU A 175 3653 4461 7956 -163 125 -846 C \nATOM 1406 C LEU A 175 19.520 -0.323 -64.781 1.00 45.93 C \nANISOU 1406 C LEU A 175 4093 4961 8399 -172 171 -870 C \nATOM 1407 O LEU A 175 20.598 -0.362 -65.368 1.00 53.78 O \nANISOU 1407 O LEU A 175 5036 6001 9397 -171 178 -911 O \nATOM 1408 CB LEU A 175 19.867 0.402 -62.460 1.00 44.51 C \nANISOU 1408 CB LEU A 175 3947 4750 8214 -207 139 -828 C \nATOM 1409 CG LEU A 175 19.782 0.181 -60.949 1.00 51.03 C \nANISOU 1409 CG LEU A 175 4794 5541 9052 -207 99 -801 C \nATOM 1410 CD1 LEU A 175 21.112 -0.228 -60.364 1.00 49.90 C \nANISOU 1410 CD1 LEU A 175 4601 5429 8931 -200 66 -830 C \nATOM 1411 CD2 LEU A 175 19.310 1.444 -60.244 1.00 49.41 C \nANISOU 1411 CD2 LEU A 175 4642 5320 8812 -250 126 -763 C \nATOM 1412 N TRP A 176 18.386 0.067 -65.361 1.00 43.47 N \nANISOU 1412 N TRP A 176 3819 4636 8063 -179 201 -844 N \nATOM 1413 CA TRP A 176 18.320 0.510 -66.752 1.00 35.11 C \nANISOU 1413 CA TRP A 176 2749 3611 6982 -188 245 -860 C \nATOM 1414 C TRP A 176 17.269 1.559 -66.853 1.00 33.09 C \nANISOU 1414 C TRP A 176 2546 3341 6684 -208 283 -817 C \nATOM 1415 O TRP A 176 16.575 1.868 -65.874 1.00 31.26 O \nANISOU 1415 O TRP A 176 2358 3077 6442 -211 274 -778 O \nATOM 1416 CB TRP A 176 18.010 -0.664 -67.693 1.00 33.33 C \nANISOU 1416 CB TRP A 176 2500 3388 6775 -152 232 -886 C \nATOM 1417 CG TRP A 176 16.679 -1.300 -67.470 1.00 33.58 C \nANISOU 1417 CG TRP A 176 2570 3383 6807 -137 214 -855 C \nATOM 1418 CD1 TRP A 176 15.535 -1.030 -68.119 1.00 31.68 C \nANISOU 1418 CD1 TRP A 176 2354 3146 6537 -142 240 -830 C \nATOM 1419 CD2 TRP A 176 16.374 -2.278 -66.504 1.00 34.36 C \nANISOU 1419 CD2 TRP A 176 2685 3441 6931 -118 164 -844 C \nATOM 1420 NE1 TRP A 176 14.540 -1.769 -67.622 1.00 32.22 N \nANISOU 1420 NE1 TRP A 176 2449 3186 6608 -132 212 -806 N \nATOM 1421 CE2 TRP A 176 15.015 -2.548 -66.614 1.00 32.15 C \nANISOU 1421 CE2 TRP A 176 2439 3145 6631 -120 164 -813 C \nATOM 1422 CE3 TRP A 176 17.134 -2.950 -65.522 1.00 38.50 C \nANISOU 1422 CE3 TRP A 176 3199 3944 7487 -101 118 -856 C \nATOM 1423 CZ2 TRP A 176 14.374 -3.472 -65.834 1.00 35.57 C \nANISOU 1423 CZ2 TRP A 176 2900 3541 7076 -113 122 -795 C \nATOM 1424 CZ3 TRP A 176 16.470 -3.877 -64.687 1.00 39.40 C \nANISOU 1424 CZ3 TRP A 176 3345 4011 7614 -88 74 -835 C \nATOM 1425 CH2 TRP A 176 15.115 -4.139 -64.873 1.00 40.41 C \nANISOU 1425 CH2 TRP A 176 3509 4123 7721 -98 77 -806 C \nATOM 1426 N GLY A 177 17.126 2.118 -68.028 1.00 29.88 N \nANISOU 1426 N GLY A 177 2139 2961 6251 -218 325 -823 N \nATOM 1427 CA GLY A 177 16.294 3.289 -68.197 1.00 33.12 C \nANISOU 1427 CA GLY A 177 2605 3365 6616 -233 366 -784 C \nATOM 1428 C GLY A 177 15.701 3.405 -69.589 1.00 34.66 C \nANISOU 1428 C GLY A 177 2797 3585 6787 -225 400 -786 C \nATOM 1429 O GLY A 177 16.070 2.655 -70.461 1.00 32.05 O \nANISOU 1429 O GLY A 177 2421 3282 6476 -216 396 -822 O \nATOM 1430 N ILE A 178 14.817 4.407 -69.760 1.00 35.06 N \nANISOU 1430 N ILE A 178 2900 3629 6791 -227 436 -746 N \nATOM 1431 CA ILE A 178 14.152 4.651 -71.019 1.00 35.84 C \nANISOU 1431 CA ILE A 178 3003 3754 6859 -217 470 -740 C \nATOM 1432 C ILE A 178 14.123 6.164 -71.248 1.00 41.55 C \nANISOU 1432 C ILE A 178 3783 4474 7531 -237 517 -715 C \nATOM 1433 O ILE A 178 14.005 6.928 -70.273 1.00 39.85 O \nANISOU 1433 O ILE A 178 3620 4225 7296 -243 521 -686 O \nATOM 1434 CB ILE A 178 12.705 4.095 -71.053 1.00 37.25 C \nANISOU 1434 CB ILE A 178 3191 3935 7027 -183 459 -709 C \nATOM 1435 CG1 ILE A 178 12.057 4.379 -72.390 1.00 38.42 C \nANISOU 1435 CG1 ILE A 178 3339 4119 7139 -174 495 -702 C \nATOM 1436 CG2 ILE A 178 11.822 4.772 -70.043 1.00 37.21 C \nANISOU 1436 CG2 ILE A 178 3241 3904 6992 -170 462 -659 C \nATOM 1437 CD1 ILE A 178 10.707 3.738 -72.581 1.00 40.10 C \nANISOU 1437 CD1 ILE A 178 3548 4351 7337 -147 485 -678 C \nATOM 1438 N HIS A 179 14.299 6.589 -72.517 1.00 38.98 N \nANISOU 1438 N HIS A 179 3452 4178 7180 -249 553 -728 N \nATOM 1439 CA HIS A 179 14.297 7.997 -72.822 1.00 37.50 C \nANISOU 1439 CA HIS A 179 3328 3982 6939 -269 598 -705 C \nATOM 1440 C HIS A 179 13.055 8.355 -73.548 1.00 32.82 C \nANISOU 1440 C HIS A 179 2766 3399 6304 -233 625 -670 C \nATOM 1441 O HIS A 179 12.891 7.991 -74.700 1.00 30.12 O \nANISOU 1441 O HIS A 179 2390 3094 5958 -226 636 -685 O \nATOM 1442 CB HIS A 179 15.536 8.447 -73.671 1.00 37.13 C \nANISOU 1442 CB HIS A 179 3262 3963 6884 -319 624 -743 C \nATOM 1443 CG HIS A 179 15.441 9.870 -74.166 1.00 32.78 C \nANISOU 1443 CG HIS A 179 2785 3399 6269 -343 672 -718 C \nATOM 1444 ND1 HIS A 179 15.527 10.206 -75.501 1.00 38.18 N \nANISOU 1444 ND1 HIS A 179 3466 4116 6925 -356 706 -728 N \nATOM 1445 CD2 HIS A 179 15.245 11.020 -73.503 1.00 30.68 C \nANISOU 1445 CD2 HIS A 179 2607 3089 5961 -353 692 -683 C \nATOM 1446 CE1 HIS A 179 15.368 11.514 -75.634 1.00 33.37 C \nANISOU 1446 CE1 HIS A 179 2943 3480 6258 -373 744 -697 C \nATOM 1447 NE2 HIS A 179 15.228 12.027 -74.431 1.00 37.02 N \nANISOU 1447 NE2 HIS A 179 3463 3893 6710 -372 737 -671 N \nATOM 1448 N HIS A 180 12.241 9.175 -72.908 1.00 31.51 N \nANISOU 1448 N HIS A 180 2669 3203 6099 -209 638 -624 N \nATOM 1449 CA HIS A 180 11.077 9.729 -73.551 1.00 29.63 C \nANISOU 1449 CA HIS A 180 2470 2980 5809 -168 667 -585 C \nATOM 1450 C HIS A 180 11.539 10.969 -74.290 1.00 30.64 C \nANISOU 1450 C HIS A 180 2656 3098 5889 -193 713 -581 C \nATOM 1451 O HIS A 180 11.823 11.986 -73.652 1.00 32.81 O \nANISOU 1451 O HIS A 180 3004 3328 6135 -209 730 -564 O \nATOM 1452 CB HIS A 180 9.992 10.050 -72.506 1.00 30.56 C \nANISOU 1452 CB HIS A 180 2636 3075 5901 -124 661 -538 C \nATOM 1453 CG HIS A 180 9.574 8.890 -71.648 1.00 27.12 C \nANISOU 1453 CG HIS A 180 2153 2645 5507 -110 615 -539 C \nATOM 1454 ND1 HIS A 180 8.955 7.782 -72.155 1.00 27.17 N \nANISOU 1454 ND1 HIS A 180 2099 2693 5530 -94 594 -547 N \nATOM 1455 CD2 HIS A 180 9.718 8.649 -70.339 1.00 27.36 C \nANISOU 1455 CD2 HIS A 180 2189 2644 5562 -116 584 -535 C \nATOM 1456 CE1 HIS A 180 8.700 6.899 -71.204 1.00 25.89 C \nANISOU 1456 CE1 HIS A 180 1913 2524 5401 -91 553 -546 C \nATOM 1457 NE2 HIS A 180 9.124 7.410 -70.074 1.00 29.56 N \nANISOU 1457 NE2 HIS A 180 2416 2946 5872 -101 546 -538 N \nATOM 1458 N SER A 181 11.583 10.897 -75.614 1.00 30.78 N \nANISOU 1458 N SER A 181 2646 3154 5894 -198 734 -595 N \nATOM 1459 CA SER A 181 11.844 12.018 -76.459 1.00 38.45 C \nANISOU 1459 CA SER A 181 3675 4121 6814 -218 778 -587 C \nATOM 1460 C SER A 181 10.693 12.973 -76.581 1.00 42.55 C \nANISOU 1460 C SER A 181 4274 4625 7266 -165 807 -532 C \nATOM 1461 O SER A 181 9.586 12.694 -76.078 1.00 53.02 O \nANISOU 1461 O SER A 181 5600 5959 8587 -107 793 -501 O \nATOM 1462 CB SER A 181 12.244 11.508 -77.866 1.00 45.61 C \nANISOU 1462 CB SER A 181 4517 5081 7730 -240 788 -622 C \nATOM 1463 OG SER A 181 11.425 10.384 -78.285 1.00 41.07 O \nANISOU 1463 OG SER A 181 3876 4549 7179 -200 767 -625 O \nATOM 1464 N ASN A 182 10.907 14.088 -77.285 1.00 47.04 N \nANISOU 1464 N ASN A 182 4913 5179 7781 -180 848 -520 N \nATOM 1465 CA ASN A 182 9.919 15.231 -77.312 1.00 53.62 C \nANISOU 1465 CA ASN A 182 5848 5985 8541 -123 880 -465 C \nATOM 1466 C ASN A 182 9.002 15.276 -78.521 1.00 55.86 C \nANISOU 1466 C ASN A 182 6122 6317 8784 -75 901 -442 C \nATOM 1467 O ASN A 182 7.828 15.628 -78.394 1.00 62.84 O \nANISOU 1467 O ASN A 182 7044 7208 9624 -1 909 -397 O \nATOM 1468 CB ASN A 182 10.628 16.542 -77.201 1.00 55.20 C \nANISOU 1468 CB ASN A 182 6155 6125 8695 -166 912 -458 C \nATOM 1469 CG ASN A 182 11.186 16.749 -75.838 1.00 63.34 C \nANISOU 1469 CG ASN A 182 7219 7102 9743 -197 895 -463 C \nATOM 1470 OD1 ASN A 182 10.516 16.432 -74.822 1.00 64.88 O \nANISOU 1470 OD1 ASN A 182 7410 7287 9954 -150 872 -445 O \nATOM 1471 ND2 ASN A 182 12.383 17.314 -75.772 1.00 62.11 N \nANISOU 1471 ND2 ASN A 182 7100 6917 9581 -278 908 -488 N \nATOM 1472 N ASP A 183 9.503 14.805 -79.649 1.00 56.74 N \nANISOU 1472 N ASP A 183 6172 6472 8912 -112 905 -474 N \nATOM 1473 CA ASP A 183 8.748 14.805 -80.889 1.00 54.82 C \nANISOU 1473 CA ASP A 183 5915 6282 8633 -76 925 -457 C \nATOM 1474 C ASP A 183 9.311 13.811 -81.892 1.00 56.47 C \nANISOU 1474 C ASP A 183 6024 6546 8884 -120 916 -505 C \nATOM 1475 O ASP A 183 10.421 13.268 -81.712 1.00 51.94 O \nANISOU 1475 O ASP A 183 5403 5969 8363 -179 899 -553 O \nATOM 1476 CB ASP A 183 8.761 16.219 -81.522 1.00 59.41 C \nANISOU 1476 CB ASP A 183 6604 6832 9139 -72 970 -427 C \nATOM 1477 CG ASP A 183 10.168 16.869 -81.549 1.00 59.81 C \nANISOU 1477 CG ASP A 183 6700 6835 9188 -160 986 -456 C \nATOM 1478 OD1 ASP A 183 10.409 17.833 -80.824 1.00 64.21 O \nANISOU 1478 OD1 ASP A 183 7357 7327 9714 -171 999 -437 O \nATOM 1479 OD2 ASP A 183 11.002 16.462 -82.321 1.00 64.51 O \nANISOU 1479 OD2 ASP A 183 7238 7465 9809 -220 987 -496 O \nATOM 1480 N ALA A 184 8.564 13.610 -82.985 1.00 53.83 N \nANISOU 1480 N ALA A 184 5661 6269 8522 -89 928 -493 N \nATOM 1481 CA ALA A 184 8.949 12.626 -83.992 1.00 54.24 C \nANISOU 1481 CA ALA A 184 5621 6377 8609 -123 921 -537 C \nATOM 1482 C ALA A 184 10.351 12.921 -84.542 1.00 59.65 C \nANISOU 1482 C ALA A 184 6305 7052 9305 -198 937 -579 C \nATOM 1483 O ALA A 184 11.119 12.013 -84.814 1.00 66.33 O \nANISOU 1483 O ALA A 184 7074 7927 10203 -238 919 -630 O \nATOM 1484 CB ALA A 184 7.934 12.561 -85.118 1.00 45.80 C \nANISOU 1484 CB ALA A 184 4534 5371 7497 -83 937 -513 C \nATOM 1485 N ALA A 185 10.664 14.198 -84.704 1.00 62.86 N \nANISOU 1485 N ALA A 185 6803 7422 9659 -216 970 -557 N \nATOM 1486 CA ALA A 185 11.952 14.621 -85.275 1.00 62.59 C \nANISOU 1486 CA ALA A 185 6776 7385 9620 -296 989 -592 C \nATOM 1487 C ALA A 185 13.126 14.179 -84.394 1.00 60.44 C \nANISOU 1487 C ALA A 185 6465 7095 9404 -350 964 -636 C \nATOM 1488 O ALA A 185 14.065 13.523 -84.887 1.00 64.47 O \nANISOU 1488 O ALA A 185 6899 7648 9950 -399 957 -689 O \nATOM 1489 CB ALA A 185 11.964 16.135 -85.499 1.00 63.16 C \nANISOU 1489 CB ALA A 185 6972 7411 9617 -307 1029 -553 C \nATOM 1490 N GLU A 186 13.076 14.536 -83.109 1.00 54.32 N \nANISOU 1490 N GLU A 186 5741 6264 8633 -340 952 -617 N \nATOM 1491 CA GLU A 186 14.103 14.111 -82.145 1.00 55.67 C \nANISOU 1491 CA GLU A 186 5875 6421 8855 -385 925 -654 C \nATOM 1492 C GLU A 186 14.220 12.637 -82.118 1.00 56.18 C \nANISOU 1492 C GLU A 186 5827 6529 8989 -371 888 -694 C \nATOM 1493 O GLU A 186 15.316 12.085 -82.044 1.00 62.03 O \nANISOU 1493 O GLU A 186 6506 7293 9770 -416 872 -742 O \nATOM 1494 CB GLU A 186 13.822 14.582 -80.732 1.00 55.90 C \nANISOU 1494 CB GLU A 186 5972 6387 8880 -365 914 -623 C \nATOM 1495 CG GLU A 186 14.949 14.315 -79.743 1.00 62.12 C \nANISOU 1495 CG GLU A 186 6732 7161 9711 -419 889 -658 C \nATOM 1496 CD GLU A 186 14.596 14.633 -78.285 1.00 67.56 C \nANISOU 1496 CD GLU A 186 7478 7791 10401 -396 874 -629 C \nATOM 1497 OE1 GLU A 186 13.435 15.020 -77.999 1.00 76.17 O \nANISOU 1497 OE1 GLU A 186 8628 8852 11462 -332 880 -582 O \nATOM 1498 OE2 GLU A 186 15.513 14.523 -77.430 1.00 63.52 O \nANISOU 1498 OE2 GLU A 186 6951 7267 9917 -442 855 -653 O \nATOM 1499 N GLN A 187 13.079 11.976 -82.193 1.00 59.45 N \nANISOU 1499 N GLN A 187 6216 6960 9414 -309 873 -674 N \nATOM 1500 CA GLN A 187 13.095 10.517 -82.123 1.00 50.88 C \nANISOU 1500 CA GLN A 187 5035 5906 8391 -295 836 -710 C \nATOM 1501 C GLN A 187 13.940 9.974 -83.249 1.00 49.53 C \nANISOU 1501 C GLN A 187 4795 5788 8237 -333 842 -762 C \nATOM 1502 O GLN A 187 14.890 9.226 -83.005 1.00 62.90 O \nANISOU 1502 O GLN A 187 6428 7493 9978 -357 819 -809 O \nATOM 1503 CB GLN A 187 11.685 9.946 -82.157 1.00 43.64 C \nANISOU 1503 CB GLN A 187 4105 5006 7469 -233 823 -679 C \nATOM 1504 CG GLN A 187 11.651 8.402 -82.221 1.00 37.98 C \nANISOU 1504 CG GLN A 187 3301 4320 6809 -226 786 -716 C \nATOM 1505 CD GLN A 187 12.138 7.735 -80.929 1.00 38.17 C \nANISOU 1505 CD GLN A 187 3305 4309 6887 -230 746 -735 C \nATOM 1506 OE1 GLN A 187 12.138 8.326 -79.865 1.00 34.37 O \nANISOU 1506 OE1 GLN A 187 2873 3785 6401 -226 741 -709 O \nATOM 1507 NE2 GLN A 187 12.508 6.466 -81.026 1.00 42.58 N \nANISOU 1507 NE2 GLN A 187 3797 4886 7497 -233 715 -778 N \nATOM 1508 N THR A 188 13.616 10.373 -84.480 1.00 45.70 N \nANISOU 1508 N THR A 188 4320 5336 7710 -335 874 -753 N \nATOM 1509 CA THR A 188 14.345 9.926 -85.681 1.00 44.14 C \nANISOU 1509 CA THR A 188 4058 5193 7520 -371 885 -801 C \nATOM 1510 C THR A 188 15.816 10.274 -85.654 1.00 49.01 C \nANISOU 1510 C THR A 188 4662 5817 8143 -436 893 -841 C \nATOM 1511 O THR A 188 16.647 9.480 -86.065 1.00 54.16 O \nANISOU 1511 O THR A 188 5237 6512 8829 -457 882 -895 O \nATOM 1512 CB THR A 188 13.710 10.466 -86.979 1.00 48.63 C \nANISOU 1512 CB THR A 188 4650 5794 8033 -365 921 -778 C \nATOM 1513 OG1 THR A 188 12.686 11.431 -86.699 1.00 52.50 O \nANISOU 1513 OG1 THR A 188 5226 6250 8471 -326 938 -714 O \nATOM 1514 CG2 THR A 188 13.050 9.329 -87.770 1.00 52.58 C \nANISOU 1514 CG2 THR A 188 5080 6345 8553 -335 909 -795 C \nATOM 1515 N LYS A 189 16.142 11.488 -85.206 1.00 62.38 N \nANISOU 1515 N LYS A 189 6434 7471 9795 -470 914 -815 N \nATOM 1516 CA LYS A 189 17.550 11.952 -85.182 1.00 61.22 C \nANISOU 1516 CA LYS A 189 6281 7339 9641 -547 925 -849 C \nATOM 1517 C LYS A 189 18.387 11.195 -84.186 1.00 62.87 C \nANISOU 1517 C LYS A 189 6430 7551 9906 -555 888 -887 C \nATOM 1518 O LYS A 189 19.567 10.947 -84.429 1.00 59.86 O \nANISOU 1518 O LYS A 189 5989 7217 9537 -602 887 -936 O \nATOM 1519 CB LYS A 189 17.694 13.450 -84.943 1.00 67.89 C \nANISOU 1519 CB LYS A 189 7236 8138 10422 -590 957 -812 C \nATOM 1520 CG LYS A 189 17.176 14.004 -83.637 1.00 74.70 C \nANISOU 1520 CG LYS A 189 8178 8926 11277 -565 947 -769 C \nATOM 1521 CD LYS A 189 17.878 15.334 -83.284 1.00 91.91 C \nANISOU 1521 CD LYS A 189 10453 11067 13402 -636 974 -756 C \nATOM 1522 CE LYS A 189 16.902 16.460 -82.864 1.00 97.36 C \nANISOU 1522 CE LYS A 189 11277 11681 14036 -601 995 -692 C \nATOM 1523 NZ LYS A 189 17.551 17.790 -82.628 1.00 92.15 N \nANISOU 1523 NZ LYS A 189 10726 10974 13313 -674 1024 -678 N \nATOM 1524 N LEU A 190 17.789 10.829 -83.052 1.00 56.26 N \nANISOU 1524 N LEU A 190 5607 6668 9100 -509 858 -865 N \nATOM 1525 CA LEU A 190 18.529 10.082 -82.068 1.00 53.11 C \nANISOU 1525 CA LEU A 190 5155 6270 8754 -511 821 -897 C \nATOM 1526 C LEU A 190 18.620 8.628 -82.412 1.00 58.08 C \nANISOU 1526 C LEU A 190 5690 6939 9438 -475 791 -940 C \nATOM 1527 O LEU A 190 19.675 7.997 -82.223 1.00 60.61 O \nANISOU 1527 O LEU A 190 5943 7292 9792 -489 771 -988 O \nATOM 1528 CB LEU A 190 17.889 10.211 -80.697 1.00 48.52 C \nANISOU 1528 CB LEU A 190 4625 5626 8185 -479 799 -857 C \nATOM 1529 CG LEU A 190 18.156 11.562 -80.052 1.00 50.96 C \nANISOU 1529 CG LEU A 190 5025 5891 8447 -523 821 -827 C \nATOM 1530 CD1 LEU A 190 17.445 11.679 -78.706 1.00 46.91 C \nANISOU 1530 CD1 LEU A 190 4564 5317 7944 -486 800 -788 C \nATOM 1531 CD2 LEU A 190 19.656 11.775 -79.841 1.00 50.50 C \nANISOU 1531 CD2 LEU A 190 4935 5863 8388 -598 821 -868 C \nATOM 1532 N TYR A 191 17.499 8.089 -82.885 1.00 61.65 N \nANISOU 1532 N TYR A 191 6140 7388 9896 -425 788 -922 N \nATOM 1533 CA TYR A 191 17.328 6.632 -82.871 1.00 58.40 C \nANISOU 1533 CA TYR A 191 5662 6990 9537 -383 751 -953 C \nATOM 1534 C TYR A 191 16.950 5.998 -84.128 1.00 65.60 C \nANISOU 1534 C TYR A 191 6534 7944 10447 -368 761 -973 C \nATOM 1535 O TYR A 191 17.049 4.790 -84.217 1.00 67.03 O \nANISOU 1535 O TYR A 191 6662 8138 10670 -343 734 -1009 O \nATOM 1536 CB TYR A 191 16.240 6.246 -81.921 1.00 51.05 C \nANISOU 1536 CB TYR A 191 4761 6013 8624 -337 724 -915 C \nATOM 1537 CG TYR A 191 16.372 6.811 -80.562 1.00 45.39 C \nANISOU 1537 CG TYR A 191 4090 5247 7910 -343 711 -888 C \nATOM 1538 CD1 TYR A 191 17.359 6.348 -79.708 1.00 45.35 C \nANISOU 1538 CD1 TYR A 191 4049 5237 7944 -354 681 -919 C \nATOM 1539 CD2 TYR A 191 15.530 7.787 -80.115 1.00 45.94 C \nANISOU 1539 CD2 TYR A 191 4236 5279 7939 -334 728 -832 C \nATOM 1540 CE1 TYR A 191 17.523 6.869 -78.427 1.00 42.81 C \nANISOU 1540 CE1 TYR A 191 3769 4874 7624 -365 669 -895 C \nATOM 1541 CE2 TYR A 191 15.695 8.323 -78.847 1.00 47.08 C \nANISOU 1541 CE2 TYR A 191 4427 5378 8085 -342 718 -810 C \nATOM 1542 CZ TYR A 191 16.688 7.849 -78.023 1.00 43.77 C \nANISOU 1542 CZ TYR A 191 3969 4955 7706 -361 688 -842 C \nATOM 1543 OH TYR A 191 16.823 8.382 -76.777 1.00 44.52 O \nANISOU 1543 OH TYR A 191 4109 5007 7798 -372 678 -820 O \nATOM 1544 N GLN A 192 16.481 6.787 -85.085 1.00 70.75 N \nANISOU 1544 N GLN A 192 7218 8614 11049 -382 799 -950 N \nATOM 1545 CA GLN A 192 16.167 6.246 -86.376 1.00 67.20 C \nANISOU 1545 CA GLN A 192 6730 8212 10592 -375 812 -970 C \nATOM 1546 C GLN A 192 14.736 5.728 -86.317 1.00 61.55 C \nANISOU 1546 C GLN A 192 6029 7483 9876 -328 798 -935 C \nATOM 1547 O GLN A 192 13.854 6.366 -86.873 1.00 57.70 O \nANISOU 1547 O GLN A 192 5577 7004 9340 -319 824 -895 O \nATOM 1548 CB GLN A 192 17.130 5.144 -86.767 1.00 79.78 C \nANISOU 1548 CB GLN A 192 8242 9843 12227 -378 794 -1039 C \nATOM 1549 CG GLN A 192 17.766 5.255 -88.166 1.00 93.15 C \nANISOU 1549 CG GLN A 192 9896 11601 13898 -411 825 -1077 C \nATOM 1550 CD GLN A 192 17.076 6.242 -89.124 1.00 87.75 C \nANISOU 1550 CD GLN A 192 9256 10931 13152 -430 866 -1038 C \nATOM 1551 OE1 GLN A 192 17.428 7.411 -89.157 1.00 92.08 O \nANISOU 1551 OE1 GLN A 192 9850 11476 13661 -469 894 -1017 O \nATOM 1552 NE2 GLN A 192 16.121 5.764 -89.918 1.00 76.39 N \nANISOU 1552 NE2 GLN A 192 7809 9512 11704 -404 871 -1029 N \nATOM 1553 N ASN A 193 14.480 4.631 -85.594 1.00 56.75 N \nANISOU 1553 N ASN A 193 5396 6853 9312 -298 758 -947 N \nATOM 1554 CA ASN A 193 13.173 4.001 -85.648 1.00 52.85 C \nANISOU 1554 CA ASN A 193 4908 6361 8814 -265 744 -921 C \nATOM 1555 C ASN A 193 12.124 4.849 -84.915 1.00 48.01 C \nANISOU 1555 C ASN A 193 4357 5720 8165 -244 750 -854 C \nATOM 1556 O ASN A 193 12.377 5.307 -83.820 1.00 49.53 O \nANISOU 1556 O ASN A 193 4582 5870 8367 -243 740 -836 O \nATOM 1557 CB ASN A 193 13.260 2.578 -85.065 1.00 60.58 C \nANISOU 1557 CB ASN A 193 5851 7321 9846 -247 699 -954 C \nATOM 1558 CG ASN A 193 14.645 1.925 -85.290 1.00 52.95 C \nANISOU 1558 CG ASN A 193 4833 6366 8920 -258 687 -1020 C \nATOM 1559 OD1 ASN A 193 15.120 1.931 -86.371 1.00 47.35 O \nANISOU 1559 OD1 ASN A 193 4092 5698 8199 -274 710 -1053 O \nATOM 1560 ND2 ASN A 193 15.283 1.414 -84.247 1.00 51.51 N \nANISOU 1560 ND2 ASN A 193 4641 6149 8781 -246 653 -1039 N \nATOM 1561 N PRO A 194 10.943 5.053 -85.520 1.00 42.76 N \nANISOU 1561 N PRO A 194 3707 5085 7456 -224 767 -816 N \nATOM 1562 CA PRO A 194 9.887 5.876 -85.009 1.00 42.04 C \nANISOU 1562 CA PRO A 194 3671 4982 7322 -194 777 -754 C \nATOM 1563 C PRO A 194 9.047 5.193 -83.936 1.00 47.42 C \nANISOU 1563 C PRO A 194 4352 5646 8020 -167 741 -732 C \nATOM 1564 O PRO A 194 8.533 5.841 -83.024 1.00 44.21 O \nANISOU 1564 O PRO A 194 3992 5214 7594 -143 740 -688 O \nATOM 1565 CB PRO A 194 9.003 6.120 -86.237 1.00 41.49 C \nANISOU 1565 CB PRO A 194 3597 4969 7198 -182 805 -731 C \nATOM 1566 CG PRO A 194 9.222 4.947 -87.080 1.00 41.72 C \nANISOU 1566 CG PRO A 194 3562 5034 7254 -202 793 -780 C \nATOM 1567 CD PRO A 194 10.650 4.595 -86.894 1.00 45.50 C \nANISOU 1567 CD PRO A 194 4016 5487 7784 -231 782 -836 C \nATOM 1568 N THR A 195 8.926 3.877 -84.047 1.00 51.61 N \nANISOU 1568 N THR A 195 4835 6190 8584 -172 711 -763 N \nATOM 1569 CA THR A 195 8.165 3.107 -83.051 1.00 51.68 C \nANISOU 1569 CA THR A 195 4845 6184 8608 -157 674 -746 C \nATOM 1570 C THR A 195 9.068 2.099 -82.394 1.00 53.12 C \nANISOU 1570 C THR A 195 5004 6324 8854 -171 636 -792 C \nATOM 1571 O THR A 195 9.663 1.235 -83.063 1.00 56.18 O \nANISOU 1571 O THR A 195 5354 6721 9270 -185 628 -842 O \nATOM 1572 CB THR A 195 6.957 2.388 -83.706 1.00 47.16 C \nANISOU 1572 CB THR A 195 4248 5667 8004 -153 670 -733 C \nATOM 1573 OG1 THR A 195 6.263 3.316 -84.513 1.00 47.24 O \nANISOU 1573 OG1 THR A 195 4271 5726 7953 -137 707 -697 O \nATOM 1574 CG2 THR A 195 6.021 1.902 -82.630 1.00 44.97 C \nANISOU 1574 CG2 THR A 195 3981 5383 7723 -140 638 -702 C \nATOM 1575 N THR A 196 9.201 2.209 -81.091 1.00 54.65 N \nANISOU 1575 N THR A 196 5223 6473 9070 -162 613 -776 N \nATOM 1576 CA THR A 196 10.283 1.473 -80.388 1.00 57.96 C \nANISOU 1576 CA THR A 196 5624 6849 9549 -171 579 -818 C \nATOM 1577 C THR A 196 9.807 0.951 -79.036 1.00 51.18 C \nANISOU 1577 C THR A 196 4785 5953 8710 -160 540 -796 C \nATOM 1578 O THR A 196 8.722 1.294 -78.604 1.00 51.42 O \nANISOU 1578 O THR A 196 4840 5991 8705 -148 542 -749 O \nATOM 1579 CB THR A 196 11.547 2.370 -80.172 1.00 58.57 C \nANISOU 1579 CB THR A 196 5709 6908 9638 -185 596 -834 C \nATOM 1580 OG1 THR A 196 11.200 3.567 -79.464 1.00 55.29 O \nANISOU 1580 OG1 THR A 196 5344 6471 9191 -179 613 -785 O \nATOM 1581 CG2 THR A 196 12.130 2.774 -81.441 1.00 68.02 C \nANISOU 1581 CG2 THR A 196 6884 8142 10818 -203 631 -860 C \nATOM 1582 N TYR A 197 10.693 0.203 -78.353 1.00 42.85 N \nANISOU 1582 N TYR A 197 3717 4860 7706 -162 505 -830 N \nATOM 1583 CA TYR A 197 10.354 -0.518 -77.134 1.00 39.40 C \nANISOU 1583 CA TYR A 197 3295 4384 7293 -156 462 -817 C \nATOM 1584 C TYR A 197 11.598 -0.984 -76.434 1.00 36.71 C \nANISOU 1584 C TYR A 197 2941 4003 7003 -153 432 -854 C \nATOM 1585 O TYR A 197 12.601 -1.352 -77.105 1.00 35.07 O \nANISOU 1585 O TYR A 197 2701 3805 6820 -153 435 -903 O \nATOM 1586 CB TYR A 197 9.463 -1.777 -77.488 1.00 37.87 C \nANISOU 1586 CB TYR A 197 3093 4202 7094 -160 438 -823 C \nATOM 1587 CG TYR A 197 10.200 -2.762 -78.359 1.00 33.09 C \nANISOU 1587 CG TYR A 197 2459 3597 6517 -163 429 -881 C \nATOM 1588 CD1 TYR A 197 10.776 -3.858 -77.826 1.00 33.39 C \nANISOU 1588 CD1 TYR A 197 2497 3591 6598 -156 388 -914 C \nATOM 1589 CD2 TYR A 197 10.329 -2.574 -79.712 1.00 40.78 C \nANISOU 1589 CD2 TYR A 197 3409 4615 7473 -170 463 -904 C \nATOM 1590 CE1 TYR A 197 11.515 -4.740 -78.573 1.00 33.56 C \nANISOU 1590 CE1 TYR A 197 2498 3611 6644 -149 381 -970 C \nATOM 1591 CE2 TYR A 197 11.057 -3.473 -80.503 1.00 41.78 C \nANISOU 1591 CE2 TYR A 197 3508 4742 7623 -169 456 -961 C \nATOM 1592 CZ TYR A 197 11.660 -4.555 -79.890 1.00 40.43 C \nANISOU 1592 CZ TYR A 197 3341 4524 7496 -155 414 -995 C \nATOM 1593 OH TYR A 197 12.361 -5.488 -80.605 1.00 48.24 O \nANISOU 1593 OH TYR A 197 4310 5511 8508 -144 406 -1052 O \nATOM 1594 N ILE A 198 11.540 -1.053 -75.111 1.00 32.88 N \nANISOU 1594 N ILE A 198 2478 3479 6534 -148 403 -832 N \nATOM 1595 CA ILE A 198 12.553 -1.752 -74.367 1.00 34.73 C \nANISOU 1595 CA ILE A 198 2701 3677 6817 -141 365 -864 C \nATOM 1596 C ILE A 198 11.856 -2.959 -73.782 1.00 44.45 C \nANISOU 1596 C ILE A 198 3950 4879 8062 -135 322 -857 C \nATOM 1597 O ILE A 198 10.719 -2.852 -73.264 1.00 44.15 O \nANISOU 1597 O ILE A 198 3938 4840 7996 -143 317 -813 O \nATOM 1598 CB ILE A 198 13.105 -0.934 -73.196 1.00 40.86 C \nANISOU 1598 CB ILE A 198 3494 4430 7603 -145 361 -845 C \nATOM 1599 CG1 ILE A 198 13.940 0.214 -73.673 1.00 40.33 C \nANISOU 1599 CG1 ILE A 198 3417 4387 7521 -160 401 -855 C \nATOM 1600 CG2 ILE A 198 13.980 -1.810 -72.277 1.00 39.50 C \nANISOU 1600 CG2 ILE A 198 3310 4222 7478 -132 314 -872 C \nATOM 1601 CD1 ILE A 198 13.137 1.451 -74.022 1.00 45.52 C \nANISOU 1601 CD1 ILE A 198 4109 5060 8126 -169 444 -813 C \nATOM 1602 N SER A 199 12.528 -4.104 -73.812 1.00 48.47 N \nANISOU 1602 N SER A 199 4445 5364 8608 -122 289 -900 N \nATOM 1603 CA SER A 199 11.917 -5.369 -73.376 1.00 50.68 C \nANISOU 1603 CA SER A 199 4752 5609 8897 -121 246 -898 C \nATOM 1604 C SER A 199 12.913 -6.044 -72.468 1.00 53.02 C \nANISOU 1604 C SER A 199 5051 5858 9238 -98 204 -923 C \nATOM 1605 O SER A 199 14.016 -6.369 -72.874 1.00 56.47 O \nANISOU 1605 O SER A 199 5460 6296 9701 -74 201 -969 O \nATOM 1606 CB SER A 199 11.560 -6.230 -74.592 1.00 55.21 C \nANISOU 1606 CB SER A 199 5320 6198 9458 -127 251 -928 C \nATOM 1607 OG SER A 199 11.673 -7.605 -74.292 1.00 56.18 O \nANISOU 1607 OG SER A 199 5467 6273 9604 -118 207 -953 O \nATOM 1608 N VAL A 200 12.555 -6.199 -71.200 1.00 55.55 N \nANISOU 1608 N VAL A 200 5401 6141 9564 -102 172 -890 N \nATOM 1609 CA VAL A 200 13.484 -6.752 -70.200 1.00 49.38 C \nANISOU 1609 CA VAL A 200 4623 5317 8822 -78 129 -907 C \nATOM 1610 C VAL A 200 12.811 -7.933 -69.502 1.00 49.21 C \nANISOU 1610 C VAL A 200 4649 5246 8805 -83 82 -893 C \nATOM 1611 O VAL A 200 11.634 -7.831 -69.106 1.00 45.25 O \nANISOU 1611 O VAL A 200 4175 4745 8273 -114 80 -851 O \nATOM 1612 CB VAL A 200 13.811 -5.752 -69.126 1.00 44.48 C \nANISOU 1612 CB VAL A 200 4000 4695 8204 -84 132 -878 C \nATOM 1613 CG1 VAL A 200 14.947 -6.260 -68.269 1.00 36.19 C \nANISOU 1613 CG1 VAL A 200 2941 3615 7193 -57 93 -900 C \nATOM 1614 CG2 VAL A 200 14.140 -4.439 -69.729 1.00 51.91 C \nANISOU 1614 CG2 VAL A 200 4914 5683 9127 -96 183 -877 C \nATOM 1615 N GLY A 201 13.538 -9.041 -69.376 1.00 45.49 N \nANISOU 1615 N GLY A 201 4188 4733 8363 -52 44 -930 N \nATOM 1616 CA GLY A 201 12.999 -10.284 -68.834 1.00 49.12 C \nANISOU 1616 CA GLY A 201 4703 5136 8824 -57 -3 -923 C \nATOM 1617 C GLY A 201 13.951 -11.062 -67.956 1.00 51.06 C \nANISOU 1617 C GLY A 201 4966 5328 9106 -16 -51 -942 C \nATOM 1618 O GLY A 201 15.119 -11.257 -68.273 1.00 49.41 O \nANISOU 1618 O GLY A 201 4727 5122 8923 31 -54 -986 O \nATOM 1619 N THR A 202 13.445 -11.497 -66.812 1.00 51.17 N \nANISOU 1619 N THR A 202 5026 5299 9119 -32 -90 -909 N \nATOM 1620 CA THR A 202 14.131 -12.469 -65.981 1.00 47.44 C \nANISOU 1620 CA THR A 202 4587 4765 8674 5 -143 -922 C \nATOM 1621 C THR A 202 13.178 -13.676 -65.811 1.00 56.17 C \nANISOU 1621 C THR A 202 5770 5813 9759 -23 -179 -910 C \nATOM 1622 O THR A 202 12.254 -13.875 -66.594 1.00 67.41 O \nANISOU 1622 O THR A 202 7211 7251 11152 -63 -161 -907 O \nATOM 1623 CB THR A 202 14.515 -11.868 -64.644 1.00 45.05 C \nANISOU 1623 CB THR A 202 4272 4459 8386 8 -161 -892 C \nATOM 1624 OG1 THR A 202 13.366 -11.710 -63.796 1.00 40.77 O \nANISOU 1624 OG1 THR A 202 3766 3906 7819 -43 -171 -839 O \nATOM 1625 CG2 THR A 202 15.099 -10.539 -64.813 1.00 44.99 C \nANISOU 1625 CG2 THR A 202 4199 4511 8382 10 -119 -893 C \nATOM 1626 N SER A 203 13.392 -14.481 -64.784 1.00 59.89 N \nANISOU 1626 N SER A 203 6291 6221 10244 -8 -231 -902 N \nATOM 1627 CA SER A 203 12.435 -15.503 -64.424 1.00 57.40 C \nANISOU 1627 CA SER A 203 6056 5851 9902 -50 -266 -881 C \nATOM 1628 C SER A 203 11.173 -14.902 -63.801 1.00 55.27 C \nANISOU 1628 C SER A 203 5790 5612 9597 -121 -257 -824 C \nATOM 1629 O SER A 203 10.077 -15.489 -63.845 1.00 65.17 O \nANISOU 1629 O SER A 203 7093 6854 10813 -177 -268 -804 O \nATOM 1630 CB SER A 203 13.052 -16.485 -63.465 1.00 57.83 C \nANISOU 1630 CB SER A 203 6167 5828 9978 -11 -324 -886 C \nATOM 1631 OG SER A 203 13.279 -15.865 -62.235 1.00 61.19 O \nANISOU 1631 OG SER A 203 6571 6261 10417 -11 -339 -852 O \nATOM 1632 N THR A 204 11.328 -13.738 -63.220 1.00 48.74 N \nANISOU 1632 N THR A 204 4912 4828 8778 -119 -237 -799 N \nATOM 1633 CA THR A 204 10.262 -13.109 -62.423 1.00 46.28 C \nANISOU 1633 CA THR A 204 4604 4545 8436 -172 -232 -744 C \nATOM 1634 C THR A 204 9.717 -11.876 -63.102 1.00 48.55 C \nANISOU 1634 C THR A 204 4838 4910 8699 -190 -174 -730 C \nATOM 1635 O THR A 204 8.598 -11.494 -62.855 1.00 54.05 O \nANISOU 1635 O THR A 204 5539 5643 9357 -233 -162 -691 O \nATOM 1636 CB THR A 204 10.834 -12.737 -61.035 1.00 55.68 C \nANISOU 1636 CB THR A 204 5790 5716 9650 -155 -258 -722 C \nATOM 1637 OG1 THR A 204 9.967 -13.268 -60.003 1.00 60.65 O \nANISOU 1637 OG1 THR A 204 6472 6316 10255 -200 -295 -683 O \nATOM 1638 CG2 THR A 204 10.992 -11.182 -60.867 1.00 56.02 C \nANISOU 1638 CG2 THR A 204 5773 5819 9694 -153 -214 -705 C \nATOM 1639 N LEU A 205 10.506 -11.293 -64.013 1.00 47.42 N \nANISOU 1639 N LEU A 205 4646 4795 8574 -154 -138 -763 N \nATOM 1640 CA LEU A 205 10.221 -10.018 -64.601 1.00 43.75 C \nANISOU 1640 CA LEU A 205 4136 4397 8091 -162 -84 -751 C \nATOM 1641 C LEU A 205 9.917 -10.188 -66.092 1.00 44.08 C \nANISOU 1641 C LEU A 205 4163 4471 8114 -167 -53 -777 C \nATOM 1642 O LEU A 205 10.600 -10.932 -66.791 1.00 42.87 O \nANISOU 1642 O LEU A 205 4013 4294 7983 -142 -61 -822 O \nATOM 1643 CB LEU A 205 11.442 -9.078 -64.419 1.00 40.63 C \nANISOU 1643 CB LEU A 205 3697 4014 7728 -125 -66 -767 C \nATOM 1644 CG LEU A 205 11.235 -7.675 -64.999 1.00 40.01 C \nANISOU 1644 CG LEU A 205 3581 3995 7626 -133 -9 -754 C \nATOM 1645 CD1 LEU A 205 10.336 -6.837 -64.128 1.00 32.98 C \nANISOU 1645 CD1 LEU A 205 2703 3121 6705 -158 1 -701 C \nATOM 1646 CD2 LEU A 205 12.618 -7.016 -65.223 1.00 43.19 C \nANISOU 1646 CD2 LEU A 205 3942 4410 8058 -103 9 -786 C \nATOM 1647 N ASN A 206 8.973 -9.377 -66.560 1.00 44.53 N \nANISOU 1647 N ASN A 206 4201 4587 8131 -193 -13 -750 N \nATOM 1648 CA ASN A 206 8.464 -9.421 -67.894 1.00 47.04 C \nANISOU 1648 CA ASN A 206 4505 4947 8422 -206 19 -764 C \nATOM 1649 C ASN A 206 7.867 -8.046 -68.199 1.00 47.75 C \nANISOU 1649 C ASN A 206 4561 5104 8477 -211 68 -732 C \nATOM 1650 O ASN A 206 6.659 -7.857 -68.101 1.00 52.35 O \nANISOU 1650 O ASN A 206 5150 5727 9014 -240 76 -694 O \nATOM 1651 CB ASN A 206 7.399 -10.539 -68.035 1.00 42.22 C \nANISOU 1651 CB ASN A 206 3936 4329 7777 -251 -6 -755 C \nATOM 1652 CG ASN A 206 6.944 -10.751 -69.465 1.00 43.39 C \nANISOU 1652 CG ASN A 206 4071 4519 7896 -268 23 -776 C \nATOM 1653 OD1 ASN A 206 7.540 -10.245 -70.439 1.00 57.03 O \nANISOU 1653 OD1 ASN A 206 5762 6272 9637 -241 58 -804 O \nATOM 1654 ND2 ASN A 206 5.886 -11.481 -69.622 1.00 40.90 N \nANISOU 1654 ND2 ASN A 206 3785 4217 7539 -318 10 -762 N \nATOM 1655 N GLN A 207 8.724 -7.106 -68.604 1.00 41.08 N \nANISOU 1655 N GLN A 207 3683 4274 7650 -182 101 -748 N \nATOM 1656 CA GLN A 207 8.275 -5.784 -68.937 1.00 38.59 C \nANISOU 1656 CA GLN A 207 3349 4012 7303 -182 148 -720 C \nATOM 1657 C GLN A 207 8.458 -5.407 -70.428 1.00 40.12 C \nANISOU 1657 C GLN A 207 3512 4248 7485 -175 191 -745 C \nATOM 1658 O GLN A 207 9.198 -5.994 -71.166 1.00 37.12 O \nANISOU 1658 O GLN A 207 3118 3856 7129 -165 188 -790 O \nATOM 1659 CB GLN A 207 8.925 -4.744 -68.042 1.00 39.95 C \nANISOU 1659 CB GLN A 207 3520 4171 7490 -165 156 -705 C \nATOM 1660 CG GLN A 207 10.241 -4.244 -68.486 1.00 43.95 C \nANISOU 1660 CG GLN A 207 4000 4673 8027 -146 175 -741 C \nATOM 1661 CD GLN A 207 10.777 -3.050 -67.650 1.00 43.73 C \nANISOU 1661 CD GLN A 207 3975 4639 8001 -142 190 -722 C \nATOM 1662 OE1 GLN A 207 11.788 -2.422 -68.007 1.00 40.75 O \nANISOU 1662 OE1 GLN A 207 3578 4270 7637 -137 212 -746 O \nATOM 1663 NE2 GLN A 207 10.132 -2.764 -66.553 1.00 43.39 N \nANISOU 1663 NE2 GLN A 207 3960 4585 7943 -149 177 -682 N \nATOM 1664 N ARG A 208 7.687 -4.441 -70.874 1.00 40.86 N \nANISOU 1664 N ARG A 208 3598 4393 7534 -177 231 -714 N \nATOM 1665 CA ARG A 208 7.867 -3.903 -72.177 1.00 38.51 C \nANISOU 1665 CA ARG A 208 3275 4135 7222 -171 273 -732 C \nATOM 1666 C ARG A 208 7.521 -2.434 -72.091 1.00 46.07 C \nANISOU 1666 C ARG A 208 4237 5123 8144 -158 313 -693 C \nATOM 1667 O ARG A 208 6.397 -2.097 -71.755 1.00 45.66 O \nANISOU 1667 O ARG A 208 4198 5102 8050 -159 319 -650 O \nATOM 1668 CB ARG A 208 6.994 -4.558 -73.187 1.00 38.15 C \nANISOU 1668 CB ARG A 208 3221 4130 7144 -189 279 -736 C \nATOM 1669 CG ARG A 208 7.716 -4.754 -74.506 1.00 36.59 C \nANISOU 1669 CG ARG A 208 2999 3944 6961 -185 300 -783 C \nATOM 1670 CD ARG A 208 6.833 -5.309 -75.548 1.00 36.13 C \nANISOU 1670 CD ARG A 208 2933 3930 6865 -207 310 -786 C \nATOM 1671 NE ARG A 208 6.348 -4.262 -76.448 1.00 38.35 N \nANISOU 1671 NE ARG A 208 3193 4275 7103 -202 358 -765 N \nATOM 1672 CZ ARG A 208 6.587 -4.192 -77.755 1.00 39.50 C \nANISOU 1672 CZ ARG A 208 3315 4454 7240 -203 386 -792 C \nATOM 1673 NH1 ARG A 208 7.385 -5.098 -78.346 1.00 42.19 N \nANISOU 1673 NH1 ARG A 208 3647 4770 7615 -207 374 -847 N \nATOM 1674 NH2 ARG A 208 6.050 -3.191 -78.457 1.00 37.42 N \nANISOU 1674 NH2 ARG A 208 3040 4248 6932 -197 428 -765 N \nATOM 1675 N LEU A 209 8.513 -1.562 -72.361 1.00 49.78 N \nANISOU 1675 N LEU A 209 4700 5587 8629 -147 340 -710 N \nATOM 1676 CA LEU A 209 8.381 -0.106 -72.148 1.00 38.61 C \nANISOU 1676 CA LEU A 209 3304 4183 7182 -136 376 -676 C \nATOM 1677 C LEU A 209 8.330 0.554 -73.498 1.00 39.18 C \nANISOU 1677 C LEU A 209 3366 4298 7224 -133 422 -681 C \nATOM 1678 O LEU A 209 9.027 0.185 -74.404 1.00 39.00 O \nANISOU 1678 O LEU A 209 3315 4282 7221 -140 428 -722 O \nATOM 1679 CB LEU A 209 9.554 0.422 -71.411 1.00 42.78 C \nANISOU 1679 CB LEU A 209 3841 4671 7742 -138 372 -689 C \nATOM 1680 CG LEU A 209 9.850 -0.200 -70.045 1.00 45.17 C \nANISOU 1680 CG LEU A 209 4153 4929 8080 -140 326 -688 C \nATOM 1681 CD1 LEU A 209 11.208 0.194 -69.493 1.00 40.48 C \nANISOU 1681 CD1 LEU A 209 3556 4307 7520 -145 321 -711 C \nATOM 1682 CD2 LEU A 209 8.743 0.105 -69.084 1.00 46.37 C \nANISOU 1682 CD2 LEU A 209 4337 5081 8201 -136 319 -638 C \nATOM 1683 N VAL A 210 7.373 1.458 -73.656 1.00 48.54 N \nANISOU 1683 N VAL A 210 4571 5515 8355 -117 452 -638 N \nATOM 1684 CA VAL A 210 7.192 2.194 -74.920 1.00 47.03 C \nANISOU 1684 CA VAL A 210 4377 5367 8126 -110 497 -634 C \nATOM 1685 C VAL A 210 7.329 3.656 -74.583 1.00 42.95 C \nANISOU 1685 C VAL A 210 3905 4835 7580 -94 529 -605 C \nATOM 1686 O VAL A 210 6.728 4.108 -73.602 1.00 49.04 O \nANISOU 1686 O VAL A 210 4709 5594 8330 -75 525 -567 O \nATOM 1687 CB VAL A 210 5.803 1.949 -75.538 1.00 46.45 C \nANISOU 1687 CB VAL A 210 4292 5355 8002 -100 505 -606 C \nATOM 1688 CG1 VAL A 210 5.562 2.981 -76.623 1.00 56.48 C \nANISOU 1688 CG1 VAL A 210 5570 6665 9225 -82 553 -590 C \nATOM 1689 CG2 VAL A 210 5.749 0.581 -76.167 1.00 49.41 C \nANISOU 1689 CG2 VAL A 210 4630 5747 8399 -125 481 -641 C \nATOM 1690 N PRO A 211 8.170 4.377 -75.317 1.00 36.74 N \nANISOU 1690 N PRO A 211 3124 4043 6791 -104 561 -624 N \nATOM 1691 CA PRO A 211 8.457 5.786 -75.016 1.00 35.36 C \nANISOU 1691 CA PRO A 211 3005 3844 6587 -98 592 -600 C \nATOM 1692 C PRO A 211 7.259 6.627 -75.299 1.00 34.87 C \nANISOU 1692 C PRO A 211 2980 3810 6458 -60 623 -551 C \nATOM 1693 O PRO A 211 6.610 6.425 -76.357 1.00 35.01 O \nANISOU 1693 O PRO A 211 2973 3880 6448 -48 637 -546 O \nATOM 1694 CB PRO A 211 9.589 6.117 -75.987 1.00 32.38 C \nANISOU 1694 CB PRO A 211 2615 3469 6219 -128 617 -638 C \nATOM 1695 CG PRO A 211 9.501 5.119 -77.066 1.00 34.49 C \nANISOU 1695 CG PRO A 211 2825 3778 6500 -134 610 -669 C \nATOM 1696 CD PRO A 211 9.058 3.870 -76.355 1.00 35.37 C \nANISOU 1696 CD PRO A 211 2909 3883 6645 -127 565 -673 C \nATOM 1697 N LYS A 212 6.909 7.490 -74.378 1.00 34.95 N \nANISOU 1697 N LYS A 212 3046 3793 6441 -36 630 -514 N \nATOM 1698 CA LYS A 212 5.809 8.457 -74.535 1.00 37.25 C \nANISOU 1698 CA LYS A 212 3384 4108 6662 14 662 -464 C \nATOM 1699 C LYS A 212 6.272 9.732 -75.198 1.00 39.21 C \nANISOU 1699 C LYS A 212 3691 4336 6872 16 706 -457 C \nATOM 1700 O LYS A 212 6.876 10.593 -74.555 1.00 37.70 O \nANISOU 1700 O LYS A 212 3559 4089 6675 5 717 -453 O \nATOM 1701 CB LYS A 212 5.287 8.858 -73.130 1.00 38.00 C \nANISOU 1701 CB LYS A 212 3522 4175 6741 42 650 -429 C \nATOM 1702 CG LYS A 212 4.227 7.913 -72.569 1.00 39.49 C \nANISOU 1702 CG LYS A 212 3669 4407 6930 59 618 -412 C \nATOM 1703 CD LYS A 212 4.780 7.123 -71.422 1.00 38.10 C \nANISOU 1703 CD LYS A 212 3476 4190 6811 26 575 -433 C \nATOM 1704 CE LYS A 212 3.882 7.231 -70.217 1.00 41.59 C \nANISOU 1704 CE LYS A 212 3938 4636 7227 54 560 -395 C \nATOM 1705 NZ LYS A 212 4.589 6.807 -68.948 1.00 39.97 N \nANISOU 1705 NZ LYS A 212 3737 4376 7073 23 524 -411 N \nATOM 1706 N ILE A 213 6.024 9.842 -76.484 1.00 44.90 N \nANISOU 1706 N ILE A 213 4396 5099 7564 23 731 -457 N \nATOM 1707 CA ILE A 213 6.552 10.971 -77.271 1.00 53.75 C \nANISOU 1707 CA ILE A 213 5572 6200 8649 15 772 -455 C \nATOM 1708 C ILE A 213 5.546 12.124 -77.070 1.00 61.81 C \nANISOU 1708 C ILE A 213 6672 7218 9596 81 801 -398 C \nATOM 1709 O ILE A 213 4.459 12.095 -77.633 1.00 67.48 O \nANISOU 1709 O ILE A 213 7376 7994 10271 130 810 -369 O \nATOM 1710 CB ILE A 213 6.597 10.627 -78.784 1.00 49.61 C \nANISOU 1710 CB ILE A 213 5001 5729 8118 1 788 -474 C \nATOM 1711 CG1 ILE A 213 7.222 9.251 -79.045 1.00 52.72 C \nANISOU 1711 CG1 ILE A 213 5309 6144 8580 -43 756 -527 C \nATOM 1712 CG2 ILE A 213 7.265 11.740 -79.567 1.00 43.96 C \nANISOU 1712 CG2 ILE A 213 4342 4992 7368 -18 828 -475 C \nATOM 1713 CD1 ILE A 213 8.738 9.253 -79.049 1.00 55.12 C \nANISOU 1713 CD1 ILE A 213 5605 6412 8926 -100 754 -574 C \nATOM 1714 N ALA A 214 5.910 13.140 -76.318 1.00 64.24 N \nANISOU 1714 N ALA A 214 7063 7461 9884 83 815 -383 N \nATOM 1715 CA ALA A 214 5.042 14.300 -76.180 1.00 68.63 C \nANISOU 1715 CA ALA A 214 7706 8005 10364 151 845 -332 C \nATOM 1716 C ALA A 214 5.806 15.588 -75.845 1.00 65.60 C \nANISOU 1716 C ALA A 214 7434 7540 9953 131 873 -326 C \nATOM 1717 O ALA A 214 6.991 15.569 -75.548 1.00 62.37 O \nANISOU 1717 O ALA A 214 7027 7087 9582 60 866 -361 O \nATOM 1718 CB ALA A 214 4.019 14.017 -75.100 1.00 69.60 C \nANISOU 1718 CB ALA A 214 7820 8146 10478 205 824 -303 C \nATOM 1719 N THR A 215 5.086 16.695 -75.870 1.00 71.25 N \nANISOU 1719 N THR A 215 8242 8237 10594 197 904 -282 N \nATOM 1720 CA THR A 215 5.638 18.035 -75.541 1.00 75.21 C \nANISOU 1720 CA THR A 215 8872 8653 11052 186 935 -270 C \nATOM 1721 C THR A 215 5.554 18.270 -74.031 1.00 75.77 C \nANISOU 1721 C THR A 215 8988 8673 11127 199 920 -259 C \nATOM 1722 O THR A 215 4.541 17.971 -73.402 1.00 76.49 O \nANISOU 1722 O THR A 215 9057 8796 11209 265 906 -234 O \nATOM 1723 CB THR A 215 4.858 19.163 -76.290 1.00 72.94 C \nANISOU 1723 CB THR A 215 8678 8361 10675 260 976 -224 C \nATOM 1724 OG1 THR A 215 5.064 19.034 -77.709 1.00 71.24 O \nANISOU 1724 OG1 THR A 215 8428 8186 10453 237 991 -235 O \nATOM 1725 CG2 THR A 215 5.305 20.556 -75.844 1.00 74.93 C \nANISOU 1725 CG2 THR A 215 9081 8515 10874 255 1006 -208 C \nATOM 1726 N ARG A 216 6.620 18.778 -73.439 1.00 83.59 N \nANISOU 1726 N ARG A 216 10038 9591 12130 133 924 -279 N \nATOM 1727 CA ARG A 216 6.614 19.009 -71.994 1.00 92.17 C \nANISOU 1727 CA ARG A 216 11170 10629 13220 138 911 -272 C \nATOM 1728 C ARG A 216 7.191 20.351 -71.626 1.00 87.39 C \nANISOU 1728 C ARG A 216 10706 9933 12564 113 942 -263 C \nATOM 1729 O ARG A 216 7.838 21.009 -72.446 1.00 79.92 O \nANISOU 1729 O ARG A 216 9817 8960 11590 68 970 -270 O \nATOM 1730 CB ARG A 216 7.422 17.950 -71.263 1.00 97.66 C \nANISOU 1730 CB ARG A 216 11774 11333 13999 68 869 -312 C \nATOM 1731 CG ARG A 216 6.813 16.559 -71.272 1.00 96.93 C \nANISOU 1731 CG ARG A 216 11557 11315 13958 91 831 -320 C \nATOM 1732 CD ARG A 216 7.864 15.525 -70.897 1.00 83.52 C \nANISOU 1732 CD ARG A 216 9773 9620 12339 15 794 -366 C \nATOM 1733 NE ARG A 216 7.659 14.234 -71.515 1.00 74.63 N \nANISOU 1733 NE ARG A 216 8535 8561 11260 14 768 -387 N \nATOM 1734 CZ ARG A 216 8.359 13.770 -72.546 1.00 77.97 C \nANISOU 1734 CZ ARG A 216 8904 9010 11712 -30 769 -421 C \nATOM 1735 NH1 ARG A 216 9.322 14.487 -73.112 1.00 84.24 N \nANISOU 1735 NH1 ARG A 216 9737 9778 12491 -79 795 -439 N \nATOM 1736 NH2 ARG A 216 8.083 12.576 -73.027 1.00 78.28 N \nANISOU 1736 NH2 ARG A 216 8849 9104 11788 -26 744 -439 N \nATOM 1737 N SER A 217 6.925 20.725 -70.375 1.00 81.63 N \nANISOU 1737 N SER A 217 10035 9159 11820 138 937 -247 N \nATOM 1738 CA SER A 217 7.534 21.888 -69.739 1.00 81.49 C \nANISOU 1738 CA SER A 217 10153 9050 11761 102 960 -244 C \nATOM 1739 C SER A 217 8.981 21.568 -69.388 1.00 83.22 C \nANISOU 1739 C SER A 217 10336 9249 12033 -20 942 -289 C \nATOM 1740 O SER A 217 9.313 20.474 -68.948 1.00 81.85 O \nANISOU 1740 O SER A 217 10050 9117 11932 -52 904 -316 O \nATOM 1741 CB SER A 217 6.766 22.291 -68.471 1.00 81.21 C \nANISOU 1741 CB SER A 217 10182 8980 11695 170 958 -215 C \nATOM 1742 OG SER A 217 6.406 21.154 -67.668 1.00 77.25 O \nANISOU 1742 OG SER A 217 9566 8532 11254 182 915 -224 O \nATOM 1743 N LYS A 218 9.858 22.537 -69.595 1.00 91.05 N \nANISOU 1743 N LYS A 218 11429 10180 12985 -90 971 -298 N \nATOM 1744 CA LYS A 218 11.288 22.316 -69.419 1.00 87.34 C \nANISOU 1744 CA LYS A 218 10923 9706 12555 -211 958 -342 C \nATOM 1745 C LYS A 218 11.590 22.283 -67.935 1.00 84.18 C \nANISOU 1745 C LYS A 218 10537 9271 12175 -239 936 -348 C \nATOM 1746 O LYS A 218 11.330 23.249 -67.239 1.00 95.58 O \nANISOU 1746 O LYS A 218 12107 10646 13564 -221 956 -325 O \nATOM 1747 CB LYS A 218 12.105 23.394 -70.135 1.00 82.15 C \nANISOU 1747 CB LYS A 218 10370 9002 11839 -287 996 -347 C \nATOM 1748 CG LYS A 218 11.978 23.298 -71.646 1.00 90.82 C \nANISOU 1748 CG LYS A 218 11437 10145 12926 -275 1014 -347 C \nATOM 1749 CD LYS A 218 12.866 24.304 -72.372 1.00 97.53 C \nANISOU 1749 CD LYS A 218 12385 10954 13718 -363 1050 -355 C \nATOM 1750 CE LYS A 218 12.973 24.028 -73.866 1.00101.99 C \nANISOU 1750 CE LYS A 218 12891 11575 14284 -373 1062 -364 C \nATOM 1751 NZ LYS A 218 11.718 24.384 -74.569 1.00108.32 N \nANISOU 1751 NZ LYS A 218 13743 12375 15039 -262 1083 -321 N \nATOM 1752 N VAL A 219 12.118 21.153 -67.471 1.00 81.49 N \nANISOU 1752 N VAL A 219 10072 8980 11912 -277 895 -380 N \nATOM 1753 CA VAL A 219 12.707 20.995 -66.142 1.00 76.75 C \nANISOU 1753 CA VAL A 219 9465 8357 11339 -327 869 -395 C \nATOM 1754 C VAL A 219 14.235 20.943 -66.278 1.00 81.85 C \nANISOU 1754 C VAL A 219 10078 9017 12005 -447 864 -438 C \nATOM 1755 O VAL A 219 14.762 20.022 -66.897 1.00 81.97 O \nANISOU 1755 O VAL A 219 9975 9096 12073 -474 844 -468 O \nATOM 1756 CB VAL A 219 12.201 19.685 -65.489 1.00 72.57 C \nANISOU 1756 CB VAL A 219 8815 7879 10880 -280 822 -398 C \nATOM 1757 CG1 VAL A 219 12.731 19.524 -64.068 1.00 71.17 C \nANISOU 1757 CG1 VAL A 219 8633 7679 10728 -324 794 -410 C \nATOM 1758 CG2 VAL A 219 10.692 19.657 -65.496 1.00 68.85 C \nANISOU 1758 CG2 VAL A 219 8358 7416 10385 -167 827 -358 C \nATOM 1759 N ASN A 220 14.936 21.889 -65.641 1.00 98.59 N \nANISOU 1759 N ASN A 220 12298 11081 14081 -520 881 -441 N \nATOM 1760 CA ASN A 220 16.395 22.126 -65.837 1.00103.14 C \nANISOU 1760 CA ASN A 220 12865 11671 14652 -646 886 -478 C \nATOM 1761 C ASN A 220 16.733 22.486 -67.283 1.00100.26 C \nANISOU 1761 C ASN A 220 12512 11326 14255 -679 917 -486 C \nATOM 1762 O ASN A 220 17.722 22.022 -67.841 1.00 99.18 O \nANISOU 1762 O ASN A 220 12289 11250 14146 -750 908 -523 O \nATOM 1763 CB ASN A 220 17.235 20.918 -65.373 1.00112.72 C \nANISOU 1763 CB ASN A 220 13929 12954 15943 -688 839 -517 C \nATOM 1764 CG ASN A 220 17.151 20.686 -63.875 1.00119.36 C \nANISOU 1764 CG ASN A 220 14769 13774 16808 -681 810 -511 C \nATOM 1765 OD1 ASN A 220 16.783 21.591 -63.119 1.00124.55 O \nANISOU 1765 OD1 ASN A 220 15546 14363 17415 -677 828 -486 O \nATOM 1766 ND2 ASN A 220 17.489 19.469 -63.434 1.00117.49 N \nANISOU 1766 ND2 ASN A 220 14402 13594 16645 -679 764 -534 N \nATOM 1767 N GLY A 221 15.875 23.294 -67.891 1.00 98.07 N \nANISOU 1767 N GLY A 221 12342 11002 13920 -621 952 -452 N \nATOM 1768 CA GLY A 221 16.000 23.637 -69.302 1.00 95.97 C \nANISOU 1768 CA GLY A 221 12094 10751 13620 -637 982 -453 C \nATOM 1769 C GLY A 221 15.916 22.446 -70.239 1.00 93.61 C \nANISOU 1769 C GLY A 221 11641 10540 13385 -606 961 -473 C \nATOM 1770 O GLY A 221 16.405 22.515 -71.362 1.00106.84 O \nANISOU 1770 O GLY A 221 13297 12249 15047 -649 978 -489 O \nATOM 1771 N GLN A 222 15.262 21.370 -69.803 1.00 91.96 N \nANISOU 1771 N GLN A 222 11333 10369 13240 -531 925 -471 N \nATOM 1772 CA GLN A 222 15.137 20.140 -70.611 1.00 90.14 C \nANISOU 1772 CA GLN A 222 10959 10218 13071 -500 902 -492 C \nATOM 1773 C GLN A 222 13.700 19.562 -70.665 1.00 85.59 C \nANISOU 1773 C GLN A 222 10351 9658 12512 -383 890 -461 C \nATOM 1774 O GLN A 222 13.115 19.152 -69.659 1.00 80.28 O \nANISOU 1774 O GLN A 222 9661 8976 11863 -336 865 -447 O \nATOM 1775 CB GLN A 222 16.085 19.070 -70.094 1.00 86.34 C \nANISOU 1775 CB GLN A 222 10355 9788 12663 -551 861 -535 C \nATOM 1776 CG GLN A 222 15.988 17.748 -70.863 1.00 89.90 C \nANISOU 1776 CG GLN A 222 10667 10314 13177 -518 835 -560 C \nATOM 1777 CD GLN A 222 16.051 17.915 -72.388 1.00 89.03 C \nANISOU 1777 CD GLN A 222 10548 10238 13043 -527 864 -567 C \nATOM 1778 OE1 GLN A 222 15.174 17.461 -73.123 1.00 85.21 O \nANISOU 1778 OE1 GLN A 222 10030 9779 12566 -460 865 -554 O \nATOM 1779 NE2 GLN A 222 17.093 18.572 -72.859 1.00 93.89 N \nANISOU 1779 NE2 GLN A 222 11194 10857 13624 -615 888 -588 N \nATOM 1780 N SER A 223 13.148 19.534 -71.867 1.00 79.44 N \nANISOU 1780 N SER A 223 9561 8909 11716 -342 908 -450 N \nATOM 1781 CA SER A 223 11.767 19.125 -72.077 1.00 79.95 C \nANISOU 1781 CA SER A 223 9601 8998 11779 -237 903 -418 C \nATOM 1782 C SER A 223 11.603 17.597 -72.105 1.00 78.27 C \nANISOU 1782 C SER A 223 9242 8855 11644 -219 861 -442 C \nATOM 1783 O SER A 223 10.495 17.081 -72.015 1.00 86.57 O \nANISOU 1783 O SER A 223 10259 9932 12700 -144 848 -419 O \nATOM 1784 CB SER A 223 11.248 19.759 -73.381 1.00 78.27 C \nANISOU 1784 CB SER A 223 9438 8793 11509 -203 941 -395 C \nATOM 1785 OG SER A 223 10.438 20.896 -73.119 1.00 75.15 O \nANISOU 1785 OG SER A 223 9175 8340 11040 -141 970 -349 O \nATOM 1786 N GLY A 224 12.711 16.882 -72.229 1.00 68.91 N \nANISOU 1786 N GLY A 224 7973 7699 10511 -288 840 -488 N \nATOM 1787 CA GLY A 224 12.701 15.418 -72.277 1.00 53.20 C \nANISOU 1787 CA GLY A 224 5855 5765 8592 -276 800 -515 C \nATOM 1788 C GLY A 224 12.594 14.843 -70.917 1.00 46.52 C \nANISOU 1788 C GLY A 224 4985 4905 7787 -264 762 -513 C \nATOM 1789 O GLY A 224 12.633 15.579 -69.924 1.00 42.72 O \nANISOU 1789 O GLY A 224 4579 4373 7281 -272 767 -496 O \nATOM 1790 N ARG A 225 12.455 13.519 -70.861 1.00 44.29 N \nANISOU 1790 N ARG A 225 4602 4664 7564 -246 724 -533 N \nATOM 1791 CA ARG A 225 12.341 12.783 -69.594 1.00 41.24 C \nANISOU 1791 CA ARG A 225 4183 4268 7220 -236 682 -532 C \nATOM 1792 C ARG A 225 13.069 11.506 -69.703 1.00 36.75 C \nANISOU 1792 C ARG A 225 3513 3735 6718 -260 645 -576 C \nATOM 1793 O ARG A 225 13.314 10.985 -70.789 1.00 40.05 O \nANISOU 1793 O ARG A 225 3875 4193 7151 -266 648 -601 O \nATOM 1794 CB ARG A 225 10.860 12.491 -69.217 1.00 49.95 C \nANISOU 1794 CB ARG A 225 5292 5378 8310 -162 672 -493 C \nATOM 1795 CG ARG A 225 10.380 13.342 -68.081 1.00 67.45 C \nANISOU 1795 CG ARG A 225 7592 7548 10489 -139 680 -458 C \nATOM 1796 CD ARG A 225 9.510 14.468 -68.536 1.00 77.28 C \nANISOU 1796 CD ARG A 225 8924 8779 11661 -89 723 -418 C \nATOM 1797 NE ARG A 225 9.090 15.348 -67.432 1.00 82.06 N \nANISOU 1797 NE ARG A 225 9620 9334 12225 -63 733 -387 N \nATOM 1798 CZ ARG A 225 9.212 16.674 -67.441 1.00 75.68 C \nANISOU 1798 CZ ARG A 225 8924 8474 11357 -64 771 -369 C \nATOM 1799 NH1 ARG A 225 9.741 17.328 -68.471 1.00 66.84 N \nANISOU 1799 NH1 ARG A 225 7844 7344 10209 -95 804 -378 N \nATOM 1800 NH2 ARG A 225 8.782 17.358 -66.424 1.00 80.53 N \nANISOU 1800 NH2 ARG A 225 9617 9044 11936 -35 778 -343 N \nATOM 1801 N MET A 226 13.378 10.928 -68.561 1.00 40.22 N \nANISOU 1801 N MET A 226 3926 4160 7196 -269 607 -584 N \nATOM 1802 CA MET A 226 14.155 9.681 -68.523 1.00 43.79 C \nANISOU 1802 CA MET A 226 4286 4640 7710 -286 567 -625 C \nATOM 1803 C MET A 226 13.740 8.886 -67.304 1.00 45.61 C \nANISOU 1803 C MET A 226 4499 4854 7975 -262 523 -613 C \nATOM 1804 O MET A 226 13.954 9.334 -66.186 1.00 54.95 O \nANISOU 1804 O MET A 226 5720 6005 9153 -278 515 -601 O \nATOM 1805 CB MET A 226 15.644 10.021 -68.492 1.00 46.12 C \nANISOU 1805 CB MET A 226 4568 4942 8012 -350 572 -661 C \nATOM 1806 CG MET A 226 16.541 8.860 -68.809 1.00 52.90 C \nANISOU 1806 CG MET A 226 5332 5842 8925 -360 541 -709 C \nATOM 1807 SD MET A 226 18.210 9.431 -69.180 1.00 57.12 S \nANISOU 1807 SD MET A 226 5844 6411 9448 -435 559 -751 S \nATOM 1808 CE MET A 226 18.016 9.985 -70.865 1.00 44.87 C \nANISOU 1808 CE MET A 226 4306 4887 7857 -443 607 -756 C \nATOM 1809 N ASP A 227 13.126 7.721 -67.497 1.00 46.53 N \nANISOU 1809 N ASP A 227 4564 4991 8122 -229 495 -617 N \nATOM 1810 CA ASP A 227 12.693 6.901 -66.379 1.00 47.22 C \nANISOU 1810 CA ASP A 227 4637 5064 8239 -211 451 -605 C \nATOM 1811 C ASP A 227 13.675 5.748 -66.157 1.00 46.52 C \nANISOU 1811 C ASP A 227 4483 4982 8209 -226 408 -646 C \nATOM 1812 O ASP A 227 14.257 5.174 -67.102 1.00 46.09 O \nANISOU 1812 O ASP A 227 4380 4955 8177 -230 407 -682 O \nATOM 1813 CB ASP A 227 11.298 6.345 -66.630 1.00 55.85 C \nANISOU 1813 CB ASP A 227 5724 6175 9319 -169 445 -578 C \nATOM 1814 CG ASP A 227 10.218 7.450 -66.756 1.00 61.74 C \nANISOU 1814 CG ASP A 227 6534 6924 10002 -139 484 -533 C \nATOM 1815 OD1 ASP A 227 10.493 8.649 -66.379 1.00 66.58 O \nANISOU 1815 OD1 ASP A 227 7209 7507 10582 -148 512 -519 O \nATOM 1816 OD2 ASP A 227 9.099 7.093 -67.209 1.00 55.01 O \nANISOU 1816 OD2 ASP A 227 5668 6104 9128 -106 486 -513 O \nATOM 1817 N PHE A 228 13.863 5.392 -64.880 1.00 35.82 N \nANISOU 1817 N PHE A 228 3130 3602 6878 -230 372 -640 N \nATOM 1818 CA PHE A 228 14.728 4.318 -64.580 1.00 33.89 C \nANISOU 1818 CA PHE A 228 2831 3362 6685 -234 330 -674 C \nATOM 1819 C PHE A 228 14.051 3.170 -63.902 1.00 34.46 C \nANISOU 1819 C PHE A 228 2892 3418 6783 -209 284 -662 C \nATOM 1820 O PHE A 228 13.030 3.353 -63.284 1.00 46.57 O \nANISOU 1820 O PHE A 228 4462 4937 8295 -199 282 -624 O \nATOM 1821 CB PHE A 228 15.900 4.835 -63.747 1.00 33.96 C \nANISOU 1821 CB PHE A 228 2842 3363 6700 -270 324 -687 C \nATOM 1822 CG PHE A 228 16.835 5.669 -64.521 1.00 33.58 C \nANISOU 1822 CG PHE A 228 2789 3340 6631 -306 361 -711 C \nATOM 1823 CD1 PHE A 228 17.810 5.105 -65.293 1.00 34.04 C \nANISOU 1823 CD1 PHE A 228 2783 3437 6712 -312 355 -756 C \nATOM 1824 CD2 PHE A 228 16.679 7.031 -64.500 1.00 34.44 C \nANISOU 1824 CD2 PHE A 228 2962 3434 6690 -333 402 -688 C \nATOM 1825 CE1 PHE A 228 18.622 5.907 -66.070 1.00 38.03 C \nANISOU 1825 CE1 PHE A 228 3284 3975 7193 -351 391 -778 C \nATOM 1826 CE2 PHE A 228 17.478 7.839 -65.282 1.00 39.50 C \nANISOU 1826 CE2 PHE A 228 3607 4097 7304 -374 439 -708 C \nATOM 1827 CZ PHE A 228 18.464 7.281 -66.064 1.00 38.48 C \nANISOU 1827 CZ PHE A 228 3408 4015 7198 -387 433 -753 C \nATOM 1828 N PHE A 229 14.704 2.001 -63.922 1.00 34.85 N \nANISOU 1828 N PHE A 229 2896 3470 6878 -201 245 -695 N \nATOM 1829 CA PHE A 229 14.075 0.792 -63.412 1.00 38.39 C \nANISOU 1829 CA PHE A 229 3340 3898 7349 -181 201 -686 C \nATOM 1830 C PHE A 229 15.162 -0.085 -62.817 1.00 36.13 C \nANISOU 1830 C PHE A 229 3021 3599 7107 -175 155 -716 C \nATOM 1831 O PHE A 229 16.300 0.070 -63.143 1.00 32.60 O \nANISOU 1831 O PHE A 229 2540 3172 6672 -180 162 -750 O \nATOM 1832 CB PHE A 229 13.386 0.047 -64.561 1.00 37.74 C \nANISOU 1832 CB PHE A 229 3242 3833 7263 -164 205 -696 C \nATOM 1833 CG PHE A 229 12.232 0.762 -65.114 1.00 38.94 C \nANISOU 1833 CG PHE A 229 3420 4005 7369 -162 244 -664 C \nATOM 1834 CD1 PHE A 229 12.374 1.635 -66.167 1.00 42.78 C \nANISOU 1834 CD1 PHE A 229 3906 4518 7830 -166 291 -671 C \nATOM 1835 CD2 PHE A 229 10.979 0.551 -64.584 1.00 41.12 C \nANISOU 1835 CD2 PHE A 229 3722 4278 7623 -156 232 -626 C \nATOM 1836 CE1 PHE A 229 11.257 2.275 -66.715 1.00 42.91 C \nANISOU 1836 CE1 PHE A 229 3948 4556 7799 -156 326 -639 C \nATOM 1837 CE2 PHE A 229 9.847 1.178 -65.104 1.00 36.75 C \nANISOU 1837 CE2 PHE A 229 3187 3755 7020 -147 267 -594 C \nATOM 1838 CZ PHE A 229 9.992 2.032 -66.174 1.00 39.67 C \nANISOU 1838 CZ PHE A 229 3557 4149 7366 -143 313 -601 C \nATOM 1839 N TRP A 230 14.764 -1.038 -61.991 1.00 35.27 N \nANISOU 1839 N TRP A 230 2922 3461 7017 -163 110 -704 N \nATOM 1840 CA TRP A 230 15.712 -1.889 -61.343 1.00 37.34 C \nANISOU 1840 CA TRP A 230 3162 3707 7317 -150 64 -727 C \nATOM 1841 C TRP A 230 15.075 -3.239 -61.037 1.00 40.87 C \nANISOU 1841 C TRP A 230 3625 4121 7782 -131 18 -721 C \nATOM 1842 O TRP A 230 13.803 -3.317 -60.865 1.00 37.01 O \nANISOU 1842 O TRP A 230 3170 3621 7269 -142 18 -686 O \nATOM 1843 CB TRP A 230 16.169 -1.255 -60.070 1.00 34.42 C \nANISOU 1843 CB TRP A 230 2804 3328 6946 -169 53 -709 C \nATOM 1844 CG TRP A 230 15.119 -1.066 -59.018 1.00 35.22 C \nANISOU 1844 CG TRP A 230 2951 3402 7029 -181 42 -662 C \nATOM 1845 CD1 TRP A 230 14.203 -0.041 -58.945 1.00 35.60 C \nANISOU 1845 CD1 TRP A 230 3035 3453 7036 -196 79 -627 C \nATOM 1846 CD2 TRP A 230 14.866 -1.924 -57.868 1.00 34.97 C \nANISOU 1846 CD2 TRP A 230 2936 3338 7015 -176 -9 -644 C \nATOM 1847 NE1 TRP A 230 13.397 -0.208 -57.785 1.00 40.51 N \nANISOU 1847 NE1 TRP A 230 3690 4053 7650 -201 54 -590 N \nATOM 1848 CE2 TRP A 230 13.787 -1.346 -57.123 1.00 34.46 C \nANISOU 1848 CE2 TRP A 230 2911 3263 6918 -194 0 -599 C \nATOM 1849 CE3 TRP A 230 15.392 -3.175 -57.450 1.00 33.72 C \nANISOU 1849 CE3 TRP A 230 2764 3155 6892 -155 -63 -661 C \nATOM 1850 CZ2 TRP A 230 13.264 -1.934 -56.014 1.00 30.11 C \nANISOU 1850 CZ2 TRP A 230 2384 2688 6370 -199 -40 -573 C \nATOM 1851 CZ3 TRP A 230 14.939 -3.753 -56.263 1.00 29.67 C \nANISOU 1851 CZ3 TRP A 230 2281 2609 6384 -160 -106 -633 C \nATOM 1852 CH2 TRP A 230 13.856 -3.140 -55.572 1.00 31.67 C \nANISOU 1852 CH2 TRP A 230 2570 2858 6604 -186 -94 -589 C \nATOM 1853 N THR A 231 15.933 -4.269 -60.942 1.00 33.64 N \nANISOU 1853 N THR A 231 2689 3191 6901 -104 -22 -753 N \nATOM 1854 CA THR A 231 15.496 -5.569 -60.453 1.00 37.51 C \nANISOU 1854 CA THR A 231 3207 3637 7406 -89 -72 -747 C \nATOM 1855 C THR A 231 16.628 -6.265 -59.767 1.00 40.20 C \nANISOU 1855 C THR A 231 3533 3961 7781 -58 -117 -769 C \nATOM 1856 O THR A 231 17.802 -5.887 -59.912 1.00 43.98 O \nANISOU 1856 O THR A 231 3968 4473 8272 -44 -108 -798 O \nATOM 1857 CB THR A 231 14.932 -6.458 -61.563 1.00 38.54 C \nANISOU 1857 CB THR A 231 3347 3762 7535 -77 -71 -765 C \nATOM 1858 OG1 THR A 231 14.488 -7.695 -61.023 1.00 52.41 O \nANISOU 1858 OG1 THR A 231 5143 5470 9300 -71 -120 -757 O \nATOM 1859 CG2 THR A 231 15.973 -6.750 -62.593 1.00 38.26 C \nANISOU 1859 CG2 THR A 231 3271 3748 7519 -45 -61 -817 C \nATOM 1860 N ILE A 232 16.294 -7.268 -58.977 1.00 41.75 N \nANISOU 1860 N ILE A 232 3765 4110 7988 -49 -166 -754 N \nATOM 1861 CA ILE A 232 17.327 -8.154 -58.367 1.00 38.35 C \nANISOU 1861 CA ILE A 232 3328 3656 7588 -7 -216 -776 C \nATOM 1862 C ILE A 232 17.440 -9.389 -59.237 1.00 39.17 C \nANISOU 1862 C ILE A 232 3443 3734 7704 34 -235 -811 C \nATOM 1863 O ILE A 232 16.419 -9.985 -59.623 1.00 37.10 O \nANISOU 1863 O ILE A 232 3225 3442 7429 17 -238 -800 O \nATOM 1864 CB ILE A 232 16.944 -8.534 -56.950 1.00 32.72 C \nANISOU 1864 CB ILE A 232 2656 2900 6876 -20 -261 -738 C \nATOM 1865 CG1 ILE A 232 16.743 -7.262 -56.090 1.00 30.43 C \nANISOU 1865 CG1 ILE A 232 2360 2634 6568 -62 -238 -703 C \nATOM 1866 CG2 ILE A 232 17.945 -9.401 -56.322 1.00 30.69 C \nANISOU 1866 CG2 ILE A 232 2396 2620 6645 27 -311 -755 C \nATOM 1867 CD1 ILE A 232 17.835 -6.265 -56.129 1.00 30.00 C \nANISOU 1867 CD1 ILE A 232 2256 2628 6517 -63 -211 -722 C \nATOM 1868 N LEU A 233 18.659 -9.756 -59.589 1.00 41.02 N \nANISOU 1868 N LEU A 233 3640 3986 7960 85 -245 -854 N \nATOM 1869 CA LEU A 233 18.880 -10.935 -60.404 1.00 46.24 C \nANISOU 1869 CA LEU A 233 4316 4621 8633 133 -263 -892 C \nATOM 1870 C LEU A 233 19.456 -12.014 -59.568 1.00 47.91 C \nANISOU 1870 C LEU A 233 4555 4785 8863 185 -323 -898 C \nATOM 1871 O LEU A 233 20.593 -11.895 -59.125 1.00 58.04 O \nANISOU 1871 O LEU A 233 5794 6099 10160 223 -338 -914 O \nATOM 1872 CB LEU A 233 19.780 -10.629 -61.548 1.00 51.00 C \nANISOU 1872 CB LEU A 233 4857 5282 9241 163 -229 -940 C \nATOM 1873 CG LEU A 233 19.961 -11.731 -62.570 1.00 54.23 C \nANISOU 1873 CG LEU A 233 5279 5670 9656 213 -238 -984 C \nATOM 1874 CD1 LEU A 233 18.642 -12.045 -63.262 1.00 58.68 C \nANISOU 1874 CD1 LEU A 233 5895 6200 10201 173 -223 -970 C \nATOM 1875 CD2 LEU A 233 21.012 -11.322 -63.592 1.00 52.06 C \nANISOU 1875 CD2 LEU A 233 4930 5466 9384 243 -204 -1033 C \nATOM 1876 N LYS A 234 18.666 -13.064 -59.322 1.00 50.07 N \nANISOU 1876 N LYS A 234 4904 4988 9132 182 -359 -882 N \nATOM 1877 CA LYS A 234 19.071 -14.172 -58.434 1.00 51.88 C \nANISOU 1877 CA LYS A 234 5181 5156 9374 228 -421 -880 C \nATOM 1878 C LYS A 234 20.260 -14.951 -59.033 1.00 52.72 C \nANISOU 1878 C LYS A 234 5267 5265 9497 318 -437 -934 C \nATOM 1879 O LYS A 234 20.480 -14.927 -60.256 1.00 41.80 O \nANISOU 1879 O LYS A 234 3855 3912 8114 337 -404 -974 O \nATOM 1880 CB LYS A 234 17.925 -15.143 -58.268 1.00 56.93 C \nANISOU 1880 CB LYS A 234 5914 5719 9998 198 -449 -857 C \nATOM 1881 CG LYS A 234 16.618 -14.591 -57.739 1.00 57.51 C \nANISOU 1881 CG LYS A 234 6012 5793 10047 113 -437 -805 C \nATOM 1882 CD LYS A 234 16.608 -14.525 -56.225 1.00 64.40 C \nANISOU 1882 CD LYS A 234 6905 6644 10922 99 -475 -764 C \nATOM 1883 CE LYS A 234 15.196 -14.229 -55.719 1.00 71.43 C \nANISOU 1883 CE LYS A 234 7831 7528 11781 18 -469 -715 C \nATOM 1884 NZ LYS A 234 15.182 -13.814 -54.281 1.00 86.13 N \nANISOU 1884 NZ LYS A 234 9695 9389 13642 -4 -492 -675 N \nATOM 1885 N PRO A 235 21.047 -15.639 -58.169 1.00 65.80 N \nANISOU 1885 N PRO A 235 6939 6894 11168 379 -488 -937 N \nATOM 1886 CA PRO A 235 22.251 -16.385 -58.534 1.00 62.23 C \nANISOU 1886 CA PRO A 235 6467 6450 10728 479 -510 -985 C \nATOM 1887 C PRO A 235 22.243 -16.994 -59.916 1.00 65.71 C \nANISOU 1887 C PRO A 235 6921 6879 11165 514 -491 -1032 C \nATOM 1888 O PRO A 235 22.896 -16.434 -60.791 1.00 66.57 O \nANISOU 1888 O PRO A 235 6954 7064 11277 532 -452 -1068 O \nATOM 1889 CB PRO A 235 22.314 -17.404 -57.451 1.00 66.64 C \nANISOU 1889 CB PRO A 235 7098 6932 11290 518 -575 -965 C \nATOM 1890 CG PRO A 235 21.923 -16.595 -56.228 1.00 68.25 C \nANISOU 1890 CG PRO A 235 7292 7149 11492 450 -580 -912 C \nATOM 1891 CD PRO A 235 20.931 -15.570 -56.697 1.00 68.27 C \nANISOU 1891 CD PRO A 235 7275 7182 11481 358 -526 -892 C \nATOM 1892 N ASN A 236 21.500 -18.065 -60.178 1.00 66.24 N \nANISOU 1892 N ASN A 236 7085 6860 11223 515 -513 -1032 N \nATOM 1893 CA ASN A 236 21.591 -18.666 -61.533 1.00 70.64 C \nANISOU 1893 CA ASN A 236 7656 7408 11775 553 -494 -1082 C \nATOM 1894 C ASN A 236 20.518 -18.271 -62.536 1.00 66.68 C \nANISOU 1894 C ASN A 236 7162 6918 11258 474 -447 -1079 C \nATOM 1895 O ASN A 236 20.194 -19.037 -63.450 1.00 81.00 O \nANISOU 1895 O ASN A 236 9025 8692 13059 484 -442 -1108 O \nATOM 1896 CB ASN A 236 21.736 -20.201 -61.451 1.00 78.46 C \nANISOU 1896 CB ASN A 236 8748 8302 12762 624 -546 -1102 C \nATOM 1897 CG ASN A 236 23.169 -20.620 -61.196 1.00 79.28 C \nANISOU 1897 CG ASN A 236 8817 8428 12880 743 -575 -1136 C \nATOM 1898 OD1 ASN A 236 23.466 -21.253 -60.189 1.00 86.90 O \nANISOU 1898 OD1 ASN A 236 9830 9341 13846 789 -627 -1118 O \nATOM 1899 ND2 ASN A 236 24.075 -20.212 -62.078 1.00 76.88 N \nANISOU 1899 ND2 ASN A 236 8422 8209 12581 793 -541 -1183 N \nATOM 1900 N ASP A 237 20.000 -17.067 -62.409 1.00 61.70 N \nANISOU 1900 N ASP A 237 6480 6342 10622 398 -410 -1047 N \nATOM 1901 CA ASP A 237 18.993 -16.572 -63.356 1.00 55.44 C \nANISOU 1901 CA ASP A 237 5684 5572 9810 328 -362 -1041 C \nATOM 1902 C ASP A 237 19.713 -15.712 -64.375 1.00 55.60 C \nANISOU 1902 C ASP A 237 5612 5680 9835 344 -312 -1077 C \nATOM 1903 O ASP A 237 20.762 -15.147 -64.094 1.00 68.74 O \nANISOU 1903 O ASP A 237 7206 7398 11513 379 -307 -1090 O \nATOM 1904 CB ASP A 237 17.930 -15.781 -62.594 1.00 55.39 C \nANISOU 1904 CB ASP A 237 5685 5572 9788 242 -353 -982 C \nATOM 1905 CG ASP A 237 16.641 -15.552 -63.398 1.00 53.65 C \nANISOU 1905 CG ASP A 237 5485 5361 9539 171 -317 -966 C \nATOM 1906 OD1 ASP A 237 16.617 -15.683 -64.633 1.00 51.68 O \nANISOU 1906 OD1 ASP A 237 5223 5131 9283 178 -288 -1001 O \nATOM 1907 OD2 ASP A 237 15.652 -15.118 -62.757 1.00 51.65 O \nANISOU 1907 OD2 ASP A 237 5250 5107 9267 107 -315 -918 O \nATOM 1908 N ALA A 238 19.150 -15.615 -65.561 1.00 54.10 N \nANISOU 1908 N ALA A 238 5420 5506 9629 315 -273 -1094 N \nATOM 1909 CA ALA A 238 19.640 -14.710 -66.601 1.00 49.75 C \nANISOU 1909 CA ALA A 238 4786 5039 9077 313 -220 -1122 C \nATOM 1910 C ALA A 238 18.649 -13.575 -66.885 1.00 51.02 C \nANISOU 1910 C ALA A 238 4929 5240 9217 230 -174 -1085 C \nATOM 1911 O ALA A 238 17.418 -13.756 -66.714 1.00 45.36 O \nANISOU 1911 O ALA A 238 4267 4487 8481 178 -178 -1050 O \nATOM 1912 CB ALA A 238 19.859 -15.481 -67.864 1.00 51.14 C \nANISOU 1912 CB ALA A 238 4972 5211 9249 353 -209 -1175 C \nATOM 1913 N ILE A 239 19.180 -12.401 -67.296 1.00 45.63 N \nANISOU 1913 N ILE A 239 4171 4634 8534 218 -130 -1093 N \nATOM 1914 CA ILE A 239 18.340 -11.259 -67.641 1.00 39.85 C \nANISOU 1914 CA ILE A 239 3423 3939 7777 151 -84 -1060 C \nATOM 1915 C ILE A 239 18.495 -10.972 -69.089 1.00 43.78 C \nANISOU 1915 C ILE A 239 3882 4488 8264 150 -39 -1096 C \nATOM 1916 O ILE A 239 19.615 -10.983 -69.550 1.00 46.63 O \nANISOU 1916 O ILE A 239 4193 4887 8637 192 -32 -1139 O \nATOM 1917 CB ILE A 239 18.622 -10.027 -66.795 1.00 43.12 C \nANISOU 1917 CB ILE A 239 3803 4389 8192 124 -70 -1029 C \nATOM 1918 CG1 ILE A 239 17.780 -8.823 -67.317 1.00 46.00 C \nANISOU 1918 CG1 ILE A 239 4158 4792 8527 65 -18 -999 C \nATOM 1919 CG2 ILE A 239 20.074 -9.673 -66.830 1.00 44.21 C \nANISOU 1919 CG2 ILE A 239 3874 4579 8344 160 -65 -1065 C \nATOM 1920 CD1 ILE A 239 17.718 -7.675 -66.367 1.00 44.54 C \nANISOU 1920 CD1 ILE A 239 3967 4622 8334 31 -6 -959 C \nATOM 1921 N ASN A 240 17.362 -10.743 -69.819 1.00 45.25 N \nANISOU 1921 N ASN A 240 4089 4680 8424 103 -9 -1077 N \nATOM 1922 CA ASN A 240 17.395 -10.521 -71.278 1.00 49.64 C \nANISOU 1922 CA ASN A 240 4613 5283 8966 99 34 -1109 C \nATOM 1923 C ASN A 240 16.912 -9.103 -71.643 1.00 48.70 C \nANISOU 1923 C ASN A 240 4465 5219 8821 48 85 -1078 C \nATOM 1924 O ASN A 240 15.906 -8.637 -71.161 1.00 50.16 O \nANISOU 1924 O ASN A 240 4678 5395 8987 10 90 -1030 O \nATOM 1925 CB ASN A 240 16.510 -11.526 -72.008 1.00 58.76 C \nANISOU 1925 CB ASN A 240 5818 6404 10106 89 28 -1119 C \nATOM 1926 CG ASN A 240 16.804 -12.978 -71.635 1.00 62.31 C \nANISOU 1926 CG ASN A 240 6319 6784 10573 134 -24 -1145 C \nATOM 1927 OD1 ASN A 240 17.596 -13.665 -72.301 1.00 61.47 O \nANISOU 1927 OD1 ASN A 240 6204 6675 10477 186 -29 -1198 O \nATOM 1928 ND2 ASN A 240 16.169 -13.443 -70.565 1.00 65.22 N \nANISOU 1928 ND2 ASN A 240 6746 7095 10941 117 -63 -1108 N \nATOM 1929 N PHE A 241 17.653 -8.409 -72.475 1.00 46.56 N \nANISOU 1929 N PHE A 241 4140 5006 8546 51 123 -1106 N \nATOM 1930 CA PHE A 241 17.267 -7.087 -72.916 1.00 38.07 C \nANISOU 1930 CA PHE A 241 3046 3977 7443 7 172 -1080 C \nATOM 1931 C PHE A 241 17.042 -7.146 -74.400 1.00 41.17 C \nANISOU 1931 C PHE A 241 3421 4405 7816 0 207 -1106 C \nATOM 1932 O PHE A 241 17.846 -7.761 -75.121 1.00 44.17 O \nANISOU 1932 O PHE A 241 3773 4801 8209 33 205 -1159 O \nATOM 1933 CB PHE A 241 18.387 -6.057 -72.633 1.00 37.59 C \nANISOU 1933 CB PHE A 241 2939 3959 7385 3 190 -1087 C \nATOM 1934 CG PHE A 241 18.633 -5.777 -71.167 1.00 37.37 C \nANISOU 1934 CG PHE A 241 2923 3905 7370 1 162 -1058 C \nATOM 1935 CD1 PHE A 241 17.820 -4.876 -70.493 1.00 36.71 C \nANISOU 1935 CD1 PHE A 241 2873 3808 7267 -37 174 -1005 C \nATOM 1936 CD2 PHE A 241 19.641 -6.369 -70.489 1.00 36.04 C \nANISOU 1936 CD2 PHE A 241 2735 3729 7229 39 125 -1083 C \nATOM 1937 CE1 PHE A 241 17.968 -4.660 -69.165 1.00 35.93 C \nANISOU 1937 CE1 PHE A 241 2789 3684 7178 -41 149 -978 C \nATOM 1938 CE2 PHE A 241 19.860 -6.094 -69.130 1.00 36.46 C \nANISOU 1938 CE2 PHE A 241 2799 3762 7293 33 99 -1055 C \nATOM 1939 CZ PHE A 241 19.015 -5.266 -68.465 1.00 36.15 C \nANISOU 1939 CZ PHE A 241 2794 3704 7235 -9 110 -1003 C \nATOM 1940 N GLU A 242 16.027 -6.421 -74.866 1.00 39.06 N \nANISOU 1940 N GLU A 242 3168 4158 7516 -38 240 -1071 N \nATOM 1941 CA GLU A 242 15.815 -6.246 -76.259 1.00 42.07 C \nANISOU 1941 CA GLU A 242 3529 4582 7873 -51 279 -1090 C \nATOM 1942 C GLU A 242 15.242 -4.848 -76.518 1.00 46.74 C \nANISOU 1942 C GLU A 242 4120 5210 8428 -87 323 -1048 C \nATOM 1943 O GLU A 242 14.266 -4.424 -75.908 1.00 59.79 O \nANISOU 1943 O GLU A 242 5806 6849 10062 -104 323 -998 O \nATOM 1944 CB GLU A 242 14.842 -7.337 -76.785 1.00 44.99 C \nANISOU 1944 CB GLU A 242 3932 4930 8232 -54 264 -1095 C \nATOM 1945 CG GLU A 242 14.858 -7.464 -78.316 1.00 46.39 C \nANISOU 1945 CG GLU A 242 4085 5151 8392 -59 298 -1130 C \nATOM 1946 CD GLU A 242 13.673 -8.165 -78.911 1.00 49.27 C \nANISOU 1946 CD GLU A 242 4482 5509 8730 -82 296 -1122 C \nATOM 1947 OE1 GLU A 242 13.356 -7.836 -80.046 1.00 49.46 O \nANISOU 1947 OE1 GLU A 242 4486 5580 8726 -100 332 -1128 O \nATOM 1948 OE2 GLU A 242 13.076 -9.032 -78.247 1.00 61.52 O \nANISOU 1948 OE2 GLU A 242 6078 7013 10285 -85 259 -1108 O \nATOM 1949 N SER A 243 15.795 -4.148 -77.486 1.00 42.13 N \nANISOU 1949 N SER A 243 3502 4676 7830 -97 363 -1069 N \nATOM 1950 CA SER A 243 15.302 -2.832 -77.807 1.00 38.21 C \nANISOU 1950 CA SER A 243 3014 4209 7295 -127 406 -1031 C \nATOM 1951 C SER A 243 15.821 -2.365 -79.121 1.00 43.25 C \nANISOU 1951 C SER A 243 3617 4901 7915 -140 447 -1061 C \nATOM 1952 O SER A 243 16.949 -2.784 -79.571 1.00 51.24 O \nANISOU 1952 O SER A 243 4587 5936 8947 -127 444 -1115 O \nATOM 1953 CB SER A 243 15.747 -1.832 -76.769 1.00 35.93 C \nANISOU 1953 CB SER A 243 2737 3908 7007 -139 408 -1004 C \nATOM 1954 OG SER A 243 15.325 -0.499 -77.110 1.00 32.44 O \nANISOU 1954 OG SER A 243 2315 3488 6522 -165 452 -969 O \nATOM 1955 N ASN A 244 15.024 -1.456 -79.714 1.00 35.25 N \nANISOU 1955 N ASN A 244 2622 3911 6859 -162 484 -1026 N \nATOM 1956 CA ASN A 244 15.378 -0.862 -80.976 1.00 38.02 C \nANISOU 1956 CA ASN A 244 2949 4313 7184 -180 527 -1045 C \nATOM 1957 C ASN A 244 15.324 0.610 -80.887 1.00 38.19 C \nANISOU 1957 C ASN A 244 2996 4344 7169 -206 562 -1006 C \nATOM 1958 O ASN A 244 15.188 1.335 -81.879 1.00 35.10 O \nANISOU 1958 O ASN A 244 2605 3988 6741 -224 601 -1000 O \nATOM 1959 CB ASN A 244 14.476 -1.391 -82.064 1.00 38.34 C \nANISOU 1959 CB ASN A 244 2987 4378 7204 -180 538 -1048 C \nATOM 1960 CG ASN A 244 13.103 -0.897 -81.932 1.00 32.83 C \nANISOU 1960 CG ASN A 244 2327 3678 6468 -185 549 -989 C \nATOM 1961 OD1 ASN A 244 12.616 -0.641 -80.861 1.00 36.73 O \nANISOU 1961 OD1 ASN A 244 2853 4141 6962 -179 533 -949 O \nATOM 1962 ND2 ASN A 244 12.472 -0.716 -83.050 1.00 33.11 N \nANISOU 1962 ND2 ASN A 244 2357 3755 6467 -195 578 -982 N \nATOM 1963 N GLY A 245 15.443 1.071 -79.660 1.00 41.56 N \nANISOU 1963 N GLY A 245 3451 4736 7605 -207 547 -980 N \nATOM 1964 CA GLY A 245 15.446 2.496 -79.450 1.00 53.88 C \nANISOU 1964 CA GLY A 245 5049 6295 9129 -231 580 -943 C \nATOM 1965 C GLY A 245 15.104 2.897 -78.032 1.00 53.82 C \nANISOU 1965 C GLY A 245 5086 6240 9124 -226 561 -902 C \nATOM 1966 O GLY A 245 14.464 2.187 -77.245 1.00 65.22 O \nANISOU 1966 O GLY A 245 6539 7655 10588 -203 527 -886 O \nATOM 1967 N ASN A 246 15.543 4.098 -77.752 1.00 50.95 N \nANISOU 1967 N ASN A 246 4754 5871 8735 -253 586 -886 N \nATOM 1968 CA ASN A 246 15.427 4.749 -76.467 1.00 43.44 C \nANISOU 1968 CA ASN A 246 3850 4877 7777 -257 578 -850 C \nATOM 1969 C ASN A 246 15.833 4.006 -75.260 1.00 38.67 C \nANISOU 1969 C ASN A 246 3229 4245 7218 -247 533 -861 C \nATOM 1970 O ASN A 246 15.357 4.302 -74.186 1.00 42.74 O \nANISOU 1970 O ASN A 246 3785 4724 7730 -240 520 -825 O \nATOM 1971 CB ASN A 246 14.038 5.359 -76.240 1.00 45.22 C \nANISOU 1971 CB ASN A 246 4136 5082 7964 -235 592 -792 C \nATOM 1972 CG ASN A 246 13.448 5.906 -77.490 1.00 47.18 C \nANISOU 1972 CG ASN A 246 4397 5361 8167 -232 632 -778 C \nATOM 1973 OD1 ASN A 246 13.648 5.345 -78.534 1.00 46.91 O \nANISOU 1973 OD1 ASN A 246 4319 5364 8141 -236 637 -809 O \nATOM 1974 ND2 ASN A 246 12.823 7.070 -77.403 1.00 49.47 N \nANISOU 1974 ND2 ASN A 246 4753 5637 8407 -226 662 -732 N \nATOM 1975 N PHE A 247 16.772 3.093 -75.399 1.00 42.85 N \nANISOU 1975 N PHE A 247 3701 4794 7787 -243 509 -910 N \nATOM 1976 CA PHE A 247 17.227 2.240 -74.322 1.00 44.25 C \nANISOU 1976 CA PHE A 247 3858 4947 8007 -226 462 -924 C \nATOM 1977 C PHE A 247 18.432 2.877 -73.626 1.00 49.11 C \nANISOU 1977 C PHE A 247 4464 5570 8624 -257 461 -937 C \nATOM 1978 O PHE A 247 19.381 3.363 -74.269 1.00 59.38 O \nANISOU 1978 O PHE A 247 5737 6915 9911 -288 486 -966 O \nATOM 1979 CB PHE A 247 17.684 0.941 -74.911 1.00 48.32 C \nANISOU 1979 CB PHE A 247 4320 5482 8558 -199 438 -974 C \nATOM 1980 CG PHE A 247 18.127 -0.083 -73.882 1.00 52.93 C \nANISOU 1980 CG PHE A 247 4887 6038 9185 -171 386 -990 C \nATOM 1981 CD1 PHE A 247 17.610 -0.080 -72.610 1.00 52.39 C \nANISOU 1981 CD1 PHE A 247 4857 5924 9126 -167 359 -952 C \nATOM 1982 CD2 PHE A 247 19.049 -1.053 -74.208 1.00 49.30 C \nANISOU 1982 CD2 PHE A 247 4376 5600 8756 -144 364 -1042 C \nATOM 1983 CE1 PHE A 247 17.981 -1.042 -71.705 1.00 53.39 C \nANISOU 1983 CE1 PHE A 247 4972 6024 9289 -140 311 -964 C \nATOM 1984 CE2 PHE A 247 19.440 -1.982 -73.288 1.00 49.55 C \nANISOU 1984 CE2 PHE A 247 4399 5603 8823 -112 316 -1055 C \nATOM 1985 CZ PHE A 247 18.902 -1.988 -72.039 1.00 50.46 C \nANISOU 1985 CZ PHE A 247 4555 5670 8947 -112 289 -1015 C \nATOM 1986 N ILE A 248 18.380 2.899 -72.311 1.00 41.62 N \nANISOU 1986 N ILE A 248 3540 4585 7689 -254 434 -914 N \nATOM 1987 CA ILE A 248 19.445 3.402 -71.522 1.00 39.00 C \nANISOU 1987 CA ILE A 248 3199 4261 7358 -285 429 -924 C \nATOM 1988 C ILE A 248 19.989 2.134 -70.881 1.00 39.66 C \nANISOU 1988 C ILE A 248 3237 4343 7491 -249 377 -952 C \nATOM 1989 O ILE A 248 19.564 1.729 -69.804 1.00 34.43 O \nANISOU 1989 O ILE A 248 2597 3638 6848 -231 343 -928 O \nATOM 1990 CB ILE A 248 18.989 4.398 -70.457 1.00 41.97 C \nANISOU 1990 CB ILE A 248 3642 4595 7709 -308 436 -876 C \nATOM 1991 CG1 ILE A 248 18.093 5.494 -71.016 1.00 48.08 C \nANISOU 1991 CG1 ILE A 248 4479 5355 8433 -321 482 -839 C \nATOM 1992 CG2 ILE A 248 20.178 5.060 -69.852 1.00 42.16 C \nANISOU 1992 CG2 ILE A 248 3658 4638 7724 -355 439 -890 C \nATOM 1993 CD1 ILE A 248 18.723 6.290 -72.144 1.00 52.08 C \nANISOU 1993 CD1 ILE A 248 4981 5901 8905 -361 525 -859 C \nATOM 1994 N ALA A 249 21.005 1.532 -71.549 1.00 41.78 N \nANISOU 1994 N ALA A 249 3439 4660 7776 -238 371 -1004 N \nATOM 1995 CA ALA A 249 21.548 0.237 -71.147 1.00 36.26 C \nANISOU 1995 CA ALA A 249 2697 3961 7120 -191 324 -1036 C \nATOM 1996 C ALA A 249 22.470 0.312 -69.948 1.00 41.65 C \nANISOU 1996 C ALA A 249 3361 4652 7814 -197 295 -1039 C \nATOM 1997 O ALA A 249 23.133 1.312 -69.725 1.00 42.35 O \nANISOU 1997 O ALA A 249 3444 4772 7875 -246 317 -1037 O \nATOM 1998 CB ALA A 249 22.312 -0.377 -72.300 1.00 42.13 C \nANISOU 1998 CB ALA A 249 3378 4758 7869 -169 330 -1091 C \nATOM 1999 N PRO A 250 22.530 -0.770 -69.174 1.00 39.14 N \nANISOU 1999 N PRO A 250 3035 4305 7532 -150 246 -1044 N \nATOM 2000 CA PRO A 250 23.442 -0.906 -68.080 1.00 42.07 C \nANISOU 2000 CA PRO A 250 3379 4688 7916 -145 213 -1051 C \nATOM 2001 C PRO A 250 24.829 -1.285 -68.522 1.00 49.15 C \nANISOU 2001 C PRO A 250 4197 5661 8818 -125 206 -1106 C \nATOM 2002 O PRO A 250 25.002 -1.804 -69.597 1.00 46.91 O \nANISOU 2002 O PRO A 250 3881 5405 8537 -97 216 -1142 O \nATOM 2003 CB PRO A 250 22.851 -2.055 -67.267 1.00 39.60 C \nANISOU 2003 CB PRO A 250 3095 4313 7639 -95 161 -1036 C \nATOM 2004 CG PRO A 250 22.022 -2.817 -68.180 1.00 36.69 C \nANISOU 2004 CG PRO A 250 2744 3918 7279 -65 164 -1043 C \nATOM 2005 CD PRO A 250 21.637 -1.920 -69.314 1.00 37.61 C \nANISOU 2005 CD PRO A 250 2865 4062 7364 -103 219 -1040 C \nATOM 2006 N GLU A 251 25.826 -0.896 -67.727 1.00 62.69 N \nANISOU 2006 N GLU A 251 5877 7418 10524 -146 195 -1112 N \nATOM 2007 CA GLU A 251 27.207 -1.318 -67.902 1.00 59.71 C \nANISOU 2007 CA GLU A 251 5415 7124 10148 -121 181 -1162 C \nATOM 2008 C GLU A 251 27.603 -1.962 -66.620 1.00 56.47 C \nANISOU 2008 C GLU A 251 4996 6700 9762 -82 129 -1155 C \nATOM 2009 O GLU A 251 28.177 -3.025 -66.627 1.00 60.79 O \nANISOU 2009 O GLU A 251 5500 7266 10330 -11 94 -1188 O \nATOM 2010 CB GLU A 251 28.122 -0.139 -68.173 1.00 68.00 C \nANISOU 2010 CB GLU A 251 6425 8258 11153 -195 220 -1175 C \nATOM 2011 CG GLU A 251 29.577 -0.559 -68.408 1.00 75.39 C \nANISOU 2011 CG GLU A 251 7261 9300 12082 -170 207 -1229 C \nATOM 2012 CD GLU A 251 30.484 0.558 -68.894 1.00 68.45 C \nANISOU 2012 CD GLU A 251 6338 8518 11151 -252 249 -1248 C \nATOM 2013 OE1 GLU A 251 30.020 1.706 -69.015 1.00 70.72 O \nANISOU 2013 OE1 GLU A 251 6682 8782 11408 -331 288 -1218 O \nATOM 2014 OE2 GLU A 251 31.648 0.262 -69.189 1.00 68.94 O \nANISOU 2014 OE2 GLU A 251 6313 8682 11201 -236 243 -1293 O \nATOM 2015 N TYR A 252 27.266 -1.324 -65.508 1.00 51.10 N \nANISOU 2015 N TYR A 252 4358 5983 9074 -125 122 -1113 N \nATOM 2016 CA TYR A 252 27.629 -1.796 -64.193 1.00 57.67 C \nANISOU 2016 CA TYR A 252 5185 6803 9924 -99 74 -1101 C \nATOM 2017 C TYR A 252 26.419 -2.213 -63.343 1.00 59.95 C \nANISOU 2017 C TYR A 252 5551 6989 10237 -82 46 -1055 C \nATOM 2018 O TYR A 252 25.373 -1.581 -63.379 1.00 66.96 O \nANISOU 2018 O TYR A 252 6501 7828 11115 -121 72 -1019 O \nATOM 2019 CB TYR A 252 28.366 -0.694 -63.436 1.00 57.87 C \nANISOU 2019 CB TYR A 252 5191 6880 9916 -171 86 -1090 C \nATOM 2020 CG TYR A 252 29.678 -0.337 -63.997 1.00 57.88 C \nANISOU 2020 CG TYR A 252 5110 6994 9887 -195 105 -1134 C \nATOM 2021 CD1 TYR A 252 30.781 -1.201 -63.868 1.00 65.71 C \nANISOU 2021 CD1 TYR A 252 6020 8059 10890 -134 69 -1173 C \nATOM 2022 CD2 TYR A 252 29.855 0.855 -64.666 1.00 60.00 C \nANISOU 2022 CD2 TYR A 252 5381 7305 10113 -277 157 -1137 C \nATOM 2023 CE1 TYR A 252 32.015 -0.876 -64.390 1.00 65.07 C \nANISOU 2023 CE1 TYR A 252 5851 8098 10774 -156 87 -1215 C \nATOM 2024 CE2 TYR A 252 31.085 1.180 -65.191 1.00 65.66 C \nANISOU 2024 CE2 TYR A 252 6018 8135 10796 -308 175 -1178 C \nATOM 2025 CZ TYR A 252 32.147 0.310 -65.051 1.00 68.28 C \nANISOU 2025 CZ TYR A 252 6259 8546 11137 -248 140 -1217 C \nATOM 2026 OH TYR A 252 33.347 0.684 -65.592 1.00 90.51 O \nANISOU 2026 OH TYR A 252 8990 11487 13912 -283 160 -1257 O \nATOM 2027 N ALA A 253 26.586 -3.291 -62.595 1.00 58.13 N \nANISOU 2027 N ALA A 253 5317 6734 10037 -21 -7 -1056 N \nATOM 2028 CA ALA A 253 25.551 -3.784 -61.712 1.00 57.79 C \nANISOU 2028 CA ALA A 253 5342 6601 10014 -7 -40 -1015 C \nATOM 2029 C ALA A 253 26.183 -3.859 -60.361 1.00 52.62 C \nANISOU 2029 C ALA A 253 4673 5956 9364 -4 -79 -1002 C \nATOM 2030 O ALA A 253 27.357 -3.685 -60.256 1.00 56.22 O \nANISOU 2030 O ALA A 253 5065 6487 9809 -2 -83 -1029 O \nATOM 2031 CB ALA A 253 25.060 -5.155 -62.176 1.00 59.01 C \nANISOU 2031 CB ALA A 253 5519 6705 10197 63 -69 -1029 C \nATOM 2032 N TYR A 254 25.411 -4.172 -59.352 1.00 51.59 N \nANISOU 2032 N TYR A 254 4600 5755 9247 -2 -110 -963 N \nATOM 2033 CA TYR A 254 25.876 -4.196 -57.991 1.00 56.12 C \nANISOU 2033 CA TYR A 254 5169 6332 9823 -4 -148 -944 C \nATOM 2034 C TYR A 254 25.610 -5.549 -57.354 1.00 62.18 C \nANISOU 2034 C TYR A 254 5965 7039 10621 62 -207 -935 C \nATOM 2035 O TYR A 254 24.465 -5.954 -57.202 1.00 65.79 O \nANISOU 2035 O TYR A 254 6488 7421 11088 62 -217 -907 O \nATOM 2036 CB TYR A 254 25.145 -3.125 -57.199 1.00 59.43 C \nANISOU 2036 CB TYR A 254 5639 6719 10222 -77 -127 -898 C \nATOM 2037 CG TYR A 254 25.498 -1.727 -57.621 1.00 61.71 C \nANISOU 2037 CG TYR A 254 5912 7061 10474 -147 -73 -903 C \nATOM 2038 CD1 TYR A 254 24.728 -1.048 -58.558 1.00 63.42 C \nANISOU 2038 CD1 TYR A 254 6163 7261 10674 -178 -23 -896 C \nATOM 2039 CD2 TYR A 254 26.600 -1.078 -57.081 1.00 62.98 C \nANISOU 2039 CD2 TYR A 254 6029 7288 10613 -186 -71 -914 C \nATOM 2040 CE1 TYR A 254 25.056 0.230 -58.964 1.00 65.59 C \nANISOU 2040 CE1 TYR A 254 6435 7576 10911 -242 26 -900 C \nATOM 2041 CE2 TYR A 254 26.935 0.198 -57.466 1.00 63.16 C \nANISOU 2041 CE2 TYR A 254 6047 7354 10596 -259 -22 -918 C \nATOM 2042 CZ TYR A 254 26.163 0.850 -58.403 1.00 65.72 C \nANISOU 2042 CZ TYR A 254 6413 7653 10904 -286 27 -911 C \nATOM 2043 OH TYR A 254 26.473 2.122 -58.791 1.00 62.16 O \nANISOU 2043 OH TYR A 254 5971 7237 10410 -359 76 -914 O \nATOM 2044 N LYS A 255 26.673 -6.235 -56.961 1.00 67.86 N \nANISOU 2044 N LYS A 255 6637 7795 11350 118 -247 -959 N \nATOM 2045 CA LYS A 255 26.570 -7.496 -56.268 1.00 63.46 C \nANISOU 2045 CA LYS A 255 6113 7182 10818 184 -306 -950 C \nATOM 2046 C LYS A 255 26.276 -7.243 -54.836 1.00 57.48 C \nANISOU 2046 C LYS A 255 5388 6393 10058 149 -333 -905 C \nATOM 2047 O LYS A 255 26.908 -6.415 -54.240 1.00 61.55 O \nANISOU 2047 O LYS A 255 5866 6965 10557 109 -325 -900 O \nATOM 2048 CB LYS A 255 27.916 -8.161 -56.297 1.00 68.69 C \nANISOU 2048 CB LYS A 255 6707 7908 11484 259 -337 -990 C \nATOM 2049 CG LYS A 255 27.935 -9.502 -56.980 1.00 75.70 C \nANISOU 2049 CG LYS A 255 7613 8758 12392 351 -363 -1021 C \nATOM 2050 CD LYS A 255 29.125 -10.341 -56.528 1.00 73.06 C \nANISOU 2050 CD LYS A 255 7233 8466 12062 442 -411 -1046 C \nATOM 2051 CE LYS A 255 30.365 -10.092 -57.361 1.00 69.76 C \nANISOU 2051 CE LYS A 255 6715 8165 11627 473 -388 -1098 C \nATOM 2052 NZ LYS A 255 31.521 -10.829 -56.789 1.00 67.71 N \nANISOU 2052 NZ LYS A 255 6405 7957 11364 564 -436 -1118 N \nATOM 2053 N ILE A 256 25.360 -7.975 -54.247 1.00 57.07 N \nANISOU 2053 N ILE A 256 5407 6256 10021 162 -367 -874 N \nATOM 2054 CA ILE A 256 25.111 -7.717 -52.850 1.00 61.63 C \nANISOU 2054 CA ILE A 256 6013 6809 10594 127 -393 -832 C \nATOM 2055 C ILE A 256 25.877 -8.631 -51.872 1.00 71.73 C \nANISOU 2055 C ILE A 256 7282 8087 11886 187 -456 -831 C \nATOM 2056 O ILE A 256 25.565 -9.805 -51.678 1.00 77.82 O \nANISOU 2056 O ILE A 256 8101 8794 12674 240 -500 -825 O \nATOM 2057 CB ILE A 256 23.619 -7.573 -52.512 1.00 57.40 C \nANISOU 2057 CB ILE A 256 5556 6199 10056 79 -386 -787 C \nATOM 2058 CG1 ILE A 256 23.202 -8.511 -51.404 1.00 57.83 C \nANISOU 2058 CG1 ILE A 256 5664 6189 10121 99 -444 -756 C \nATOM 2059 CG2 ILE A 256 22.770 -7.696 -53.749 1.00 57.15 C \nANISOU 2059 CG2 ILE A 256 5549 6142 10023 76 -352 -798 C \nATOM 2060 CD1 ILE A 256 23.422 -7.919 -50.044 1.00 57.48 C \nANISOU 2060 CD1 ILE A 256 5615 6158 10066 61 -460 -725 C \nATOM 2061 N VAL A 257 26.851 -8.021 -51.222 1.00 80.33 N \nANISOU 2061 N VAL A 257 8314 9248 12962 171 -459 -834 N \nATOM 2062 CA VAL A 257 27.579 -8.646 -50.130 1.00 83.26 C \nANISOU 2062 CA VAL A 257 8669 9629 13337 215 -516 -826 C \nATOM 2063 C VAL A 257 28.063 -7.530 -49.221 1.00 88.38 C \nANISOU 2063 C VAL A 257 9280 10339 13961 146 -505 -808 C \nATOM 2064 O VAL A 257 28.969 -6.787 -49.603 1.00104.19 O \nANISOU 2064 O VAL A 257 11211 12433 15944 123 -475 -836 O \nATOM 2065 CB VAL A 257 28.730 -9.536 -50.648 1.00 80.34 C \nANISOU 2065 CB VAL A 257 8242 9310 12974 314 -543 -870 C \nATOM 2066 CG1 VAL A 257 29.776 -8.759 -51.477 1.00 68.45 C \nANISOU 2066 CG1 VAL A 257 6641 7921 11448 303 -501 -913 C \nATOM 2067 CG2 VAL A 257 29.336 -10.305 -49.477 1.00 79.74 C \nANISOU 2067 CG2 VAL A 257 8164 9233 12901 372 -607 -856 C \nATOM 2068 N LYS A 258 27.476 -7.369 -48.038 1.00 87.02 N \nANISOU 2068 N LYS A 258 9156 10120 13786 106 -525 -765 N \nATOM 2069 CA LYS A 258 26.626 -8.350 -47.395 1.00 86.21 C \nANISOU 2069 CA LYS A 258 9129 9925 13702 134 -571 -733 C \nATOM 2070 C LYS A 258 25.254 -7.799 -47.013 1.00 81.73 C \nANISOU 2070 C LYS A 258 8632 9294 13129 61 -549 -691 C \nATOM 2071 O LYS A 258 24.976 -6.606 -47.171 1.00 71.80 O \nANISOU 2071 O LYS A 258 7369 8061 11852 -7 -499 -686 O \nATOM 2072 CB LYS A 258 27.309 -8.816 -46.127 1.00103.83 C \nANISOU 2072 CB LYS A 258 11347 12170 15933 163 -628 -716 C \nATOM 2073 CG LYS A 258 27.348 -7.737 -45.058 1.00117.47 C \nANISOU 2073 CG LYS A 258 13065 13930 17638 81 -617 -687 C \nATOM 2074 CD LYS A 258 28.287 -8.078 -43.920 1.00130.63 C \nANISOU 2074 CD LYS A 258 14696 15638 19298 109 -668 -678 C \nATOM 2075 CE LYS A 258 29.733 -7.830 -44.323 1.00136.65 C \nANISOU 2075 CE LYS A 258 15358 16517 20046 137 -661 -719 C \nATOM 2076 NZ LYS A 258 30.690 -8.098 -43.210 1.00137.33 N \nANISOU 2076 NZ LYS A 258 15400 16660 20119 163 -710 -710 N \nATOM 2077 N LYS A 259 24.395 -8.697 -46.523 1.00 82.94 N \nANISOU 2077 N LYS A 259 8854 9366 13293 77 -588 -663 N \nATOM 2078 CA LYS A 259 23.065 -8.337 -45.998 1.00 79.36 C \nANISOU 2078 CA LYS A 259 8466 8858 12829 14 -576 -620 C \nATOM 2079 C LYS A 259 23.024 -8.307 -44.461 1.00 82.10 C \nANISOU 2079 C LYS A 259 8835 9193 13168 -13 -615 -582 C \nATOM 2080 O LYS A 259 23.202 -9.341 -43.822 1.00 74.71 O \nANISOU 2080 O LYS A 259 7922 8222 12243 29 -672 -571 O \nATOM 2081 CB LYS A 259 21.983 -9.289 -46.500 1.00 73.13 C \nANISOU 2081 CB LYS A 259 7743 7995 12049 31 -589 -611 C \nATOM 2082 CG LYS A 259 21.471 -8.990 -47.880 1.00 75.57 C \nANISOU 2082 CG LYS A 259 8048 8308 12355 23 -538 -633 C \nATOM 2083 CD LYS A 259 19.977 -9.248 -48.020 1.00 77.04 C \nANISOU 2083 CD LYS A 259 8302 8438 12532 -11 -531 -605 C \nATOM 2084 CE LYS A 259 19.473 -9.016 -49.428 1.00 79.83 C \nANISOU 2084 CE LYS A 259 8650 8800 12880 -14 -483 -626 C \nATOM 2085 NZ LYS A 259 19.985 -10.057 -50.377 1.00 89.80 N \nANISOU 2085 NZ LYS A 259 9907 10049 14162 49 -500 -665 N \nATOM 2086 N GLY A 260 22.777 -7.124 -43.884 1.00 78.45 N \nANISOU 2086 N GLY A 260 8369 8754 12684 -83 -583 -562 N \nATOM 2087 CA GLY A 260 22.634 -6.977 -42.431 1.00 78.02 C \nANISOU 2087 CA GLY A 260 8337 8688 12618 -117 -613 -525 C \nATOM 2088 C GLY A 260 21.673 -5.868 -42.049 1.00 84.27 C \nANISOU 2088 C GLY A 260 9163 9471 13384 -192 -571 -497 C \nATOM 2089 O GLY A 260 20.662 -5.667 -42.699 1.00 98.23 O \nANISOU 2089 O GLY A 260 10965 11213 15146 -207 -538 -491 O \nATOM 2090 N ASP A 261 21.982 -5.149 -40.985 1.00 79.78 N \nANISOU 2090 N ASP A 261 8588 8928 12797 -235 -573 -480 N \nATOM 2091 CA ASP A 261 21.107 -4.106 -40.519 1.00 79.06 C \nANISOU 2091 CA ASP A 261 8535 8827 12678 -299 -536 -454 C \nATOM 2092 C ASP A 261 21.623 -2.793 -41.068 1.00 76.98 C \nANISOU 2092 C ASP A 261 8244 8612 12394 -336 -478 -477 C \nATOM 2093 O ASP A 261 22.825 -2.615 -41.257 1.00 80.79 O \nANISOU 2093 O ASP A 261 8670 9148 12877 -331 -478 -505 O \nATOM 2094 CB ASP A 261 21.045 -4.073 -38.981 1.00 83.16 C \nANISOU 2094 CB ASP A 261 9075 9338 13184 -331 -571 -420 C \nATOM 2095 CG ASP A 261 20.099 -5.135 -38.382 1.00 87.72 C \nANISOU 2095 CG ASP A 261 9703 9857 13769 -318 -617 -387 C \nATOM 2096 OD1 ASP A 261 19.062 -5.473 -39.013 1.00100.06 O \nANISOU 2096 OD1 ASP A 261 11302 11384 15333 -311 -605 -380 O \nATOM 2097 OD2 ASP A 261 20.375 -5.617 -37.260 1.00 78.78 O \nANISOU 2097 OD2 ASP A 261 8578 8718 12638 -319 -666 -367 O \nATOM 2098 N SER A 262 20.706 -1.872 -41.315 1.00 78.08 N \nANISOU 2098 N SER A 262 8423 8735 12509 -372 -428 -465 N \nATOM 2099 CA SER A 262 21.036 -0.536 -41.746 1.00 76.25 C \nANISOU 2099 CA SER A 262 8186 8537 12250 -415 -370 -480 C \nATOM 2100 C SER A 262 19.753 0.305 -41.717 1.00 86.09 C \nANISOU 2100 C SER A 262 9495 9749 13465 -443 -327 -455 C \nATOM 2101 O SER A 262 18.644 -0.214 -41.407 1.00 86.25 O \nANISOU 2101 O SER A 262 9551 9732 13487 -429 -343 -427 O \nATOM 2102 CB SER A 262 21.597 -0.585 -43.179 1.00 75.29 C \nANISOU 2102 CB SER A 262 8023 8444 12140 -388 -344 -519 C \nATOM 2103 OG SER A 262 21.520 0.693 -43.798 1.00 92.70 O \nANISOU 2103 OG SER A 262 10244 10664 14314 -428 -281 -528 O \nATOM 2104 N ALA A 263 19.897 1.598 -42.028 1.00 76.62 N \nANISOU 2104 N ALA A 263 8313 8566 12234 -482 -272 -464 N \nATOM 2105 CA ALA A 263 18.756 2.394 -42.462 1.00 74.92 C \nANISOU 2105 CA ALA A 263 8152 8324 11990 -489 -222 -448 C \nATOM 2106 C ALA A 263 19.271 3.560 -43.245 1.00 65.56 C \nANISOU 2106 C ALA A 263 6972 7160 10777 -519 -166 -471 C \nATOM 2107 O ALA A 263 20.416 3.595 -43.614 1.00 57.73 O \nANISOU 2107 O ALA A 263 5934 6206 9793 -531 -167 -500 O \nATOM 2108 CB ALA A 263 17.885 2.834 -41.283 1.00 83.95 C \nANISOU 2108 CB ALA A 263 9350 9442 13105 -513 -223 -412 C \nATOM 2109 N ILE A 264 18.405 4.519 -43.512 1.00 70.16 N \nANISOU 2109 N ILE A 264 7613 7720 11325 -528 -117 -457 N \nATOM 2110 CA ILE A 264 18.797 5.666 -44.271 1.00 60.51 C \nANISOU 2110 CA ILE A 264 6412 6508 10071 -558 -62 -475 C \nATOM 2111 C ILE A 264 18.376 6.903 -43.475 1.00 63.34 C \nANISOU 2111 C ILE A 264 6847 6840 10379 -597 -28 -455 C \nATOM 2112 O ILE A 264 17.209 7.287 -43.444 1.00 80.47 O \nANISOU 2112 O ILE A 264 9071 8979 12524 -575 -4 -430 O \nATOM 2113 CB ILE A 264 18.174 5.635 -45.672 1.00 59.50 C \nANISOU 2113 CB ILE A 264 6286 6375 9946 -520 -29 -482 C \nATOM 2114 CG1 ILE A 264 18.844 4.552 -46.500 1.00 60.08 C \nANISOU 2114 CG1 ILE A 264 6286 6477 10064 -489 -57 -511 C \nATOM 2115 CG2 ILE A 264 18.315 6.998 -46.337 1.00 63.29 C \nANISOU 2115 CG2 ILE A 264 6812 6853 10381 -552 33 -491 C \nATOM 2116 CD1 ILE A 264 18.152 4.249 -47.808 1.00 56.13 C \nANISOU 2116 CD1 ILE A 264 5782 5973 9573 -448 -36 -516 C \nATOM 2117 N VAL A 265 19.362 7.520 -42.844 1.00 62.30 N \nANISOU 2117 N VAL A 265 6719 6726 10227 -655 -26 -466 N \nATOM 2118 CA VAL A 265 19.167 8.685 -42.000 1.00 57.68 C \nANISOU 2118 CA VAL A 265 6210 6116 9591 -702 3 -451 C \nATOM 2119 C VAL A 265 19.156 9.941 -42.842 1.00 55.21 C \nANISOU 2119 C VAL A 265 5959 5787 9232 -726 67 -461 C \nATOM 2120 O VAL A 265 19.953 10.078 -43.751 1.00 61.26 O \nANISOU 2120 O VAL A 265 6695 6581 10001 -746 83 -488 O \nATOM 2121 CB VAL A 265 20.280 8.757 -40.960 1.00 61.76 C \nANISOU 2121 CB VAL A 265 6703 6661 10102 -761 -25 -460 C \nATOM 2122 CG1 VAL A 265 20.109 9.970 -40.049 1.00 78.71 C \nANISOU 2122 CG1 VAL A 265 8936 8779 12193 -815 6 -447 C \nATOM 2123 CG2 VAL A 265 20.290 7.491 -40.128 1.00 46.03 C \nANISOU 2123 CG2 VAL A 265 4655 4682 8154 -732 -90 -448 C \nATOM 2124 N LYS A 266 18.270 10.860 -42.501 1.00 58.51 N \nANISOU 2124 N LYS A 266 6466 6160 9605 -724 103 -440 N \nATOM 2125 CA LYS A 266 18.142 12.151 -43.166 1.00 62.41 C \nANISOU 2125 CA LYS A 266 7041 6626 10046 -743 165 -444 C \nATOM 2126 C LYS A 266 18.752 13.194 -42.282 1.00 67.29 C \nANISOU 2126 C LYS A 266 7725 7228 10615 -819 183 -447 C \nATOM 2127 O LYS A 266 18.043 14.067 -41.777 1.00 80.18 O \nANISOU 2127 O LYS A 266 9451 8814 12200 -816 213 -429 O \nATOM 2128 CB LYS A 266 16.658 12.512 -43.408 1.00 61.07 C \nANISOU 2128 CB LYS A 266 6937 6416 9851 -678 195 -416 C \nATOM 2129 CG LYS A 266 15.865 11.489 -44.234 1.00 59.69 C \nANISOU 2129 CG LYS A 266 6703 6259 9717 -605 179 -409 C \nATOM 2130 CD LYS A 266 16.493 11.274 -45.593 1.00 63.14 C \nANISOU 2130 CD LYS A 266 7094 6721 10176 -606 190 -435 C \nATOM 2131 CE LYS A 266 15.470 11.100 -46.703 1.00 64.12 C \nANISOU 2131 CE LYS A 266 7219 6843 10301 -541 212 -425 C \nATOM 2132 NZ LYS A 266 16.032 11.695 -47.983 1.00 72.18 N \nANISOU 2132 NZ LYS A 266 8249 7869 11306 -559 252 -448 N \nATOM 2133 N SER A 267 20.077 13.136 -42.135 1.00 68.18 N \nANISOU 2133 N SER A 267 7790 7383 10733 -886 166 -472 N \nATOM 2134 CA SER A 267 20.816 14.110 -41.307 1.00 70.62 C \nANISOU 2134 CA SER A 267 8156 7687 10990 -975 182 -480 C \nATOM 2135 C SER A 267 21.502 15.168 -42.134 1.00 64.09 C \nANISOU 2135 C SER A 267 7379 6860 10114 -1040 231 -502 C \nATOM 2136 O SER A 267 21.866 14.919 -43.259 1.00 62.87 O \nANISOU 2136 O SER A 267 7177 6735 9978 -1030 239 -519 O \nATOM 2137 CB SER A 267 21.852 13.385 -40.446 1.00 77.06 C \nANISOU 2137 CB SER A 267 8886 8562 11833 -1017 129 -490 C \nATOM 2138 OG SER A 267 22.594 14.314 -39.656 1.00 75.65 O \nANISOU 2138 OG SER A 267 8757 8387 11601 -1111 144 -498 O \nATOM 2139 N GLU A 268 21.679 16.346 -41.554 1.00 76.69 N \nANISOU 2139 N GLU A 268 9075 8420 11645 -1108 264 -501 N \nATOM 2140 CA GLU A 268 22.585 17.400 -42.102 1.00 78.90 C \nANISOU 2140 CA GLU A 268 9408 8704 11867 -1201 306 -524 C \nATOM 2141 C GLU A 268 23.910 17.461 -41.313 1.00 65.46 C \nANISOU 2141 C GLU A 268 7663 7062 10146 -1306 283 -544 C \nATOM 2142 O GLU A 268 24.858 18.095 -41.701 1.00 76.23 O \nANISOU 2142 O GLU A 268 9041 8457 11468 -1394 306 -567 O \nATOM 2143 CB GLU A 268 21.885 18.768 -42.077 1.00 80.32 C \nANISOU 2143 CB GLU A 268 9747 8796 11974 -1213 364 -510 C \nATOM 2144 CG GLU A 268 22.583 19.832 -42.923 1.00 93.52 C \nANISOU 2144 CG GLU A 268 11490 10458 13585 -1294 413 -530 C \nATOM 2145 CD GLU A 268 22.118 21.264 -42.666 1.00104.33 C \nANISOU 2145 CD GLU A 268 13034 11736 14871 -1325 467 -519 C \nATOM 2146 OE1 GLU A 268 21.177 21.712 -43.356 1.00115.65 O \nANISOU 2146 OE1 GLU A 268 14545 13110 16286 -1255 502 -503 O \nATOM 2147 OE2 GLU A 268 22.715 21.969 -41.814 1.00101.80 O \nANISOU 2147 OE2 GLU A 268 12777 11403 14497 -1419 475 -526 O \nATOM 2148 N VAL A 269 23.928 16.786 -40.188 1.00 58.68 N \nANISOU 2148 N VAL A 269 6754 6225 9317 -1295 237 -534 N \nATOM 2149 CA VAL A 269 25.038 16.768 -39.267 1.00 52.79 C \nANISOU 2149 CA VAL A 269 5966 5539 8555 -1382 210 -547 C \nATOM 2150 C VAL A 269 26.222 16.058 -39.906 1.00 58.31 C \nANISOU 2150 C VAL A 269 6536 6337 9282 -1404 183 -575 C \nATOM 2151 O VAL A 269 26.083 15.125 -40.733 1.00 54.87 O \nANISOU 2151 O VAL A 269 6018 5926 8904 -1327 163 -579 O \nATOM 2152 CB VAL A 269 24.636 16.022 -37.975 1.00 53.26 C \nANISOU 2152 CB VAL A 269 5991 5597 8648 -1344 161 -525 C \nATOM 2153 CG1 VAL A 269 25.815 15.776 -37.069 1.00 53.55 C \nANISOU 2153 CG1 VAL A 269 5960 5710 8677 -1421 123 -537 C \nATOM 2154 CG2 VAL A 269 23.542 16.806 -37.244 1.00 50.33 C \nANISOU 2154 CG2 VAL A 269 5747 5137 8238 -1330 189 -500 C \nATOM 2155 N GLU A 270 27.410 16.508 -39.525 1.00 63.12 N \nANISOU 2155 N GLU A 270 7128 7010 9846 -1511 182 -595 N \nATOM 2156 CA GLU A 270 28.637 15.962 -40.080 1.00 64.78 C \nANISOU 2156 CA GLU A 270 7215 7329 10069 -1541 160 -624 C \nATOM 2157 C GLU A 270 29.175 14.791 -39.248 1.00 59.43 C \nANISOU 2157 C GLU A 270 6415 6726 9438 -1510 94 -623 C \nATOM 2158 O GLU A 270 28.756 14.552 -38.147 1.00 52.61 O \nANISOU 2158 O GLU A 270 5568 5834 8586 -1492 66 -601 O \nATOM 2159 CB GLU A 270 29.676 17.054 -40.197 1.00 78.85 C \nANISOU 2159 CB GLU A 270 9034 9155 11770 -1678 196 -648 C \nATOM 2160 CG GLU A 270 29.991 17.760 -38.885 1.00 88.96 C \nANISOU 2160 CG GLU A 270 10377 10430 12993 -1774 196 -642 C \nATOM 2161 CD GLU A 270 31.107 18.785 -39.032 1.00 96.21 C \nANISOU 2161 CD GLU A 270 11326 11404 13825 -1923 229 -668 C \nATOM 2162 OE1 GLU A 270 31.713 18.850 -40.133 1.00 98.45 O \nANISOU 2162 OE1 GLU A 270 11566 11743 14097 -1950 246 -691 O \nATOM 2163 OE2 GLU A 270 31.376 19.508 -38.043 1.00 97.59 O \nANISOU 2163 OE2 GLU A 270 11569 11570 13941 -2017 236 -665 O \nATOM 2164 N TYR A 271 30.119 14.074 -39.823 1.00 59.73 N \nANISOU 2164 N TYR A 271 6332 6862 9500 -1501 68 -648 N \nATOM 2165 CA TYR A 271 30.759 12.950 -39.163 1.00 64.96 C \nANISOU 2165 CA TYR A 271 6876 7605 10202 -1465 5 -650 C \nATOM 2166 C TYR A 271 31.660 13.504 -38.077 1.00 69.85 C \nANISOU 2166 C TYR A 271 7492 8286 10764 -1573 -4 -654 C \nATOM 2167 O TYR A 271 32.022 14.678 -38.108 1.00 84.65 O \nANISOU 2167 O TYR A 271 9436 10161 12566 -1684 40 -665 O \nATOM 2168 CB TYR A 271 31.570 12.175 -40.201 1.00 66.52 C \nANISOU 2168 CB TYR A 271 6953 7894 10428 -1425 -12 -679 C \nATOM 2169 CG TYR A 271 32.208 10.917 -39.708 1.00 68.43 C \nANISOU 2169 CG TYR A 271 7071 8216 10713 -1365 -77 -682 C \nATOM 2170 CD1 TYR A 271 31.461 9.913 -39.168 1.00 66.17 C \nANISOU 2170 CD1 TYR A 271 6776 7878 10488 -1267 -121 -657 C \nATOM 2171 CD2 TYR A 271 33.593 10.733 -39.801 1.00 81.40 C \nANISOU 2171 CD2 TYR A 271 8605 9993 12331 -1406 -95 -711 C \nATOM 2172 CE1 TYR A 271 32.053 8.740 -38.731 1.00 72.58 C \nANISOU 2172 CE1 TYR A 271 7484 8757 11337 -1206 -183 -659 C \nATOM 2173 CE2 TYR A 271 34.205 9.563 -39.353 1.00 81.95 C \nANISOU 2173 CE2 TYR A 271 8562 10140 12436 -1338 -157 -714 C \nATOM 2174 CZ TYR A 271 33.429 8.565 -38.826 1.00 78.09 C \nANISOU 2174 CZ TYR A 271 8076 9585 12010 -1236 -201 -687 C \nATOM 2175 OH TYR A 271 34.048 7.420 -38.384 1.00 79.93 O \nANISOU 2175 OH TYR A 271 8208 9887 12273 -1167 -262 -689 O \nATOM 2176 N GLY A 272 32.020 12.676 -37.114 1.00 73.80 N \nANISOU 2176 N GLY A 272 7915 8836 11289 -1547 -61 -645 N \nATOM 2177 CA GLY A 272 32.757 13.136 -35.928 1.00 69.27 C \nANISOU 2177 CA GLY A 272 7339 8318 10662 -1645 -74 -644 C \nATOM 2178 C GLY A 272 33.816 12.188 -35.412 1.00 70.02 C \nANISOU 2178 C GLY A 272 7296 8536 10773 -1628 -134 -653 C \nATOM 2179 O GLY A 272 34.295 12.354 -34.299 1.00 74.35 O \nANISOU 2179 O GLY A 272 7834 9129 11287 -1690 -156 -646 O \nATOM 2180 N ASN A 273 34.141 11.157 -36.187 1.00 70.57 N \nANISOU 2180 N ASN A 273 7262 8659 10892 -1538 -163 -666 N \nATOM 2181 CA ASN A 273 35.059 10.092 -35.748 1.00 75.95 C \nANISOU 2181 CA ASN A 273 7811 9451 11594 -1491 -225 -672 C \nATOM 2182 C ASN A 273 34.774 9.504 -34.350 1.00 84.47 C \nANISOU 2182 C ASN A 273 8891 10509 12697 -1459 -277 -640 C \nATOM 2183 O ASN A 273 35.684 9.356 -33.554 1.00 94.16 O \nANISOU 2183 O ASN A 273 10048 11833 13894 -1497 -311 -643 O \nATOM 2184 CB ASN A 273 36.484 10.585 -35.818 1.00 65.80 C \nANISOU 2184 CB ASN A 273 6448 8312 10241 -1592 -218 -703 C \nATOM 2185 CG ASN A 273 36.817 11.148 -37.182 1.00 69.52 C \nANISOU 2185 CG ASN A 273 6916 8814 10685 -1631 -168 -734 C \nATOM 2186 OD1 ASN A 273 37.306 10.446 -38.055 1.00 63.25 O \nANISOU 2186 OD1 ASN A 273 6026 8089 9917 -1565 -181 -756 O \nATOM 2187 ND2 ASN A 273 36.550 12.444 -37.373 1.00 73.34 N \nANISOU 2187 ND2 ASN A 273 7511 9243 11113 -1739 -109 -736 N \nATOM 2188 N CYS A 274 33.522 9.133 -34.095 1.00 95.11 N \nANISOU 2188 N CYS A 274 10309 11736 14093 -1387 -285 -611 N \nATOM 2189 CA CYS A 274 33.108 8.609 -32.787 1.00101.08 C \nANISOU 2189 CA CYS A 274 11078 12458 14869 -1360 -331 -578 C \nATOM 2190 C CYS A 274 32.566 7.192 -32.936 1.00100.52 C \nANISOU 2190 C CYS A 274 10968 12349 14875 -1224 -381 -563 C \nATOM 2191 O CYS A 274 32.636 6.621 -34.021 1.00 99.77 O \nANISOU 2191 O CYS A 274 10830 12264 14815 -1155 -380 -580 O \nATOM 2192 CB CYS A 274 32.075 9.532 -32.135 1.00 97.78 C \nANISOU 2192 CB CYS A 274 10791 11934 14426 -1413 -296 -555 C \nATOM 2193 SG CYS A 274 31.191 10.587 -33.293 1.00106.16 S \nANISOU 2193 SG CYS A 274 11964 12900 15472 -1433 -218 -564 S \nATOM 2194 N ASN A 275 32.062 6.637 -31.835 1.00105.51 N \nANISOU 2194 N ASN A 275 11619 12940 15529 -1192 -423 -530 N \nATOM 2195 CA ASN A 275 31.401 5.341 -31.834 1.00106.99 C \nANISOU 2195 CA ASN A 275 11794 13075 15782 -1076 -470 -510 C \nATOM 2196 C ASN A 275 30.172 5.341 -30.963 1.00110.59 C \nANISOU 2196 C ASN A 275 12338 13429 16250 -1071 -476 -473 C \nATOM 2197 O ASN A 275 30.114 6.075 -29.983 1.00115.54 O \nANISOU 2197 O ASN A 275 13011 14053 16838 -1147 -467 -460 O \nATOM 2198 CB ASN A 275 32.361 4.286 -31.285 1.00106.75 C \nANISOU 2198 CB ASN A 275 11664 13131 15766 -1026 -538 -509 C \nATOM 2199 CG ASN A 275 33.313 3.769 -32.332 1.00106.72 C \nANISOU 2199 CG ASN A 275 11563 13212 15773 -974 -545 -543 C \nATOM 2200 OD1 ASN A 275 33.068 3.900 -33.517 1.00114.55 O \nANISOU 2200 OD1 ASN A 275 12565 14181 16779 -953 -509 -563 O \nATOM 2201 ND2 ASN A 275 34.413 3.185 -31.895 1.00111.26 N \nANISOU 2201 ND2 ASN A 275 12044 13893 16337 -951 -592 -550 N \nATOM 2202 N THR A 276 29.230 4.466 -31.301 1.00106.71 N \nANISOU 2202 N THR A 276 11869 12865 15812 -982 -495 -457 N \nATOM 2203 CA THR A 276 27.992 4.307 -30.554 1.00110.92 C \nANISOU 2203 CA THR A 276 12477 13309 16358 -968 -504 -421 C \nATOM 2204 C THR A 276 27.320 2.995 -30.965 1.00119.45 C \nANISOU 2204 C THR A 276 13549 14341 17497 -865 -542 -407 C \nATOM 2205 O THR A 276 27.663 2.424 -31.991 1.00132.29 O \nANISOU 2205 O THR A 276 15128 15985 19151 -809 -546 -429 O \nATOM 2206 CB THR A 276 27.042 5.494 -30.790 1.00118.49 C \nANISOU 2206 CB THR A 276 13533 14202 17288 -1017 -438 -418 C \nATOM 2207 OG1 THR A 276 25.813 5.288 -30.086 1.00119.36 O \nANISOU 2207 OG1 THR A 276 13707 14237 17408 -996 -448 -384 O \nATOM 2208 CG2 THR A 276 26.721 5.653 -32.239 1.00121.37 C \nANISOU 2208 CG2 THR A 276 13906 14542 17667 -984 -396 -438 C \nATOM 2209 N LYS A 277 26.399 2.504 -30.146 1.00116.22 N \nANISOU 2209 N LYS A 277 13185 13872 17102 -846 -571 -373 N \nATOM 2210 CA LYS A 277 25.504 1.428 -30.548 1.00120.38 C \nANISOU 2210 CA LYS A 277 13728 14337 17674 -767 -596 -357 C \nATOM 2211 C LYS A 277 24.139 2.038 -30.814 1.00122.37 C \nANISOU 2211 C LYS A 277 14061 14518 17916 -780 -549 -344 C \nATOM 2212 O LYS A 277 23.200 1.346 -31.269 1.00141.67 O \nANISOU 2212 O LYS A 277 16529 16911 20389 -728 -557 -332 O \nATOM 2213 CB LYS A 277 25.408 0.355 -29.459 1.00131.30 C \nANISOU 2213 CB LYS A 277 15107 15708 19075 -735 -666 -326 C \nATOM 2214 CG LYS A 277 24.687 -0.923 -29.894 1.00136.08 C \nANISOU 2214 CG LYS A 277 15725 16255 19723 -655 -701 -313 C \nATOM 2215 CD LYS A 277 24.602 -2.034 -28.853 1.00134.46 C \nANISOU 2215 CD LYS A 277 15525 16032 19533 -625 -771 -281 C \nATOM 2216 CE LYS A 277 23.787 -3.211 -29.362 1.00132.75 C \nANISOU 2216 CE LYS A 277 15339 15749 19350 -559 -799 -269 C \nATOM 2217 NZ LYS A 277 24.108 -3.644 -30.756 1.00129.72 N \nANISOU 2217 NZ LYS A 277 14924 15369 18995 -499 -787 -301 N \nATOM 2218 N CYS A 278 24.026 3.334 -30.526 1.00102.99 N \nANISOU 2218 N CYS A 278 11650 12063 15417 -851 -500 -347 N \nATOM 2219 CA CYS A 278 22.803 4.042 -30.763 1.00110.57 C \nANISOU 2219 CA CYS A 278 12687 12965 16360 -859 -451 -336 C \nATOM 2220 C CYS A 278 23.076 5.388 -31.419 1.00106.15 C \nANISOU 2220 C CYS A 278 12158 12414 15762 -909 -384 -361 C \nATOM 2221 O CYS A 278 23.780 6.214 -30.845 1.00 96.51 O \nANISOU 2221 O CYS A 278 10943 11224 14501 -979 -370 -370 O \nATOM 2222 CB CYS A 278 22.052 4.246 -29.451 1.00112.60 C \nANISOU 2222 CB CYS A 278 12996 13192 16593 -889 -462 -304 C \nATOM 2223 SG CYS A 278 20.486 5.076 -29.757 1.00128.76 S \nANISOU 2223 SG CYS A 278 15133 15177 18613 -884 -403 -290 S \nATOM 2224 N GLN A 279 22.459 5.606 -32.590 1.00 90.49 N \nANISOU 2224 N GLN A 279 10197 10399 13785 -877 -343 -370 N \nATOM 2225 CA GLN A 279 22.628 6.836 -33.345 1.00 70.16 C \nANISOU 2225 CA GLN A 279 7660 7824 11173 -917 -279 -392 C \nATOM 2226 C GLN A 279 21.286 7.444 -33.716 1.00 70.50 C \nANISOU 2226 C GLN A 279 7784 7805 11198 -896 -232 -377 C \nATOM 2227 O GLN A 279 20.337 6.716 -34.005 1.00 70.87 O \nANISOU 2227 O GLN A 279 7831 7824 11274 -836 -246 -361 O \nATOM 2228 CB GLN A 279 23.419 6.531 -34.588 1.00 61.06 C \nANISOU 2228 CB GLN A 279 6446 6712 10044 -895 -274 -423 C \nATOM 2229 CG GLN A 279 23.580 7.709 -35.520 1.00 66.10 C \nANISOU 2229 CG GLN A 279 7122 7348 10645 -935 -208 -445 C \nATOM 2230 CD GLN A 279 24.583 8.745 -35.020 1.00 67.46 C \nANISOU 2230 CD GLN A 279 7307 7559 10765 -1030 -187 -461 C \nATOM 2231 OE1 GLN A 279 25.788 8.454 -34.897 1.00 57.52 O \nANISOU 2231 OE1 GLN A 279 5974 6374 9507 -1057 -214 -479 O \nATOM 2232 NE2 GLN A 279 24.109 9.963 -34.774 1.00 63.36 N \nANISOU 2232 NE2 GLN A 279 6883 6997 10195 -1080 -138 -455 N \nATOM 2233 N THR A 280 21.213 8.777 -33.708 1.00 67.94 N \nANISOU 2233 N THR A 280 7530 7461 10821 -947 -177 -384 N \nATOM 2234 CA THR A 280 19.994 9.488 -34.148 1.00 66.21 C \nANISOU 2234 CA THR A 280 7393 7188 10576 -920 -127 -372 C \nATOM 2235 C THR A 280 20.426 10.444 -35.223 1.00 65.95 C \nANISOU 2235 C THR A 280 7390 7153 10516 -946 -72 -397 C \nATOM 2236 O THR A 280 21.629 10.643 -35.410 1.00 68.56 O \nANISOU 2236 O THR A 280 7684 7527 10840 -998 -72 -422 O \nATOM 2237 CB THR A 280 19.246 10.211 -33.005 1.00 68.45 C \nANISOU 2237 CB THR A 280 7757 7435 10815 -942 -111 -349 C \nATOM 2238 OG1 THR A 280 19.416 11.623 -33.103 1.00 78.64 O \nANISOU 2238 OG1 THR A 280 9130 8702 12047 -993 -54 -362 O \nATOM 2239 CG2 THR A 280 19.723 9.750 -31.644 1.00 67.25 C \nANISOU 2239 CG2 THR A 280 7575 7308 10668 -978 -162 -338 C \nATOM 2240 N PRO A 281 19.475 11.041 -35.946 1.00 67.43 N \nANISOU 2240 N PRO A 281 7641 7298 10682 -911 -24 -391 N \nATOM 2241 CA PRO A 281 19.839 12.012 -36.982 1.00 76.31 C \nANISOU 2241 CA PRO A 281 8805 8413 11774 -937 30 -413 C \nATOM 2242 C PRO A 281 20.573 13.262 -36.500 1.00 72.67 C \nANISOU 2242 C PRO A 281 8412 7946 11252 -1027 63 -426 C \nATOM 2243 O PRO A 281 21.413 13.800 -37.230 1.00 77.93 O \nANISOU 2243 O PRO A 281 9080 8632 11899 -1076 90 -450 O \nATOM 2244 CB PRO A 281 18.476 12.435 -37.555 1.00 79.36 C \nANISOU 2244 CB PRO A 281 9260 8750 12142 -875 71 -395 C \nATOM 2245 CG PRO A 281 17.595 11.267 -37.314 1.00 75.33 C \nANISOU 2245 CG PRO A 281 8702 8246 11676 -807 29 -372 C \nATOM 2246 CD PRO A 281 18.035 10.782 -35.953 1.00 72.37 C \nANISOU 2246 CD PRO A 281 8296 7888 11312 -843 -20 -364 C \nATOM 2247 N ILE A 282 20.251 13.705 -35.290 1.00 62.42 N \nANISOU 2247 N ILE A 282 7172 6623 9922 -1053 62 -410 N \nATOM 2248 CA ILE A 282 20.847 14.890 -34.740 1.00 59.39 C \nANISOU 2248 CA ILE A 282 6865 6225 9474 -1142 94 -421 C \nATOM 2249 C ILE A 282 22.063 14.631 -33.816 1.00 66.02 C \nANISOU 2249 C ILE A 282 7647 7124 10315 -1221 54 -432 C \nATOM 2250 O ILE A 282 22.676 15.582 -33.293 1.00 73.08 O \nANISOU 2250 O ILE A 282 8600 8016 11152 -1309 77 -443 O \nATOM 2251 CB ILE A 282 19.809 15.728 -34.008 1.00 54.62 C \nANISOU 2251 CB ILE A 282 6375 5556 8821 -1129 126 -400 C \nATOM 2252 CG1 ILE A 282 19.326 15.048 -32.753 1.00 58.19 C \nANISOU 2252 CG1 ILE A 282 6800 6016 9293 -1108 81 -378 C \nATOM 2253 CG2 ILE A 282 18.661 16.021 -34.928 1.00 47.31 C \nANISOU 2253 CG2 ILE A 282 5503 4585 7888 -1048 165 -389 C \nATOM 2254 CD1 ILE A 282 18.557 15.991 -31.842 1.00 59.57 C \nANISOU 2254 CD1 ILE A 282 7087 6138 9409 -1114 112 -363 C \nATOM 2255 N GLY A 283 22.403 13.362 -33.615 1.00 59.19 N \nANISOU 2255 N GLY A 283 6671 6311 9508 -1189 -5 -429 N \nATOM 2256 CA GLY A 283 23.591 13.012 -32.861 1.00 63.79 C \nANISOU 2256 CA GLY A 283 7184 6960 10093 -1250 -46 -439 C \nATOM 2257 C GLY A 283 23.560 11.621 -32.271 1.00 60.97 C \nANISOU 2257 C GLY A 283 6737 6635 9795 -1197 -114 -423 C \nATOM 2258 O GLY A 283 22.511 11.096 -31.994 1.00 58.10 O \nANISOU 2258 O GLY A 283 6387 6232 9456 -1134 -130 -398 O \nATOM 2259 N ALA A 284 24.741 11.059 -32.044 1.00 58.75 N \nANISOU 2259 N ALA A 284 6367 6429 9528 -1225 -155 -437 N \nATOM 2260 CA ALA A 284 24.892 9.805 -31.356 1.00 62.80 C \nANISOU 2260 CA ALA A 284 6801 6974 10087 -1183 -222 -421 C \nATOM 2261 C ALA A 284 24.619 9.914 -29.840 1.00 68.65 C \nANISOU 2261 C ALA A 284 7576 7701 10806 -1216 -245 -397 C \nATOM 2262 O ALA A 284 24.680 10.990 -29.249 1.00 75.20 O \nANISOU 2262 O ALA A 284 8475 8516 11579 -1290 -213 -399 O \nATOM 2263 CB ALA A 284 26.286 9.267 -31.562 1.00 62.75 C \nANISOU 2263 CB ALA A 284 6691 7059 10094 -1199 -256 -444 C \nATOM 2264 N ILE A 285 24.298 8.785 -29.224 1.00 68.08 N \nANISOU 2264 N ILE A 285 7461 7630 10776 -1163 -302 -374 N \nATOM 2265 CA ILE A 285 24.233 8.720 -27.784 1.00 63.19 C \nANISOU 2265 CA ILE A 285 6856 7015 10141 -1196 -334 -352 C \nATOM 2266 C ILE A 285 24.889 7.489 -27.195 1.00 70.26 C \nANISOU 2266 C ILE A 285 7661 7962 11073 -1169 -406 -342 C \nATOM 2267 O ILE A 285 24.391 6.393 -27.334 1.00 75.74 O \nANISOU 2267 O ILE A 285 8327 8636 11813 -1095 -444 -326 O \nATOM 2268 CB ILE A 285 22.791 8.945 -27.213 1.00 61.11 C \nANISOU 2268 CB ILE A 285 6675 6678 9865 -1173 -318 -324 C \nATOM 2269 CG1 ILE A 285 22.833 8.833 -25.692 1.00 67.84 C \nANISOU 2269 CG1 ILE A 285 7533 7542 10700 -1212 -354 -303 C \nATOM 2270 CG2 ILE A 285 21.731 8.028 -27.756 1.00 53.13 C \nANISOU 2270 CG2 ILE A 285 5655 5630 8901 -1084 -334 -307 C \nATOM 2271 CD1 ILE A 285 23.839 9.788 -25.041 1.00 61.94 C \nANISOU 2271 CD1 ILE A 285 6802 6835 9899 -1311 -338 -320 C \nATOM 2272 N ASN A 286 26.001 7.716 -26.491 1.00 86.29 N \nANISOU 2272 N ASN A 286 9654 10059 13075 -1234 -425 -351 N \nATOM 2273 CA ASN A 286 26.672 6.716 -25.627 1.00 85.04 C \nANISOU 2273 CA ASN A 286 9420 9956 12936 -1219 -495 -337 C \nATOM 2274 C ASN A 286 26.178 6.774 -24.176 1.00 87.73 C \nANISOU 2274 C ASN A 286 9803 10274 13256 -1251 -518 -307 C \nATOM 2275 O ASN A 286 26.799 7.399 -23.334 1.00 85.43 O \nANISOU 2275 O ASN A 286 9515 10023 12920 -1330 -516 -310 O \nATOM 2276 CB ASN A 286 28.184 6.935 -25.654 1.00 87.31 C \nANISOU 2276 CB ASN A 286 9632 10344 13197 -1272 -504 -363 C \nATOM 2277 CG ASN A 286 28.938 5.964 -24.765 1.00 91.48 C \nANISOU 2277 CG ASN A 286 10082 10939 13739 -1253 -575 -349 C \nATOM 2278 OD1 ASN A 286 28.408 4.935 -24.337 1.00 99.33 O \nANISOU 2278 OD1 ASN A 286 11069 11899 14772 -1185 -623 -322 O \nATOM 2279 ND2 ASN A 286 30.185 6.297 -24.472 1.00 92.66 N \nANISOU 2279 ND2 ASN A 286 10171 11185 13849 -1314 -583 -366 N \nATOM 2280 N SER A 287 25.052 6.118 -23.899 1.00 97.61 N \nANISOU 2280 N SER A 287 11085 11464 14537 -1195 -538 -279 N \nATOM 2281 CA SER A 287 24.493 6.066 -22.542 1.00 98.51 C \nANISOU 2281 CA SER A 287 11237 11558 14633 -1219 -563 -249 C \nATOM 2282 C SER A 287 24.030 4.684 -22.147 1.00 93.21 C \nANISOU 2282 C SER A 287 10537 10870 14007 -1152 -627 -218 C \nATOM 2283 O SER A 287 24.280 3.711 -22.866 1.00 97.32 O \nANISOU 2283 O SER A 287 11007 11399 14573 -1086 -657 -222 O \nATOM 2284 CB SER A 287 23.353 7.069 -22.395 1.00100.23 C \nANISOU 2284 CB SER A 287 11554 11712 14816 -1244 -506 -243 C \nATOM 2285 OG SER A 287 23.859 8.396 -22.489 1.00102.60 O \nANISOU 2285 OG SER A 287 11895 12023 15064 -1320 -452 -268 O \nATOM 2286 N SER A 288 23.414 4.597 -20.970 1.00 90.86 N \nANISOU 2286 N SER A 288 10276 10553 13694 -1173 -648 -189 N \nATOM 2287 CA SER A 288 22.855 3.339 -20.477 1.00 90.14 C \nANISOU 2287 CA SER A 288 10173 10439 13636 -1121 -708 -157 C \nATOM 2288 C SER A 288 21.675 3.613 -19.569 1.00 86.64 C \nANISOU 2288 C SER A 288 9798 9955 13168 -1146 -699 -130 C \nATOM 2289 O SER A 288 21.852 3.761 -18.358 1.00 78.42 O \nANISOU 2289 O SER A 288 8765 8934 12099 -1194 -721 -114 O \nATOM 2290 CB SER A 288 23.908 2.531 -19.730 1.00 86.88 C \nANISOU 2290 CB SER A 288 9696 10081 13234 -1120 -775 -146 C \nATOM 2291 OG SER A 288 23.383 1.269 -19.380 1.00 90.75 O \nANISOU 2291 OG SER A 288 10185 10541 13756 -1066 -833 -115 O \nATOM 2292 N MET A 289 20.489 3.675 -20.178 1.00 84.63 N \nANISOU 2292 N MET A 289 9587 9649 12918 -1111 -667 -125 N \nATOM 2293 CA MET A 289 19.272 4.055 -19.488 1.00 92.29 C \nANISOU 2293 CA MET A 289 10621 10588 13857 -1127 -648 -105 C \nATOM 2294 C MET A 289 18.035 3.568 -20.245 1.00 88.04 C \nANISOU 2294 C MET A 289 10103 10010 13338 -1069 -637 -94 C \nATOM 2295 O MET A 289 18.001 3.551 -21.460 1.00 93.71 O \nANISOU 2295 O MET A 289 10810 10716 14078 -1029 -612 -111 O \nATOM 2296 CB MET A 289 19.232 5.586 -19.323 1.00 97.16 C \nANISOU 2296 CB MET A 289 11295 11201 14421 -1181 -581 -124 C \nATOM 2297 CG MET A 289 19.976 6.145 -18.111 1.00104.53 C \nANISOU 2297 CG MET A 289 12234 12167 15315 -1257 -591 -124 C \nATOM 2298 SD MET A 289 19.594 7.891 -17.759 1.00118.37 S \nANISOU 2298 SD MET A 289 14083 13896 16996 -1317 -513 -141 S \nATOM 2299 CE MET A 289 20.891 8.252 -16.592 1.00 84.04 C \nANISOU 2299 CE MET A 289 9715 9603 12615 -1410 -538 -147 C \nATOM 2300 N PRO A 290 16.979 3.220 -19.531 1.00 99.58 N \nANISOU 2300 N PRO A 290 11593 11457 14785 -1068 -653 -64 N \nATOM 2301 CA PRO A 290 15.803 2.651 -20.202 1.00101.79 C \nANISOU 2301 CA PRO A 290 11886 11712 15079 -1020 -648 -52 C \nATOM 2302 C PRO A 290 15.051 3.625 -21.091 1.00 93.72 C \nANISOU 2302 C PRO A 290 10902 10675 14034 -999 -576 -69 C \nATOM 2303 O PRO A 290 14.237 3.192 -21.936 1.00 90.07 O \nANISOU 2303 O PRO A 290 10439 10200 13585 -954 -567 -65 O \nATOM 2304 CB PRO A 290 14.905 2.213 -19.036 1.00 97.35 C \nANISOU 2304 CB PRO A 290 11347 11151 14493 -1040 -680 -17 C \nATOM 2305 CG PRO A 290 15.300 3.087 -17.914 1.00101.27 C \nANISOU 2305 CG PRO A 290 11864 11664 14949 -1097 -669 -18 C \nATOM 2306 CD PRO A 290 16.772 3.368 -18.085 1.00105.64 C \nANISOU 2306 CD PRO A 290 12383 12236 15518 -1117 -673 -42 C \nATOM 2307 N PHE A 291 15.305 4.918 -20.925 1.00 83.82 N \nANISOU 2307 N PHE A 291 9684 9422 12741 -1031 -525 -87 N \nATOM 2308 CA PHE A 291 14.582 5.907 -21.727 1.00 92.82 C \nANISOU 2308 CA PHE A 291 10872 10543 13853 -1006 -456 -101 C \nATOM 2309 C PHE A 291 15.432 7.080 -22.224 1.00 86.76 C \nANISOU 2309 C PHE A 291 10129 9770 13068 -1032 -406 -134 C \nATOM 2310 O PHE A 291 16.522 7.342 -21.712 1.00 79.72 O \nANISOU 2310 O PHE A 291 9225 8895 12171 -1084 -418 -145 O \nATOM 2311 CB PHE A 291 13.384 6.424 -20.945 1.00 95.55 C \nANISOU 2311 CB PHE A 291 11271 10886 14148 -1009 -432 -83 C \nATOM 2312 CG PHE A 291 12.495 5.328 -20.410 1.00100.24 C \nANISOU 2312 CG PHE A 291 11844 11494 14750 -996 -479 -51 C \nATOM 2313 CD1 PHE A 291 12.650 4.857 -19.120 1.00102.24 C \nANISOU 2313 CD1 PHE A 291 12088 11761 14996 -1037 -527 -30 C \nATOM 2314 CD2 PHE A 291 11.527 4.763 -21.203 1.00 98.70 C \nANISOU 2314 CD2 PHE A 291 11638 11299 14564 -948 -476 -41 C \nATOM 2315 CE1 PHE A 291 11.837 3.863 -18.611 1.00 99.30 C \nANISOU 2315 CE1 PHE A 291 11703 11401 14625 -1033 -571 1 C \nATOM 2316 CE2 PHE A 291 10.706 3.765 -20.709 1.00104.21 C \nANISOU 2316 CE2 PHE A 291 12321 12013 15262 -947 -519 -11 C \nATOM 2317 CZ PHE A 291 10.859 3.313 -19.411 1.00103.12 C \nANISOU 2317 CZ PHE A 291 12180 11886 15117 -991 -566 11 C \nATOM 2318 N HIS A 292 14.925 7.739 -23.269 1.00 85.13 N \nANISOU 2318 N HIS A 292 9955 9541 12848 -997 -350 -148 N \nATOM 2319 CA HIS A 292 15.500 8.976 -23.794 1.00 74.70 C \nANISOU 2319 CA HIS A 292 8679 8206 11499 -1021 -293 -176 C \nATOM 2320 C HIS A 292 14.410 9.794 -24.458 1.00 74.99 C \nANISOU 2320 C HIS A 292 8779 8213 11499 -975 -232 -178 C \nATOM 2321 O HIS A 292 13.320 9.283 -24.731 1.00 92.07 O \nANISOU 2321 O HIS A 292 10933 10379 13669 -921 -235 -160 O \nATOM 2322 CB HIS A 292 16.657 8.693 -24.758 1.00 71.57 C \nANISOU 2322 CB HIS A 292 8227 7824 11141 -1026 -302 -200 C \nATOM 2323 CG HIS A 292 16.230 8.287 -26.137 1.00 80.33 C \nANISOU 2323 CG HIS A 292 9315 8925 12283 -963 -288 -206 C \nATOM 2324 ND1 HIS A 292 15.698 9.172 -27.049 1.00 88.30 N \nANISOU 2324 ND1 HIS A 292 10376 9908 13266 -937 -227 -217 N \nATOM 2325 CD2 HIS A 292 16.309 7.100 -26.778 1.00 78.67 C \nANISOU 2325 CD2 HIS A 292 9040 8726 12126 -922 -328 -203 C \nATOM 2326 CE1 HIS A 292 15.432 8.546 -28.178 1.00 86.13 C \nANISOU 2326 CE1 HIS A 292 10063 9634 13027 -886 -229 -220 C \nATOM 2327 NE2 HIS A 292 15.793 7.285 -28.038 1.00 84.23 N \nANISOU 2327 NE2 HIS A 292 9753 9415 12835 -877 -289 -213 N \nATOM 2328 N ASN A 293 14.716 11.055 -24.730 1.00 78.46 N \nANISOU 2328 N ASN A 293 9285 8629 11898 -999 -176 -199 N \nATOM 2329 CA ASN A 293 13.797 11.972 -25.425 1.00 73.95 C \nANISOU 2329 CA ASN A 293 8786 8026 11287 -951 -113 -202 C \nATOM 2330 C ASN A 293 14.486 12.790 -26.507 1.00 71.88 C \nANISOU 2330 C ASN A 293 8555 7741 11015 -963 -67 -230 C \nATOM 2331 O ASN A 293 14.103 13.920 -26.781 1.00 76.37 O \nANISOU 2331 O ASN A 293 9211 8273 11532 -952 -10 -238 O \nATOM 2332 CB ASN A 293 13.169 12.915 -24.431 1.00 78.74 C \nANISOU 2332 CB ASN A 293 9478 8613 11828 -961 -81 -196 C \nATOM 2333 CG ASN A 293 14.190 13.783 -23.731 1.00 78.89 C \nANISOU 2333 CG ASN A 293 9546 8617 11812 -1043 -68 -214 C \nATOM 2334 OD1 ASN A 293 15.383 13.461 -23.679 1.00 74.57 O \nANISOU 2334 OD1 ASN A 293 8950 8091 11293 -1101 -98 -226 O \nATOM 2335 ND2 ASN A 293 13.717 14.888 -23.184 1.00 78.67 N \nANISOU 2335 ND2 ASN A 293 9617 8556 11718 -1049 -23 -217 N \nATOM 2336 N ILE A 294 15.505 12.197 -27.115 1.00 66.79 N \nANISOU 2336 N ILE A 294 7841 7120 10418 -985 -94 -245 N \nATOM 2337 CA ILE A 294 16.366 12.867 -28.065 1.00 67.29 C \nANISOU 2337 CA ILE A 294 7921 7174 10474 -1013 -59 -272 C \nATOM 2338 C ILE A 294 15.672 13.099 -29.396 1.00 71.44 C \nANISOU 2338 C ILE A 294 8467 7678 11000 -948 -18 -275 C \nATOM 2339 O ILE A 294 15.498 14.229 -29.835 1.00 75.26 O \nANISOU 2339 O ILE A 294 9034 8124 11436 -948 39 -285 O \nATOM 2340 CB ILE A 294 17.634 12.041 -28.343 1.00 59.91 C \nANISOU 2340 CB ILE A 294 6890 6284 9589 -1045 -104 -287 C \nATOM 2341 CG1 ILE A 294 18.355 11.639 -27.051 1.00 63.39 C \nANISOU 2341 CG1 ILE A 294 7295 6758 10034 -1102 -153 -281 C \nATOM 2342 CG2 ILE A 294 18.566 12.843 -29.237 1.00 57.16 C \nANISOU 2342 CG2 ILE A 294 6560 5935 9222 -1088 -65 -317 C \nATOM 2343 CD1 ILE A 294 18.834 12.804 -26.198 1.00 67.08 C \nANISOU 2343 CD1 ILE A 294 7835 7215 10439 -1183 -124 -291 C \nATOM 2344 N HIS A 295 15.281 11.996 -30.023 1.00 75.43 N \nANISOU 2344 N HIS A 295 8899 8204 11557 -892 -49 -266 N \nATOM 2345 CA HIS A 295 14.687 12.020 -31.358 1.00 75.63 C \nANISOU 2345 CA HIS A 295 8926 8219 11590 -832 -18 -269 C \nATOM 2346 C HIS A 295 13.917 10.700 -31.618 1.00 65.51 C \nANISOU 2346 C HIS A 295 7573 6962 10355 -773 -59 -250 C \nATOM 2347 O HIS A 295 14.367 9.645 -31.206 1.00 68.56 O \nANISOU 2347 O HIS A 295 7892 7372 10785 -787 -115 -245 O \nATOM 2348 CB HIS A 295 15.805 12.214 -32.381 1.00 80.31 C \nANISOU 2348 CB HIS A 295 9495 8819 12200 -861 -4 -298 C \nATOM 2349 CG HIS A 295 15.317 12.569 -33.753 1.00 81.22 C \nANISOU 2349 CG HIS A 295 9632 8917 12309 -812 40 -304 C \nATOM 2350 ND1 HIS A 295 15.058 11.618 -34.715 1.00 79.21 N \nANISOU 2350 ND1 HIS A 295 9311 8684 12103 -761 21 -303 N \nATOM 2351 CD2 HIS A 295 15.018 13.765 -34.310 1.00 83.84 C \nANISOU 2351 CD2 HIS A 295 10052 9212 12590 -804 101 -310 C \nATOM 2352 CE1 HIS A 295 14.625 12.218 -35.808 1.00 85.33 C \nANISOU 2352 CE1 HIS A 295 10123 9440 12857 -726 69 -308 C \nATOM 2353 NE2 HIS A 295 14.586 13.522 -35.588 1.00 83.03 N \nANISOU 2353 NE2 HIS A 295 9927 9113 12506 -749 118 -312 N \nATOM 2354 N PRO A 296 12.752 10.771 -32.268 1.00 63.53 N \nANISOU 2354 N PRO A 296 7342 6706 10090 -710 -32 -237 N \nATOM 2355 CA PRO A 296 11.950 9.572 -32.544 1.00 59.63 C \nANISOU 2355 CA PRO A 296 6789 6238 9631 -663 -67 -219 C \nATOM 2356 C PRO A 296 12.665 8.603 -33.425 1.00 72.71 C \nANISOU 2356 C PRO A 296 8372 7907 11346 -661 -98 -234 C \nATOM 2357 O PRO A 296 12.799 7.435 -33.079 1.00 63.59 O \nANISOU 2357 O PRO A 296 7161 6769 10232 -663 -153 -226 O \nATOM 2358 CB PRO A 296 10.705 10.114 -33.263 1.00 59.87 C \nANISOU 2358 CB PRO A 296 6860 6267 9623 -600 -19 -209 C \nATOM 2359 CG PRO A 296 11.005 11.544 -33.640 1.00 68.13 C \nANISOU 2359 CG PRO A 296 7985 7278 10623 -606 42 -225 C \nATOM 2360 CD PRO A 296 12.051 12.025 -32.650 1.00 71.68 C \nANISOU 2360 CD PRO A 296 8462 7711 11064 -679 34 -237 C \nATOM 2361 N LEU A 297 13.109 9.103 -34.577 1.00 93.56 N \nANISOU 2361 N LEU A 297 11019 10540 13989 -653 -62 -256 N \nATOM 2362 CA LEU A 297 13.801 8.284 -35.584 1.00100.88 C \nANISOU 2362 CA LEU A 297 11880 11483 14969 -645 -83 -275 C \nATOM 2363 C LEU A 297 15.175 7.875 -35.115 1.00 95.42 C \nANISOU 2363 C LEU A 297 11142 10806 14308 -693 -123 -292 C \nATOM 2364 O LEU A 297 16.154 8.534 -35.391 1.00108.01 O \nANISOU 2364 O LEU A 297 12742 12404 15894 -730 -101 -315 O \nATOM 2365 CB LEU A 297 13.921 9.025 -36.921 1.00106.16 C \nANISOU 2365 CB LEU A 297 12570 12143 15625 -629 -30 -294 C \nATOM 2366 CG LEU A 297 12.608 9.491 -37.548 1.00104.81 C \nANISOU 2366 CG LEU A 297 12442 11962 15418 -573 12 -279 C \nATOM 2367 CD1 LEU A 297 12.832 10.517 -38.656 1.00105.53 C \nANISOU 2367 CD1 LEU A 297 12577 12037 15484 -567 70 -297 C \nATOM 2368 CD2 LEU A 297 11.847 8.289 -38.084 1.00105.71 C \nANISOU 2368 CD2 LEU A 297 12499 12100 15566 -527 -18 -267 C \nATOM 2369 N THR A 298 15.245 6.775 -34.399 1.00 88.42 N \nANISOU 2369 N THR A 298 10211 9932 13454 -692 -181 -279 N \nATOM 2370 CA THR A 298 16.497 6.333 -33.822 1.00 84.66 C \nANISOU 2370 CA THR A 298 9688 9476 13003 -729 -224 -291 C \nATOM 2371 C THR A 298 16.898 5.072 -34.520 1.00 76.19 C \nANISOU 2371 C THR A 298 8547 8418 11984 -694 -265 -300 C \nATOM 2372 O THR A 298 16.053 4.433 -35.129 1.00 92.79 O \nANISOU 2372 O THR A 298 10643 10509 14102 -649 -269 -291 O \nATOM 2373 CB THR A 298 16.278 6.096 -32.320 1.00 94.88 C \nANISOU 2373 CB THR A 298 10995 10770 14286 -755 -261 -266 C \nATOM 2374 OG1 THR A 298 15.656 7.268 -31.740 1.00 99.05 O \nANISOU 2374 OG1 THR A 298 11596 11280 14759 -776 -217 -256 O \nATOM 2375 CG2 THR A 298 17.575 5.810 -31.603 1.00 92.25 C \nANISOU 2375 CG2 THR A 298 10620 10463 13968 -796 -301 -275 C \nATOM 2376 N ILE A 299 18.173 4.704 -34.451 1.00 67.57 N \nANISOU 2376 N ILE A 299 7402 7354 10916 -711 -295 -319 N \nATOM 2377 CA ILE A 299 18.667 3.509 -35.125 1.00 67.16 C \nANISOU 2377 CA ILE A 299 7288 7316 10913 -670 -334 -332 C \nATOM 2378 C ILE A 299 19.698 2.772 -34.307 1.00 70.03 C \nANISOU 2378 C ILE A 299 7603 7708 11299 -679 -392 -334 C \nATOM 2379 O ILE A 299 20.625 3.366 -33.790 1.00 86.74 O \nANISOU 2379 O ILE A 299 9707 9856 13396 -724 -389 -345 O \nATOM 2380 CB ILE A 299 19.201 3.800 -36.571 1.00 79.67 C \nANISOU 2380 CB ILE A 299 8847 8918 12507 -655 -297 -366 C \nATOM 2381 CG1 ILE A 299 20.760 3.939 -36.656 1.00 80.81 C \nANISOU 2381 CG1 ILE A 299 8936 9111 12655 -683 -306 -396 C \nATOM 2382 CG2 ILE A 299 18.481 5.007 -37.209 1.00 80.12 C \nANISOU 2382 CG2 ILE A 299 8963 8954 12526 -665 -229 -367 C \nATOM 2383 CD1 ILE A 299 21.447 2.750 -37.288 1.00 79.81 C \nANISOU 2383 CD1 ILE A 299 8739 9011 12575 -634 -346 -415 C \nATOM 2384 N GLY A 300 19.546 1.466 -34.195 1.00 92.30 N \nANISOU 2384 N GLY A 300 10399 10518 14155 -636 -446 -322 N \nATOM 2385 CA GLY A 300 20.452 0.613 -33.409 1.00109.03 C \nANISOU 2385 CA GLY A 300 12474 12658 16293 -630 -508 -320 C \nATOM 2386 C GLY A 300 19.707 -0.026 -32.240 1.00120.05 C \nANISOU 2386 C GLY A 300 13901 14024 17687 -634 -552 -282 C \nATOM 2387 O GLY A 300 18.516 -0.339 -32.362 1.00112.54 O \nANISOU 2387 O GLY A 300 12986 13037 16735 -619 -548 -262 O \nATOM 2388 N GLU A 301 20.417 -0.235 -31.126 1.00128.77 N \nANISOU 2388 N GLU A 301 14987 15151 18788 -655 -594 -272 N \nATOM 2389 CA GLU A 301 19.788 -0.636 -29.854 1.00132.29 C \nANISOU 2389 CA GLU A 301 15466 15575 19224 -673 -632 -235 C \nATOM 2390 C GLU A 301 19.821 0.568 -28.911 1.00125.49 C \nANISOU 2390 C GLU A 301 14630 14731 18320 -739 -603 -229 C \nATOM 2391 O GLU A 301 20.849 0.945 -28.325 1.00 86.51 O \nANISOU 2391 O GLU A 301 9666 9834 13371 -773 -612 -237 O \nATOM 2392 CB GLU A 301 20.402 -1.885 -29.202 1.00138.67 C \nANISOU 2392 CB GLU A 301 16245 16387 20057 -644 -706 -222 C \nATOM 2393 CG GLU A 301 19.582 -3.158 -29.384 1.00129.17 C \nANISOU 2393 CG GLU A 301 15067 15135 18878 -601 -746 -202 C \nATOM 2394 CD GLU A 301 20.188 -4.366 -28.681 1.00128.17 C \nANISOU 2394 CD GLU A 301 14926 15002 18770 -571 -821 -187 C \nATOM 2395 OE1 GLU A 301 21.255 -4.242 -28.055 1.00126.39 O \nANISOU 2395 OE1 GLU A 301 14663 14818 18541 -578 -844 -192 O \nATOM 2396 OE2 GLU A 301 19.598 -5.458 -28.755 1.00129.33 O \nANISOU 2396 OE2 GLU A 301 15104 15105 18932 -541 -858 -170 O \nATOM 2397 N CYS A 302 18.645 1.154 -28.783 1.00131.49 N \nANISOU 2397 N CYS A 302 15445 15463 19053 -755 -567 -213 N \nATOM 2398 CA CYS A 302 18.478 2.438 -28.159 1.00128.08 C \nANISOU 2398 CA CYS A 302 15053 15036 18575 -808 -524 -211 C \nATOM 2399 C CYS A 302 17.338 2.402 -27.158 1.00126.63 C \nANISOU 2399 C CYS A 302 14916 14832 18367 -822 -533 -178 C \nATOM 2400 O CYS A 302 16.296 1.773 -27.387 1.00138.89 O \nANISOU 2400 O CYS A 302 16483 16364 19927 -791 -542 -160 O \nATOM 2401 CB CYS A 302 18.152 3.476 -29.229 1.00123.06 C \nANISOU 2401 CB CYS A 302 14446 14391 17920 -805 -454 -232 C \nATOM 2402 SG CYS A 302 19.411 3.516 -30.492 1.00111.20 S \nANISOU 2402 SG CYS A 302 12889 12919 16444 -792 -440 -272 S \nATOM 2403 N PRO A 303 17.526 3.094 -26.041 1.00111.50 N \nANISOU 2403 N PRO A 303 13022 12926 16415 -873 -529 -170 N \nATOM 2404 CA PRO A 303 16.452 3.337 -25.102 1.00103.03 C \nANISOU 2404 CA PRO A 303 11997 11840 15308 -892 -525 -143 C \nATOM 2405 C PRO A 303 15.131 3.711 -25.754 1.00 91.01 C \nANISOU 2405 C PRO A 303 10515 10298 13766 -861 -479 -138 C \nATOM 2406 O PRO A 303 15.096 4.271 -26.846 1.00100.17 O \nANISOU 2406 O PRO A 303 11683 11451 14925 -839 -432 -158 O \nATOM 2407 CB PRO A 303 16.982 4.532 -24.280 1.00107.86 C \nANISOU 2407 CB PRO A 303 12639 12465 15877 -952 -497 -152 C \nATOM 2408 CG PRO A 303 18.400 4.765 -24.705 1.00101.31 C \nANISOU 2408 CG PRO A 303 11770 11663 15061 -972 -496 -180 C \nATOM 2409 CD PRO A 303 18.813 3.606 -25.548 1.00102.14 C \nANISOU 2409 CD PRO A 303 11815 11775 15220 -920 -534 -187 C \nATOM 2410 N LYS A 304 14.049 3.452 -25.055 1.00 95.49 N \nANISOU 2410 N LYS A 304 11108 10863 14312 -861 -491 -110 N \nATOM 2411 CA LYS A 304 12.750 3.816 -25.572 1.00101.37 C \nANISOU 2411 CA LYS A 304 11884 11602 15029 -830 -448 -102 C \nATOM 2412 C LYS A 304 12.637 5.319 -25.657 1.00 92.08 C \nANISOU 2412 C LYS A 304 10759 10420 13807 -838 -380 -118 C \nATOM 2413 O LYS A 304 12.647 6.005 -24.651 1.00 98.42 O \nANISOU 2413 O LYS A 304 11597 11224 14573 -873 -370 -113 O \nATOM 2414 CB LYS A 304 11.644 3.294 -24.655 1.00112.03 C \nANISOU 2414 CB LYS A 304 13247 12963 16355 -838 -475 -69 C \nATOM 2415 CG LYS A 304 11.550 1.785 -24.547 1.00119.17 C \nANISOU 2415 CG LYS A 304 14119 13867 17295 -833 -541 -49 C \nATOM 2416 CD LYS A 304 10.139 1.383 -24.157 1.00111.34 C \nANISOU 2416 CD LYS A 304 13142 12891 16269 -834 -548 -20 C \nATOM 2417 CE LYS A 304 9.152 1.722 -25.242 1.00108.28 C \nANISOU 2417 CE LYS A 304 12762 12515 15863 -793 -499 -26 C \nATOM 2418 NZ LYS A 304 9.586 1.387 -26.631 1.00103.98 N \nANISOU 2418 NZ LYS A 304 12193 11954 15361 -758 -492 -47 N \nATOM 2419 N TYR A 305 12.516 5.826 -26.865 1.00 89.80 N \nANISOU 2419 N TYR A 305 10480 10122 13519 -805 -334 -136 N \nATOM 2420 CA TYR A 305 12.160 7.211 -27.036 1.00 90.75 C \nANISOU 2420 CA TYR A 305 10662 10229 13588 -801 -268 -146 C \nATOM 2421 C TYR A 305 10.830 7.510 -26.317 1.00 88.28 C \nANISOU 2421 C TYR A 305 10391 9927 13226 -784 -252 -123 C \nATOM 2422 O TYR A 305 9.815 6.821 -26.508 1.00 70.95 O \nANISOU 2422 O TYR A 305 8175 7751 11032 -751 -265 -103 O \nATOM 2423 CB TYR A 305 12.057 7.581 -28.514 1.00 83.42 C \nANISOU 2423 CB TYR A 305 9739 9291 12667 -759 -224 -165 C \nATOM 2424 CG TYR A 305 11.646 9.026 -28.743 1.00 94.26 C \nANISOU 2424 CG TYR A 305 11188 10644 13983 -747 -154 -173 C \nATOM 2425 CD1 TYR A 305 12.503 10.069 -28.461 1.00 94.59 C \nANISOU 2425 CD1 TYR A 305 11276 10665 13999 -793 -125 -193 C \nATOM 2426 CD2 TYR A 305 10.385 9.349 -29.221 1.00 93.00 C \nANISOU 2426 CD2 TYR A 305 11057 10488 13790 -691 -117 -162 C \nATOM 2427 CE1 TYR A 305 12.118 11.383 -28.657 1.00 95.03 C \nANISOU 2427 CE1 TYR A 305 11416 10693 13998 -780 -62 -200 C \nATOM 2428 CE2 TYR A 305 10.012 10.665 -29.424 1.00 93.58 C \nANISOU 2428 CE2 TYR A 305 11208 10540 13808 -670 -55 -169 C \nATOM 2429 CZ TYR A 305 10.885 11.678 -29.135 1.00 91.25 C \nANISOU 2429 CZ TYR A 305 10969 10213 13489 -715 -27 -188 C \nATOM 2430 OH TYR A 305 10.517 12.989 -29.328 1.00 98.63 O \nANISOU 2430 OH TYR A 305 11994 11116 14364 -693 35 -195 O \nATOM 2431 N VAL A 306 10.841 8.555 -25.502 1.00 83.77 N \nANISOU 2431 N VAL A 306 9876 9344 12606 -809 -222 -125 N \nATOM 2432 CA VAL A 306 9.612 9.011 -24.832 1.00 86.02 C \nANISOU 2432 CA VAL A 306 10205 9642 12835 -787 -199 -107 C \nATOM 2433 C VAL A 306 9.548 10.509 -24.898 1.00 78.09 C \nANISOU 2433 C VAL A 306 9284 8610 11776 -778 -132 -123 C \nATOM 2434 O VAL A 306 10.574 11.115 -25.029 1.00 70.10 O \nANISOU 2434 O VAL A 306 8298 7571 10767 -816 -117 -145 O \nATOM 2435 CB VAL A 306 9.572 8.552 -23.373 1.00 82.01 C \nANISOU 2435 CB VAL A 306 9688 9153 12319 -831 -244 -87 C \nATOM 2436 CG1 VAL A 306 8.734 7.292 -23.287 1.00 82.21 C \nANISOU 2436 CG1 VAL A 306 9661 9211 12362 -814 -290 -60 C \nATOM 2437 CG2 VAL A 306 10.982 8.304 -22.857 1.00 74.92 C \nANISOU 2437 CG2 VAL A 306 8766 8244 11455 -893 -282 -98 C \nATOM 2438 N LYS A 307 8.351 11.090 -24.826 1.00 85.48 N \nANISOU 2438 N LYS A 307 10265 9556 12658 -728 -94 -113 N \nATOM 2439 CA LYS A 307 8.222 12.548 -24.882 1.00109.72 C \nANISOU 2439 CA LYS A 307 13429 12591 15668 -709 -28 -127 C \nATOM 2440 C LYS A 307 8.031 13.245 -23.524 1.00115.46 C \nANISOU 2440 C LYS A 307 14217 13312 16339 -734 -17 -124 C \nATOM 2441 O LYS A 307 7.449 14.326 -23.450 1.00128.40 O \nANISOU 2441 O LYS A 307 15938 14932 17916 -696 36 -129 O \nATOM 2442 CB LYS A 307 7.144 12.953 -25.878 1.00119.75 C \nANISOU 2442 CB LYS A 307 14723 13870 16907 -624 18 -123 C \nATOM 2443 CG LYS A 307 5.707 12.653 -25.491 1.00125.41 C \nANISOU 2443 CG LYS A 307 15424 14641 17587 -570 17 -98 C \nATOM 2444 CD LYS A 307 4.765 13.122 -26.613 1.00128.83 C \nANISOU 2444 CD LYS A 307 15875 15087 17986 -483 65 -96 C \nATOM 2445 CE LYS A 307 5.439 13.136 -27.993 1.00128.34 C \nANISOU 2445 CE LYS A 307 15804 14994 17966 -477 79 -113 C \nATOM 2446 NZ LYS A 307 4.551 13.572 -29.097 1.00133.54 N \nANISOU 2446 NZ LYS A 307 16480 15667 18592 -393 124 -109 N \nATOM 2447 N SER A 308 8.550 12.628 -22.466 1.00119.82 N \nANISOU 2447 N SER A 308 14733 13879 16913 -797 -68 -117 N \nATOM 2448 CA SER A 308 8.594 13.241 -21.134 1.00118.98 C \nANISOU 2448 CA SER A 308 14681 13766 16760 -837 -63 -117 C \nATOM 2449 C SER A 308 9.842 14.095 -21.012 1.00114.54 C \nANISOU 2449 C SER A 308 14173 13159 16190 -901 -43 -143 C \nATOM 2450 O SER A 308 10.829 13.842 -21.699 1.00102.28 O \nANISOU 2450 O SER A 308 12584 11596 14681 -932 -56 -156 O \nATOM 2451 CB SER A 308 8.651 12.171 -20.032 1.00116.36 C \nANISOU 2451 CB SER A 308 14284 13473 16453 -883 -129 -95 C \nATOM 2452 OG SER A 308 7.492 11.349 -19.989 1.00113.72 O \nANISOU 2452 OG SER A 308 13905 13186 16119 -840 -151 -70 O \nATOM 2453 N ASN A 309 9.792 15.093 -20.132 1.00111.05 N \nANISOU 2453 N ASN A 309 13815 12693 15686 -925 -12 -151 N \nATOM 2454 CA ASN A 309 10.968 15.898 -19.804 1.00108.84 C \nANISOU 2454 CA ASN A 309 13591 12375 15387 -1004 4 -175 C \nATOM 2455 C ASN A 309 11.732 15.357 -18.609 1.00106.84 C \nANISOU 2455 C ASN A 309 13293 12149 15152 -1086 -50 -169 C \nATOM 2456 O ASN A 309 12.907 15.654 -18.442 1.00102.13 O \nANISOU 2456 O ASN A 309 12704 11542 14557 -1162 -55 -187 O \nATOM 2457 CB ASN A 309 10.575 17.346 -19.538 1.00112.47 C \nANISOU 2457 CB ASN A 309 14182 12786 15766 -990 70 -189 C \nATOM 2458 CG ASN A 309 10.182 18.076 -20.808 1.00117.97 C \nANISOU 2458 CG ASN A 309 14937 13444 16441 -922 126 -200 C \nATOM 2459 OD1 ASN A 309 10.770 17.857 -21.868 1.00114.97 O \nANISOU 2459 OD1 ASN A 309 14524 13059 16103 -928 125 -209 O \nATOM 2460 ND2 ASN A 309 9.185 18.942 -20.708 1.00119.27 N \nANISOU 2460 ND2 ASN A 309 15193 13585 16539 -854 176 -199 N \nATOM 2461 N LYS A 310 11.055 14.553 -17.792 1.00106.86 N \nANISOU 2461 N LYS A 310 13248 12192 15163 -1073 -90 -144 N \nATOM 2462 CA LYS A 310 11.608 14.083 -16.533 1.00 96.59 C \nANISOU 2462 CA LYS A 310 11914 10918 13868 -1144 -139 -135 C \nATOM 2463 C LYS A 310 11.126 12.667 -16.201 1.00 92.84 C \nANISOU 2463 C LYS A 310 11347 10491 13438 -1127 -203 -104 C \nATOM 2464 O LYS A 310 9.919 12.404 -16.123 1.00 99.10 O \nANISOU 2464 O LYS A 310 12136 11304 14214 -1073 -199 -86 O \nATOM 2465 CB LYS A 310 11.197 15.055 -15.425 1.00 92.66 C \nANISOU 2465 CB LYS A 310 11506 10406 13297 -1164 -107 -139 C \nATOM 2466 CG LYS A 310 11.802 14.754 -14.065 1.00 92.37 C \nANISOU 2466 CG LYS A 310 11447 10393 13255 -1246 -151 -132 C \nATOM 2467 CD LYS A 310 11.065 15.491 -12.964 1.00 90.73 C \nANISOU 2467 CD LYS A 310 11315 10180 12976 -1247 -123 -132 C \nATOM 2468 CE LYS A 310 11.628 15.132 -11.599 1.00 92.94 C \nANISOU 2468 CE LYS A 310 11569 10490 13252 -1330 -170 -122 C \nATOM 2469 NZ LYS A 310 11.200 16.125 -10.577 1.00 99.72 N \nANISOU 2469 NZ LYS A 310 12521 11333 14033 -1347 -132 -132 N \nATOM 2470 N LEU A 311 12.076 11.759 -16.008 1.00 82.10 N \nANISOU 2470 N LEU A 311 9914 9150 12129 -1174 -262 -98 N \nATOM 2471 CA LEU A 311 11.784 10.462 -15.394 1.00 89.21 C \nANISOU 2471 CA LEU A 311 10745 10089 13063 -1176 -328 -68 C \nATOM 2472 C LEU A 311 12.811 10.182 -14.318 1.00 83.57 C \nANISOU 2472 C LEU A 311 10006 9392 12356 -1253 -375 -64 C \nATOM 2473 O LEU A 311 13.914 9.689 -14.621 1.00 80.67 O \nANISOU 2473 O LEU A 311 9586 9031 12032 -1278 -408 -70 O \nATOM 2474 CB LEU A 311 11.791 9.308 -16.420 1.00 91.12 C \nANISOU 2474 CB LEU A 311 10913 10339 13369 -1134 -363 -58 C \nATOM 2475 CG LEU A 311 10.681 9.341 -17.487 1.00 97.61 C \nANISOU 2475 CG LEU A 311 11744 11157 14188 -1058 -327 -56 C \nATOM 2476 CD1 LEU A 311 10.852 8.192 -18.476 1.00 95.96 C \nANISOU 2476 CD1 LEU A 311 11466 10954 14043 -1029 -364 -50 C \nATOM 2477 CD2 LEU A 311 9.281 9.315 -16.883 1.00 98.30 C \nANISOU 2477 CD2 LEU A 311 11849 11271 14229 -1029 -319 -35 C \nATOM 2478 N VAL A 312 12.427 10.451 -13.066 1.00 77.68 N \nANISOU 2478 N VAL A 312 9291 8659 11565 -1286 -379 -53 N \nATOM 2479 CA VAL A 312 13.327 10.241 -11.906 1.00 74.76 C \nANISOU 2479 CA VAL A 312 8902 8310 11193 -1362 -423 -47 C \nATOM 2480 C VAL A 312 12.724 9.347 -10.799 1.00 73.97 C \nANISOU 2480 C VAL A 312 8771 8243 11090 -1374 -476 -13 C \nATOM 2481 O VAL A 312 11.685 9.653 -10.218 1.00 75.48 O \nANISOU 2481 O VAL A 312 9000 8443 11237 -1361 -455 -4 O \nATOM 2482 CB VAL A 312 13.758 11.583 -11.296 1.00 64.21 C \nANISOU 2482 CB VAL A 312 7644 6957 9796 -1418 -376 -71 C \nATOM 2483 CG1 VAL A 312 14.693 11.359 -10.130 1.00 58.70 C \nANISOU 2483 CG1 VAL A 312 6920 6289 9094 -1500 -422 -65 C \nATOM 2484 CG2 VAL A 312 14.444 12.428 -12.355 1.00 58.96 C \nANISOU 2484 CG2 VAL A 312 7013 6260 9130 -1420 -328 -104 C \nATOM 2485 N LEU A 313 13.410 8.258 -10.505 1.00 69.16 N \nANISOU 2485 N LEU A 313 8095 7657 10526 -1397 -544 6 N \nATOM 2486 CA LEU A 313 12.924 7.317 -9.512 1.00 75.20 C \nANISOU 2486 CA LEU A 313 8833 8450 11291 -1412 -600 40 C \nATOM 2487 C LEU A 313 13.510 7.670 -8.155 1.00 82.79 C \nANISOU 2487 C LEU A 313 9808 9431 12217 -1486 -617 43 C \nATOM 2488 O LEU A 313 14.735 7.745 -7.992 1.00 82.38 O \nANISOU 2488 O LEU A 313 9734 9387 12178 -1530 -636 33 O \nATOM 2489 CB LEU A 313 13.324 5.871 -9.866 1.00 67.87 C \nANISOU 2489 CB LEU A 313 7833 7527 10425 -1394 -669 62 C \nATOM 2490 CG LEU A 313 12.674 5.272 -11.108 1.00 68.02 C \nANISOU 2490 CG LEU A 313 7833 7530 10480 -1327 -664 65 C \nATOM 2491 CD1 LEU A 313 13.515 4.110 -11.626 1.00 61.81 C \nANISOU 2491 CD1 LEU A 313 6988 6740 9756 -1311 -722 72 C \nATOM 2492 CD2 LEU A 313 11.230 4.847 -10.811 1.00 69.84 C \nANISOU 2492 CD2 LEU A 313 8075 7775 10684 -1307 -667 90 C \nATOM 2493 N ALA A 314 12.645 7.854 -7.167 1.00 79.97 N \nANISOU 2493 N ALA A 314 9482 9088 11812 -1503 -613 57 N \nATOM 2494 CA ALA A 314 13.116 7.997 -5.805 1.00 80.29 C \nANISOU 2494 CA ALA A 314 9530 9153 11822 -1574 -639 65 C \nATOM 2495 C ALA A 314 13.679 6.660 -5.364 1.00 73.20 C \nANISOU 2495 C ALA A 314 8565 8280 10968 -1594 -722 97 C \nATOM 2496 O ALA A 314 13.055 5.626 -5.557 1.00 78.31 O \nANISOU 2496 O ALA A 314 9183 8930 11642 -1560 -760 123 O \nATOM 2497 CB ALA A 314 11.978 8.404 -4.898 1.00 87.59 C \nANISOU 2497 CB ALA A 314 10501 10093 12687 -1580 -616 74 C \nATOM 2498 N THR A 315 14.857 6.690 -4.767 1.00 65.04 N \nANISOU 2498 N THR A 315 7511 7266 9937 -1649 -752 94 N \nATOM 2499 CA THR A 315 15.454 5.510 -4.143 1.00 66.47 C \nANISOU 2499 CA THR A 315 7634 7473 10148 -1669 -833 126 C \nATOM 2500 C THR A 315 15.589 5.689 -2.617 1.00 75.21 C \nANISOU 2500 C THR A 315 8754 8613 11208 -1741 -857 141 C \nATOM 2501 O THR A 315 15.375 4.763 -1.844 1.00 81.53 O \nANISOU 2501 O THR A 315 9532 9432 12013 -1754 -915 176 O \nATOM 2502 CB THR A 315 16.844 5.221 -4.749 1.00 66.01 C \nANISOU 2502 CB THR A 315 7523 7424 10133 -1666 -859 114 C \nATOM 2503 OG1 THR A 315 17.732 6.365 -4.607 1.00 58.20 O \nANISOU 2503 OG1 THR A 315 6553 6449 9111 -1720 -819 82 O \nATOM 2504 CG2 THR A 315 16.684 4.870 -6.233 1.00 62.63 C \nANISOU 2504 CG2 THR A 315 7078 6965 9753 -1593 -844 103 C \nATOM 2505 N GLY A 316 15.952 6.888 -2.195 1.00 76.41 N \nANISOU 2505 N GLY A 316 8947 8770 11313 -1792 -810 114 N \nATOM 2506 CA GLY A 316 16.119 7.181 -0.792 1.00 75.02 C \nANISOU 2506 CA GLY A 316 8789 8626 11090 -1864 -826 123 C \nATOM 2507 C GLY A 316 14.856 7.723 -0.148 1.00 76.34 C \nANISOU 2507 C GLY A 316 9017 8788 11203 -1868 -788 124 C \nATOM 2508 O GLY A 316 13.742 7.474 -0.639 1.00 72.64 O \nANISOU 2508 O GLY A 316 8557 8302 10738 -1810 -772 132 O \nATOM 2509 N LEU A 317 15.058 8.523 0.909 1.00 71.69 N \nANISOU 2509 N LEU A 317 8467 8215 10556 -1935 -770 113 N \nATOM 2510 CA LEU A 317 14.003 8.969 1.809 1.00 77.13 C \nANISOU 2510 CA LEU A 317 9208 8912 11186 -1949 -745 117 C \nATOM 2511 C LEU A 317 13.583 10.423 1.629 1.00 73.94 C \nANISOU 2511 C LEU A 317 8891 8476 10726 -1943 -659 77 C \nATOM 2512 O LEU A 317 14.362 11.237 1.209 1.00 84.65 O \nANISOU 2512 O LEU A 317 10277 9810 12074 -1966 -623 47 O \nATOM 2513 CB LEU A 317 14.463 8.789 3.252 1.00 79.26 C \nANISOU 2513 CB LEU A 317 9466 9224 11425 -2030 -789 135 C \nATOM 2514 CG LEU A 317 15.098 7.430 3.554 1.00 86.56 C \nANISOU 2514 CG LEU A 317 10313 10180 12398 -2042 -878 175 C \nATOM 2515 CD1 LEU A 317 16.623 7.516 3.610 1.00 83.12 C \nANISOU 2515 CD1 LEU A 317 9841 9765 11976 -2089 -903 165 C \nATOM 2516 CD2 LEU A 317 14.542 6.868 4.853 1.00 87.19 C \nANISOU 2516 CD2 LEU A 317 10387 10294 12446 -2080 -922 209 C \nATOM 2517 N ARG A 318 12.349 10.736 1.986 1.00 69.22 N \nANISOU 2517 N ARG A 318 8335 7881 10084 -1914 -627 78 N \nATOM 2518 CA ARG A 318 11.912 12.117 2.092 1.00 72.83 C \nANISOU 2518 CA ARG A 318 8886 8310 10475 -1909 -549 43 C \nATOM 2519 C ARG A 318 12.936 12.910 2.889 1.00 81.37 C \nANISOU 2519 C ARG A 318 10009 9391 11518 -2000 -540 22 C \nATOM 2520 O ARG A 318 13.254 12.547 4.013 1.00 79.30 O \nANISOU 2520 O ARG A 318 9722 9168 11240 -2065 -584 40 O \nATOM 2521 CB ARG A 318 10.553 12.216 2.787 1.00 65.19 C \nANISOU 2521 CB ARG A 318 7947 7369 9455 -1881 -531 52 C \nATOM 2522 CG ARG A 318 9.380 11.820 1.915 1.00 62.76 C \nANISOU 2522 CG ARG A 318 7621 7064 9162 -1788 -516 63 C \nATOM 2523 CD ARG A 318 8.077 11.952 2.686 1.00 69.89 C \nANISOU 2523 CD ARG A 318 8544 8007 10002 -1766 -498 71 C \nATOM 2524 NE ARG A 318 6.935 11.331 2.031 1.00 74.20 N \nANISOU 2524 NE ARG A 318 9053 8581 10560 -1693 -499 89 N \nATOM 2525 CZ ARG A 318 6.105 11.942 1.199 1.00 78.41 C \nANISOU 2525 CZ ARG A 318 9620 9102 11069 -1610 -440 71 C \nATOM 2526 NH1 ARG A 318 6.253 13.220 0.909 1.00 86.92 N \nANISOU 2526 NH1 ARG A 318 10781 10134 12111 -1583 -372 34 N \nATOM 2527 NH2 ARG A 318 5.103 11.275 0.670 1.00 84.42 N \nANISOU 2527 NH2 ARG A 318 10336 9901 11838 -1554 -448 91 N \nATOM 2528 N ASN A 319 13.435 14.003 2.319 1.00 92.31 N \nANISOU 2528 N ASN A 319 11460 10732 12881 -2009 -482 -16 N \nATOM 2529 CA ASN A 319 14.503 14.785 2.963 1.00 94.55 C \nANISOU 2529 CA ASN A 319 11785 11015 13124 -2106 -471 -39 C \nATOM 2530 C ASN A 319 14.207 16.278 2.984 1.00 97.22 C \nANISOU 2530 C ASN A 319 12251 11301 13388 -2112 -388 -79 C \nATOM 2531 O ASN A 319 14.692 17.039 2.152 1.00 92.62 O \nANISOU 2531 O ASN A 319 11720 10673 12799 -2114 -344 -108 O \nATOM 2532 CB ASN A 319 15.818 14.518 2.248 1.00 92.53 C \nANISOU 2532 CB ASN A 319 11476 10765 12917 -2139 -497 -43 C \nATOM 2533 CG ASN A 319 16.953 15.341 2.794 1.00 85.87 C \nANISOU 2533 CG ASN A 319 10671 9930 12027 -2245 -484 -68 C \nATOM 2534 OD1 ASN A 319 17.024 15.608 3.987 1.00 96.72 O \nANISOU 2534 OD1 ASN A 319 12071 11328 13352 -2312 -491 -67 O \nATOM 2535 ND2 ASN A 319 17.839 15.773 1.910 1.00 80.13 N \nANISOU 2535 ND2 ASN A 319 9949 9185 11311 -2266 -462 -92 N \nATOM 2536 N SER A 320 13.352 16.680 3.914 1.00111.03 N \nANISOU 2536 N SER A 320 14055 13055 15077 -2109 -367 -81 N \nATOM 2537 CA SER A 320 13.143 18.101 4.189 1.00120.46 C \nANISOU 2537 CA SER A 320 15380 14200 16190 -2123 -292 -120 C \nATOM 2538 C SER A 320 13.942 18.499 5.439 1.00121.97 C \nANISOU 2538 C SER A 320 15600 14413 16331 -2242 -305 -130 C \nATOM 2539 O SER A 320 14.009 17.721 6.405 1.00113.15 O \nANISOU 2539 O SER A 320 14414 13355 15222 -2284 -362 -102 O \nATOM 2540 CB SER A 320 11.655 18.418 4.371 1.00119.85 C \nANISOU 2540 CB SER A 320 15355 14115 16067 -2034 -251 -122 C \nATOM 2541 OG SER A 320 11.483 19.710 4.931 1.00122.59 O \nANISOU 2541 OG SER A 320 15831 14421 16328 -2055 -188 -158 O \nATOM 2542 N PRO A 321 14.585 19.687 5.405 1.00123.58 N \nANISOU 2542 N PRO A 321 15906 14569 16480 -2302 -253 -168 N \nATOM 2543 CA PRO A 321 15.162 20.301 6.617 1.00129.03 C \nANISOU 2543 CA PRO A 321 16652 15272 17103 -2414 -249 -184 C \nATOM 2544 C PRO A 321 14.102 21.068 7.424 1.00120.80 C \nANISOU 2544 C PRO A 321 15713 14204 15981 -2386 -200 -201 C \nATOM 2545 O PRO A 321 14.319 22.210 7.823 1.00121.71 O \nANISOU 2545 O PRO A 321 15948 14274 16020 -2439 -149 -237 O \nATOM 2546 CB PRO A 321 16.262 21.237 6.065 1.00127.10 C \nANISOU 2546 CB PRO A 321 16476 14983 16831 -2489 -211 -220 C \nATOM 2547 CG PRO A 321 16.390 20.899 4.611 1.00132.97 C \nANISOU 2547 CG PRO A 321 17175 15706 17642 -2421 -210 -216 C \nATOM 2548 CD PRO A 321 15.048 20.375 4.191 1.00127.32 C \nANISOU 2548 CD PRO A 321 16434 14983 16960 -2289 -207 -196 C \nTER 2549 PRO A 321 \nATOM 2550 N ILE B 10 10.335 10.999 12.775 1.00 98.50 N \nANISOU 2550 N ILE B 10 12185 11944 13298 -1318 -779 -14 N \nATOM 2551 CA ILE B 10 8.929 11.517 12.661 1.00 96.54 C \nANISOU 2551 CA ILE B 10 11963 11743 12975 -1172 -805 -52 C \nATOM 2552 C ILE B 10 8.875 13.057 12.671 1.00109.89 C \nANISOU 2552 C ILE B 10 13864 13327 14561 -1085 -863 -78 C \nATOM 2553 O ILE B 10 8.087 13.668 11.945 1.00131.03 O \nANISOU 2553 O ILE B 10 16628 15995 17163 -964 -896 -111 O \nATOM 2554 CB ILE B 10 7.973 10.906 13.718 1.00 86.39 C \nANISOU 2554 CB ILE B 10 10547 10605 11672 -1118 -796 -66 C \nATOM 2555 CG1 ILE B 10 7.021 11.966 14.305 1.00 81.91 C \nANISOU 2555 CG1 ILE B 10 10043 10096 10984 -945 -840 -116 C \nATOM 2556 CG2 ILE B 10 8.762 10.211 14.809 1.00 85.96 C \nANISOU 2556 CG2 ILE B 10 10433 10548 11681 -1221 -777 -37 C \nATOM 2557 CD1 ILE B 10 5.836 11.407 15.069 1.00 79.19 C \nANISOU 2557 CD1 ILE B 10 9534 9975 10580 -884 -831 -139 C \nATOM 2558 N GLU B 11 9.721 13.681 13.476 1.00107.55 N \nANISOU 2558 N GLU B 11 13676 12945 14246 -1145 -886 -66 N \nATOM 2559 CA GLU B 11 9.855 15.135 13.460 1.00105.55 C \nANISOU 2559 CA GLU B 11 13687 12545 13872 -1103 -959 -81 C \nATOM 2560 C GLU B 11 10.726 15.593 12.287 1.00101.41 C \nANISOU 2560 C GLU B 11 13298 11908 13326 -1248 -973 -50 C \nATOM 2561 O GLU B 11 10.928 16.796 12.091 1.00110.87 O \nANISOU 2561 O GLU B 11 14765 12958 14403 -1261 -1046 -53 O \nATOM 2562 CB GLU B 11 10.437 15.614 14.793 1.00112.40 C \nANISOU 2562 CB GLU B 11 14632 13365 14709 -1143 -984 -74 C \nATOM 2563 CG GLU B 11 9.608 15.254 16.020 1.00119.89 C \nANISOU 2563 CG GLU B 11 15457 14435 15661 -1007 -975 -105 C \nATOM 2564 CD GLU B 11 8.176 15.776 15.979 1.00121.49 C \nANISOU 2564 CD GLU B 11 15705 14707 15749 -756 -1022 -170 C \nATOM 2565 OE1 GLU B 11 7.963 16.954 16.363 1.00120.68 O \nANISOU 2565 OE1 GLU B 11 15834 14507 15512 -621 -1103 -207 O \nATOM 2566 OE2 GLU B 11 7.257 15.005 15.595 1.00120.50 O \nANISOU 2566 OE2 GLU B 11 15391 14749 15644 -689 -985 -187 O \nATOM 2567 N GLY B 12 11.217 14.633 11.500 1.00 97.18 N \nANISOU 2567 N GLY B 12 12595 11444 12886 -1357 -912 -23 N \nATOM 2568 CA GLY B 12 12.164 14.882 10.420 1.00 99.41 C \nANISOU 2568 CA GLY B 12 12943 11679 13147 -1518 -912 9 C \nATOM 2569 C GLY B 12 13.309 13.884 10.483 1.00103.90 C \nANISOU 2569 C GLY B 12 13316 12364 13799 -1663 -851 39 C \nATOM 2570 O GLY B 12 13.395 13.085 11.421 1.00 99.47 O \nANISOU 2570 O GLY B 12 12609 11878 13306 -1637 -820 38 O \nATOM 2571 N GLY B 13 14.188 13.936 9.483 1.00102.21 N \nANISOU 2571 N GLY B 13 13101 12177 13557 -1803 -842 62 N \nATOM 2572 CA GLY B 13 15.341 13.027 9.397 1.00100.43 C \nANISOU 2572 CA GLY B 13 12684 12103 13371 -1906 -793 78 C \nATOM 2573 C GLY B 13 16.567 13.479 10.187 1.00 94.76 C \nANISOU 2573 C GLY B 13 11978 11448 12580 -2069 -802 100 C \nATOM 2574 O GLY B 13 16.677 14.638 10.572 1.00 90.46 O \nANISOU 2574 O GLY B 13 11632 10804 11936 -2161 -852 116 O \nATOM 2575 N TRP B 14 17.483 12.546 10.437 1.00 97.22 N \nANISOU 2575 N TRP B 14 12091 11928 12921 -2096 -762 99 N \nATOM 2576 CA TRP B 14 18.706 12.819 11.225 1.00 87.73 C \nANISOU 2576 CA TRP B 14 10848 10846 11641 -2243 -763 115 C \nATOM 2577 C TRP B 14 19.831 13.235 10.289 1.00 87.49 C \nANISOU 2577 C TRP B 14 10791 10971 11479 -2447 -763 135 C \nATOM 2578 O TRP B 14 20.543 12.376 9.735 1.00 80.42 O \nANISOU 2578 O TRP B 14 9697 10281 10577 -2430 -728 118 O \nATOM 2579 CB TRP B 14 19.233 11.585 11.988 1.00 81.86 C \nANISOU 2579 CB TRP B 14 9895 10246 10961 -2150 -727 93 C \nATOM 2580 CG TRP B 14 18.445 10.912 13.070 1.00 79.70 C \nANISOU 2580 CG TRP B 14 9600 9887 10794 -1993 -724 78 C \nATOM 2581 CD1 TRP B 14 18.558 9.572 13.474 1.00 78.23 C \nANISOU 2581 CD1 TRP B 14 9278 9772 10674 -1870 -706 56 C \nATOM 2582 CD2 TRP B 14 17.461 11.498 13.919 1.00 81.77 C \nANISOU 2582 CD2 TRP B 14 9989 9994 11085 -1943 -746 81 C \nATOM 2583 NE1 TRP B 14 17.697 9.324 14.511 1.00 80.69 N \nANISOU 2583 NE1 TRP B 14 9625 9981 11055 -1787 -713 54 N \nATOM 2584 CE2 TRP B 14 16.998 10.473 14.792 1.00 85.22 C \nANISOU 2584 CE2 TRP B 14 10334 10436 11608 -1820 -732 66 C \nATOM 2585 CE3 TRP B 14 16.890 12.776 14.010 1.00 79.31 C \nANISOU 2585 CE3 TRP B 14 9877 9541 10714 -1975 -787 89 C \nATOM 2586 CZ2 TRP B 14 16.000 10.700 15.739 1.00 83.85 C \nANISOU 2586 CZ2 TRP B 14 10221 10173 11464 -1746 -746 61 C \nATOM 2587 CZ3 TRP B 14 15.897 12.993 14.949 1.00 81.65 C \nANISOU 2587 CZ3 TRP B 14 10241 9743 11038 -1857 -807 75 C \nATOM 2588 CH2 TRP B 14 15.466 11.969 15.809 1.00 82.52 C \nANISOU 2588 CH2 TRP B 14 10216 9902 11237 -1753 -781 62 C \nATOM 2589 N GLN B 15 20.023 14.540 10.134 1.00 88.03 N \nANISOU 2589 N GLN B 15 11071 10959 11417 -2642 -811 168 N \nATOM 2590 CA GLN B 15 21.163 15.044 9.387 1.00 90.13 C \nANISOU 2590 CA GLN B 15 11323 11404 11517 -2903 -818 197 C \nATOM 2591 C GLN B 15 22.458 14.357 9.849 1.00 89.56 C \nANISOU 2591 C GLN B 15 10983 11654 11393 -2968 -777 187 C \nATOM 2592 O GLN B 15 23.414 14.208 9.069 1.00 83.33 O \nANISOU 2592 O GLN B 15 10044 11131 10485 -3100 -758 189 O \nATOM 2593 CB GLN B 15 21.274 16.552 9.556 1.00 98.24 C \nANISOU 2593 CB GLN B 15 12663 12281 12381 -3140 -894 242 C \nATOM 2594 CG GLN B 15 22.294 17.200 8.617 1.00101.74 C \nANISOU 2594 CG GLN B 15 13147 12892 12620 -3465 -915 284 C \nATOM 2595 CD GLN B 15 21.963 17.092 7.119 1.00108.69 C \nANISOU 2595 CD GLN B 15 14031 13764 13501 -3450 -908 281 C \nATOM 2596 OE1 GLN B 15 20.810 16.900 6.701 1.00100.38 O \nANISOU 2596 OE1 GLN B 15 13057 12505 12577 -3225 -910 256 O \nATOM 2597 NE2 GLN B 15 23.001 17.207 6.298 1.00115.48 N \nANISOU 2597 NE2 GLN B 15 14788 14886 14201 -3699 -898 305 N \nATOM 2598 N GLY B 16 22.469 13.940 11.118 1.00 86.77 N \nANISOU 2598 N GLY B 16 10563 11294 11110 -2860 -766 172 N \nATOM 2599 CA GLY B 16 23.629 13.354 11.746 1.00 85.33 C \nANISOU 2599 CA GLY B 16 10153 11398 10869 -2889 -737 155 C \nATOM 2600 C GLY B 16 23.828 11.867 11.534 1.00 93.01 C \nANISOU 2600 C GLY B 16 10879 12538 11923 -2648 -696 102 C \nATOM 2601 O GLY B 16 24.868 11.346 11.924 1.00 94.95 O \nANISOU 2601 O GLY B 16 10929 13059 12089 -2638 -681 76 O \nATOM 2602 N MET B 17 22.866 11.164 10.931 1.00 96.92 N \nANISOU 2602 N MET B 17 11393 12880 12553 -2447 -688 81 N \nATOM 2603 CA MET B 17 23.039 9.730 10.731 1.00 91.64 C \nANISOU 2603 CA MET B 17 10551 12332 11938 -2218 -669 30 C \nATOM 2604 C MET B 17 23.583 9.424 9.353 1.00 89.71 C \nANISOU 2604 C MET B 17 10190 12290 11608 -2222 -657 10 C \nATOM 2605 O MET B 17 22.848 9.360 8.374 1.00 95.64 O \nANISOU 2605 O MET B 17 11010 12910 12418 -2179 -656 14 O \nATOM 2606 CB MET B 17 21.766 8.933 10.959 1.00 94.86 C \nANISOU 2606 CB MET B 17 11038 12489 12515 -2008 -673 18 C \nATOM 2607 CG MET B 17 22.051 7.434 10.827 1.00 94.43 C \nANISOU 2607 CG MET B 17 10862 12537 12479 -1789 -676 -31 C \nATOM 2608 SD MET B 17 20.830 6.371 11.545 1.00 83.59 S \nANISOU 2608 SD MET B 17 9588 10917 11254 -1601 -696 -39 S \nATOM 2609 CE MET B 17 19.406 6.949 10.611 1.00 93.12 C \nANISOU 2609 CE MET B 17 10926 11911 12545 -1650 -688 -7 C \nATOM 2610 N VAL B 18 24.882 9.216 9.302 1.00 97.10 N \nANISOU 2610 N VAL B 18 10932 13572 12390 -2262 -649 -16 N \nATOM 2611 CA VAL B 18 25.612 8.977 8.063 1.00106.11 C \nANISOU 2611 CA VAL B 18 11920 14997 13402 -2276 -639 -43 C \nATOM 2612 C VAL B 18 25.819 7.474 7.841 1.00111.64 C \nANISOU 2612 C VAL B 18 12485 15813 14118 -1952 -645 -117 C \nATOM 2613 O VAL B 18 26.220 7.048 6.761 1.00127.41 O \nANISOU 2613 O VAL B 18 14372 18007 16033 -1879 -643 -152 O \nATOM 2614 CB VAL B 18 26.997 9.691 8.102 1.00108.80 C \nANISOU 2614 CB VAL B 18 12103 15731 13505 -2530 -632 -34 C \nATOM 2615 CG1 VAL B 18 26.825 11.168 8.462 1.00106.16 C \nANISOU 2615 CG1 VAL B 18 11966 15242 13126 -2865 -647 43 C \nATOM 2616 CG2 VAL B 18 27.957 9.016 9.085 1.00105.72 C \nANISOU 2616 CG2 VAL B 18 11517 15620 13030 -2402 -632 -85 C \nATOM 2617 N ASP B 19 25.550 6.686 8.874 1.00110.47 N \nANISOU 2617 N ASP B 19 12373 15538 14062 -1757 -663 -141 N \nATOM 2618 CA ASP B 19 25.852 5.250 8.898 1.00114.42 C \nANISOU 2618 CA ASP B 19 12803 16131 14542 -1443 -693 -215 C \nATOM 2619 C ASP B 19 24.864 4.378 8.078 1.00119.32 C \nANISOU 2619 C ASP B 19 13552 16509 15276 -1263 -715 -227 C \nATOM 2620 O ASP B 19 25.169 3.232 7.719 1.00110.14 O \nANISOU 2620 O ASP B 19 12363 15431 14057 -1011 -754 -290 O \nATOM 2621 CB ASP B 19 25.851 4.763 10.361 1.00121.88 C \nANISOU 2621 CB ASP B 19 13789 16984 15534 -1331 -716 -227 C \nATOM 2622 CG ASP B 19 26.915 5.447 11.213 1.00123.38 C \nANISOU 2622 CG ASP B 19 13839 17442 15596 -1476 -700 -225 C \nATOM 2623 OD1 ASP B 19 27.827 6.083 10.636 1.00130.80 O \nANISOU 2623 OD1 ASP B 19 14620 18708 16371 -1638 -679 -226 O \nATOM 2624 OD2 ASP B 19 26.835 5.337 12.458 1.00120.99 O \nANISOU 2624 OD2 ASP B 19 13585 17038 15346 -1445 -711 -220 O \nATOM 2625 N GLY B 20 23.673 4.906 7.799 1.00112.74 N \nANISOU 2625 N GLY B 20 12872 15379 14584 -1381 -699 -171 N \nATOM 2626 CA GLY B 20 22.632 4.121 7.132 1.00101.22 C \nANISOU 2626 CA GLY B 20 11538 13690 13230 -1246 -719 -174 C \nATOM 2627 C GLY B 20 21.363 4.893 6.824 1.00 94.23 C \nANISOU 2627 C GLY B 20 10789 12545 12471 -1390 -697 -116 C \nATOM 2628 O GLY B 20 21.327 6.122 6.932 1.00 93.10 O \nANISOU 2628 O GLY B 20 10665 12389 12322 -1586 -673 -75 O \nATOM 2629 N TRP B 21 20.311 4.160 6.469 1.00 85.18 N \nANISOU 2629 N TRP B 21 9754 11194 11418 -1287 -716 -114 N \nATOM 2630 CA TRP B 21 19.023 4.780 6.121 1.00 88.66 C \nANISOU 2630 CA TRP B 21 10304 11423 11959 -1383 -700 -70 C \nATOM 2631 C TRP B 21 18.104 4.923 7.309 1.00 77.47 C \nANISOU 2631 C TRP B 21 8977 9832 10625 -1408 -704 -44 C \nATOM 2632 O TRP B 21 17.440 5.937 7.458 1.00 69.48 O \nANISOU 2632 O TRP B 21 8023 8728 9648 -1510 -689 -14 O \nATOM 2633 CB TRP B 21 18.311 3.981 5.027 1.00100.63 C \nANISOU 2633 CB TRP B 21 11875 12850 13511 -1288 -714 -80 C \nATOM 2634 CG TRP B 21 18.773 4.299 3.627 1.00111.53 C \nANISOU 2634 CG TRP B 21 13189 14353 14832 -1316 -698 -90 C \nATOM 2635 CD1 TRP B 21 19.765 5.156 3.259 1.00116.05 C \nANISOU 2635 CD1 TRP B 21 13660 15126 15309 -1432 -674 -90 C \nATOM 2636 CD2 TRP B 21 18.270 3.732 2.421 1.00114.58 C \nANISOU 2636 CD2 TRP B 21 13612 14687 15237 -1244 -707 -100 C \nATOM 2637 NE1 TRP B 21 19.896 5.173 1.902 1.00118.04 N \nANISOU 2637 NE1 TRP B 21 13874 15456 15519 -1436 -666 -99 N \nATOM 2638 CE2 TRP B 21 18.993 4.300 1.361 1.00114.79 C \nANISOU 2638 CE2 TRP B 21 13546 14885 15185 -1307 -685 -108 C \nATOM 2639 CE3 TRP B 21 17.271 2.794 2.132 1.00119.86 C \nANISOU 2639 CE3 TRP B 21 14388 15188 15967 -1153 -735 -99 C \nATOM 2640 CZ2 TRP B 21 18.754 3.963 0.029 1.00123.21 C \nANISOU 2640 CZ2 TRP B 21 14616 15951 16247 -1257 -686 -119 C \nATOM 2641 CZ3 TRP B 21 17.030 2.460 0.801 1.00123.94 C \nANISOU 2641 CZ3 TRP B 21 14918 15698 16476 -1110 -739 -109 C \nATOM 2642 CH2 TRP B 21 17.768 3.047 -0.232 1.00120.36 C \nANISOU 2642 CH2 TRP B 21 14364 15408 15959 -1149 -713 -121 C \nATOM 2643 N TYR B 22 18.058 3.885 8.133 1.00 75.47 N \nANISOU 2643 N TYR B 22 8751 9539 10385 -1302 -735 -59 N \nATOM 2644 CA TYR B 22 17.300 3.938 9.368 1.00 74.67 C \nANISOU 2644 CA TYR B 22 8714 9315 10341 -1333 -740 -36 C \nATOM 2645 C TYR B 22 18.193 3.599 10.537 1.00 73.58 C \nANISOU 2645 C TYR B 22 8540 9254 10165 -1290 -757 -53 C \nATOM 2646 O TYR B 22 19.192 2.886 10.380 1.00 77.57 O \nANISOU 2646 O TYR B 22 8996 9882 10595 -1179 -781 -92 O \nATOM 2647 CB TYR B 22 16.160 2.939 9.346 1.00 80.65 C \nANISOU 2647 CB TYR B 22 9571 9932 11140 -1286 -771 -27 C \nATOM 2648 CG TYR B 22 15.540 2.714 7.993 1.00 78.65 C \nANISOU 2648 CG TYR B 22 9348 9639 10897 -1276 -770 -25 C \nATOM 2649 CD1 TYR B 22 15.668 1.493 7.348 1.00 72.31 C \nANISOU 2649 CD1 TYR B 22 8605 8812 10056 -1176 -814 -45 C \nATOM 2650 CD2 TYR B 22 14.792 3.719 7.378 1.00 72.99 C \nANISOU 2650 CD2 TYR B 22 8623 8896 10215 -1354 -736 -5 C \nATOM 2651 CE1 TYR B 22 15.077 1.277 6.122 1.00 71.02 C \nANISOU 2651 CE1 TYR B 22 8475 8607 9902 -1174 -815 -42 C \nATOM 2652 CE2 TYR B 22 14.186 3.507 6.157 1.00 69.17 C \nANISOU 2652 CE2 TYR B 22 8163 8378 9740 -1343 -736 -4 C \nATOM 2653 CZ TYR B 22 14.338 2.286 5.526 1.00 68.58 C \nANISOU 2653 CZ TYR B 22 8129 8288 9639 -1263 -770 -20 C \nATOM 2654 OH TYR B 22 13.764 2.098 4.287 1.00 58.31 O \nANISOU 2654 OH TYR B 22 6854 6956 8346 -1259 -770 -18 O \nATOM 2655 N GLY B 23 17.827 4.105 11.710 1.00 67.41 N \nANISOU 2655 N GLY B 23 7780 8411 9421 -1357 -749 -30 N \nATOM 2656 CA GLY B 23 18.586 3.811 12.916 1.00 67.35 C \nANISOU 2656 CA GLY B 23 7745 8463 9383 -1322 -764 -43 C \nATOM 2657 C GLY B 23 18.122 4.524 14.149 1.00 65.58 C \nANISOU 2657 C GLY B 23 7545 8172 9202 -1407 -751 -16 C \nATOM 2658 O GLY B 23 16.969 4.960 14.238 1.00 57.40 O \nANISOU 2658 O GLY B 23 6565 7026 8217 -1456 -742 8 O \nATOM 2659 N TYR B 24 19.039 4.688 15.095 1.00 72.70 N \nANISOU 2659 N TYR B 24 8394 9163 10065 -1413 -751 -25 N \nATOM 2660 CA TYR B 24 18.679 5.182 16.436 1.00 73.56 C \nANISOU 2660 CA TYR B 24 8533 9208 10209 -1471 -747 -5 C \nATOM 2661 C TYR B 24 19.477 6.398 16.846 1.00 71.66 C \nANISOU 2661 C TYR B 24 8249 9057 9923 -1583 -726 5 C \nATOM 2662 O TYR B 24 20.494 6.727 16.234 1.00 85.61 O \nANISOU 2662 O TYR B 24 9940 10976 11612 -1631 -717 -6 O \nATOM 2663 CB TYR B 24 18.910 4.091 17.464 1.00 73.51 C \nANISOU 2663 CB TYR B 24 8543 9190 10196 -1381 -781 -19 C \nATOM 2664 CG TYR B 24 18.343 2.738 17.077 1.00 78.55 C \nANISOU 2664 CG TYR B 24 9273 9737 10835 -1286 -825 -28 C \nATOM 2665 CD1 TYR B 24 19.108 1.822 16.349 1.00 77.93 C \nANISOU 2665 CD1 TYR B 24 9201 9721 10689 -1155 -860 -66 C \nATOM 2666 CD2 TYR B 24 17.045 2.371 17.443 1.00 78.26 C \nANISOU 2666 CD2 TYR B 24 9326 9569 10840 -1333 -839 1 C \nATOM 2667 CE1 TYR B 24 18.606 0.572 16.014 1.00 75.74 C \nANISOU 2667 CE1 TYR B 24 9061 9327 10389 -1072 -919 -73 C \nATOM 2668 CE2 TYR B 24 16.532 1.131 17.113 1.00 80.81 C \nANISOU 2668 CE2 TYR B 24 9765 9802 11136 -1292 -890 2 C \nATOM 2669 CZ TYR B 24 17.322 0.230 16.397 1.00 84.60 C \nANISOU 2669 CZ TYR B 24 10295 10298 11553 -1161 -935 -34 C \nATOM 2670 OH TYR B 24 16.842 -1.012 16.046 1.00 95.24 O \nANISOU 2670 OH TYR B 24 11810 11527 12851 -1121 -1004 -33 O \nATOM 2671 N HIS B 25 18.991 7.076 17.870 1.00 64.47 N \nANISOU 2671 N HIS B 25 7391 8063 9041 -1638 -725 25 N \nATOM 2672 CA HIS B 25 19.746 8.081 18.552 1.00 62.42 C \nANISOU 2672 CA HIS B 25 7125 7863 8727 -1747 -720 36 C \nATOM 2673 C HIS B 25 19.456 7.974 20.019 1.00 64.92 C \nANISOU 2673 C HIS B 25 7464 8121 9081 -1722 -728 40 C \nATOM 2674 O HIS B 25 18.317 8.182 20.446 1.00 67.87 O \nANISOU 2674 O HIS B 25 7910 8374 9504 -1700 -734 51 O \nATOM 2675 CB HIS B 25 19.414 9.492 18.103 1.00 66.88 C \nANISOU 2675 CB HIS B 25 7797 8357 9259 -1867 -722 60 C \nATOM 2676 CG HIS B 25 20.190 10.535 18.854 1.00 79.24 C \nANISOU 2676 CG HIS B 25 9403 9961 10744 -2008 -732 77 C \nATOM 2677 ND1 HIS B 25 21.570 10.592 18.851 1.00 89.42 N \nANISOU 2677 ND1 HIS B 25 10590 11448 11935 -2114 -724 76 N \nATOM 2678 CD2 HIS B 25 19.776 11.535 19.667 1.00 82.86 C \nANISOU 2678 CD2 HIS B 25 9997 10300 11186 -2060 -755 93 C \nATOM 2679 CE1 HIS B 25 21.969 11.599 19.605 1.00 93.90 C \nANISOU 2679 CE1 HIS B 25 11237 12008 12433 -2259 -741 100 C \nATOM 2680 NE2 HIS B 25 20.897 12.192 20.106 1.00 91.00 N \nANISOU 2680 NE2 HIS B 25 11031 11428 12116 -2220 -763 110 N \nATOM 2681 N HIS B 26 20.487 7.669 20.799 1.00 65.45 N \nANISOU 2681 N HIS B 26 7457 8302 9108 -1721 -731 29 N \nATOM 2682 CA HIS B 26 20.353 7.604 22.247 1.00 67.88 C \nANISOU 2682 CA HIS B 26 7783 8565 9444 -1708 -739 34 C \nATOM 2683 C HIS B 26 20.972 8.823 22.938 1.00 71.61 C \nANISOU 2683 C HIS B 26 8273 9077 9860 -1841 -736 51 C \nATOM 2684 O HIS B 26 21.858 9.490 22.421 1.00 72.38 O \nANISOU 2684 O HIS B 26 8344 9289 9869 -1957 -731 56 O \nATOM 2685 CB HIS B 26 20.978 6.302 22.777 1.00 71.12 C \nANISOU 2685 CB HIS B 26 8130 9049 9843 -1591 -757 6 C \nATOM 2686 CG HIS B 26 22.472 6.320 22.834 1.00 77.58 C \nANISOU 2686 CG HIS B 26 8833 10081 10562 -1597 -755 -19 C \nATOM 2687 ND1 HIS B 26 23.259 6.089 21.730 1.00 78.30 N \nANISOU 2687 ND1 HIS B 26 8836 10342 10574 -1567 -752 -45 N \nATOM 2688 CD2 HIS B 26 23.327 6.541 23.865 1.00 82.42 C \nANISOU 2688 CD2 HIS B 26 9386 10805 11124 -1628 -755 -24 C \nATOM 2689 CE1 HIS B 26 24.535 6.180 22.071 1.00 85.02 C \nANISOU 2689 CE1 HIS B 26 9563 11427 11315 -1581 -750 -69 C \nATOM 2690 NE2 HIS B 26 24.604 6.444 23.364 1.00 80.88 N \nANISOU 2690 NE2 HIS B 26 9056 10867 10809 -1621 -752 -56 N \nATOM 2691 N SER B 27 20.489 9.095 24.127 1.00 73.46 N \nANISOU 2691 N SER B 27 8561 9222 10128 -1837 -743 60 N \nATOM 2692 CA SER B 27 21.135 10.040 24.991 1.00 74.30 C \nANISOU 2692 CA SER B 27 8696 9359 10176 -1949 -749 74 C \nATOM 2693 C SER B 27 20.994 9.525 26.426 1.00 71.58 C \nANISOU 2693 C SER B 27 8329 8990 9878 -1882 -754 69 C \nATOM 2694 O SER B 27 19.908 9.134 26.849 1.00 68.20 O \nANISOU 2694 O SER B 27 7938 8458 9517 -1799 -759 68 O \nATOM 2695 CB SER B 27 20.547 11.441 24.815 1.00 71.04 C \nANISOU 2695 CB SER B 27 8449 8816 9727 -2036 -770 95 C \nATOM 2696 OG SER B 27 19.241 11.516 25.348 1.00 78.57 O \nANISOU 2696 OG SER B 27 9479 9633 10740 -1929 -782 89 O \nATOM 2697 N ASN B 28 22.111 9.510 27.151 1.00 70.71 N \nANISOU 2697 N ASN B 28 8148 9004 9715 -1928 -752 65 N \nATOM 2698 CA ASN B 28 22.140 9.052 28.539 1.00 69.33 C \nANISOU 2698 CA ASN B 28 7953 8817 9573 -1874 -759 60 C \nATOM 2699 C ASN B 28 23.273 9.726 29.317 1.00 67.05 C \nANISOU 2699 C ASN B 28 7628 8647 9202 -1989 -759 66 C \nATOM 2700 O ASN B 28 23.911 10.625 28.795 1.00 68.41 O \nANISOU 2700 O ASN B 28 7811 8898 9282 -2137 -758 81 O \nATOM 2701 CB ASN B 28 22.252 7.522 28.601 1.00 71.75 C \nANISOU 2701 CB ASN B 28 8192 9161 9907 -1726 -768 33 C \nATOM 2702 CG ASN B 28 23.530 6.997 27.966 1.00 72.41 C \nANISOU 2702 CG ASN B 28 8162 9447 9905 -1684 -770 1 C \nATOM 2703 OD1 ASN B 28 24.323 7.755 27.414 1.00 72.76 O \nANISOU 2703 OD1 ASN B 28 8144 9635 9865 -1794 -754 4 O \nATOM 2704 ND2 ASN B 28 23.724 5.688 28.028 1.00 67.60 N \nANISOU 2704 ND2 ASN B 28 7535 8860 9288 -1524 -797 -32 N \nATOM 2705 N GLU B 29 23.485 9.313 30.570 1.00 62.94 N \nANISOU 2705 N GLU B 29 7075 8139 8701 -1941 -764 59 N \nATOM 2706 CA GLU B 29 24.553 9.856 31.435 1.00 69.03 C \nANISOU 2706 CA GLU B 29 7800 9037 9392 -2046 -764 64 C \nATOM 2707 C GLU B 29 25.970 9.707 30.793 1.00 69.58 C \nANISOU 2707 C GLU B 29 7718 9385 9333 -2101 -755 44 C \nATOM 2708 O GLU B 29 26.795 10.591 30.936 1.00 70.89 O \nANISOU 2708 O GLU B 29 7863 9683 9388 -2281 -754 61 O \nATOM 2709 CB GLU B 29 24.489 9.245 32.862 1.00 67.89 C \nANISOU 2709 CB GLU B 29 7639 8861 9296 -1956 -772 54 C \nATOM 2710 CG GLU B 29 24.548 7.703 32.875 1.00 80.65 C \nANISOU 2710 CG GLU B 29 9193 10510 10942 -1773 -784 20 C \nATOM 2711 CD GLU B 29 23.196 6.947 32.601 1.00 84.08 C \nANISOU 2711 CD GLU B 29 9717 10759 11470 -1679 -796 25 C \nATOM 2712 OE1 GLU B 29 22.068 7.480 32.757 1.00 70.69 O \nANISOU 2712 OE1 GLU B 29 8101 8927 9831 -1720 -791 49 O \nATOM 2713 OE2 GLU B 29 23.257 5.763 32.220 1.00 90.59 O \nANISOU 2713 OE2 GLU B 29 10539 11592 12288 -1558 -819 2 O \nATOM 2714 N GLN B 30 26.187 8.636 30.030 1.00 70.60 N \nANISOU 2714 N GLN B 30 7755 9612 9459 -1954 -755 8 N \nATOM 2715 CA GLN B 30 27.435 8.407 29.304 1.00 71.80 C \nANISOU 2715 CA GLN B 30 7742 10069 9470 -1960 -749 -25 C \nATOM 2716 C GLN B 30 27.544 9.270 28.023 1.00 82.63 C \nANISOU 2716 C GLN B 30 9119 11506 10772 -2133 -736 -1 C \nATOM 2717 O GLN B 30 28.549 9.178 27.290 1.00 79.12 O \nANISOU 2717 O GLN B 30 8522 11352 10189 -2168 -728 -25 O \nATOM 2718 CB GLN B 30 27.621 6.921 28.952 1.00 74.22 C \nANISOU 2718 CB GLN B 30 7979 10448 9773 -1699 -770 -82 C \nATOM 2719 CG GLN B 30 27.780 5.999 30.154 1.00 88.27 C \nANISOU 2719 CG GLN B 30 9765 12205 11570 -1530 -800 -112 C \nATOM 2720 CD GLN B 30 26.457 5.469 30.704 1.00101.23 C \nANISOU 2720 CD GLN B 30 11579 13524 13360 -1460 -819 -90 C \nATOM 2721 OE1 GLN B 30 25.371 5.927 30.329 1.00113.12 O \nANISOU 2721 OE1 GLN B 30 13183 14838 14959 -1543 -804 -51 O \nATOM 2722 NE2 GLN B 30 26.544 4.497 31.599 1.00106.08 N \nANISOU 2722 NE2 GLN B 30 12232 14098 13974 -1310 -857 -115 N \nATOM 2723 N GLY B 31 26.564 10.147 27.774 1.00 88.84 N \nANISOU 2723 N GLY B 31 10080 12048 11627 -2241 -738 43 N \nATOM 2724 CA GLY B 31 26.548 10.982 26.557 1.00 88.40 C \nANISOU 2724 CA GLY B 31 10080 12004 11504 -2403 -737 68 C \nATOM 2725 C GLY B 31 25.512 10.516 25.534 1.00 85.79 C \nANISOU 2725 C GLY B 31 9810 11508 11278 -2272 -733 61 C \nATOM 2726 O GLY B 31 24.456 10.035 25.891 1.00 87.55 O \nANISOU 2726 O GLY B 31 10107 11527 11629 -2129 -738 57 O \nATOM 2727 N SER B 32 25.832 10.680 24.255 1.00 84.37 N \nANISOU 2727 N SER B 32 9591 11441 11026 -2342 -727 61 N \nATOM 2728 CA SER B 32 24.884 10.501 23.181 1.00 75.56 C \nANISOU 2728 CA SER B 32 8550 10170 9989 -2266 -725 62 C \nATOM 2729 C SER B 32 25.545 9.907 21.943 1.00 79.42 C \nANISOU 2729 C SER B 32 8895 10876 10404 -2228 -712 33 C \nATOM 2730 O SER B 32 26.767 9.747 21.893 1.00 73.28 O \nANISOU 2730 O SER B 32 7951 10400 9492 -2271 -706 11 O \nATOM 2731 CB SER B 32 24.231 11.836 22.833 1.00 70.82 C \nANISOU 2731 CB SER B 32 8154 9381 9372 -2427 -744 105 C \nATOM 2732 OG SER B 32 25.063 12.639 22.062 1.00 71.92 O \nANISOU 2732 OG SER B 32 8297 9670 9359 -2650 -751 127 O \nATOM 2733 N GLY B 33 24.720 9.541 20.962 1.00 81.60 N \nANISOU 2733 N GLY B 33 9224 11023 10759 -2134 -710 29 N \nATOM 2734 CA GLY B 33 25.226 8.971 19.716 1.00 82.94 C \nANISOU 2734 CA GLY B 33 9275 11376 10865 -2079 -702 -1 C \nATOM 2735 C GLY B 33 24.176 8.441 18.750 1.00 81.83 C \nANISOU 2735 C GLY B 33 9208 11055 10828 -1955 -703 -5 C \nATOM 2736 O GLY B 33 23.069 8.111 19.150 1.00 82.18 O \nANISOU 2736 O GLY B 33 9359 10869 10997 -1860 -711 2 O \nATOM 2737 N TYR B 34 24.537 8.377 17.468 1.00 83.49 N \nANISOU 2737 N TYR B 34 9352 11400 10971 -1972 -695 -17 N \nATOM 2738 CA TYR B 34 23.705 7.755 16.433 1.00 82.30 C \nANISOU 2738 CA TYR B 34 9248 11121 10900 -1847 -697 -28 C \nATOM 2739 C TYR B 34 24.138 6.317 16.168 1.00 82.13 C \nANISOU 2739 C TYR B 34 9130 11222 10855 -1617 -715 -85 C \nATOM 2740 O TYR B 34 25.256 5.929 16.462 1.00 80.65 O \nANISOU 2740 O TYR B 34 8806 11283 10553 -1552 -723 -125 O \nATOM 2741 CB TYR B 34 23.782 8.529 15.125 1.00 80.80 C \nANISOU 2741 CB TYR B 34 9068 10984 10647 -1992 -685 -8 C \nATOM 2742 CG TYR B 34 23.280 9.961 15.189 1.00 80.54 C \nANISOU 2742 CG TYR B 34 9202 10790 10611 -2200 -691 44 C \nATOM 2743 CD1 TYR B 34 24.166 11.024 15.395 1.00 71.48 C \nANISOU 2743 CD1 TYR B 34 8061 9777 9319 -2441 -697 73 C \nATOM 2744 CD2 TYR B 34 21.923 10.261 15.025 1.00 74.21 C \nANISOU 2744 CD2 TYR B 34 8567 9710 9918 -2155 -701 62 C \nATOM 2745 CE1 TYR B 34 23.708 12.331 15.465 1.00 71.56 C \nANISOU 2745 CE1 TYR B 34 8289 9602 9300 -2621 -725 119 C \nATOM 2746 CE2 TYR B 34 21.469 11.573 15.090 1.00 73.18 C \nANISOU 2746 CE2 TYR B 34 8624 9426 9756 -2297 -724 98 C \nATOM 2747 CZ TYR B 34 22.362 12.598 15.315 1.00 74.34 C \nANISOU 2747 CZ TYR B 34 8821 9662 9762 -2525 -742 126 C \nATOM 2748 OH TYR B 34 21.902 13.886 15.374 1.00 80.30 O \nANISOU 2748 OH TYR B 34 9823 10227 10461 -2654 -786 160 O \nATOM 2749 N ALA B 35 23.226 5.530 15.619 1.00 86.51 N \nANISOU 2749 N ALA B 35 9772 11600 11498 -1485 -730 -92 N \nATOM 2750 CA ALA B 35 23.480 4.122 15.350 1.00 91.39 C \nANISOU 2750 CA ALA B 35 10376 12266 12084 -1253 -768 -145 C \nATOM 2751 C ALA B 35 22.455 3.594 14.355 1.00 90.70 C \nANISOU 2751 C ALA B 35 10397 11995 12070 -1193 -781 -138 C \nATOM 2752 O ALA B 35 21.277 3.546 14.651 1.00 88.12 O \nANISOU 2752 O ALA B 35 10194 11438 11850 -1226 -783 -104 O \nATOM 2753 CB ALA B 35 23.423 3.324 16.643 1.00 93.20 C \nANISOU 2753 CB ALA B 35 10669 12408 12336 -1134 -805 -159 C \nATOM 2754 N ALA B 36 22.913 3.228 13.166 1.00100.81 N \nANISOU 2754 N ALA B 36 11617 13408 13277 -1112 -787 -171 N \nATOM 2755 CA ALA B 36 22.017 2.757 12.109 1.00104.68 C \nANISOU 2755 CA ALA B 36 12204 13743 13825 -1064 -799 -165 C \nATOM 2756 C ALA B 36 21.688 1.281 12.271 1.00104.40 C \nANISOU 2756 C ALA B 36 12305 13577 13787 -863 -867 -196 C \nATOM 2757 O ALA B 36 22.508 0.512 12.773 1.00106.63 O \nANISOU 2757 O ALA B 36 12581 13959 13973 -695 -914 -245 O \nATOM 2758 CB ALA B 36 22.638 3.009 10.744 1.00109.00 C \nANISOU 2758 CB ALA B 36 12640 14486 14288 -1069 -781 -187 C \nATOM 2759 N ASP B 37 20.489 0.888 11.850 1.00101.55 N \nANISOU 2759 N ASP B 37 12085 12995 13506 -884 -881 -167 N \nATOM 2760 CA ASP B 37 20.119 -0.515 11.858 1.00105.12 C \nANISOU 2760 CA ASP B 37 12714 13300 13925 -736 -960 -186 C \nATOM 2761 C ASP B 37 20.665 -1.181 10.594 1.00111.68 C \nANISOU 2761 C ASP B 37 13549 14222 14663 -567 -997 -238 C \nATOM 2762 O ASP B 37 20.353 -0.768 9.479 1.00120.49 O \nANISOU 2762 O ASP B 37 14617 15354 15809 -629 -961 -225 O \nATOM 2763 CB ASP B 37 18.612 -0.665 11.942 1.00104.54 C \nANISOU 2763 CB ASP B 37 12779 12995 13945 -863 -964 -130 C \nATOM 2764 CG ASP B 37 18.191 -2.046 12.347 1.00107.99 C \nANISOU 2764 CG ASP B 37 13439 13262 14330 -786 -1056 -134 C \nATOM 2765 OD1 ASP B 37 18.916 -3.020 12.056 1.00113.31 O \nANISOU 2765 OD1 ASP B 37 14211 13949 14894 -590 -1131 -186 O \nATOM 2766 OD2 ASP B 37 17.119 -2.157 12.959 1.00114.80 O \nANISOU 2766 OD2 ASP B 37 14393 13988 15238 -922 -1061 -86 O \nATOM 2767 N LYS B 38 21.470 -2.221 10.779 1.00104.59 N \nANISOU 2767 N LYS B 38 12720 13381 13637 -335 -1076 -302 N \nATOM 2768 CA LYS B 38 22.144 -2.879 9.671 1.00102.36 C \nANISOU 2768 CA LYS B 38 12436 13227 13230 -119 -1123 -369 C \nATOM 2769 C LYS B 38 21.180 -3.657 8.811 1.00100.41 C \nANISOU 2769 C LYS B 38 12400 12746 13003 -100 -1174 -352 C \nATOM 2770 O LYS B 38 21.211 -3.557 7.585 1.00 92.28 O \nANISOU 2770 O LYS B 38 11315 11788 11960 -74 -1157 -366 O \nATOM 2771 CB LYS B 38 23.210 -3.834 10.204 1.00108.44 C \nANISOU 2771 CB LYS B 38 13260 14113 13829 172 -1214 -453 C \nATOM 2772 CG LYS B 38 24.018 -4.547 9.133 1.00112.09 C \nANISOU 2772 CG LYS B 38 13716 14754 14121 457 -1277 -542 C \nATOM 2773 CD LYS B 38 25.187 -5.309 9.711 1.00110.79 C \nANISOU 2773 CD LYS B 38 13564 14775 13757 778 -1364 -640 C \nATOM 2774 CE LYS B 38 26.163 -5.692 8.629 1.00112.25 C \nANISOU 2774 CE LYS B 38 13636 15264 13748 1061 -1403 -740 C \nATOM 2775 NZ LYS B 38 27.281 -6.527 9.134 1.00115.45 N \nANISOU 2775 NZ LYS B 38 14070 15874 13922 1440 -1506 -853 N \nATOM 2776 N GLU B 39 20.338 -4.449 9.470 1.00100.43 N \nANISOU 2776 N GLU B 39 12654 12482 13025 -131 -1241 -321 N \nATOM 2777 CA GLU B 39 19.396 -5.315 8.775 1.00 97.99 C \nANISOU 2777 CA GLU B 39 12586 11941 12703 -142 -1308 -299 C \nATOM 2778 C GLU B 39 18.384 -4.473 8.009 1.00 98.02 C \nANISOU 2778 C GLU B 39 12485 11915 12843 -371 -1218 -237 C \nATOM 2779 O GLU B 39 18.181 -4.671 6.815 1.00 96.72 O \nANISOU 2779 O GLU B 39 12346 11738 12664 -337 -1225 -246 O \nATOM 2780 CB GLU B 39 18.675 -6.254 9.755 1.00 96.52 C \nANISOU 2780 CB GLU B 39 12692 11497 12484 -197 -1399 -266 C \nATOM 2781 CG GLU B 39 17.665 -7.176 9.079 1.00103.45 C \nANISOU 2781 CG GLU B 39 13848 12140 13319 -261 -1479 -234 C \nATOM 2782 CD GLU B 39 17.074 -8.238 9.993 1.00105.10 C \nANISOU 2782 CD GLU B 39 14394 12102 13438 -330 -1595 -202 C \nATOM 2783 OE1 GLU B 39 17.612 -8.455 11.099 1.00112.11 O \nANISOU 2783 OE1 GLU B 39 15335 12984 14276 -254 -1634 -221 O \nATOM 2784 OE2 GLU B 39 16.058 -8.863 9.602 1.00101.29 O \nANISOU 2784 OE2 GLU B 39 14132 11435 12919 -481 -1651 -153 O \nATOM 2785 N SER B 40 17.776 -3.519 8.706 1.00 96.83 N \nANISOU 2785 N SER B 40 12220 11760 12810 -583 -1139 -181 N \nATOM 2786 CA SER B 40 16.704 -2.711 8.148 1.00 93.02 C \nANISOU 2786 CA SER B 40 11664 11243 12438 -777 -1066 -127 C \nATOM 2787 C SER B 40 17.182 -1.903 6.932 1.00 87.78 C \nANISOU 2787 C SER B 40 10828 10733 11793 -758 -1004 -147 C \nATOM 2788 O SER B 40 16.535 -1.896 5.884 1.00 97.28 O \nANISOU 2788 O SER B 40 12054 11887 13022 -800 -993 -132 O \nATOM 2789 CB SER B 40 16.140 -1.779 9.230 1.00 91.12 C \nANISOU 2789 CB SER B 40 11333 11002 12285 -949 -1005 -82 C \nATOM 2790 OG SER B 40 14.725 -1.841 9.249 1.00 90.50 O \nANISOU 2790 OG SER B 40 11327 10810 12248 -1102 -1002 -32 O \nATOM 2791 N THR B 41 18.311 -1.227 7.075 1.00 90.53 N \nANISOU 2791 N THR B 41 11006 11280 12112 -714 -966 -177 N \nATOM 2792 CA THR B 41 18.905 -0.450 5.980 1.00 87.82 C \nANISOU 2792 CA THR B 41 10499 11118 11751 -727 -913 -194 C \nATOM 2793 C THR B 41 19.199 -1.363 4.785 1.00 93.01 C \nANISOU 2793 C THR B 41 11210 11804 12324 -555 -963 -240 C \nATOM 2794 O THR B 41 18.934 -1.004 3.640 1.00102.18 O \nANISOU 2794 O THR B 41 12327 12988 13509 -602 -931 -231 O \nATOM 2795 CB THR B 41 20.192 0.266 6.444 1.00 86.57 C \nANISOU 2795 CB THR B 41 10157 11211 11526 -728 -879 -220 C \nATOM 2796 OG1 THR B 41 19.872 1.227 7.459 1.00 85.62 O \nANISOU 2796 OG1 THR B 41 10007 11043 11481 -900 -835 -174 O \nATOM 2797 CG2 THR B 41 20.862 0.993 5.286 1.00 92.59 C \nANISOU 2797 CG2 THR B 41 10760 12191 12231 -774 -835 -234 C \nATOM 2798 N GLN B 42 19.734 -2.549 5.053 1.00 93.97 N \nANISOU 2798 N GLN B 42 11450 11917 12337 -340 -1050 -293 N \nATOM 2799 CA GLN B 42 20.038 -3.516 3.997 1.00 89.64 C \nANISOU 2799 CA GLN B 42 10996 11384 11681 -131 -1120 -348 C \nATOM 2800 C GLN B 42 18.800 -3.947 3.227 1.00 86.90 C \nANISOU 2800 C GLN B 42 10825 10798 11396 -213 -1141 -306 C \nATOM 2801 O GLN B 42 18.768 -3.873 2.001 1.00 92.46 O \nANISOU 2801 O GLN B 42 11486 11551 12092 -189 -1126 -317 O \nATOM 2802 CB GLN B 42 20.735 -4.753 4.571 1.00 85.13 C \nANISOU 2802 CB GLN B 42 10590 10799 10958 141 -1235 -416 C \nATOM 2803 CG GLN B 42 21.357 -5.644 3.515 1.00 86.34 C \nANISOU 2803 CG GLN B 42 10816 11036 10954 423 -1315 -496 C \nATOM 2804 CD GLN B 42 22.292 -4.864 2.597 1.00 87.32 C \nANISOU 2804 CD GLN B 42 10634 11520 11025 460 -1242 -538 C \nATOM 2805 OE1 GLN B 42 23.107 -4.059 3.058 1.00 88.50 O \nANISOU 2805 OE1 GLN B 42 10540 11936 11150 408 -1179 -549 O \nATOM 2806 NE2 GLN B 42 22.184 -5.105 1.292 1.00 88.52 N \nANISOU 2806 NE2 GLN B 42 10799 11691 11142 531 -1253 -559 N \nATOM 2807 N LYS B 43 17.795 -4.410 3.965 1.00 86.52 N \nANISOU 2807 N LYS B 43 10966 10513 11393 -322 -1178 -257 N \nATOM 2808 CA LYS B 43 16.507 -4.841 3.393 1.00 81.92 C \nANISOU 2808 CA LYS B 43 10550 9725 10850 -448 -1202 -208 C \nATOM 2809 C LYS B 43 15.906 -3.776 2.456 1.00 84.55 C \nANISOU 2809 C LYS B 43 10710 10121 11293 -601 -1103 -173 C \nATOM 2810 O LYS B 43 15.343 -4.091 1.417 1.00 89.98 O \nANISOU 2810 O LYS B 43 11468 10741 11979 -614 -1117 -165 O \nATOM 2811 CB LYS B 43 15.522 -5.158 4.510 1.00 85.23 C \nANISOU 2811 CB LYS B 43 11118 9970 11295 -615 -1230 -151 C \nATOM 2812 CG LYS B 43 15.550 -6.584 5.015 1.00102.70 C \nANISOU 2812 CG LYS B 43 13648 12000 13372 -521 -1366 -164 C \nATOM 2813 CD LYS B 43 16.939 -7.025 5.468 1.00114.88 C \nANISOU 2813 CD LYS B 43 15218 13626 14804 -248 -1428 -242 C \nATOM 2814 CE LYS B 43 16.990 -8.508 5.838 1.00124.34 C \nANISOU 2814 CE LYS B 43 16802 14608 15835 -112 -1591 -265 C \nATOM 2815 NZ LYS B 43 18.299 -9.016 6.355 1.00129.14 N \nANISOU 2815 NZ LYS B 43 17466 15298 16305 197 -1669 -351 N \nATOM 2816 N ALA B 44 16.063 -2.514 2.825 1.00 85.66 N \nANISOU 2816 N ALA B 44 10646 10385 11514 -709 -1012 -155 N \nATOM 2817 CA ALA B 44 15.540 -1.416 2.039 1.00 82.73 C \nANISOU 2817 CA ALA B 44 10148 10059 11228 -841 -932 -125 C \nATOM 2818 C ALA B 44 16.293 -1.221 0.746 1.00 82.88 C \nANISOU 2818 C ALA B 44 10070 10217 11204 -756 -915 -162 C \nATOM 2819 O ALA B 44 15.707 -0.865 -0.261 1.00 92.30 O \nANISOU 2819 O ALA B 44 11247 11385 12438 -821 -886 -143 O \nATOM 2820 CB ALA B 44 15.540 -0.134 2.852 1.00 75.78 C \nANISOU 2820 CB ALA B 44 9137 9243 10413 -970 -864 -99 C \nATOM 2821 N ILE B 45 17.593 -1.440 0.777 1.00 86.15 N \nANISOU 2821 N ILE B 45 10407 10805 11520 -608 -934 -216 N \nATOM 2822 CA ILE B 45 18.439 -1.268 -0.402 1.00 86.75 C \nANISOU 2822 CA ILE B 45 10359 11082 11522 -525 -919 -258 C \nATOM 2823 C ILE B 45 18.217 -2.429 -1.359 1.00 81.51 C \nANISOU 2823 C ILE B 45 9842 10328 10799 -362 -989 -290 C \nATOM 2824 O ILE B 45 18.089 -2.223 -2.558 1.00 83.89 O \nANISOU 2824 O ILE B 45 10098 10670 11105 -375 -966 -292 O \nATOM 2825 CB ILE B 45 19.944 -1.215 -0.001 1.00 92.42 C \nANISOU 2825 CB ILE B 45 10922 12084 12111 -402 -924 -317 C \nATOM 2826 CG1 ILE B 45 20.246 -0.016 0.898 1.00 93.92 C \nANISOU 2826 CG1 ILE B 45 10975 12371 12338 -589 -859 -282 C \nATOM 2827 CG2 ILE B 45 20.852 -1.165 -1.221 1.00 94.88 C \nANISOU 2827 CG2 ILE B 45 11085 12660 12303 -304 -916 -369 C \nATOM 2828 CD1 ILE B 45 21.498 -0.202 1.738 1.00100.16 C \nANISOU 2828 CD1 ILE B 45 11656 13393 13007 -474 -879 -333 C \nATOM 2829 N ASP B 46 18.221 -3.645 -0.828 1.00 84.25 N \nANISOU 2829 N ASP B 46 10387 10549 11075 -206 -1084 -318 N \nATOM 2830 CA ASP B 46 17.881 -4.837 -1.608 1.00 84.76 C \nANISOU 2830 CA ASP B 46 10672 10464 11067 -65 -1175 -342 C \nATOM 2831 C ASP B 46 16.540 -4.667 -2.308 1.00 90.05 C \nANISOU 2831 C ASP B 46 11414 10959 11844 -257 -1146 -277 C \nATOM 2832 O ASP B 46 16.424 -4.930 -3.510 1.00 95.59 O \nANISOU 2832 O ASP B 46 12144 11657 12520 -201 -1159 -292 O \nATOM 2833 CB ASP B 46 17.874 -6.075 -0.719 1.00 85.98 C \nANISOU 2833 CB ASP B 46 11100 10441 11125 69 -1295 -362 C \nATOM 2834 CG ASP B 46 19.288 -6.558 -0.394 1.00101.62 C \nANISOU 2834 CG ASP B 46 13054 12611 12944 367 -1357 -455 C \nATOM 2835 OD1 ASP B 46 20.252 -6.075 -1.033 1.00108.06 O \nANISOU 2835 OD1 ASP B 46 13634 13722 13701 477 -1312 -508 O \nATOM 2836 OD2 ASP B 46 19.456 -7.398 0.520 1.00108.95 O \nANISOU 2836 OD2 ASP B 46 14190 13421 13784 489 -1453 -477 O \nATOM 2837 N GLY B 47 15.542 -4.181 -1.572 1.00 85.08 N \nANISOU 2837 N GLY B 47 10791 10216 11321 -475 -1104 -210 N \nATOM 2838 CA GLY B 47 14.228 -3.956 -2.135 1.00 78.88 C \nANISOU 2838 CA GLY B 47 10040 9314 10615 -653 -1074 -155 C \nATOM 2839 C GLY B 47 14.228 -2.860 -3.186 1.00 80.48 C \nANISOU 2839 C GLY B 47 10052 9640 10887 -710 -987 -150 C \nATOM 2840 O GLY B 47 13.779 -3.058 -4.331 1.00 86.49 O \nANISOU 2840 O GLY B 47 10850 10362 11649 -711 -991 -147 O \nATOM 2841 N VAL B 48 14.718 -1.690 -2.810 1.00 77.15 N \nANISOU 2841 N VAL B 48 9448 9354 10510 -772 -915 -146 N \nATOM 2842 CA VAL B 48 14.635 -0.514 -3.695 1.00 83.17 C \nANISOU 2842 CA VAL B 48 10073 10204 11323 -867 -841 -132 C \nATOM 2843 C VAL B 48 15.448 -0.695 -4.973 1.00 86.50 C \nANISOU 2843 C VAL B 48 10433 10757 11676 -757 -845 -174 C \nATOM 2844 O VAL B 48 15.037 -0.262 -6.046 1.00 95.56 O \nANISOU 2844 O VAL B 48 11553 11902 12854 -814 -815 -160 O \nATOM 2845 CB VAL B 48 15.032 0.784 -2.947 1.00 80.95 C \nANISOU 2845 CB VAL B 48 9665 10019 11073 -977 -783 -115 C \nATOM 2846 CG1 VAL B 48 15.736 1.770 -3.860 1.00 81.04 C \nANISOU 2846 CG1 VAL B 48 9551 10188 11054 -1030 -737 -122 C \nATOM 2847 CG2 VAL B 48 13.791 1.424 -2.308 1.00 76.62 C \nANISOU 2847 CG2 VAL B 48 9157 9346 10608 -1109 -758 -69 C \nATOM 2848 N THR B 49 16.594 -1.349 -4.871 1.00 91.80 N \nANISOU 2848 N THR B 49 11080 11560 12239 -585 -888 -230 N \nATOM 2849 CA THR B 49 17.474 -1.480 -6.035 1.00 91.64 C \nANISOU 2849 CA THR B 49 10965 11731 12122 -463 -891 -280 C \nATOM 2850 C THR B 49 16.874 -2.408 -7.087 1.00 96.99 C \nANISOU 2850 C THR B 49 11791 12273 12787 -366 -942 -291 C \nATOM 2851 O THR B 49 16.917 -2.102 -8.274 1.00105.14 O \nANISOU 2851 O THR B 49 12752 13384 13813 -377 -914 -297 O \nATOM 2852 CB THR B 49 18.878 -1.991 -5.678 1.00 91.32 C \nANISOU 2852 CB THR B 49 10843 11924 11930 -258 -932 -354 C \nATOM 2853 OG1 THR B 49 18.760 -2.956 -4.637 1.00 99.60 O \nANISOU 2853 OG1 THR B 49 12064 12823 12955 -138 -1007 -368 O \nATOM 2854 CG2 THR B 49 19.780 -0.850 -5.205 1.00 94.73 C \nANISOU 2854 CG2 THR B 49 11051 12611 12329 -382 -866 -350 C \nATOM 2855 N ASN B 50 16.299 -3.529 -6.665 1.00 88.19 N \nANISOU 2855 N ASN B 50 10902 10950 11657 -291 -1023 -290 N \nATOM 2856 CA ASN B 50 15.707 -4.469 -7.620 1.00 84.54 C \nANISOU 2856 CA ASN B 50 10622 10337 11161 -220 -1086 -296 C \nATOM 2857 C ASN B 50 14.425 -3.919 -8.224 1.00 79.00 C \nANISOU 2857 C ASN B 50 9919 9519 10578 -431 -1031 -232 C \nATOM 2858 O ASN B 50 14.061 -4.269 -9.347 1.00 83.21 O \nANISOU 2858 O ASN B 50 10514 10005 11099 -405 -1048 -235 O \nATOM 2859 CB ASN B 50 15.406 -5.800 -6.936 1.00 87.27 C \nANISOU 2859 CB ASN B 50 11258 10472 11428 -128 -1203 -303 C \nATOM 2860 CG ASN B 50 16.552 -6.297 -6.082 1.00 90.02 C \nANISOU 2860 CG ASN B 50 11632 10915 11658 85 -1265 -366 C \nATOM 2861 OD1 ASN B 50 17.651 -5.741 -6.103 1.00 91.61 O \nANISOU 2861 OD1 ASN B 50 11610 11379 11817 185 -1221 -413 O \nATOM 2862 ND2 ASN B 50 16.299 -7.351 -5.317 1.00 89.21 N \nANISOU 2862 ND2 ASN B 50 11808 10608 11480 145 -1372 -367 N \nATOM 2863 N LYS B 51 13.758 -3.051 -7.482 1.00 72.37 N \nANISOU 2863 N LYS B 51 9008 8649 9839 -619 -970 -179 N \nATOM 2864 CA LYS B 51 12.665 -2.286 -8.035 1.00 71.25 C \nANISOU 2864 CA LYS B 51 8820 8461 9791 -786 -910 -132 C \nATOM 2865 C LYS B 51 13.124 -1.493 -9.236 1.00 80.68 C \nANISOU 2865 C LYS B 51 9874 9786 10995 -777 -857 -147 C \nATOM 2866 O LYS B 51 12.538 -1.591 -10.323 1.00 89.43 O \nANISOU 2866 O LYS B 51 11013 10848 12118 -794 -854 -139 O \nATOM 2867 CB LYS B 51 12.128 -1.325 -7.009 1.00 70.19 C \nANISOU 2867 CB LYS B 51 8612 8325 9732 -932 -858 -93 C \nATOM 2868 CG LYS B 51 10.931 -0.539 -7.486 1.00 69.38 C \nANISOU 2868 CG LYS B 51 8475 8189 9697 -1062 -810 -56 C \nATOM 2869 CD LYS B 51 10.553 0.575 -6.523 1.00 67.45 C \nANISOU 2869 CD LYS B 51 8156 7970 9502 -1157 -764 -33 C \nATOM 2870 CE LYS B 51 9.379 0.152 -5.684 1.00 68.71 C \nANISOU 2870 CE LYS B 51 8380 8066 9663 -1236 -785 -5 C \nATOM 2871 NZ LYS B 51 8.959 1.082 -4.619 1.00 76.38 N \nANISOU 2871 NZ LYS B 51 9288 9071 10660 -1296 -753 9 N \nATOM 2872 N VAL B 52 14.190 -0.727 -9.047 1.00 83.77 N \nANISOU 2872 N VAL B 52 10116 10352 11361 -768 -818 -168 N \nATOM 2873 CA VAL B 52 14.809 -0.002 -10.148 1.00 83.34 C \nANISOU 2873 CA VAL B 52 9932 10458 11277 -785 -776 -182 C \nATOM 2874 C VAL B 52 15.182 -0.939 -11.319 1.00 82.64 C \nANISOU 2874 C VAL B 52 9871 10418 11111 -623 -818 -227 C \nATOM 2875 O VAL B 52 14.923 -0.627 -12.485 1.00 93.75 O \nANISOU 2875 O VAL B 52 11250 11840 12532 -661 -793 -220 O \nATOM 2876 CB VAL B 52 16.074 0.759 -9.670 1.00 81.08 C \nANISOU 2876 CB VAL B 52 9487 10397 10922 -816 -745 -199 C \nATOM 2877 CG1 VAL B 52 16.912 1.238 -10.852 1.00 74.10 C \nANISOU 2877 CG1 VAL B 52 8467 9736 9953 -831 -718 -222 C \nATOM 2878 CG2 VAL B 52 15.673 1.942 -8.801 1.00 82.69 C \nANISOU 2878 CG2 VAL B 52 9680 10542 11195 -999 -702 -151 C \nATOM 2879 N ASN B 53 15.836 -2.053 -11.019 1.00 70.87 N \nANISOU 2879 N ASN B 53 8447 8958 9523 -426 -889 -278 N \nATOM 2880 CA ASN B 53 16.301 -2.937 -12.078 1.00 74.63 C \nANISOU 2880 CA ASN B 53 8964 9497 9895 -228 -943 -335 C \nATOM 2881 C ASN B 53 15.112 -3.574 -12.785 1.00 83.81 C \nANISOU 2881 C ASN B 53 10316 10420 11109 -253 -978 -306 C \nATOM 2882 O ASN B 53 15.072 -3.660 -14.008 1.00 85.93 O \nANISOU 2882 O ASN B 53 10571 10721 11357 -212 -976 -320 O \nATOM 2883 CB ASN B 53 17.269 -4.008 -11.548 1.00 75.56 C \nANISOU 2883 CB ASN B 53 9149 9695 9865 36 -1031 -408 C \nATOM 2884 CG ASN B 53 18.489 -3.410 -10.862 1.00 82.70 C \nANISOU 2884 CG ASN B 53 9840 10888 10695 63 -996 -442 C \nATOM 2885 OD1 ASN B 53 18.945 -2.318 -11.209 1.00 82.39 O \nANISOU 2885 OD1 ASN B 53 9585 11062 10659 -79 -916 -428 O \nATOM 2886 ND2 ASN B 53 19.012 -4.120 -9.869 1.00 84.10 N \nANISOU 2886 ND2 ASN B 53 10093 11074 10789 229 -1062 -484 N \nATOM 2887 N SER B 54 14.135 -4.030 -12.014 1.00 89.55 N \nANISOU 2887 N SER B 54 11215 10924 11887 -337 -1012 -264 N \nATOM 2888 CA SER B 54 12.958 -4.648 -12.609 1.00 89.20 C \nANISOU 2888 CA SER B 54 11347 10678 11865 -404 -1049 -230 C \nATOM 2889 C SER B 54 12.320 -3.713 -13.632 1.00 91.64 C \nANISOU 2889 C SER B 54 11531 11023 12265 -540 -968 -198 C \nATOM 2890 O SER B 54 11.972 -4.131 -14.731 1.00 99.67 O \nANISOU 2890 O SER B 54 12614 11991 13264 -510 -990 -203 O \nATOM 2891 CB SER B 54 11.957 -5.032 -11.524 1.00 93.46 C \nANISOU 2891 CB SER B 54 12038 11039 12433 -545 -1081 -179 C \nATOM 2892 OG SER B 54 12.461 -6.115 -10.742 1.00 86.50 O \nANISOU 2892 OG SER B 54 11349 10075 11443 -412 -1182 -209 O \nATOM 2893 N ILE B 55 12.182 -2.438 -13.277 1.00 92.37 N \nANISOU 2893 N ILE B 55 11463 11192 12442 -680 -885 -168 N \nATOM 2894 CA ILE B 55 11.671 -1.425 -14.212 1.00 86.80 C \nANISOU 2894 CA ILE B 55 10659 10518 11802 -789 -818 -143 C \nATOM 2895 C ILE B 55 12.549 -1.335 -15.451 1.00 95.11 C \nANISOU 2895 C ILE B 55 11627 11712 12800 -699 -808 -181 C \nATOM 2896 O ILE B 55 12.043 -1.332 -16.565 1.00108.47 O \nANISOU 2896 O ILE B 55 13336 13368 14509 -716 -799 -174 O \nATOM 2897 CB ILE B 55 11.609 -0.029 -13.538 1.00 82.84 C \nANISOU 2897 CB ILE B 55 10045 10070 11360 -922 -752 -115 C \nATOM 2898 CG1 ILE B 55 10.468 0.023 -12.511 1.00 82.60 C \nANISOU 2898 CG1 ILE B 55 10078 9923 11383 -1015 -754 -78 C \nATOM 2899 CG2 ILE B 55 11.457 1.114 -14.538 1.00 80.28 C \nANISOU 2899 CG2 ILE B 55 9646 9794 11062 -1006 -699 -102 C \nATOM 2900 CD1 ILE B 55 10.614 1.121 -11.481 1.00 75.84 C \nANISOU 2900 CD1 ILE B 55 9151 9108 10556 -1090 -716 -64 C \nATOM 2901 N ILE B 56 13.861 -1.266 -15.234 1.00100.49 N \nANISOU 2901 N ILE B 56 12202 12579 13400 -608 -808 -223 N \nATOM 2902 CA ILE B 56 14.838 -1.175 -16.321 1.00 99.19 C \nANISOU 2902 CA ILE B 56 11917 12624 13145 -524 -799 -266 C \nATOM 2903 C ILE B 56 14.935 -2.460 -17.151 1.00 97.85 C \nANISOU 2903 C ILE B 56 11857 12424 12896 -316 -871 -315 C \nATOM 2904 O ILE B 56 14.967 -2.391 -18.376 1.00102.20 O \nANISOU 2904 O ILE B 56 12368 13037 13427 -296 -859 -327 O \nATOM 2905 CB ILE B 56 16.255 -0.826 -15.791 1.00100.04 C \nANISOU 2905 CB ILE B 56 11858 13007 13146 -481 -786 -305 C \nATOM 2906 CG1 ILE B 56 16.271 0.588 -15.221 1.00 98.42 C \nANISOU 2906 CG1 ILE B 56 11559 12845 12992 -713 -719 -255 C \nATOM 2907 CG2 ILE B 56 17.308 -0.933 -16.897 1.00 95.87 C \nANISOU 2907 CG2 ILE B 56 11186 12759 12479 -371 -787 -361 C \nATOM 2908 CD1 ILE B 56 17.508 0.922 -14.419 1.00 99.84 C \nANISOU 2908 CD1 ILE B 56 11595 13270 13069 -718 -710 -280 C \nATOM 2909 N ASP B 57 15.033 -3.607 -16.488 1.00 98.22 N \nANISOU 2909 N ASP B 57 12062 12375 12883 -157 -955 -345 N \nATOM 2910 CA ASP B 57 15.272 -4.896 -17.170 1.00106.07 C \nANISOU 2910 CA ASP B 57 13215 13327 13759 81 -1051 -402 C \nATOM 2911 C ASP B 57 14.069 -5.411 -17.970 1.00101.96 C \nANISOU 2911 C ASP B 57 12882 12568 13291 15 -1081 -365 C \nATOM 2912 O ASP B 57 14.230 -5.912 -19.081 1.00104.31 O \nANISOU 2912 O ASP B 57 13225 12887 13520 144 -1117 -402 O \nATOM 2913 CB ASP B 57 15.716 -5.976 -16.170 1.00113.19 C \nANISOU 2913 CB ASP B 57 14293 14160 14553 275 -1154 -446 C \nATOM 2914 CG ASP B 57 17.006 -5.628 -15.466 1.00114.08 C \nANISOU 2914 CG ASP B 57 14216 14548 14579 386 -1136 -498 C \nATOM 2915 OD1 ASP B 57 17.865 -4.968 -16.088 1.00119.04 O \nANISOU 2915 OD1 ASP B 57 14601 15477 15152 408 -1080 -531 O \nATOM 2916 OD2 ASP B 57 17.140 -6.001 -14.282 1.00113.72 O \nANISOU 2916 OD2 ASP B 57 14264 14432 14511 430 -1180 -503 O \nATOM 2917 N LYS B 58 12.872 -5.295 -17.407 1.00100.64 N \nANISOU 2917 N LYS B 58 12812 12201 13227 -185 -1067 -296 N \nATOM 2918 CA LYS B 58 11.639 -5.658 -18.135 1.00102.71 C \nANISOU 2918 CA LYS B 58 13216 12282 13529 -296 -1085 -254 C \nATOM 2919 C LYS B 58 11.509 -4.947 -19.474 1.00111.24 C \nANISOU 2919 C LYS B 58 14153 13455 14659 -336 -1017 -251 C \nATOM 2920 O LYS B 58 10.844 -5.435 -20.387 1.00115.64 O \nANISOU 2920 O LYS B 58 14821 13908 15209 -348 -1046 -240 O \nATOM 2921 CB LYS B 58 10.404 -5.362 -17.295 1.00 99.74 C \nANISOU 2921 CB LYS B 58 12878 11779 13240 -527 -1058 -183 C \nATOM 2922 CG LYS B 58 10.248 -6.308 -16.121 1.00102.72 C \nANISOU 2922 CG LYS B 58 13462 12017 13550 -528 -1144 -174 C \nATOM 2923 CD LYS B 58 9.603 -7.623 -16.559 1.00108.12 C \nANISOU 2923 CD LYS B 58 14448 12501 14132 -532 -1256 -163 C \nATOM 2924 CE LYS B 58 10.006 -8.790 -15.663 1.00104.24 C \nANISOU 2924 CE LYS B 58 14232 11867 13505 -429 -1383 -183 C \nATOM 2925 NZ LYS B 58 11.283 -9.420 -16.112 1.00102.02 N \nANISOU 2925 NZ LYS B 58 14033 11625 13102 -106 -1459 -270 N \nATOM 2926 N MET B 59 12.189 -3.817 -19.600 1.00111.88 N \nANISOU 2926 N MET B 59 14005 13733 14773 -367 -936 -259 N \nATOM 2927 CA MET B 59 12.190 -3.079 -20.836 1.00117.65 C \nANISOU 2927 CA MET B 59 14610 14561 15532 -417 -877 -256 C \nATOM 2928 C MET B 59 12.933 -3.797 -21.971 1.00119.25 C \nANISOU 2928 C MET B 59 14821 14864 15624 -220 -922 -316 C \nATOM 2929 O MET B 59 12.908 -3.312 -23.095 1.00118.27 O \nANISOU 2929 O MET B 59 14608 14816 15513 -257 -881 -315 O \nATOM 2930 CB MET B 59 12.774 -1.676 -20.622 1.00126.47 C \nANISOU 2930 CB MET B 59 15522 15853 16676 -535 -795 -243 C \nATOM 2931 CG MET B 59 12.200 -0.642 -21.571 1.00134.19 C \nANISOU 2931 CG MET B 59 16440 16828 17718 -682 -734 -208 C \nATOM 2932 SD MET B 59 10.425 -0.417 -21.303 1.00148.53 S \nANISOU 2932 SD MET B 59 18371 18410 19652 -818 -723 -149 S \nATOM 2933 CE MET B 59 9.787 -1.400 -22.668 1.00152.07 C \nANISOU 2933 CE MET B 59 18924 18770 20087 -749 -761 -158 C \nATOM 2934 N ASN B 60 13.546 -4.953 -21.695 1.00124.29 N \nANISOU 2934 N ASN B 60 15585 15498 16142 1 -1014 -373 N \nATOM 2935 CA ASN B 60 14.276 -5.770 -22.708 1.00137.08 C \nANISOU 2935 CA ASN B 60 17243 17219 17622 250 -1078 -447 C \nATOM 2936 C ASN B 60 13.661 -5.875 -24.131 1.00141.67 C \nANISOU 2936 C ASN B 60 17867 17732 18227 226 -1073 -435 C \nATOM 2937 O ASN B 60 14.266 -6.479 -25.040 1.00133.99 O \nANISOU 2937 O ASN B 60 16914 16860 17135 438 -1124 -499 O \nATOM 2938 CB ASN B 60 14.446 -7.208 -22.162 1.00144.94 C \nANISOU 2938 CB ASN B 60 18516 18064 18490 478 -1214 -494 C \nATOM 2939 CG ASN B 60 15.768 -7.431 -21.449 1.00148.59 C \nANISOU 2939 CG ASN B 60 18898 18746 18814 708 -1252 -571 C \nATOM 2940 OD1 ASN B 60 16.801 -6.850 -21.802 1.00151.06 O \nANISOU 2940 OD1 ASN B 60 18948 19390 19058 784 -1200 -618 O \nATOM 2941 ND2 ASN B 60 15.752 -8.314 -20.456 1.00150.01 N \nANISOU 2941 ND2 ASN B 60 19312 18759 18927 817 -1349 -586 N \nATOM 2942 N THR B 61 12.475 -5.286 -24.312 1.00142.65 N \nANISOU 2942 N THR B 61 18000 17707 18492 -13 -1016 -361 N \nATOM 2943 CA THR B 61 11.678 -5.433 -25.537 1.00149.85 C \nANISOU 2943 CA THR B 61 18979 18520 19439 -60 -1015 -341 C \nATOM 2944 C THR B 61 12.335 -4.945 -26.842 1.00162.71 C \nANISOU 2944 C THR B 61 20436 20355 21032 1 -971 -375 C \nATOM 2945 O THR B 61 12.462 -5.724 -27.791 1.00175.62 O \nANISOU 2945 O THR B 61 22161 21978 22586 156 -1028 -415 O \nATOM 2946 CB THR B 61 10.300 -4.756 -25.384 1.00141.18 C \nANISOU 2946 CB THR B 61 17883 17281 18480 -317 -957 -262 C \nATOM 2947 OG1 THR B 61 10.467 -3.367 -25.083 1.00134.67 O \nANISOU 2947 OG1 THR B 61 16854 16582 17732 -448 -863 -238 O \nATOM 2948 CG2 THR B 61 9.495 -5.414 -24.282 1.00132.67 C \nANISOU 2948 CG2 THR B 61 16986 16015 17406 -396 -1010 -226 C \nATOM 2949 N GLN B 62 12.715 -3.665 -26.893 1.00166.71 N \nANISOU 2949 N GLN B 62 20718 21040 21583 -134 -879 -357 N \nATOM 2950 CA GLN B 62 13.312 -3.047 -28.101 1.00160.50 C \nANISOU 2950 CA GLN B 62 19762 20467 20752 -140 -832 -377 C \nATOM 2951 C GLN B 62 14.589 -3.748 -28.637 1.00149.69 C \nANISOU 2951 C GLN B 62 18317 19354 19205 116 -880 -465 C \nATOM 2952 O GLN B 62 15.460 -4.160 -27.859 1.00143.95 O \nANISOU 2952 O GLN B 62 17558 18762 18373 267 -919 -515 O \nATOM 2953 CB GLN B 62 13.562 -1.532 -27.900 1.00162.16 C \nANISOU 2953 CB GLN B 62 19794 20814 21005 -364 -743 -336 C \nATOM 2954 CG GLN B 62 14.714 -1.138 -26.981 1.00164.99 C \nANISOU 2954 CG GLN B 62 20009 21401 21277 -366 -729 -358 C \nATOM 2955 CD GLN B 62 14.457 -1.471 -25.523 1.00176.48 C \nANISOU 2955 CD GLN B 62 21559 22712 22781 -349 -756 -346 C \nATOM 2956 OE1 GLN B 62 13.387 -1.956 -25.163 1.00176.66 O \nANISOU 2956 OE1 GLN B 62 21753 22472 22896 -359 -784 -316 O \nATOM 2957 NE2 GLN B 62 15.445 -1.221 -24.674 1.00195.70 N \nANISOU 2957 NE2 GLN B 62 23876 25342 25138 -335 -750 -369 N \nATOM 2958 N PHE B 63 14.651 -3.916 -29.963 1.00141.25 N \nANISOU 2958 N PHE B 63 17223 18357 18090 183 -883 -489 N \nATOM 2959 CA PHE B 63 15.872 -4.347 -30.672 1.00148.24 C \nANISOU 2959 CA PHE B 63 17979 19559 18786 415 -915 -578 C \nATOM 2960 C PHE B 63 16.106 -3.603 -32.008 1.00140.16 C \nANISOU 2960 C PHE B 63 16778 18739 17736 311 -852 -573 C \nATOM 2961 O PHE B 63 17.130 -2.947 -32.201 1.00126.47 O \nANISOU 2961 O PHE B 63 14805 17363 15886 264 -808 -597 O \nATOM 2962 CB PHE B 63 15.837 -5.852 -30.986 1.00153.49 C \nANISOU 2962 CB PHE B 63 18871 20098 19349 728 -1034 -645 C \nATOM 2963 CG PHE B 63 15.568 -6.743 -29.800 1.00156.68 C \nANISOU 2963 CG PHE B 63 19517 20267 19748 835 -1121 -650 C \nATOM 2964 CD1 PHE B 63 16.595 -7.105 -28.925 1.00151.18 C \nANISOU 2964 CD1 PHE B 63 18777 19751 18912 1038 -1169 -717 C \nATOM 2965 CD2 PHE B 63 14.298 -7.261 -29.586 1.00156.27 C \nANISOU 2965 CD2 PHE B 63 19738 19833 19803 731 -1163 -591 C \nATOM 2966 CE1 PHE B 63 16.353 -7.939 -27.843 1.00147.02 C \nANISOU 2966 CE1 PHE B 63 18500 18992 18368 1135 -1258 -722 C \nATOM 2967 CE2 PHE B 63 14.050 -8.095 -28.503 1.00159.63 C \nANISOU 2967 CE2 PHE B 63 20406 20047 20200 795 -1250 -590 C \nATOM 2968 CZ PHE B 63 15.079 -8.433 -27.631 1.00151.50 C \nANISOU 2968 CZ PHE B 63 19355 19163 19043 1001 -1300 -655 C \nATOM 2969 N GLU B 64 15.139 -3.720 -32.921 1.00141.10 N \nANISOU 2969 N GLU B 64 17020 18642 17951 258 -851 -539 N \nATOM 2970 CA GLU B 64 15.245 -3.167 -34.281 1.00136.96 C \nANISOU 2970 CA GLU B 64 16371 18266 17403 180 -804 -536 C \nATOM 2971 C GLU B 64 14.833 -1.711 -34.256 1.00130.56 C \nANISOU 2971 C GLU B 64 15477 17428 16701 -151 -714 -454 C \nATOM 2972 O GLU B 64 14.141 -1.303 -33.334 1.00145.37 O \nANISOU 2972 O GLU B 64 17441 19097 18698 -287 -697 -400 O \nATOM 2973 CB GLU B 64 14.309 -3.899 -35.257 1.00136.37 C \nANISOU 2973 CB GLU B 64 16482 17947 17385 259 -845 -532 C \nATOM 2974 CG GLU B 64 14.751 -5.303 -35.659 1.00142.33 C \nANISOU 2974 CG GLU B 64 17358 18728 17993 600 -949 -619 C \nATOM 2975 CD GLU B 64 15.993 -5.334 -36.560 1.00143.58 C \nANISOU 2975 CD GLU B 64 17303 19295 17957 779 -951 -703 C \nATOM 2976 OE1 GLU B 64 15.923 -4.970 -37.765 1.00138.82 O \nANISOU 2976 OE1 GLU B 64 16611 18783 17350 715 -913 -696 O \nATOM 2977 OE2 GLU B 64 17.063 -5.744 -36.057 1.00146.01 O \nANISOU 2977 OE2 GLU B 64 17521 19860 18095 996 -994 -780 O \nATOM 2978 N ALA B 65 15.207 -0.946 -35.282 1.00112.18 N \nANISOU 2978 N ALA B 65 13009 15297 14317 -275 -667 -446 N \nATOM 2979 CA ALA B 65 14.779 0.449 -35.393 1.00102.36 C \nANISOU 2979 CA ALA B 65 11751 13991 13151 -583 -603 -369 C \nATOM 2980 C ALA B 65 14.625 0.849 -36.860 1.00 99.78 C \nANISOU 2980 C ALA B 65 11393 13716 12803 -664 -579 -358 C \nATOM 2981 O ALA B 65 15.355 0.334 -37.712 1.00105.79 O \nANISOU 2981 O ALA B 65 12038 14721 13434 -530 -593 -414 O \nATOM 2982 CB ALA B 65 15.755 1.363 -34.666 1.00 93.85 C \nANISOU 2982 CB ALA B 65 10526 13163 11972 -754 -572 -357 C \nATOM 2983 N VAL B 66 13.649 1.714 -37.172 1.00 91.56 N \nANISOU 2983 N VAL B 66 10462 12448 11878 -855 -550 -293 N \nATOM 2984 CA VAL B 66 13.402 2.130 -38.579 1.00 92.46 C \nANISOU 2984 CA VAL B 66 10573 12577 11980 -937 -531 -278 C \nATOM 2985 C VAL B 66 12.560 3.421 -38.626 1.00 90.61 C \nANISOU 2985 C VAL B 66 10464 12136 11828 -1174 -505 -207 C \nATOM 2986 O VAL B 66 11.826 3.708 -37.681 1.00 87.82 O \nANISOU 2986 O VAL B 66 10224 11567 11575 -1206 -509 -177 O \nATOM 2987 CB VAL B 66 12.828 0.954 -39.478 1.00 85.72 C \nANISOU 2987 CB VAL B 66 9787 11611 11171 -716 -563 -315 C \nATOM 2988 CG1 VAL B 66 12.185 -0.168 -38.635 1.00 81.17 C \nANISOU 2988 CG1 VAL B 66 9351 10812 10680 -536 -612 -331 C \nATOM 2989 CG2 VAL B 66 11.824 1.474 -40.508 1.00 82.59 C \nANISOU 2989 CG2 VAL B 66 9485 11032 10863 -824 -543 -273 C \nATOM 2990 N GLY B 67 12.749 4.214 -39.693 1.00 93.25 N \nANISOU 2990 N GLY B 67 10781 12558 12093 -1332 -487 -185 N \nATOM 2991 CA GLY B 67 11.853 5.324 -40.065 1.00 89.04 C \nANISOU 2991 CA GLY B 67 10414 11802 11617 -1503 -482 -129 C \nATOM 2992 C GLY B 67 10.801 4.832 -41.042 1.00 85.97 C \nANISOU 2992 C GLY B 67 10102 11234 11330 -1382 -486 -135 C \nATOM 2993 O GLY B 67 9.939 4.075 -40.627 1.00 85.11 O \nANISOU 2993 O GLY B 67 10053 10948 11337 -1231 -498 -146 O \nATOM 2994 N ARG B 68 10.882 5.279 -42.314 1.00 83.64 N \nANISOU 2994 N ARG B 68 9805 10997 10976 -1472 -478 -125 N \nATOM 2995 CA ARG B 68 10.175 4.710 -43.526 1.00 71.04 C \nANISOU 2995 CA ARG B 68 8236 9314 9441 -1357 -479 -140 C \nATOM 2996 C ARG B 68 9.808 5.788 -44.556 1.00 70.84 C \nANISOU 2996 C ARG B 68 8313 9219 9385 -1522 -475 -103 C \nATOM 2997 O ARG B 68 9.548 6.939 -44.195 1.00 80.30 O \nANISOU 2997 O ARG B 68 9648 10298 10562 -1681 -487 -63 O \nATOM 2998 CB ARG B 68 8.950 3.901 -43.183 1.00 73.05 C \nANISOU 2998 CB ARG B 68 8584 9329 9844 -1189 -493 -147 C \nATOM 2999 CG ARG B 68 8.480 2.946 -44.284 1.00 77.98 C \nANISOU 2999 CG ARG B 68 9208 9917 10504 -1047 -501 -173 C \nATOM 3000 CD ARG B 68 8.213 1.531 -43.754 1.00 74.19 C \nANISOU 3000 CD ARG B 68 8749 9371 10071 -856 -533 -204 C \nATOM 3001 NE ARG B 68 7.644 1.585 -42.416 1.00 80.30 N \nANISOU 3001 NE ARG B 68 9589 10008 10913 -873 -541 -184 N \nATOM 3002 CZ ARG B 68 8.042 0.833 -41.392 1.00 93.23 C \nANISOU 3002 CZ ARG B 68 11218 11666 12538 -784 -566 -205 C \nATOM 3003 NH1 ARG B 68 9.007 -0.066 -41.562 1.00102.62 N \nANISOU 3003 NH1 ARG B 68 12347 13004 13640 -640 -594 -253 N \nATOM 3004 NH2 ARG B 68 7.474 0.989 -40.207 1.00 84.68 N \nANISOU 3004 NH2 ARG B 68 10193 10466 11516 -823 -568 -182 N \nATOM 3005 N GLU B 69 9.797 5.420 -45.840 1.00 64.11 N \nANISOU 3005 N GLU B 69 7415 8430 8514 -1477 -469 -118 N \nATOM 3006 CA GLU B 69 9.760 6.397 -46.928 1.00 63.27 C \nANISOU 3006 CA GLU B 69 7382 8321 8337 -1652 -468 -87 C \nATOM 3007 C GLU B 69 8.646 6.139 -47.935 1.00 59.87 C \nANISOU 3007 C GLU B 69 7038 7706 8004 -1547 -471 -90 C \nATOM 3008 O GLU B 69 8.479 5.027 -48.397 1.00 62.48 O \nANISOU 3008 O GLU B 69 7290 8064 8387 -1372 -466 -125 O \nATOM 3009 CB GLU B 69 11.109 6.397 -47.633 1.00 72.77 C \nANISOU 3009 CB GLU B 69 8410 9874 9366 -1759 -455 -100 C \nATOM 3010 CG GLU B 69 11.473 7.678 -48.385 1.00 79.80 C \nANISOU 3010 CG GLU B 69 9382 10826 10113 -2054 -463 -52 C \nATOM 3011 CD GLU B 69 12.952 8.073 -48.241 1.00 85.01 C \nANISOU 3011 CD GLU B 69 9883 11863 10553 -2275 -456 -45 C \nATOM 3012 OE1 GLU B 69 13.728 7.359 -47.546 1.00 80.19 O \nANISOU 3012 OE1 GLU B 69 9078 11487 9902 -2168 -442 -86 O \nATOM 3013 OE2 GLU B 69 13.351 9.103 -48.842 1.00 93.98 O \nANISOU 3013 OE2 GLU B 69 11094 13080 11533 -2566 -470 2 O \nATOM 3014 N PHE B 70 7.927 7.194 -48.324 1.00 59.85 N \nANISOU 3014 N PHE B 70 7213 7524 8003 -1655 -487 -55 N \nATOM 3015 CA PHE B 70 6.715 7.098 -49.151 1.00 53.11 C \nANISOU 3015 CA PHE B 70 6455 6486 7237 -1553 -493 -58 C \nATOM 3016 C PHE B 70 6.644 8.196 -50.168 1.00 50.44 C \nANISOU 3016 C PHE B 70 6256 6098 6812 -1706 -512 -30 C \nATOM 3017 O PHE B 70 7.106 9.268 -49.911 1.00 64.43 O \nANISOU 3017 O PHE B 70 8144 7864 8473 -1894 -537 2 O \nATOM 3018 CB PHE B 70 5.475 7.206 -48.279 1.00 53.80 C \nANISOU 3018 CB PHE B 70 6659 6355 7427 -1447 -509 -58 C \nATOM 3019 CG PHE B 70 5.365 6.119 -47.229 1.00 50.17 C \nANISOU 3019 CG PHE B 70 6099 5911 7051 -1314 -498 -79 C \nATOM 3020 CD1 PHE B 70 5.665 6.385 -45.945 1.00 46.68 C \nANISOU 3020 CD1 PHE B 70 5665 5469 6602 -1348 -504 -72 C \nATOM 3021 CD2 PHE B 70 5.020 4.829 -47.589 1.00 45.99 C \nANISOU 3021 CD2 PHE B 70 5492 5394 6590 -1170 -492 -105 C \nATOM 3022 CE1 PHE B 70 5.581 5.395 -44.999 1.00 46.28 C \nANISOU 3022 CE1 PHE B 70 5540 5427 6616 -1237 -501 -90 C \nATOM 3023 CE2 PHE B 70 4.979 3.822 -46.685 1.00 43.67 C \nANISOU 3023 CE2 PHE B 70 5150 5101 6343 -1071 -498 -121 C \nATOM 3024 CZ PHE B 70 5.252 4.105 -45.363 1.00 45.50 C \nANISOU 3024 CZ PHE B 70 5384 5332 6573 -1103 -501 -113 C \nATOM 3025 N ASN B 71 6.025 7.944 -51.311 1.00 47.65 N \nANISOU 3025 N ASN B 71 5917 5690 6498 -1633 -507 -39 N \nATOM 3026 CA ASN B 71 5.936 8.930 -52.354 1.00 48.28 C \nANISOU 3026 CA ASN B 71 6142 5713 6489 -1769 -531 -14 C \nATOM 3027 C ASN B 71 4.694 9.834 -52.200 1.00 47.27 C \nANISOU 3027 C ASN B 71 6262 5316 6384 -1719 -576 -5 C \nATOM 3028 O ASN B 71 4.124 9.924 -51.144 1.00 54.32 O \nANISOU 3028 O ASN B 71 7207 6105 7327 -1628 -589 -13 O \nATOM 3029 CB ASN B 71 6.031 8.271 -53.745 1.00 49.15 C \nANISOU 3029 CB ASN B 71 6141 5929 6605 -1724 -506 -30 C \nATOM 3030 CG ASN B 71 4.756 7.632 -54.186 1.00 50.04 C \nANISOU 3030 CG ASN B 71 6274 5890 6851 -1523 -502 -53 C \nATOM 3031 OD1 ASN B 71 3.714 7.776 -53.557 1.00 66.48 O \nANISOU 3031 OD1 ASN B 71 8452 7804 9005 -1425 -518 -57 O \nATOM 3032 ND2 ASN B 71 4.827 6.896 -55.242 1.00 52.51 N \nANISOU 3032 ND2 ASN B 71 6486 6286 7180 -1461 -482 -71 N \nATOM 3033 N ASN B 72 4.342 10.560 -53.227 1.00 48.16 N \nANISOU 3033 N ASN B 72 6532 5334 6433 -1774 -606 7 N \nATOM 3034 CA ASN B 72 3.317 11.556 -53.126 1.00 51.60 C \nANISOU 3034 CA ASN B 72 7232 5536 6838 -1715 -667 7 C \nATOM 3035 C ASN B 72 1.916 10.948 -53.267 1.00 51.80 C \nANISOU 3035 C ASN B 72 7211 5482 6987 -1457 -655 -33 C \nATOM 3036 O ASN B 72 0.962 11.535 -52.785 1.00 53.02 O \nANISOU 3036 O ASN B 72 7518 5499 7127 -1334 -698 -51 O \nATOM 3037 CB ASN B 72 3.522 12.594 -54.210 1.00 55.67 C \nANISOU 3037 CB ASN B 72 7968 5975 7208 -1879 -718 35 C \nATOM 3038 CG ASN B 72 2.826 13.884 -53.909 1.00 60.21 C \nANISOU 3038 CG ASN B 72 8897 6302 7679 -1856 -811 37 C \nATOM 3039 OD1 ASN B 72 2.742 14.302 -52.742 1.00 68.46 O \nANISOU 3039 OD1 ASN B 72 10042 7269 8702 -1829 -844 35 O \nATOM 3040 ND2 ASN B 72 2.374 14.573 -54.955 1.00 59.49 N \nANISOU 3040 ND2 ASN B 72 9023 6079 7503 -1862 -865 40 N \nATOM 3041 N LEU B 73 1.794 9.817 -53.975 1.00 49.39 N \nANISOU 3041 N LEU B 73 6709 5280 6776 -1380 -604 -48 N \nATOM 3042 CA LEU B 73 0.562 9.092 -54.084 1.00 44.71 C \nANISOU 3042 CA LEU B 73 6048 4656 6285 -1185 -589 -79 C \nATOM 3043 C LEU B 73 0.438 7.958 -53.093 1.00 42.70 C \nANISOU 3043 C LEU B 73 5623 4475 6127 -1102 -556 -92 C \nATOM 3044 O LEU B 73 -0.359 7.052 -53.313 1.00 47.11 O \nANISOU 3044 O LEU B 73 6092 5053 6756 -995 -539 -108 O \nATOM 3045 CB LEU B 73 0.358 8.595 -55.499 1.00 42.88 C \nANISOU 3045 CB LEU B 73 5758 4457 6076 -1162 -570 -84 C \nATOM 3046 CG LEU B 73 0.157 9.719 -56.448 1.00 44.95 C \nANISOU 3046 CG LEU B 73 6219 4617 6243 -1213 -612 -75 C \nATOM 3047 CD1 LEU B 73 -0.026 9.179 -57.862 1.00 43.26 C \nANISOU 3047 CD1 LEU B 73 5933 4446 6060 -1190 -588 -81 C \nATOM 3048 CD2 LEU B 73 -1.025 10.636 -56.020 1.00 47.87 C \nANISOU 3048 CD2 LEU B 73 6786 4836 6566 -1077 -670 -98 C \nATOM 3049 N GLU B 74 1.179 8.068 -51.994 1.00 45.15 N \nANISOU 3049 N GLU B 74 5914 4818 6422 -1167 -556 -81 N \nATOM 3050 CA GLU B 74 1.090 7.117 -50.862 1.00 42.72 C \nANISOU 3050 CA GLU B 74 5483 4558 6190 -1097 -536 -91 C \nATOM 3051 C GLU B 74 0.923 7.867 -49.555 1.00 43.41 C \nANISOU 3051 C GLU B 74 5657 4586 6250 -1099 -560 -89 C \nATOM 3052 O GLU B 74 1.482 7.487 -48.550 1.00 42.94 O \nANISOU 3052 O GLU B 74 5526 4577 6212 -1123 -549 -85 O \nATOM 3053 CB GLU B 74 2.339 6.242 -50.800 1.00 42.75 C \nANISOU 3053 CB GLU B 74 5344 4698 6200 -1147 -510 -90 C \nATOM 3054 CG GLU B 74 2.561 5.389 -52.071 1.00 42.78 C \nANISOU 3054 CG GLU B 74 5263 4776 6217 -1112 -493 -102 C \nATOM 3055 CD GLU B 74 3.851 4.584 -51.982 1.00 44.59 C \nANISOU 3055 CD GLU B 74 5358 5172 6414 -1115 -480 -115 C \nATOM 3056 OE1 GLU B 74 4.896 5.200 -51.688 1.00 46.47 O \nANISOU 3056 OE1 GLU B 74 5568 5520 6569 -1230 -477 -106 O \nATOM 3057 OE2 GLU B 74 3.822 3.348 -52.241 1.00 40.17 O \nANISOU 3057 OE2 GLU B 74 4732 4643 5887 -999 -482 -139 O \nATOM 3058 N ARG B 75 0.060 8.878 -49.546 1.00 43.13 N \nANISOU 3058 N ARG B 75 5782 4443 6162 -1041 -601 -98 N \nATOM 3059 CA ARG B 75 -0.208 9.651 -48.346 1.00 42.90 C \nANISOU 3059 CA ARG B 75 5862 4349 6088 -1007 -636 -105 C \nATOM 3060 C ARG B 75 -1.066 8.900 -47.301 1.00 40.36 C \nANISOU 3060 C ARG B 75 5416 4086 5831 -884 -620 -126 C \nATOM 3061 O ARG B 75 -0.943 9.127 -46.104 1.00 39.02 O \nANISOU 3061 O ARG B 75 5262 3912 5653 -881 -630 -127 O \nATOM 3062 CB ARG B 75 -0.855 10.981 -48.737 1.00 46.85 C \nANISOU 3062 CB ARG B 75 6609 4715 6475 -946 -703 -119 C \nATOM 3063 CG ARG B 75 0.001 11.836 -49.654 1.00 48.10 C \nANISOU 3063 CG ARG B 75 6942 4798 6537 -1112 -735 -89 C \nATOM 3064 CD ARG B 75 1.350 12.005 -49.016 1.00 56.81 C \nANISOU 3064 CD ARG B 75 8037 5944 7604 -1315 -728 -52 C \nATOM 3065 NE ARG B 75 2.188 12.995 -49.664 1.00 69.04 N \nANISOU 3065 NE ARG B 75 9783 7437 9011 -1527 -773 -16 N \nATOM 3066 CZ ARG B 75 3.493 13.147 -49.394 1.00 80.78 C \nANISOU 3066 CZ ARG B 75 11241 9022 10431 -1760 -764 22 C \nATOM 3067 NH1 ARG B 75 4.093 12.349 -48.508 1.00 85.19 N \nANISOU 3067 NH1 ARG B 75 11578 9728 11063 -1769 -711 21 N \nATOM 3068 NH2 ARG B 75 4.212 14.082 -50.020 1.00 77.42 N \nANISOU 3068 NH2 ARG B 75 11008 8565 9843 -1996 -811 62 N \nATOM 3069 N ARG B 76 -1.921 7.994 -47.748 1.00 40.97 N \nANISOU 3069 N ARG B 76 5375 4230 5961 -805 -597 -141 N \nATOM 3070 CA ARG B 76 -2.731 7.194 -46.749 1.00 40.00 C \nANISOU 3070 CA ARG B 76 5132 4193 5873 -739 -585 -153 C \nATOM 3071 C ARG B 76 -1.869 6.282 -45.962 1.00 36.20 C \nANISOU 3071 C ARG B 76 4558 3744 5454 -821 -560 -132 C \nATOM 3072 O ARG B 76 -1.824 6.344 -44.737 1.00 32.64 O \nANISOU 3072 O ARG B 76 4094 3305 5001 -819 -565 -132 O \nATOM 3073 CB ARG B 76 -3.787 6.391 -47.470 1.00 37.81 C \nANISOU 3073 CB ARG B 76 4763 3995 5609 -688 -572 -164 C \nATOM 3074 CG ARG B 76 -4.860 7.237 -48.148 1.00 37.48 C \nANISOU 3074 CG ARG B 76 4791 3964 5488 -565 -600 -198 C \nATOM 3075 CD ARG B 76 -5.725 6.388 -49.032 1.00 36.11 C \nANISOU 3075 CD ARG B 76 4514 3883 5324 -550 -583 -203 C \nATOM 3076 NE ARG B 76 -4.910 5.835 -50.094 1.00 38.47 N \nANISOU 3076 NE ARG B 76 4813 4117 5687 -639 -562 -177 N \nATOM 3077 CZ ARG B 76 -5.228 4.728 -50.737 1.00 42.96 C \nANISOU 3077 CZ ARG B 76 5298 4735 6288 -676 -545 -167 C \nATOM 3078 NH1 ARG B 76 -6.331 4.032 -50.397 1.00 47.66 N \nANISOU 3078 NH1 ARG B 76 5805 5452 6853 -673 -546 -173 N \nATOM 3079 NH2 ARG B 76 -4.485 4.315 -51.708 1.00 43.40 N \nANISOU 3079 NH2 ARG B 76 5365 4737 6386 -725 -533 -153 N \nATOM 3080 N ILE B 77 -1.032 5.535 -46.689 1.00 37.08 N \nANISOU 3080 N ILE B 77 4618 3868 5604 -882 -540 -118 N \nATOM 3081 CA ILE B 77 -0.031 4.669 -46.031 1.00 39.07 C \nANISOU 3081 CA ILE B 77 4798 4157 5890 -928 -529 -108 C \nATOM 3082 C ILE B 77 0.907 5.449 -45.154 1.00 37.94 C \nANISOU 3082 C ILE B 77 4686 4010 5718 -987 -532 -100 C \nATOM 3083 O ILE B 77 1.261 5.018 -44.042 1.00 47.77 O \nANISOU 3083 O ILE B 77 5888 5281 6981 -992 -530 -98 O \nATOM 3084 CB ILE B 77 0.798 3.921 -47.104 1.00 46.75 C \nANISOU 3084 CB ILE B 77 5725 5167 6870 -943 -518 -109 C \nATOM 3085 CG1 ILE B 77 -0.066 2.991 -47.921 1.00 47.63 C \nANISOU 3085 CG1 ILE B 77 5822 5269 7006 -895 -522 -114 C \nATOM 3086 CG2 ILE B 77 1.850 3.037 -46.440 1.00 56.98 C \nANISOU 3086 CG2 ILE B 77 6959 6522 8171 -940 -519 -113 C \nATOM 3087 CD1 ILE B 77 -0.897 2.055 -47.054 1.00 48.16 C \nANISOU 3087 CD1 ILE B 77 5875 5334 7087 -882 -537 -110 C \nATOM 3088 N GLU B 78 1.366 6.591 -45.624 1.00 38.79 N \nANISOU 3088 N GLU B 78 4886 4087 5766 -1051 -542 -92 N \nATOM 3089 CA GLU B 78 2.335 7.384 -44.846 1.00 43.94 C \nANISOU 3089 CA GLU B 78 5588 4742 6363 -1151 -552 -77 C \nATOM 3090 C GLU B 78 1.744 7.861 -43.557 1.00 42.56 C \nANISOU 3090 C GLU B 78 5476 4508 6186 -1103 -573 -82 C \nATOM 3091 O GLU B 78 2.366 7.827 -42.521 1.00 55.79 O \nANISOU 3091 O GLU B 78 7123 6212 7862 -1146 -570 -75 O \nATOM 3092 CB GLU B 78 2.786 8.561 -45.714 1.00 53.36 C \nANISOU 3092 CB GLU B 78 6919 5895 7461 -1263 -575 -61 C \nATOM 3093 CG GLU B 78 3.810 9.477 -45.054 1.00 65.60 C \nANISOU 3093 CG GLU B 78 8554 7453 8916 -1422 -596 -36 C \nATOM 3094 CD GLU B 78 4.188 10.641 -45.952 1.00 76.54 C \nANISOU 3094 CD GLU B 78 10121 8785 10175 -1574 -634 -12 C \nATOM 3095 OE1 GLU B 78 5.398 10.870 -46.167 1.00 96.28 O \nANISOU 3095 OE1 GLU B 78 12591 11406 12586 -1766 -628 14 O \nATOM 3096 OE2 GLU B 78 3.277 11.332 -46.467 1.00 79.47 O \nANISOU 3096 OE2 GLU B 78 10670 9009 10514 -1507 -675 -20 O \nATOM 3097 N ASN B 79 0.502 8.273 -43.620 1.00 46.13 N \nANISOU 3097 N ASN B 79 6000 4900 6625 -996 -595 -101 N \nATOM 3098 CA ASN B 79 -0.208 8.779 -42.458 1.00 52.11 C \nANISOU 3098 CA ASN B 79 6813 5630 7355 -914 -621 -117 C \nATOM 3099 C ASN B 79 -0.435 7.615 -41.515 1.00 48.89 C \nANISOU 3099 C ASN B 79 6246 5310 7020 -890 -592 -118 C \nATOM 3100 O ASN B 79 -0.355 7.777 -40.292 1.00 41.92 O \nANISOU 3100 O ASN B 79 5364 4432 6132 -886 -599 -119 O \nATOM 3101 CB ASN B 79 -1.556 9.392 -42.876 1.00 55.19 C \nANISOU 3101 CB ASN B 79 7289 5994 7685 -764 -655 -151 C \nATOM 3102 CG ASN B 79 -2.201 10.173 -41.764 1.00 62.44 C \nANISOU 3102 CG ASN B 79 8297 6897 8531 -649 -698 -179 C \nATOM 3103 OD1 ASN B 79 -3.244 9.803 -41.292 1.00 63.10 O \nANISOU 3103 OD1 ASN B 79 8280 7086 8607 -532 -694 -208 O \nATOM 3104 ND2 ASN B 79 -1.568 11.271 -41.339 1.00 70.89 N \nANISOU 3104 ND2 ASN B 79 9562 7847 9525 -691 -744 -172 N \nATOM 3105 N LEU B 80 -0.772 6.457 -42.099 1.00 44.48 N \nANISOU 3105 N LEU B 80 5576 4809 6514 -881 -568 -117 N \nATOM 3106 CA LEU B 80 -0.932 5.217 -41.322 1.00 44.89 C \nANISOU 3106 CA LEU B 80 5521 4922 6613 -890 -555 -112 C \nATOM 3107 C LEU B 80 0.343 4.889 -40.576 1.00 42.77 C \nANISOU 3107 C LEU B 80 5230 4652 6369 -951 -548 -98 C \nATOM 3108 O LEU B 80 0.332 4.624 -39.370 1.00 40.42 O \nANISOU 3108 O LEU B 80 4907 4371 6081 -954 -552 -96 O \nATOM 3109 CB LEU B 80 -1.326 4.064 -42.271 1.00 46.13 C \nANISOU 3109 CB LEU B 80 5624 5107 6795 -894 -548 -108 C \nATOM 3110 CG LEU B 80 -1.407 2.661 -41.713 1.00 48.20 C \nANISOU 3110 CG LEU B 80 5841 5395 7077 -928 -555 -97 C \nATOM 3111 CD1 LEU B 80 -2.099 2.621 -40.383 1.00 56.08 C \nANISOU 3111 CD1 LEU B 80 6811 6445 8052 -939 -564 -95 C \nATOM 3112 CD2 LEU B 80 -2.146 1.769 -42.631 1.00 49.46 C \nANISOU 3112 CD2 LEU B 80 5995 5571 7227 -940 -564 -93 C \nATOM 3113 N ASN B 81 1.470 4.909 -41.297 1.00 44.52 N \nANISOU 3113 N ASN B 81 5449 4881 6587 -998 -539 -93 N \nATOM 3114 CA ASN B 81 2.778 4.769 -40.636 1.00 50.36 C \nANISOU 3114 CA ASN B 81 6149 5669 7317 -1048 -534 -88 C \nATOM 3115 C ASN B 81 2.988 5.829 -39.534 1.00 53.38 C \nANISOU 3115 C ASN B 81 6589 6024 7668 -1095 -543 -79 C \nATOM 3116 O ASN B 81 3.402 5.512 -38.435 1.00 51.79 O \nANISOU 3116 O ASN B 81 6349 5850 7479 -1101 -542 -78 O \nATOM 3117 CB ASN B 81 3.899 4.948 -41.651 1.00 55.20 C \nANISOU 3117 CB ASN B 81 6736 6352 7886 -1105 -524 -87 C \nATOM 3118 CG ASN B 81 5.239 4.489 -41.124 1.00 59.04 C \nANISOU 3118 CG ASN B 81 7134 6960 8340 -1126 -518 -95 C \nATOM 3119 OD1 ASN B 81 5.492 3.294 -41.027 1.00 61.43 O \nANISOU 3119 OD1 ASN B 81 7377 7305 8657 -1039 -525 -114 O \nATOM 3120 ND2 ASN B 81 6.068 5.421 -40.729 1.00 58.60 N \nANISOU 3120 ND2 ASN B 81 7085 6961 8218 -1237 -515 -82 N \nATOM 3121 N LYS B 82 2.740 7.096 -39.849 1.00 51.21 N \nANISOU 3121 N LYS B 82 6433 5684 7339 -1125 -561 -75 N \nATOM 3122 CA LYS B 82 2.924 8.134 -38.851 1.00 64.17 C \nANISOU 3122 CA LYS B 82 8177 7275 8929 -1166 -585 -68 C \nATOM 3123 C LYS B 82 2.092 7.869 -37.591 1.00 72.57 C \nANISOU 3123 C LYS B 82 9213 8332 10027 -1073 -590 -81 C \nATOM 3124 O LYS B 82 2.575 8.050 -36.474 1.00 73.38 O \nANISOU 3124 O LYS B 82 9318 8438 10123 -1107 -594 -75 O \nATOM 3125 CB LYS B 82 2.545 9.470 -39.431 1.00 75.20 C \nANISOU 3125 CB LYS B 82 9767 8566 10240 -1177 -626 -68 C \nATOM 3126 CG LYS B 82 2.595 10.614 -38.445 1.00 81.84 C \nANISOU 3126 CG LYS B 82 10777 9318 11001 -1198 -673 -65 C \nATOM 3127 CD LYS B 82 4.026 10.964 -38.076 1.00 93.67 C \nANISOU 3127 CD LYS B 82 12293 10853 12444 -1390 -673 -32 C \nATOM 3128 CE LYS B 82 4.088 12.317 -37.380 1.00100.12 C \nANISOU 3128 CE LYS B 82 13357 11539 13145 -1446 -739 -22 C \nATOM 3129 NZ LYS B 82 3.132 12.480 -36.240 1.00101.87 N \nANISOU 3129 NZ LYS B 82 13621 11699 13384 -1274 -763 -52 N \nATOM 3130 N LYS B 83 0.833 7.454 -37.756 1.00 76.67 N \nANISOU 3130 N LYS B 83 9697 8865 10568 -968 -590 -99 N \nATOM 3131 CA LYS B 83 -0.062 7.257 -36.602 1.00 71.27 C \nANISOU 3131 CA LYS B 83 8973 8222 9886 -896 -597 -113 C \nATOM 3132 C LYS B 83 0.274 6.046 -35.767 1.00 60.54 C \nANISOU 3132 C LYS B 83 7501 6918 8584 -939 -577 -100 C \nATOM 3133 O LYS B 83 0.120 6.061 -34.526 1.00 57.23 O \nANISOU 3133 O LYS B 83 7064 6520 8160 -930 -582 -101 O \nATOM 3134 CB LYS B 83 -1.506 7.158 -37.034 1.00 82.26 C \nANISOU 3134 CB LYS B 83 10335 9675 11246 -794 -604 -138 C \nATOM 3135 CG LYS B 83 -2.083 8.480 -37.564 1.00 94.74 C \nANISOU 3135 CG LYS B 83 12057 11204 12737 -688 -643 -167 C \nATOM 3136 CD LYS B 83 -1.308 9.737 -37.114 1.00 97.08 C \nANISOU 3136 CD LYS B 83 12536 11374 12974 -709 -682 -163 C \nATOM 3137 CE LYS B 83 -1.946 11.068 -37.518 1.00 95.45 C \nANISOU 3137 CE LYS B 83 12540 11083 12645 -579 -747 -198 C \nATOM 3138 NZ LYS B 83 -0.934 12.122 -37.811 1.00 91.38 N \nANISOU 3138 NZ LYS B 83 12253 10403 12064 -688 -791 -174 N \nATOM 3139 N MET B 84 0.776 5.014 -36.416 1.00 53.44 N \nANISOU 3139 N MET B 84 6547 6033 7726 -976 -562 -90 N \nATOM 3140 CA MET B 84 1.385 3.899 -35.680 1.00 50.19 C \nANISOU 3140 CA MET B 84 6081 5642 7345 -1004 -562 -81 C \nATOM 3141 C MET B 84 2.486 4.346 -34.747 1.00 51.61 C \nANISOU 3141 C MET B 84 6263 5825 7521 -1038 -559 -77 C \nATOM 3142 O MET B 84 2.544 3.930 -33.579 1.00 55.99 O \nANISOU 3142 O MET B 84 6797 6391 8087 -1040 -565 -74 O \nATOM 3143 CB MET B 84 1.973 2.859 -36.618 1.00 52.10 C \nANISOU 3143 CB MET B 84 6305 5890 7602 -1000 -563 -82 C \nATOM 3144 CG MET B 84 2.280 1.572 -35.880 1.00 54.89 C \nANISOU 3144 CG MET B 84 6656 6242 7959 -992 -586 -80 C \nATOM 3145 SD MET B 84 2.976 0.368 -36.917 1.00 68.56 S \nANISOU 3145 SD MET B 84 8410 7968 9673 -936 -610 -95 S \nATOM 3146 CE MET B 84 4.652 1.037 -37.023 1.00 49.19 C \nANISOU 3146 CE MET B 84 5884 5615 7192 -917 -588 -114 C \nATOM 3147 N GLU B 85 3.380 5.204 -35.229 1.00 56.11 N \nANISOU 3147 N GLU B 85 6862 6397 8059 -1085 -553 -74 N \nATOM 3148 CA GLU B 85 4.487 5.714 -34.358 1.00 58.78 C \nANISOU 3148 CA GLU B 85 7199 6767 8368 -1151 -553 -67 C \nATOM 3149 C GLU B 85 4.028 6.626 -33.264 1.00 56.66 C \nANISOU 3149 C GLU B 85 7006 6442 8082 -1155 -568 -63 C \nATOM 3150 O GLU B 85 4.405 6.440 -32.118 1.00 65.16 O \nANISOU 3150 O GLU B 85 8051 7539 9168 -1166 -568 -61 O \nATOM 3151 CB GLU B 85 5.577 6.401 -35.166 1.00 71.20 C \nANISOU 3151 CB GLU B 85 8784 8393 9874 -1250 -548 -59 C \nATOM 3152 CG GLU B 85 6.180 5.561 -36.297 1.00 78.95 C \nANISOU 3152 CG GLU B 85 9675 9471 10849 -1231 -534 -70 C \nATOM 3153 CD GLU B 85 6.701 4.193 -35.856 1.00 86.77 C \nANISOU 3153 CD GLU B 85 10568 10539 11860 -1143 -535 -92 C \nATOM 3154 OE1 GLU B 85 6.807 3.907 -34.635 1.00 91.61 O \nANISOU 3154 OE1 GLU B 85 11171 11146 12490 -1123 -543 -93 O \nATOM 3155 OE2 GLU B 85 7.026 3.393 -36.763 1.00 96.31 O \nANISOU 3155 OE2 GLU B 85 11728 11810 13054 -1080 -537 -111 O \nATOM 3156 N ASP B 86 3.194 7.593 -33.577 1.00 63.95 N \nANISOU 3156 N ASP B 86 8036 7293 8967 -1123 -589 -69 N \nATOM 3157 CA ASP B 86 2.571 8.422 -32.517 1.00 69.94 C \nANISOU 3157 CA ASP B 86 8882 8004 9690 -1073 -616 -78 C \nATOM 3158 C ASP B 86 1.776 7.537 -31.568 1.00 73.52 C \nANISOU 3158 C ASP B 86 9228 8519 10188 -1003 -605 -89 C \nATOM 3159 O ASP B 86 1.785 7.759 -30.373 1.00 80.98 O \nANISOU 3159 O ASP B 86 10178 9467 11123 -994 -614 -90 O \nATOM 3160 CB ASP B 86 1.620 9.474 -33.104 1.00 78.80 C \nANISOU 3160 CB ASP B 86 10148 9053 10738 -986 -655 -99 C \nATOM 3161 CG ASP B 86 2.329 10.469 -34.002 1.00 91.79 C \nANISOU 3161 CG ASP B 86 11955 10611 12310 -1080 -682 -83 C \nATOM 3162 OD1 ASP B 86 3.559 10.646 -33.853 1.00105.51 O \nANISOU 3162 OD1 ASP B 86 13704 12359 14026 -1232 -677 -55 O \nATOM 3163 OD2 ASP B 86 1.662 11.086 -34.867 1.00 99.79 O \nANISOU 3163 OD2 ASP B 86 13089 11560 13267 -1013 -714 -99 O \nATOM 3164 N GLY B 87 1.079 6.547 -32.120 1.00 71.49 N \nANISOU 3164 N GLY B 87 8885 8313 9964 -973 -591 -92 N \nATOM 3165 CA GLY B 87 0.279 5.625 -31.319 1.00 70.78 C \nANISOU 3165 CA GLY B 87 8708 8298 9888 -956 -588 -94 C \nATOM 3166 C GLY B 87 1.092 4.947 -30.229 1.00 64.61 C \nANISOU 3166 C GLY B 87 7890 7516 9141 -1011 -584 -78 C \nATOM 3167 O GLY B 87 0.738 5.057 -29.055 1.00 74.70 O \nANISOU 3167 O GLY B 87 9152 8827 10405 -1002 -591 -80 O \nATOM 3168 N PHE B 88 2.168 4.260 -30.607 1.00 46.50 N \nANISOU 3168 N PHE B 88 5584 5204 6880 -1050 -578 -68 N \nATOM 3169 CA PHE B 88 3.005 3.559 -29.638 1.00 49.54 C \nANISOU 3169 CA PHE B 88 5943 5597 7281 -1072 -583 -62 C \nATOM 3170 C PHE B 88 3.796 4.461 -28.733 1.00 55.89 C \nANISOU 3170 C PHE B 88 6759 6403 8074 -1098 -578 -61 C \nATOM 3171 O PHE B 88 4.046 4.141 -27.555 1.00 60.19 O \nANISOU 3171 O PHE B 88 7284 6958 8626 -1105 -583 -58 O \nATOM 3172 CB PHE B 88 3.970 2.608 -30.334 1.00 47.37 C \nANISOU 3172 CB PHE B 88 5655 5332 7010 -1058 -588 -68 C \nATOM 3173 CG PHE B 88 3.318 1.384 -30.876 1.00 40.60 C \nANISOU 3173 CG PHE B 88 4826 4450 6152 -1041 -612 -66 C \nATOM 3174 CD1 PHE B 88 2.626 0.516 -30.037 1.00 43.85 C \nANISOU 3174 CD1 PHE B 88 5270 4841 6549 -1071 -640 -53 C \nATOM 3175 CD2 PHE B 88 3.424 1.083 -32.161 1.00 40.44 C \nANISOU 3175 CD2 PHE B 88 4815 4425 6127 -1015 -613 -73 C \nATOM 3176 CE1 PHE B 88 2.024 -0.650 -30.513 1.00 44.49 C \nANISOU 3176 CE1 PHE B 88 5418 4887 6600 -1095 -676 -44 C \nATOM 3177 CE2 PHE B 88 2.832 -0.092 -32.660 1.00 44.54 C \nANISOU 3177 CE2 PHE B 88 5392 4903 6629 -1010 -646 -69 C \nATOM 3178 CZ PHE B 88 2.112 -0.934 -31.843 1.00 42.13 C \nANISOU 3178 CZ PHE B 88 5142 4568 6298 -1061 -680 -52 C \nATOM 3179 N LEU B 89 4.121 5.633 -29.245 1.00 68.36 N \nANISOU 3179 N LEU B 89 8390 7962 9621 -1125 -575 -61 N \nATOM 3180 CA LEU B 89 4.836 6.637 -28.456 1.00 76.68 C \nANISOU 3180 CA LEU B 89 9493 9004 10638 -1182 -581 -54 C \nATOM 3181 C LEU B 89 3.969 7.127 -27.308 1.00 77.95 C \nANISOU 3181 C LEU B 89 9697 9130 10790 -1133 -598 -60 C \nATOM 3182 O LEU B 89 4.432 7.230 -26.171 1.00 88.60 O \nANISOU 3182 O LEU B 89 11040 10487 12139 -1159 -600 -55 O \nATOM 3183 CB LEU B 89 5.223 7.798 -29.360 1.00 89.00 C \nANISOU 3183 CB LEU B 89 11154 10529 12133 -1250 -592 -46 C \nATOM 3184 CG LEU B 89 5.883 9.018 -28.717 1.00 99.12 C \nANISOU 3184 CG LEU B 89 12550 11773 13338 -1347 -616 -32 C \nATOM 3185 CD1 LEU B 89 6.778 9.757 -29.697 1.00 93.64 C \nANISOU 3185 CD1 LEU B 89 11928 11096 12557 -1491 -626 -12 C \nATOM 3186 CD2 LEU B 89 4.796 9.953 -28.218 1.00104.81 C \nANISOU 3186 CD2 LEU B 89 13420 12382 14022 -1263 -656 -45 C \nATOM 3187 N ASP B 90 2.710 7.438 -27.615 1.00 78.85 N \nANISOU 3187 N ASP B 90 9845 9230 10884 -1051 -610 -76 N \nATOM 3188 CA ASP B 90 1.738 7.874 -26.607 1.00 83.84 C \nANISOU 3188 CA ASP B 90 10495 9882 11479 -969 -629 -95 C \nATOM 3189 C ASP B 90 1.633 6.827 -25.500 1.00 79.05 C \nANISOU 3189 C ASP B 90 9777 9346 10913 -992 -615 -86 C \nATOM 3190 O ASP B 90 1.762 7.148 -24.332 1.00 85.98 O \nANISOU 3190 O ASP B 90 10664 10226 11777 -987 -623 -88 O \nATOM 3191 CB ASP B 90 0.365 8.123 -27.234 1.00 95.93 C \nANISOU 3191 CB ASP B 90 12030 11458 12959 -858 -644 -123 C \nATOM 3192 CG ASP B 90 0.295 9.439 -28.014 1.00111.70 C \nANISOU 3192 CG ASP B 90 14198 13363 14882 -796 -681 -141 C \nATOM 3193 OD1 ASP B 90 1.350 10.088 -28.258 1.00115.01 O \nANISOU 3193 OD1 ASP B 90 14736 13676 15287 -886 -694 -121 O \nATOM 3194 OD2 ASP B 90 -0.844 9.819 -28.390 1.00135.78 O \nANISOU 3194 OD2 ASP B 90 17269 16458 17862 -662 -704 -176 O \nATOM 3195 N VAL B 91 1.427 5.573 -25.888 1.00 71.83 N \nANISOU 3195 N VAL B 91 8784 8474 10035 -1024 -602 -76 N \nATOM 3196 CA VAL B 91 1.261 4.463 -24.957 1.00 64.95 C \nANISOU 3196 CA VAL B 91 7852 7649 9178 -1067 -604 -63 C \nATOM 3197 C VAL B 91 2.493 4.304 -24.099 1.00 69.51 C \nANISOU 3197 C VAL B 91 8439 8186 9788 -1102 -603 -53 C \nATOM 3198 O VAL B 91 2.399 4.286 -22.873 1.00 74.62 O \nANISOU 3198 O VAL B 91 9070 8855 10428 -1111 -609 -50 O \nATOM 3199 CB VAL B 91 1.026 3.173 -25.715 1.00 62.75 C \nANISOU 3199 CB VAL B 91 7557 7376 8909 -1110 -609 -50 C \nATOM 3200 CG1 VAL B 91 1.070 1.976 -24.783 1.00 67.71 C \nANISOU 3200 CG1 VAL B 91 8188 8009 9531 -1175 -631 -31 C \nATOM 3201 CG2 VAL B 91 -0.318 3.229 -26.414 1.00 64.07 C \nANISOU 3201 CG2 VAL B 91 7692 7624 9028 -1096 -610 -58 C \nATOM 3202 N TRP B 92 3.661 4.237 -24.732 1.00 69.44 N \nANISOU 3202 N TRP B 92 8442 8144 9798 -1117 -596 -51 N \nATOM 3203 CA TRP B 92 4.940 4.099 -23.978 1.00 69.01 C \nANISOU 3203 CA TRP B 92 8372 8098 9750 -1141 -596 -48 C \nATOM 3204 C TRP B 92 5.325 5.276 -23.109 1.00 74.33 C \nANISOU 3204 C TRP B 92 9074 8765 10404 -1170 -593 -46 C \nATOM 3205 O TRP B 92 5.873 5.105 -22.022 1.00 85.43 O \nANISOU 3205 O TRP B 92 10459 10188 11814 -1186 -596 -43 O \nATOM 3206 CB TRP B 92 6.109 3.782 -24.918 1.00 64.65 C \nANISOU 3206 CB TRP B 92 7795 7581 9186 -1141 -591 -56 C \nATOM 3207 CG TRP B 92 6.068 2.354 -25.370 1.00 60.85 C \nANISOU 3207 CG TRP B 92 7314 7095 8710 -1087 -612 -64 C \nATOM 3208 CD1 TRP B 92 5.881 1.887 -26.638 1.00 58.73 C \nANISOU 3208 CD1 TRP B 92 7058 6819 8438 -1058 -616 -70 C \nATOM 3209 CD2 TRP B 92 6.168 1.205 -24.531 1.00 53.48 C \nANISOU 3209 CD2 TRP B 92 6409 6142 7770 -1056 -644 -66 C \nATOM 3210 NE1 TRP B 92 5.884 0.506 -26.638 1.00 58.47 N \nANISOU 3210 NE1 TRP B 92 7074 6755 8388 -1008 -656 -77 N \nATOM 3211 CE2 TRP B 92 6.054 0.067 -25.352 1.00 57.97 C \nANISOU 3211 CE2 TRP B 92 7034 6676 8317 -1008 -678 -74 C \nATOM 3212 CE3 TRP B 92 6.357 1.031 -23.173 1.00 58.23 C \nANISOU 3212 CE3 TRP B 92 7016 6739 8371 -1066 -656 -62 C \nATOM 3213 CZ2 TRP B 92 6.125 -1.241 -24.850 1.00 64.52 C \nANISOU 3213 CZ2 TRP B 92 7959 7447 9107 -969 -735 -78 C \nATOM 3214 CZ3 TRP B 92 6.410 -0.281 -22.651 1.00 66.74 C \nANISOU 3214 CZ3 TRP B 92 8167 7771 9420 -1031 -706 -64 C \nATOM 3215 CH2 TRP B 92 6.303 -1.396 -23.496 1.00 66.79 C \nANISOU 3215 CH2 TRP B 92 8262 7725 9389 -984 -750 -73 C \nATOM 3216 N THR B 93 5.014 6.477 -23.562 1.00 80.46 N \nANISOU 3216 N THR B 93 9922 9504 11145 -1174 -598 -48 N \nATOM 3217 CA THR B 93 5.194 7.674 -22.720 1.00 78.03 C \nANISOU 3217 CA THR B 93 9699 9156 10791 -1197 -615 -46 C \nATOM 3218 C THR B 93 4.294 7.532 -21.496 1.00 72.93 C \nANISOU 3218 C THR B 93 9032 8524 10153 -1131 -623 -56 C \nATOM 3219 O THR B 93 4.748 7.609 -20.368 1.00 74.98 O \nANISOU 3219 O THR B 93 9285 8788 10414 -1156 -625 -51 O \nATOM 3220 CB THR B 93 4.860 8.980 -23.498 1.00 83.06 C \nANISOU 3220 CB THR B 93 10484 9716 11359 -1192 -642 -51 C \nATOM 3221 OG1 THR B 93 5.904 9.274 -24.428 1.00 76.17 O \nANISOU 3221 OG1 THR B 93 9641 8847 10455 -1303 -638 -34 O \nATOM 3222 CG2 THR B 93 4.673 10.171 -22.554 1.00 82.89 C \nANISOU 3222 CG2 THR B 93 10605 9623 11267 -1170 -682 -58 C \nATOM 3223 N TYR B 94 3.008 7.327 -21.740 1.00 73.71 N \nANISOU 3223 N TYR B 94 9107 8657 10241 -1054 -627 -72 N \nATOM 3224 CA TYR B 94 2.027 7.147 -20.679 1.00 72.02 C \nANISOU 3224 CA TYR B 94 8842 8517 10004 -1001 -634 -84 C \nATOM 3225 C TYR B 94 2.441 6.118 -19.640 1.00 68.40 C \nANISOU 3225 C TYR B 94 8310 8090 9588 -1067 -624 -65 C \nATOM 3226 O TYR B 94 2.295 6.360 -18.445 1.00 58.01 O \nANISOU 3226 O TYR B 94 6986 6802 8254 -1055 -631 -69 O \nATOM 3227 CB TYR B 94 0.699 6.720 -21.274 1.00 75.37 C \nANISOU 3227 CB TYR B 94 9202 9040 10394 -951 -634 -99 C \nATOM 3228 CG TYR B 94 -0.353 6.422 -20.243 1.00 82.19 C \nANISOU 3228 CG TYR B 94 9978 10048 11203 -925 -639 -111 C \nATOM 3229 CD1 TYR B 94 -1.251 7.407 -19.843 1.00 80.71 C \nANISOU 3229 CD1 TYR B 94 9799 9950 10919 -790 -662 -153 C \nATOM 3230 CD2 TYR B 94 -0.447 5.149 -19.674 1.00 76.99 C \nANISOU 3230 CD2 TYR B 94 9240 9448 10563 -1033 -632 -84 C \nATOM 3231 CE1 TYR B 94 -2.211 7.127 -18.912 1.00 86.45 C \nANISOU 3231 CE1 TYR B 94 10414 10863 11571 -768 -665 -168 C \nATOM 3232 CE2 TYR B 94 -1.404 4.867 -18.750 1.00 84.83 C \nANISOU 3232 CE2 TYR B 94 10147 10602 11483 -1048 -638 -90 C \nATOM 3233 CZ TYR B 94 -2.278 5.860 -18.381 1.00 90.36 C \nANISOU 3233 CZ TYR B 94 10812 11430 12089 -917 -649 -133 C \nATOM 3234 OH TYR B 94 -3.249 5.563 -17.463 1.00132.97 O \nANISOU 3234 OH TYR B 94 16091 17043 17389 -934 -654 -143 O \nATOM 3235 N ASN B 95 2.912 4.959 -20.089 1.00 66.19 N \nANISOU 3235 N ASN B 95 7997 7802 9352 -1122 -616 -48 N \nATOM 3236 CA ASN B 95 3.283 3.911 -19.151 1.00 63.99 C \nANISOU 3236 CA ASN B 95 7692 7530 9091 -1168 -624 -34 C \nATOM 3237 C ASN B 95 4.423 4.372 -18.268 1.00 69.69 C \nANISOU 3237 C ASN B 95 8426 8224 9829 -1176 -620 -33 C \nATOM 3238 O ASN B 95 4.300 4.391 -17.022 1.00 74.23 O \nANISOU 3238 O ASN B 95 8988 8817 10398 -1185 -626 -30 O \nATOM 3239 CB ASN B 95 3.684 2.621 -19.872 1.00 65.51 C \nANISOU 3239 CB ASN B 95 7900 7691 9298 -1190 -637 -25 C \nATOM 3240 CG ASN B 95 2.488 1.886 -20.481 1.00 66.87 C \nANISOU 3240 CG ASN B 95 8076 7895 9439 -1224 -650 -16 C \nATOM 3241 OD1 ASN B 95 1.334 1.997 -20.019 1.00 73.12 O \nANISOU 3241 OD1 ASN B 95 8825 8772 10184 -1255 -651 -13 O \nATOM 3242 ND2 ASN B 95 2.760 1.128 -21.511 1.00 67.53 N \nANISOU 3242 ND2 ASN B 95 8199 7932 9526 -1222 -663 -14 N \nATOM 3243 N ALA B 96 5.519 4.776 -18.890 1.00 64.41 N \nANISOU 3243 N ALA B 96 7771 7536 9165 -1187 -612 -35 N \nATOM 3244 CA ALA B 96 6.707 5.156 -18.119 1.00 75.22 C \nANISOU 3244 CA ALA B 96 9134 8918 10526 -1221 -609 -33 C \nATOM 3245 C ALA B 96 6.410 6.222 -17.036 1.00 84.92 C \nANISOU 3245 C ALA B 96 10407 10123 11734 -1230 -615 -32 C \nATOM 3246 O ALA B 96 6.863 6.116 -15.893 1.00 82.79 O \nANISOU 3246 O ALA B 96 10120 9867 11470 -1247 -617 -28 O \nATOM 3247 CB ALA B 96 7.777 5.655 -19.057 1.00 79.77 C \nANISOU 3247 CB ALA B 96 9710 9528 11073 -1264 -599 -34 C \nATOM 3248 N GLU B 97 5.610 7.228 -17.385 1.00 92.75 N \nANISOU 3248 N GLU B 97 11472 11077 12691 -1198 -626 -40 N \nATOM 3249 CA GLU B 97 5.256 8.281 -16.430 1.00 92.19 C \nANISOU 3249 CA GLU B 97 11479 10974 12574 -1168 -648 -48 C \nATOM 3250 C GLU B 97 4.396 7.782 -15.275 1.00 88.97 C \nANISOU 3250 C GLU B 97 11003 10626 12174 -1115 -649 -57 C \nATOM 3251 O GLU B 97 4.622 8.163 -14.136 1.00 79.21 O \nANISOU 3251 O GLU B 97 9787 9385 10924 -1117 -658 -58 O \nATOM 3252 CB GLU B 97 4.549 9.431 -17.123 1.00 97.24 C \nANISOU 3252 CB GLU B 97 12246 11556 13144 -1102 -678 -67 C \nATOM 3253 CG GLU B 97 5.372 10.069 -18.227 1.00 98.95 C \nANISOU 3253 CG GLU B 97 12562 11706 13327 -1186 -687 -52 C \nATOM 3254 CD GLU B 97 5.323 11.574 -18.180 1.00 98.95 C \nANISOU 3254 CD GLU B 97 12785 11592 13220 -1179 -743 -59 C \nATOM 3255 OE1 GLU B 97 5.335 12.133 -17.070 1.00107.38 O \nANISOU 3255 OE1 GLU B 97 13927 12625 14247 -1158 -771 -64 O \nATOM 3256 OE2 GLU B 97 5.301 12.193 -19.246 1.00 97.81 O \nANISOU 3256 OE2 GLU B 97 12763 11381 13020 -1196 -768 -58 O \nATOM 3257 N LEU B 98 3.398 6.949 -15.562 1.00 85.26 N \nANISOU 3257 N LEU B 98 10457 10229 11709 -1087 -642 -62 N \nATOM 3258 CA LEU B 98 2.555 6.395 -14.475 1.00 80.87 C \nANISOU 3258 CA LEU B 98 9825 9771 11132 -1080 -645 -64 C \nATOM 3259 C LEU B 98 3.230 5.286 -13.721 1.00 66.03 C \nANISOU 3259 C LEU B 98 7908 7881 9299 -1164 -640 -39 C \nATOM 3260 O LEU B 98 2.974 5.094 -12.541 1.00 62.69 O \nANISOU 3260 O LEU B 98 7454 7506 8859 -1180 -646 -36 O \nATOM 3261 CB LEU B 98 1.199 5.913 -14.974 1.00 89.12 C \nANISOU 3261 CB LEU B 98 10798 10937 12126 -1060 -646 -74 C \nATOM 3262 CG LEU B 98 0.215 7.028 -15.377 1.00 96.70 C \nANISOU 3262 CG LEU B 98 11776 11964 13000 -923 -661 -115 C \nATOM 3263 CD1 LEU B 98 -1.188 6.453 -15.399 1.00104.89 C \nANISOU 3263 CD1 LEU B 98 12687 13211 13954 -917 -661 -128 C \nATOM 3264 CD2 LEU B 98 0.225 8.231 -14.451 1.00 97.24 C \nANISOU 3264 CD2 LEU B 98 11918 12017 13013 -816 -687 -145 C \nATOM 3265 N LEU B 99 4.159 4.626 -14.367 1.00 63.60 N \nANISOU 3265 N LEU B 99 7617 7515 9035 -1202 -636 -27 N \nATOM 3266 CA LEU B 99 4.985 3.685 -13.640 1.00 65.42 C \nANISOU 3266 CA LEU B 99 7845 7724 9288 -1239 -646 -14 C \nATOM 3267 C LEU B 99 5.801 4.389 -12.573 1.00 74.28 C \nANISOU 3267 C LEU B 99 8968 8837 10417 -1240 -641 -16 C \nATOM 3268 O LEU B 99 5.891 3.911 -11.459 1.00 91.07 O \nANISOU 3268 O LEU B 99 11084 10974 12545 -1258 -651 -10 O \nATOM 3269 CB LEU B 99 5.925 2.949 -14.578 1.00 62.35 C \nANISOU 3269 CB LEU B 99 7474 7301 8916 -1229 -652 -16 C \nATOM 3270 CG LEU B 99 6.815 1.921 -13.870 1.00 70.61 C \nANISOU 3270 CG LEU B 99 8541 8331 9958 -1219 -678 -16 C \nATOM 3271 CD1 LEU B 99 5.975 0.912 -13.105 1.00 65.83 C \nANISOU 3271 CD1 LEU B 99 7984 7704 9326 -1266 -712 1 C \nATOM 3272 CD2 LEU B 99 7.723 1.189 -14.860 1.00 75.56 C \nANISOU 3272 CD2 LEU B 99 9187 8953 10569 -1159 -694 -33 C \nATOM 3273 N VAL B 100 6.400 5.526 -12.916 1.00 81.29 N \nANISOU 3273 N VAL B 100 9887 9704 11297 -1237 -631 -22 N \nATOM 3274 CA VAL B 100 7.265 6.263 -11.980 1.00 71.14 C \nANISOU 3274 CA VAL B 100 8620 8410 9998 -1268 -632 -20 C \nATOM 3275 C VAL B 100 6.477 6.848 -10.817 1.00 71.93 C \nANISOU 3275 C VAL B 100 8744 8509 10079 -1238 -643 -25 C \nATOM 3276 O VAL B 100 6.834 6.639 -9.663 1.00 84.90 O \nANISOU 3276 O VAL B 100 10363 10164 11730 -1256 -645 -20 O \nATOM 3277 CB VAL B 100 8.040 7.367 -12.702 1.00 67.44 C \nANISOU 3277 CB VAL B 100 8213 7921 9490 -1319 -631 -17 C \nATOM 3278 CG1 VAL B 100 8.590 8.388 -11.731 1.00 67.42 C \nANISOU 3278 CG1 VAL B 100 8277 7896 9445 -1372 -645 -11 C \nATOM 3279 CG2 VAL B 100 9.188 6.752 -13.493 1.00 70.56 C \nANISOU 3279 CG2 VAL B 100 8544 8383 9884 -1358 -618 -16 C \nATOM 3280 N LEU B 101 5.412 7.572 -11.117 1.00 68.89 N \nANISOU 3280 N LEU B 101 8400 8122 9652 -1174 -655 -41 N \nATOM 3281 CA LEU B 101 4.574 8.186 -10.067 1.00 73.38 C \nANISOU 3281 CA LEU B 101 8986 8726 10171 -1103 -673 -60 C \nATOM 3282 C LEU B 101 4.097 7.148 -9.069 1.00 75.13 C \nANISOU 3282 C LEU B 101 9100 9038 10407 -1125 -664 -53 C \nATOM 3283 O LEU B 101 4.276 7.303 -7.880 1.00 77.99 O \nANISOU 3283 O LEU B 101 9458 9412 10764 -1129 -670 -52 O \nATOM 3284 CB LEU B 101 3.348 8.917 -10.670 1.00 73.24 C \nANISOU 3284 CB LEU B 101 9007 8742 10077 -983 -695 -93 C \nATOM 3285 CG LEU B 101 3.627 10.085 -11.640 1.00 75.17 C \nANISOU 3285 CG LEU B 101 9413 8874 10275 -949 -723 -104 C \nATOM 3286 CD1 LEU B 101 2.351 10.675 -12.210 1.00 70.03 C \nANISOU 3286 CD1 LEU B 101 8804 8270 9535 -792 -752 -146 C \nATOM 3287 CD2 LEU B 101 4.436 11.163 -10.943 1.00 80.59 C \nANISOU 3287 CD2 LEU B 101 10252 9451 10916 -976 -756 -100 C \nATOM 3288 N MET B 102 3.496 6.079 -9.574 1.00 78.16 N \nANISOU 3288 N MET B 102 9417 9482 10798 -1159 -657 -43 N \nATOM 3289 CA MET B 102 2.939 5.036 -8.720 1.00 75.38 C \nANISOU 3289 CA MET B 102 8997 9218 10428 -1223 -662 -29 C \nATOM 3290 C MET B 102 4.029 4.443 -7.864 1.00 79.94 C \nANISOU 3290 C MET B 102 9597 9723 11054 -1280 -665 -9 C \nATOM 3291 O MET B 102 3.876 4.301 -6.659 1.00 77.43 O \nANISOU 3291 O MET B 102 9255 9448 10718 -1305 -672 -4 O \nATOM 3292 CB MET B 102 2.285 3.947 -9.577 1.00 73.44 C \nANISOU 3292 CB MET B 102 8725 9016 10163 -1290 -666 -13 C \nATOM 3293 CG MET B 102 0.887 4.316 -10.079 1.00 76.01 C \nANISOU 3293 CG MET B 102 8982 9494 10404 -1249 -665 -34 C \nATOM 3294 SD MET B 102 0.294 3.228 -11.373 1.00 79.55 S \nANISOU 3294 SD MET B 102 9423 9971 10830 -1339 -670 -14 S \nATOM 3295 CE MET B 102 1.016 1.666 -10.917 1.00 72.27 C \nANISOU 3295 CE MET B 102 8586 8939 9934 -1484 -699 30 C \nATOM 3296 N GLU B 103 5.153 4.126 -8.497 1.00 81.30 N \nANISOU 3296 N GLU B 103 9808 9807 11274 -1289 -663 -3 N \nATOM 3297 CA GLU B 103 6.211 3.378 -7.838 1.00 71.14 C \nANISOU 3297 CA GLU B 103 8539 8479 10011 -1312 -675 7 C \nATOM 3298 C GLU B 103 7.027 4.248 -6.905 1.00 66.51 C \nANISOU 3298 C GLU B 103 7947 7887 9436 -1302 -665 1 C \nATOM 3299 O GLU B 103 7.568 3.771 -5.896 1.00 60.55 O \nANISOU 3299 O GLU B 103 7191 7130 8687 -1317 -675 6 O \nATOM 3300 CB GLU B 103 7.113 2.729 -8.887 1.00 69.09 C \nANISOU 3300 CB GLU B 103 8306 8180 9767 -1290 -682 2 C \nATOM 3301 CG GLU B 103 7.494 1.304 -8.534 1.00 81.75 C \nANISOU 3301 CG GLU B 103 9966 9744 11349 -1289 -723 6 C \nATOM 3302 CD GLU B 103 6.309 0.352 -8.449 1.00 87.92 C \nANISOU 3302 CD GLU B 103 10807 10511 12089 -1362 -756 29 C \nATOM 3303 OE1 GLU B 103 6.486 -0.747 -7.887 1.00 89.68 O \nANISOU 3303 OE1 GLU B 103 11125 10678 12270 -1386 -806 38 O \nATOM 3304 OE2 GLU B 103 5.206 0.697 -8.916 1.00 99.70 O \nANISOU 3304 OE2 GLU B 103 12260 12056 13567 -1404 -740 36 O \nATOM 3305 N ASN B 104 7.149 5.526 -7.243 1.00 66.22 N \nANISOU 3305 N ASN B 104 7932 7839 9390 -1284 -653 -8 N \nATOM 3306 CA ASN B 104 7.836 6.451 -6.357 1.00 70.64 C \nANISOU 3306 CA ASN B 104 8519 8385 9938 -1300 -653 -9 C \nATOM 3307 C ASN B 104 7.051 6.592 -5.068 1.00 73.75 C \nANISOU 3307 C ASN B 104 8903 8804 10316 -1276 -662 -12 C \nATOM 3308 O ASN B 104 7.630 6.572 -3.982 1.00 84.87 O \nANISOU 3308 O ASN B 104 10304 10212 11732 -1299 -664 -7 O \nATOM 3309 CB ASN B 104 7.977 7.824 -7.006 1.00 75.47 C \nANISOU 3309 CB ASN B 104 9217 8950 10507 -1304 -659 -14 C \nATOM 3310 CG ASN B 104 9.224 7.947 -7.853 1.00 66.80 C \nANISOU 3310 CG ASN B 104 8122 7861 9398 -1379 -650 -5 C \nATOM 3311 OD1 ASN B 104 10.103 7.073 -7.842 1.00 68.59 O \nANISOU 3311 OD1 ASN B 104 8269 8149 9643 -1397 -639 -4 O \nATOM 3312 ND2 ASN B 104 9.337 9.068 -8.534 1.00 59.22 N \nANISOU 3312 ND2 ASN B 104 7264 6853 8383 -1419 -664 -2 N \nATOM 3313 N GLU B 105 5.733 6.732 -5.167 1.00 70.10 N \nANISOU 3313 N GLU B 105 8425 8393 9816 -1225 -668 -25 N \nATOM 3314 CA GLU B 105 4.900 6.716 -3.976 1.00 76.73 C \nANISOU 3314 CA GLU B 105 9220 9316 10616 -1202 -676 -33 C \nATOM 3315 C GLU B 105 5.098 5.461 -3.101 1.00 82.84 C \nANISOU 3315 C GLU B 105 9945 10115 11414 -1286 -677 -9 C \nATOM 3316 O GLU B 105 5.265 5.555 -1.881 1.00 82.66 O \nANISOU 3316 O GLU B 105 9912 10108 11386 -1295 -681 -7 O \nATOM 3317 CB GLU B 105 3.436 6.806 -4.329 1.00 77.80 C \nANISOU 3317 CB GLU B 105 9304 9576 10680 -1142 -682 -54 C \nATOM 3318 CG GLU B 105 2.613 7.083 -3.085 1.00 94.57 C \nANISOU 3318 CG GLU B 105 11370 11833 12729 -1095 -693 -74 C \nATOM 3319 CD GLU B 105 1.233 6.494 -3.143 1.00108.23 C \nANISOU 3319 CD GLU B 105 12979 13773 14370 -1109 -693 -82 C \nATOM 3320 OE1 GLU B 105 0.293 7.299 -3.056 1.00115.97 O \nANISOU 3320 OE1 GLU B 105 13920 14896 15247 -975 -706 -127 O \nATOM 3321 OE2 GLU B 105 1.060 5.245 -3.277 1.00115.31 O \nANISOU 3321 OE2 GLU B 105 13830 14708 15272 -1251 -688 -47 O \nATOM 3322 N ARG B 106 5.106 4.289 -3.722 1.00 79.35 N \nANISOU 3322 N ARG B 106 9502 9661 10987 -1344 -682 9 N \nATOM 3323 CA ARG B 106 5.253 3.060 -2.956 1.00 75.48 C \nANISOU 3323 CA ARG B 106 9026 9163 10490 -1422 -704 32 C \nATOM 3324 C ARG B 106 6.605 3.075 -2.287 1.00 75.50 C \nANISOU 3324 C ARG B 106 9059 9092 10536 -1401 -706 30 C \nATOM 3325 O ARG B 106 6.746 2.683 -1.125 1.00 82.26 O \nANISOU 3325 O ARG B 106 9922 9952 11383 -1433 -721 40 O \nATOM 3326 CB ARG B 106 5.082 1.833 -3.846 1.00 77.60 C \nANISOU 3326 CB ARG B 106 9348 9396 10742 -1477 -729 48 C \nATOM 3327 CG ARG B 106 3.644 1.679 -4.393 1.00 83.28 C \nANISOU 3327 CG ARG B 106 10024 10226 11393 -1535 -730 55 C \nATOM 3328 CD ARG B 106 3.544 0.651 -5.507 1.00101.31 C \nANISOU 3328 CD ARG B 106 12383 12452 13660 -1587 -756 71 C \nATOM 3329 NE ARG B 106 4.047 -0.637 -5.041 1.00120.35 N \nANISOU 3329 NE ARG B 106 14923 14762 16042 -1657 -810 94 N \nATOM 3330 CZ ARG B 106 5.320 -1.043 -5.097 1.00133.79 C \nANISOU 3330 CZ ARG B 106 16711 16339 17784 -1574 -832 82 C \nATOM 3331 NH1 ARG B 106 6.276 -0.274 -5.612 1.00128.56 N \nANISOU 3331 NH1 ARG B 106 15996 15661 17192 -1454 -797 53 N \nATOM 3332 NH2 ARG B 106 5.637 -2.238 -4.630 1.00139.22 N \nANISOU 3332 NH2 ARG B 106 17549 16932 18415 -1614 -898 96 N \nATOM 3333 N THR B 107 7.617 3.559 -2.997 1.00 77.05 N \nANISOU 3333 N THR B 107 9264 9245 10765 -1357 -693 19 N \nATOM 3334 CA THR B 107 8.979 3.633 -2.418 1.00 71.91 C \nANISOU 3334 CA THR B 107 8613 8580 10130 -1344 -692 13 C \nATOM 3335 C THR B 107 8.983 4.490 -1.156 1.00 69.47 C \nANISOU 3335 C THR B 107 8290 8286 9819 -1358 -684 14 C \nATOM 3336 O THR B 107 9.588 4.136 -0.147 1.00 69.33 O \nANISOU 3336 O THR B 107 8268 8270 9804 -1365 -693 17 O \nATOM 3337 CB THR B 107 9.979 4.203 -3.423 1.00 73.80 C \nANISOU 3337 CB THR B 107 8839 8832 10370 -1329 -676 1 C \nATOM 3338 OG1 THR B 107 10.131 3.301 -4.523 1.00 74.69 O \nANISOU 3338 OG1 THR B 107 8962 8940 10478 -1295 -688 -6 O \nATOM 3339 CG2 THR B 107 11.335 4.421 -2.785 1.00 77.42 C \nANISOU 3339 CG2 THR B 107 9266 9338 10812 -1336 -673 -6 C \nATOM 3340 N LEU B 108 8.304 5.628 -1.208 1.00 67.63 N \nANISOU 3340 N LEU B 108 8067 8060 9569 -1343 -675 8 N \nATOM 3341 CA LEU B 108 8.338 6.575 -0.088 1.00 66.39 C \nANISOU 3341 CA LEU B 108 7929 7904 9393 -1335 -678 3 C \nATOM 3342 C LEU B 108 7.647 6.038 1.152 1.00 69.65 C \nANISOU 3342 C LEU B 108 8301 8368 9796 -1339 -685 7 C \nATOM 3343 O LEU B 108 8.192 6.137 2.254 1.00 86.09 O \nANISOU 3343 O LEU B 108 10383 10444 11885 -1354 -688 10 O \nATOM 3344 CB LEU B 108 7.768 7.941 -0.483 1.00 62.18 C \nANISOU 3344 CB LEU B 108 7467 7347 8812 -1283 -687 -14 C \nATOM 3345 CG LEU B 108 8.594 8.746 -1.519 1.00 62.88 C \nANISOU 3345 CG LEU B 108 7637 7371 8885 -1319 -690 -11 C \nATOM 3346 CD1 LEU B 108 8.055 10.183 -1.646 1.00 61.34 C \nANISOU 3346 CD1 LEU B 108 7583 7111 8612 -1262 -724 -28 C \nATOM 3347 CD2 LEU B 108 10.084 8.775 -1.193 1.00 57.55 C \nANISOU 3347 CD2 LEU B 108 6954 6698 8214 -1413 -682 5 C \nATOM 3348 N ASP B 109 6.464 5.457 1.017 1.00 65.40 N \nANISOU 3348 N ASP B 109 7723 7900 9226 -1344 -690 8 N \nATOM 3349 CA ASP B 109 5.864 4.888 2.208 1.00 72.19 C \nANISOU 3349 CA ASP B 109 8540 8837 10052 -1388 -701 17 C \nATOM 3350 C ASP B 109 6.340 3.455 2.533 1.00 64.65 C \nANISOU 3350 C ASP B 109 7617 7837 9111 -1474 -721 44 C \nATOM 3351 O ASP B 109 6.084 2.945 3.606 1.00 68.75 O \nANISOU 3351 O ASP B 109 8130 8393 9599 -1533 -737 58 O \nATOM 3352 CB ASP B 109 4.351 5.100 2.241 1.00 80.62 C \nANISOU 3352 CB ASP B 109 9536 10062 11033 -1369 -702 3 C \nATOM 3353 CG ASP B 109 3.666 4.473 1.137 1.00 84.28 C \nANISOU 3353 CG ASP B 109 9980 10572 11470 -1410 -704 10 C \nATOM 3354 OD1 ASP B 109 4.195 3.451 0.651 1.00 99.27 O \nANISOU 3354 OD1 ASP B 109 11933 12379 13405 -1485 -714 36 O \nATOM 3355 OD2 ASP B 109 2.584 5.001 0.773 1.00 84.63 O \nANISOU 3355 OD2 ASP B 109 9962 10754 11440 -1351 -701 -15 O \nATOM 3356 N PHE B 110 7.105 2.850 1.649 1.00 60.01 N \nANISOU 3356 N PHE B 110 7081 7165 8555 -1468 -730 48 N \nATOM 3357 CA PHE B 110 7.918 1.709 2.018 1.00 62.32 C \nANISOU 3357 CA PHE B 110 7445 7388 8848 -1485 -765 58 C \nATOM 3358 C PHE B 110 8.869 2.136 3.159 1.00 67.56 C \nANISOU 3358 C PHE B 110 8091 8044 9535 -1455 -758 50 C \nATOM 3359 O PHE B 110 8.937 1.473 4.184 1.00 81.07 O \nANISOU 3359 O PHE B 110 9839 9740 11224 -1488 -785 61 O \nATOM 3360 CB PHE B 110 8.735 1.235 0.828 1.00 61.36 C \nANISOU 3360 CB PHE B 110 7369 7206 8739 -1427 -776 45 C \nATOM 3361 CG PHE B 110 9.673 0.099 1.130 1.00 58.97 C \nANISOU 3361 CG PHE B 110 7159 6839 8408 -1383 -826 38 C \nATOM 3362 CD1 PHE B 110 9.198 -1.079 1.687 1.00 60.32 C \nANISOU 3362 CD1 PHE B 110 7455 6948 8518 -1444 -886 59 C \nATOM 3363 CD2 PHE B 110 11.013 0.174 0.795 1.00 57.98 C \nANISOU 3363 CD2 PHE B 110 7013 6731 8288 -1278 -824 8 C \nATOM 3364 CE1 PHE B 110 10.036 -2.174 1.916 1.00 60.95 C \nANISOU 3364 CE1 PHE B 110 7674 6941 8544 -1372 -953 45 C \nATOM 3365 CE2 PHE B 110 11.879 -0.913 1.036 1.00 61.27 C \nANISOU 3365 CE2 PHE B 110 7521 7110 8648 -1185 -883 -14 C \nATOM 3366 CZ PHE B 110 11.388 -2.096 1.583 1.00 61.46 C \nANISOU 3366 CZ PHE B 110 7708 7030 8614 -1215 -953 2 C \nATOM 3367 N HIS B 111 9.568 3.247 2.977 1.00 57.29 N \nANISOU 3367 N HIS B 111 6747 6754 8265 -1411 -727 34 N \nATOM 3368 CA HIS B 111 10.465 3.797 4.001 1.00 57.57 C \nANISOU 3368 CA HIS B 111 6764 6799 8311 -1404 -719 29 C \nATOM 3369 C HIS B 111 9.746 4.148 5.297 1.00 59.52 C \nANISOU 3369 C HIS B 111 6997 7070 8548 -1431 -719 37 C \nATOM 3370 O HIS B 111 10.209 3.810 6.408 1.00 56.98 O \nANISOU 3370 O HIS B 111 6678 6745 8226 -1443 -731 41 O \nATOM 3371 CB HIS B 111 11.153 5.078 3.496 1.00 54.22 C \nANISOU 3371 CB HIS B 111 6325 6388 7888 -1403 -694 20 C \nATOM 3372 CG HIS B 111 12.131 4.849 2.394 1.00 51.68 C \nANISOU 3372 CG HIS B 111 5986 6093 7556 -1390 -690 10 C \nATOM 3373 ND1 HIS B 111 13.084 3.857 2.448 1.00 57.23 N \nANISOU 3373 ND1 HIS B 111 6668 6836 8240 -1342 -708 -5 N \nATOM 3374 CD2 HIS B 111 12.314 5.475 1.212 1.00 54.50 C \nANISOU 3374 CD2 HIS B 111 6344 6463 7900 -1406 -676 7 C \nATOM 3375 CE1 HIS B 111 13.826 3.888 1.360 1.00 55.74 C \nANISOU 3375 CE1 HIS B 111 6445 6711 8024 -1323 -701 -20 C \nATOM 3376 NE2 HIS B 111 13.374 4.857 0.586 1.00 57.25 N \nANISOU 3376 NE2 HIS B 111 6646 6883 8222 -1379 -679 -8 N \nATOM 3377 N ASP B 112 8.594 4.803 5.169 1.00 58.12 N \nANISOU 3377 N ASP B 112 6801 6935 8348 -1425 -710 33 N \nATOM 3378 CA ASP B 112 7.765 5.084 6.367 1.00 58.01 C \nANISOU 3378 CA ASP B 112 6754 6992 8297 -1430 -714 32 C \nATOM 3379 C ASP B 112 7.386 3.803 7.104 1.00 60.11 C \nANISOU 3379 C ASP B 112 7015 7290 8536 -1513 -736 54 C \nATOM 3380 O ASP B 112 7.448 3.738 8.333 1.00 65.11 O \nANISOU 3380 O ASP B 112 7638 7946 9157 -1538 -742 60 O \nATOM 3381 CB ASP B 112 6.518 5.887 6.016 1.00 56.16 C \nANISOU 3381 CB ASP B 112 6487 6846 8005 -1373 -709 11 C \nATOM 3382 CG ASP B 112 6.847 7.314 5.535 1.00 61.08 C \nANISOU 3382 CG ASP B 112 7177 7406 8623 -1286 -709 -13 C \nATOM 3383 OD1 ASP B 112 8.037 7.686 5.592 1.00 67.04 O \nANISOU 3383 OD1 ASP B 112 7987 8069 9415 -1312 -707 -5 O \nATOM 3384 OD2 ASP B 112 5.936 8.045 5.049 1.00 66.53 O \nANISOU 3384 OD2 ASP B 112 7878 8146 9254 -1199 -718 -40 O \nATOM 3385 N SER B 113 7.021 2.776 6.353 1.00 63.23 N \nANISOU 3385 N SER B 113 7441 7674 8908 -1569 -754 70 N \nATOM 3386 CA SER B 113 6.625 1.501 6.964 1.00 69.33 C \nANISOU 3386 CA SER B 113 8267 8453 9622 -1684 -795 99 C \nATOM 3387 C SER B 113 7.822 0.873 7.691 1.00 66.29 C \nANISOU 3387 C SER B 113 7970 7955 9263 -1667 -824 103 C \nATOM 3388 O SER B 113 7.691 0.359 8.793 1.00 70.94 O \nANISOU 3388 O SER B 113 8593 8550 9811 -1737 -851 120 O \nATOM 3389 CB SER B 113 6.054 0.525 5.922 1.00 73.91 C \nANISOU 3389 CB SER B 113 8913 9017 10153 -1761 -824 118 C \nATOM 3390 OG SER B 113 6.853 -0.652 5.878 1.00 87.60 O \nANISOU 3390 OG SER B 113 10801 10608 11877 -1775 -878 130 O \nATOM 3391 N ASN B 114 8.985 0.901 7.071 1.00 60.31 N \nANISOU 3391 N ASN B 114 7242 7119 8554 -1572 -822 83 N \nATOM 3392 CA ASN B 114 10.181 0.309 7.691 1.00 60.84 C \nANISOU 3392 CA ASN B 114 7376 7120 8621 -1517 -855 74 C \nATOM 3393 C ASN B 114 10.615 1.046 8.945 1.00 61.02 C \nANISOU 3393 C ASN B 114 7332 7181 8670 -1508 -831 69 C \nATOM 3394 O ASN B 114 11.034 0.438 9.917 1.00 61.43 O \nANISOU 3394 O ASN B 114 7441 7201 8700 -1511 -864 73 O \nATOM 3395 CB ASN B 114 11.350 0.300 6.693 1.00 67.65 C \nANISOU 3395 CB ASN B 114 8239 7965 9502 -1402 -853 44 C \nATOM 3396 CG ASN B 114 11.214 -0.774 5.623 1.00 67.86 C \nANISOU 3396 CG ASN B 114 8377 7925 9484 -1377 -900 41 C \nATOM 3397 OD1 ASN B 114 10.640 -1.827 5.845 1.00 69.81 O \nANISOU 3397 OD1 ASN B 114 8761 8097 9669 -1438 -959 62 O \nATOM 3398 ND2 ASN B 114 11.728 -0.486 4.449 1.00 74.13 N \nANISOU 3398 ND2 ASN B 114 9127 8745 10295 -1303 -880 19 N \nATOM 3399 N VAL B 115 10.532 2.376 8.920 1.00 63.50 N \nANISOU 3399 N VAL B 115 7553 7551 9022 -1494 -782 60 N \nATOM 3400 CA VAL B 115 10.834 3.179 10.116 1.00 57.32 C \nANISOU 3400 CA VAL B 115 6728 6797 8253 -1493 -765 57 C \nATOM 3401 C VAL B 115 9.875 2.784 11.232 1.00 58.84 C \nANISOU 3401 C VAL B 115 6921 7025 8409 -1560 -781 75 C \nATOM 3402 O VAL B 115 10.300 2.514 12.350 1.00 58.17 O \nANISOU 3402 O VAL B 115 6852 6929 8321 -1573 -795 80 O \nATOM 3403 CB VAL B 115 10.722 4.705 9.839 1.00 52.25 C \nANISOU 3403 CB VAL B 115 6047 6181 7625 -1470 -730 45 C \nATOM 3404 CG1 VAL B 115 10.640 5.515 11.127 1.00 53.75 C \nANISOU 3404 CG1 VAL B 115 6224 6393 7806 -1470 -726 43 C \nATOM 3405 CG2 VAL B 115 11.911 5.185 9.047 1.00 44.97 C \nANISOU 3405 CG2 VAL B 115 5126 5246 6716 -1452 -718 35 C \nATOM 3406 N LYS B 116 8.577 2.776 10.927 1.00 63.28 N \nANISOU 3406 N LYS B 116 7455 7660 8929 -1607 -778 83 N \nATOM 3407 CA LYS B 116 7.547 2.328 11.897 1.00 69.04 C \nANISOU 3407 CA LYS B 116 8161 8485 9587 -1703 -795 102 C \nATOM 3408 C LYS B 116 7.849 0.952 12.504 1.00 66.59 C \nANISOU 3408 C LYS B 116 7962 8101 9239 -1797 -846 131 C \nATOM 3409 O LYS B 116 7.541 0.702 13.658 1.00 70.46 O \nANISOU 3409 O LYS B 116 8450 8639 9684 -1873 -862 146 O \nATOM 3410 CB LYS B 116 6.154 2.265 11.246 1.00 78.25 C \nANISOU 3410 CB LYS B 116 9268 9784 10677 -1760 -791 106 C \nATOM 3411 CG LYS B 116 5.298 3.508 11.386 1.00 85.08 C \nANISOU 3411 CG LYS B 116 10016 10805 11505 -1676 -761 75 C \nATOM 3412 CD LYS B 116 4.806 3.612 12.809 1.00102.49 C \nANISOU 3412 CD LYS B 116 12156 13142 13645 -1712 -765 75 C \nATOM 3413 CE LYS B 116 4.045 4.896 13.037 1.00114.46 C \nANISOU 3413 CE LYS B 116 13574 14813 15101 -1573 -749 28 C \nATOM 3414 NZ LYS B 116 3.752 5.053 14.488 1.00122.45 N \nANISOU 3414 NZ LYS B 116 14524 15948 16054 -1584 -754 23 N \nATOM 3415 N ASN B 117 8.429 0.054 11.721 1.00 60.76 N \nANISOU 3415 N ASN B 117 7340 7244 8501 -1785 -883 135 N \nATOM 3416 CA ASN B 117 8.777 -1.268 12.229 1.00 71.08 C \nANISOU 3416 CA ASN B 117 8816 8444 9747 -1842 -955 154 C \nATOM 3417 C ASN B 117 9.871 -1.237 13.268 1.00 80.89 C \nANISOU 3417 C ASN B 117 10080 9634 11020 -1763 -965 139 C \nATOM 3418 O ASN B 117 9.805 -1.959 14.273 1.00 98.56 O \nANISOU 3418 O ASN B 117 12418 11833 13197 -1837 -1014 159 O \nATOM 3419 CB ASN B 117 9.158 -2.213 11.096 1.00 76.93 C \nANISOU 3419 CB ASN B 117 9706 9065 10459 -1803 -1007 151 C \nATOM 3420 CG ASN B 117 7.942 -2.918 10.511 1.00 84.33 C \nANISOU 3420 CG ASN B 117 10719 10018 11303 -1967 -1041 186 C \nATOM 3421 OD1 ASN B 117 7.063 -3.354 11.255 1.00 93.67 O \nANISOU 3421 OD1 ASN B 117 11937 11259 12393 -2145 -1070 224 O \nATOM 3422 ND2 ASN B 117 7.892 -3.046 9.190 1.00 84.57 N \nANISOU 3422 ND2 ASN B 117 10774 10016 11343 -1925 -1042 178 N \nATOM 3423 N LEU B 118 10.873 -0.398 13.048 1.00 75.45 N \nANISOU 3423 N LEU B 118 9303 8956 10409 -1630 -922 106 N \nATOM 3424 CA LEU B 118 11.878 -0.165 14.070 1.00 66.83 C \nANISOU 3424 CA LEU B 118 8192 7861 9340 -1565 -920 90 C \nATOM 3425 C LEU B 118 11.279 0.374 15.355 1.00 67.58 C \nANISOU 3425 C LEU B 118 8222 8018 9438 -1645 -898 108 C \nATOM 3426 O LEU B 118 11.557 -0.142 16.460 1.00 64.79 O \nANISOU 3426 O LEU B 118 7928 7634 9056 -1667 -932 116 O \nATOM 3427 CB LEU B 118 12.931 0.773 13.564 1.00 71.52 C \nANISOU 3427 CB LEU B 118 8684 8500 9988 -1463 -875 59 C \nATOM 3428 CG LEU B 118 14.262 0.115 13.227 1.00 72.78 C \nANISOU 3428 CG LEU B 118 8889 8649 10116 -1337 -910 26 C \nATOM 3429 CD1 LEU B 118 14.028 -1.143 12.419 1.00 75.40 C \nANISOU 3429 CD1 LEU B 118 9370 8891 10387 -1300 -975 23 C \nATOM 3430 CD2 LEU B 118 15.152 1.097 12.475 1.00 69.08 C \nANISOU 3430 CD2 LEU B 118 8295 8280 9672 -1287 -860 1 C \nATOM 3431 N TYR B 119 10.446 1.406 15.218 1.00 66.47 N \nANISOU 3431 N TYR B 119 7970 7970 9317 -1670 -850 108 N \nATOM 3432 CA TYR B 119 9.748 2.012 16.390 1.00 65.15 C \nANISOU 3432 CA TYR B 119 7728 7895 9130 -1717 -832 115 C \nATOM 3433 C TYR B 119 8.964 1.000 17.172 1.00 70.15 C \nANISOU 3433 C TYR B 119 8413 8563 9680 -1851 -873 146 C \nATOM 3434 O TYR B 119 8.956 1.061 18.390 1.00 77.26 O \nANISOU 3434 O TYR B 119 9295 9498 10563 -1884 -877 152 O \nATOM 3435 CB TYR B 119 8.837 3.147 15.944 1.00 59.13 C \nANISOU 3435 CB TYR B 119 6867 7238 8361 -1684 -793 99 C \nATOM 3436 CG TYR B 119 8.205 3.924 17.072 1.00 64.54 C \nANISOU 3436 CG TYR B 119 7476 8037 9010 -1674 -780 89 C \nATOM 3437 CD1 TYR B 119 8.867 5.009 17.671 1.00 64.31 C \nANISOU 3437 CD1 TYR B 119 7442 7975 9020 -1590 -764 68 C \nATOM 3438 CD2 TYR B 119 6.926 3.596 17.537 1.00 70.52 C \nANISOU 3438 CD2 TYR B 119 8166 8958 9669 -1754 -788 98 C \nATOM 3439 CE1 TYR B 119 8.275 5.731 18.703 1.00 69.64 C \nANISOU 3439 CE1 TYR B 119 8065 8747 9647 -1554 -761 53 C \nATOM 3440 CE2 TYR B 119 6.324 4.306 18.572 1.00 68.71 C \nANISOU 3440 CE2 TYR B 119 7850 8871 9384 -1719 -779 79 C \nATOM 3441 CZ TYR B 119 6.991 5.363 19.154 1.00 72.32 C \nANISOU 3441 CZ TYR B 119 8321 9266 9891 -1604 -768 54 C \nATOM 3442 OH TYR B 119 6.379 6.045 20.174 1.00 70.44 O \nANISOU 3442 OH TYR B 119 8015 9164 9584 -1547 -768 30 O \nATOM 3443 N ASP B 120 8.327 0.055 16.469 1.00 79.40 N \nANISOU 3443 N ASP B 120 9661 9724 10785 -1948 -908 169 N \nATOM 3444 CA ASP B 120 7.488 -0.980 17.119 1.00 86.98 C \nANISOU 3444 CA ASP B 120 10699 10725 11623 -2138 -961 210 C \nATOM 3445 C ASP B 120 8.322 -2.110 17.779 1.00 87.02 C \nANISOU 3445 C ASP B 120 10909 10559 11595 -2165 -1035 227 C \nATOM 3446 O ASP B 120 8.031 -2.510 18.884 1.00 84.60 O \nANISOU 3446 O ASP B 120 10645 10279 11219 -2282 -1065 252 O \nATOM 3447 CB ASP B 120 6.484 -1.575 16.131 1.00 95.83 C \nANISOU 3447 CB ASP B 120 11854 11902 12655 -2266 -983 234 C \nATOM 3448 CG ASP B 120 5.229 -0.724 15.971 1.00111.09 C \nANISOU 3448 CG ASP B 120 13583 14085 14541 -2298 -930 224 C \nATOM 3449 OD1 ASP B 120 5.175 0.416 16.497 1.00115.31 O \nANISOU 3449 OD1 ASP B 120 13970 14724 15117 -2183 -880 192 O \nATOM 3450 OD2 ASP B 120 4.281 -1.200 15.294 1.00125.79 O \nANISOU 3450 OD2 ASP B 120 15441 16049 16305 -2430 -946 246 O \nATOM 3451 N LYS B 121 9.353 -2.612 17.104 1.00 83.10 N \nANISOU 3451 N LYS B 121 10543 9901 11131 -2041 -1070 207 N \nATOM 3452 CA LYS B 121 10.309 -3.528 17.732 1.00 89.35 C \nANISOU 3452 CA LYS B 121 11527 10539 11883 -1987 -1146 202 C \nATOM 3453 C LYS B 121 10.792 -3.036 19.113 1.00 90.23 C \nANISOU 3453 C LYS B 121 11561 10689 12032 -1955 -1122 194 C \nATOM 3454 O LYS B 121 10.939 -3.822 20.047 1.00 91.10 O \nANISOU 3454 O LYS B 121 11823 10722 12069 -2012 -1188 211 O \nATOM 3455 CB LYS B 121 11.529 -3.712 16.846 1.00 96.92 C \nANISOU 3455 CB LYS B 121 12543 11401 12879 -1776 -1163 157 C \nATOM 3456 CG LYS B 121 11.347 -4.594 15.619 1.00107.82 C \nANISOU 3456 CG LYS B 121 14091 12682 14193 -1772 -1224 159 C \nATOM 3457 CD LYS B 121 12.621 -4.619 14.761 1.00110.20 C \nANISOU 3457 CD LYS B 121 14399 12948 14525 -1530 -1231 102 C \nATOM 3458 CE LYS B 121 13.875 -5.001 15.559 1.00108.61 C \nANISOU 3458 CE LYS B 121 14273 12704 14288 -1359 -1280 61 C \nATOM 3459 NZ LYS B 121 14.103 -6.456 15.624 1.00116.69 N \nANISOU 3459 NZ LYS B 121 15627 13548 15164 -1299 -1418 53 N \nATOM 3460 N VAL B 122 11.055 -1.738 19.224 1.00 90.68 N \nANISOU 3460 N VAL B 122 11410 10851 12194 -1869 -1037 169 N \nATOM 3461 CA VAL B 122 11.489 -1.133 20.482 1.00 90.34 C \nANISOU 3461 CA VAL B 122 11285 10851 12188 -1841 -1010 162 C \nATOM 3462 C VAL B 122 10.341 -1.032 21.473 1.00 89.26 C \nANISOU 3462 C VAL B 122 11097 10821 11996 -1999 -1004 193 C \nATOM 3463 O VAL B 122 10.455 -1.518 22.596 1.00 86.62 O \nANISOU 3463 O VAL B 122 10834 10461 11618 -2059 -1040 210 O \nATOM 3464 CB VAL B 122 12.090 0.266 20.267 1.00 91.94 C \nANISOU 3464 CB VAL B 122 11322 11121 12491 -1725 -935 129 C \nATOM 3465 CG1 VAL B 122 12.539 0.880 21.576 1.00 96.34 C \nANISOU 3465 CG1 VAL B 122 11817 11714 13076 -1708 -915 124 C \nATOM 3466 CG2 VAL B 122 13.280 0.176 19.334 1.00 93.18 C \nANISOU 3466 CG2 VAL B 122 11499 11229 12676 -1592 -939 98 C \nATOM 3467 N ARG B 123 9.224 -0.456 21.037 1.00 87.28 N \nANISOU 3467 N ARG B 123 10723 10710 11727 -2061 -964 199 N \nATOM 3468 CA ARG B 123 8.045 -0.277 21.901 1.00 84.14 C \nANISOU 3468 CA ARG B 123 10230 10493 11245 -2195 -953 219 C \nATOM 3469 C ARG B 123 7.584 -1.553 22.563 1.00 82.14 C \nANISOU 3469 C ARG B 123 10120 10228 10863 -2402 -1024 266 C \nATOM 3470 O ARG B 123 7.100 -1.504 23.685 1.00 92.49 O \nANISOU 3470 O ARG B 123 11374 11658 12109 -2502 -1025 282 O \nATOM 3471 CB ARG B 123 6.865 0.293 21.132 1.00 80.85 C \nANISOU 3471 CB ARG B 123 9676 10260 10785 -2217 -917 211 C \nATOM 3472 CG ARG B 123 5.659 0.580 21.995 1.00 81.75 C \nANISOU 3472 CG ARG B 123 9647 10631 10783 -2318 -903 216 C \nATOM 3473 CD ARG B 123 4.626 1.371 21.208 1.00 93.44 C \nANISOU 3473 CD ARG B 123 10969 12320 12216 -2260 -865 187 C \nATOM 3474 NE ARG B 123 3.377 1.566 21.963 1.00108.57 N \nANISOU 3474 NE ARG B 123 12720 14554 13977 -2344 -858 182 N \nATOM 3475 CZ ARG B 123 2.164 1.665 21.412 1.00118.48 C \nANISOU 3475 CZ ARG B 123 13839 16076 15101 -2391 -848 171 C \nATOM 3476 NH1 ARG B 123 1.999 1.580 20.092 1.00113.29 N \nANISOU 3476 NH1 ARG B 123 13206 15378 14463 -2371 -845 168 N \nATOM 3477 NH2 ARG B 123 1.101 1.849 22.189 1.00120.83 N \nANISOU 3477 NH2 ARG B 123 13962 16715 15232 -2454 -843 159 N \nATOM 3478 N LEU B 124 7.725 -2.686 21.885 1.00 81.03 N \nANISOU 3478 N LEU B 124 10181 9941 10665 -2474 -1093 290 N \nATOM 3479 CA LEU B 124 7.323 -3.969 22.475 1.00 90.37 C \nANISOU 3479 CA LEU B 124 11574 11069 11692 -2699 -1185 342 C \nATOM 3480 C LEU B 124 8.260 -4.434 23.573 1.00 88.70 C \nANISOU 3480 C LEU B 124 11514 10704 11484 -2654 -1236 342 C \nATOM 3481 O LEU B 124 7.806 -5.043 24.546 1.00 83.10 O \nANISOU 3481 O LEU B 124 10903 10018 10654 -2848 -1288 382 O \nATOM 3482 CB LEU B 124 7.210 -5.069 21.426 1.00 91.49 C \nANISOU 3482 CB LEU B 124 11951 11065 11747 -2784 -1264 366 C \nATOM 3483 CG LEU B 124 5.941 -4.983 20.589 1.00100.15 C \nANISOU 3483 CG LEU B 124 12940 12347 12763 -2946 -1240 389 C \nATOM 3484 CD1 LEU B 124 5.768 -6.254 19.759 1.00100.47 C \nANISOU 3484 CD1 LEU B 124 13270 12225 12678 -3090 -1341 427 C \nATOM 3485 CD2 LEU B 124 4.708 -4.703 21.446 1.00 98.01 C \nANISOU 3485 CD2 LEU B 124 12492 12377 12372 -3163 -1212 418 C \nATOM 3486 N GLN B 125 9.546 -4.110 23.439 1.00 89.81 N \nANISOU 3486 N GLN B 125 11660 10718 11747 -2409 -1221 295 N \nATOM 3487 CA GLN B 125 10.541 -4.532 24.424 1.00 93.02 C \nANISOU 3487 CA GLN B 125 12198 10995 12152 -2327 -1270 284 C \nATOM 3488 C GLN B 125 10.508 -3.791 25.754 1.00 85.48 C \nANISOU 3488 C GLN B 125 11083 10157 11237 -2345 -1219 284 C \nATOM 3489 O GLN B 125 10.992 -4.323 26.733 1.00 98.96 O \nANISOU 3489 O GLN B 125 12921 11776 12903 -2353 -1272 291 O \nATOM 3490 CB GLN B 125 11.956 -4.460 23.869 1.00 92.08 C \nANISOU 3490 CB GLN B 125 12109 10762 12115 -2059 -1274 229 C \nATOM 3491 CG GLN B 125 12.291 -5.566 22.887 1.00 89.94 C \nANISOU 3491 CG GLN B 125 12090 10323 11760 -1996 -1367 220 C \nATOM 3492 CD GLN B 125 13.708 -5.456 22.406 1.00 91.42 C \nANISOU 3492 CD GLN B 125 12265 10470 12002 -1713 -1368 154 C \nATOM 3493 OE1 GLN B 125 14.542 -6.288 22.720 1.00 94.66 O \nANISOU 3493 OE1 GLN B 125 12876 10758 12330 -1579 -1458 126 O \nATOM 3494 NE2 GLN B 125 13.999 -4.394 21.672 1.00 97.00 N \nANISOU 3494 NE2 GLN B 125 12732 11300 12825 -1619 -1271 127 N \nATOM 3495 N LEU B 126 9.886 -2.623 25.833 1.00 86.21 N \nANISOU 3495 N LEU B 126 10923 10442 11391 -2350 -1128 275 N \nATOM 3496 CA LEU B 126 9.990 -1.836 27.059 1.00 85.13 C \nANISOU 3496 CA LEU B 126 10648 10401 11296 -2323 -1084 265 C \nATOM 3497 C LEU B 126 8.706 -1.150 27.506 1.00 83.40 C \nANISOU 3497 C LEU B 126 10239 10426 11022 -2433 -1036 276 C \nATOM 3498 O LEU B 126 8.727 -0.104 28.125 1.00 93.36 O \nANISOU 3498 O LEU B 126 11347 11789 12338 -2342 -983 249 O \nATOM 3499 CB LEU B 126 11.154 -0.849 26.914 1.00 87.49 C \nANISOU 3499 CB LEU B 126 10850 10657 11734 -2101 -1030 218 C \nATOM 3500 CG LEU B 126 11.358 -0.108 25.596 1.00 80.90 C \nANISOU 3500 CG LEU B 126 9929 9832 10976 -1985 -982 189 C \nATOM 3501 CD1 LEU B 126 10.385 1.047 25.464 1.00 85.92 C \nANISOU 3501 CD1 LEU B 126 10392 10631 11622 -1991 -921 181 C \nATOM 3502 CD2 LEU B 126 12.769 0.391 25.491 1.00 74.43 C \nANISOU 3502 CD2 LEU B 126 9089 8949 10241 -1821 -962 154 C \nATOM 3503 N ARG B 127 7.595 -1.809 27.250 1.00 93.37 N \nANISOU 3503 N ARG B 127 11528 11798 12151 -2635 -1067 312 N \nATOM 3504 CA ARG B 127 6.222 -1.315 27.537 1.00 96.98 C \nANISOU 3504 CA ARG B 127 11783 12562 12501 -2752 -1030 317 C \nATOM 3505 C ARG B 127 6.139 -0.154 28.534 1.00 95.72 C \nANISOU 3505 C ARG B 127 11431 12559 12380 -2631 -974 281 C \nATOM 3506 O ARG B 127 5.937 1.000 28.141 1.00 95.85 O \nANISOU 3506 O ARG B 127 11294 12675 12449 -2460 -919 235 O \nATOM 3507 CB ARG B 127 5.276 -2.468 27.982 1.00 97.52 C \nANISOU 3507 CB ARG B 127 11944 12744 12365 -3073 -1096 379 C \nATOM 3508 CG ARG B 127 5.672 -3.862 27.487 1.00 99.35 C \nANISOU 3508 CG ARG B 127 12493 12720 12535 -3209 -1193 424 C \nATOM 3509 CD ARG B 127 6.230 -4.715 28.628 1.00103.58 C \nANISOU 3509 CD ARG B 127 13252 13092 13012 -3308 -1271 456 C \nATOM 3510 NE ARG B 127 7.336 -5.564 28.223 1.00109.25 N \nANISOU 3510 NE ARG B 127 14272 13473 13765 -3204 -1352 453 N \nATOM 3511 CZ ARG B 127 7.236 -6.682 27.517 1.00117.68 C \nANISOU 3511 CZ ARG B 127 15619 14377 14716 -3327 -1448 487 C \nATOM 3512 NH1 ARG B 127 6.055 -7.100 27.088 1.00127.54 N \nANISOU 3512 NH1 ARG B 127 16879 15771 15808 -3602 -1472 535 N \nATOM 3513 NH2 ARG B 127 8.330 -7.377 27.219 1.00120.91 N \nANISOU 3513 NH2 ARG B 127 16301 14491 15147 -3164 -1527 466 N \nATOM 3514 N ASP B 128 6.270 -0.476 29.814 1.00 96.99 N \nANISOU 3514 N ASP B 128 11625 12730 12497 -2720 -997 301 N \nATOM 3515 CA ASP B 128 6.124 0.513 30.881 1.00101.05 C \nANISOU 3515 CA ASP B 128 11972 13400 13021 -2624 -954 270 C \nATOM 3516 C ASP B 128 7.482 0.905 31.498 1.00 99.41 C \nANISOU 3516 C ASP B 128 11837 12972 12962 -2464 -947 250 C \nATOM 3517 O ASP B 128 7.535 1.720 32.417 1.00105.10 O \nANISOU 3517 O ASP B 128 12457 13773 13702 -2377 -918 225 O \nATOM 3518 CB ASP B 128 5.129 0.043 31.958 1.00100.40 C \nANISOU 3518 CB ASP B 128 11819 13569 12758 -2847 -977 301 C \nATOM 3519 CG ASP B 128 5.404 -1.383 32.460 1.00104.97 C \nANISOU 3519 CG ASP B 128 12630 13994 13258 -3091 -1056 367 C \nATOM 3520 OD1 ASP B 128 6.450 -1.974 32.120 1.00 97.53 O \nANISOU 3520 OD1 ASP B 128 11907 12743 12407 -3036 -1097 376 O \nATOM 3521 OD2 ASP B 128 4.540 -1.913 33.189 1.00108.64 O \nANISOU 3521 OD2 ASP B 128 13067 14667 13544 -3337 -1085 405 O \nATOM 3522 N ASN B 129 8.562 0.349 30.960 1.00 85.98 N \nANISOU 3522 N ASN B 129 10302 11019 11347 -2415 -975 257 N \nATOM 3523 CA ASN B 129 9.884 0.799 31.299 1.00 85.19 C \nANISOU 3523 CA ASN B 129 10237 10760 11372 -2252 -962 231 C \nATOM 3524 C ASN B 129 10.261 2.156 30.657 1.00 85.14 C \nANISOU 3524 C ASN B 129 10122 10760 11468 -2067 -903 187 C \nATOM 3525 O ASN B 129 11.251 2.759 31.056 1.00 76.91 O \nANISOU 3525 O ASN B 129 9079 9639 10505 -1961 -886 167 O \nATOM 3526 CB ASN B 129 10.896 -0.274 30.919 1.00 87.76 C \nANISOU 3526 CB ASN B 129 10763 10867 11715 -2238 -1019 242 C \nATOM 3527 CG ASN B 129 10.901 -1.422 31.917 1.00 96.60 C \nANISOU 3527 CG ASN B 129 12047 11918 12737 -2377 -1093 278 C \nATOM 3528 OD1 ASN B 129 9.993 -1.538 32.750 1.00101.98 O \nANISOU 3528 OD1 ASN B 129 12687 12737 13326 -2540 -1099 307 O \nATOM 3529 ND2 ASN B 129 11.937 -2.257 31.864 1.00 92.63 N \nANISOU 3529 ND2 ASN B 129 11739 11219 12236 -2304 -1156 273 N \nATOM 3530 N ALA B 130 9.469 2.624 29.686 1.00 78.13 N \nANISOU 3530 N ALA B 130 9160 9968 10560 -2044 -879 174 N \nATOM 3531 CA ALA B 130 9.649 3.930 29.052 1.00 73.69 C \nANISOU 3531 CA ALA B 130 8534 9407 10060 -1887 -838 135 C \nATOM 3532 C ALA B 130 8.346 4.657 28.715 1.00 74.59 C \nANISOU 3532 C ALA B 130 8532 9717 10091 -1846 -820 110 C \nATOM 3533 O ALA B 130 7.302 4.024 28.531 1.00 73.33 O \nANISOU 3533 O ALA B 130 8320 9711 9831 -1956 -830 125 O \nATOM 3534 CB ALA B 130 10.473 3.776 27.772 1.00 76.88 C \nANISOU 3534 CB ALA B 130 9011 9664 10537 -1837 -837 132 C \nATOM 3535 N LYS B 131 8.451 5.985 28.577 1.00 77.01 N \nANISOU 3535 N LYS B 131 8818 10020 10421 -1687 -802 69 N \nATOM 3536 CA LYS B 131 7.340 6.873 28.175 1.00 82.90 C \nANISOU 3536 CA LYS B 131 9486 10936 11077 -1573 -796 27 C \nATOM 3537 C LYS B 131 7.433 7.122 26.670 1.00 85.56 C \nANISOU 3537 C LYS B 131 9870 11186 11453 -1520 -790 18 C \nATOM 3538 O LYS B 131 8.460 7.555 26.193 1.00 67.77 O \nANISOU 3538 O LYS B 131 7713 8747 9288 -1479 -787 19 O \nATOM 3539 CB LYS B 131 7.394 8.263 28.845 1.00 91.50 C \nANISOU 3539 CB LYS B 131 10594 12033 12141 -1400 -804 -20 C \nATOM 3540 CG LYS B 131 6.786 8.397 30.234 1.00102.40 C \nANISOU 3540 CG LYS B 131 11885 13595 13429 -1380 -812 -37 C \nATOM 3541 CD LYS B 131 6.780 9.854 30.735 1.00103.18 C \nANISOU 3541 CD LYS B 131 12042 13683 13479 -1169 -834 -93 C \nATOM 3542 CE LYS B 131 6.377 10.003 32.232 1.00104.49 C \nANISOU 3542 CE LYS B 131 12130 14010 13561 -1136 -844 -112 C \nATOM 3543 NZ LYS B 131 5.320 9.042 32.681 1.00103.77 N \nANISOU 3543 NZ LYS B 131 11853 14215 13361 -1257 -832 -99 N \nATOM 3544 N GLU B 132 6.347 6.852 25.935 1.00 96.43 N \nANISOU 3544 N GLU B 132 11169 12723 12746 -1534 -789 11 N \nATOM 3545 CA GLU B 132 6.238 7.264 24.534 1.00 93.28 C \nANISOU 3545 CA GLU B 132 10804 12273 12365 -1456 -784 -7 C \nATOM 3546 C GLU B 132 5.978 8.762 24.462 1.00 93.86 C \nANISOU 3546 C GLU B 132 10910 12364 12387 -1243 -797 -65 C \nATOM 3547 O GLU B 132 4.871 9.218 24.765 1.00 96.34 O \nANISOU 3547 O GLU B 132 11134 12902 12568 -1131 -810 -110 O \nATOM 3548 CB GLU B 132 5.104 6.525 23.829 1.00 93.00 C \nANISOU 3548 CB GLU B 132 10673 12426 12238 -1539 -783 1 C \nATOM 3549 CG GLU B 132 5.293 5.026 23.720 1.00 93.84 C \nANISOU 3549 CG GLU B 132 10811 12480 12363 -1759 -791 60 C \nATOM 3550 CD GLU B 132 4.197 4.365 22.904 1.00 96.89 C \nANISOU 3550 CD GLU B 132 11129 13041 12644 -1867 -796 73 C \nATOM 3551 OE1 GLU B 132 4.160 4.558 21.678 1.00 91.07 O \nANISOU 3551 OE1 GLU B 132 10414 12250 11938 -1807 -789 62 O \nATOM 3552 OE2 GLU B 132 3.365 3.648 23.495 1.00102.08 O \nANISOU 3552 OE2 GLU B 132 11710 13904 13173 -2032 -810 97 O \nATOM 3553 N LEU B 133 6.993 9.514 24.055 1.00 88.37 N \nANISOU 3553 N LEU B 133 10358 11448 11772 -1187 -804 -68 N \nATOM 3554 CA LEU B 133 6.905 10.979 24.013 1.00 90.50 C \nANISOU 3554 CA LEU B 133 10741 11667 11977 -1002 -838 -117 C \nATOM 3555 C LEU B 133 5.974 11.455 22.902 1.00 93.14 C \nANISOU 3555 C LEU B 133 11081 12083 12225 -869 -855 -158 C \nATOM 3556 O LEU B 133 5.556 12.639 22.889 1.00 88.93 O \nANISOU 3556 O LEU B 133 10653 11552 11586 -669 -902 -214 O \nATOM 3557 CB LEU B 133 8.285 11.626 23.851 1.00 82.07 C \nANISOU 3557 CB LEU B 133 9846 10348 10989 -1038 -848 -97 C \nATOM 3558 CG LEU B 133 9.204 11.755 25.036 1.00 79.92 C \nANISOU 3558 CG LEU B 133 9614 9996 10758 -1099 -850 -79 C \nATOM 3559 CD1 LEU B 133 8.845 10.747 26.083 1.00 81.43 C \nANISOU 3559 CD1 LEU B 133 9655 10327 10959 -1165 -828 -63 C \nATOM 3560 CD2 LEU B 133 10.651 11.609 24.600 1.00 81.16 C \nANISOU 3560 CD2 LEU B 133 9838 9990 11010 -1234 -835 -38 C \nATOM 3561 N GLY B 134 5.647 10.536 21.987 1.00 82.52 N \nANISOU 3561 N GLY B 134 9645 10799 10910 -968 -827 -133 N \nATOM 3562 CA GLY B 134 4.776 10.845 20.854 1.00 81.29 C \nANISOU 3562 CA GLY B 134 9474 10734 10678 -860 -837 -168 C \nATOM 3563 C GLY B 134 5.513 11.603 19.785 1.00 82.46 C \nANISOU 3563 C GLY B 134 9803 10648 10880 -816 -854 -169 C \nATOM 3564 O GLY B 134 4.927 12.419 19.077 1.00 90.47 O \nANISOU 3564 O GLY B 134 10890 11679 11805 -655 -887 -214 O \nATOM 3565 N ASN B 135 6.807 11.317 19.667 1.00 86.16 N \nANISOU 3565 N ASN B 135 10345 10919 11475 -961 -835 -120 N \nATOM 3566 CA ASN B 135 7.722 12.107 18.829 1.00 84.07 C \nANISOU 3566 CA ASN B 135 10255 10445 11242 -968 -853 -113 C \nATOM 3567 C ASN B 135 8.760 11.224 18.109 1.00 82.76 C \nANISOU 3567 C ASN B 135 10059 10191 11196 -1139 -815 -62 C \nATOM 3568 O ASN B 135 9.607 11.724 17.368 1.00 76.32 O \nANISOU 3568 O ASN B 135 9352 9246 10399 -1184 -822 -50 O \nATOM 3569 CB ASN B 135 8.427 13.173 19.670 1.00 83.17 C \nANISOU 3569 CB ASN B 135 10304 10202 11093 -939 -892 -120 C \nATOM 3570 CG ASN B 135 9.508 12.597 20.531 1.00 85.67 C \nANISOU 3570 CG ASN B 135 10572 10477 11501 -1091 -863 -77 C \nATOM 3571 OD1 ASN B 135 9.449 11.419 20.931 1.00 95.67 O \nANISOU 3571 OD1 ASN B 135 11683 11837 12830 -1167 -825 -55 O \nATOM 3572 ND2 ASN B 135 10.523 13.406 20.807 1.00 78.52 N \nANISOU 3572 ND2 ASN B 135 9816 9432 10586 -1146 -888 -65 N \nATOM 3573 N GLY B 136 8.693 9.914 18.332 1.00 77.23 N \nANISOU 3573 N GLY B 136 9224 9569 10550 -1231 -783 -36 N \nATOM 3574 CA GLY B 136 9.646 9.007 17.749 1.00 67.41 C \nANISOU 3574 CA GLY B 136 7966 8255 9394 -1345 -761 -1 C \nATOM 3575 C GLY B 136 10.569 8.486 18.800 1.00 68.87 C \nANISOU 3575 C GLY B 136 8132 8413 9623 -1417 -756 20 C \nATOM 3576 O GLY B 136 11.267 7.500 18.570 1.00 58.83 O \nANISOU 3576 O GLY B 136 6838 7116 8399 -1480 -748 40 O \nATOM 3577 N CYS B 137 10.555 9.145 19.961 1.00 78.61 N \nANISOU 3577 N CYS B 137 9386 9656 10827 -1385 -767 9 N \nATOM 3578 CA CYS B 137 11.482 8.848 21.046 1.00 79.96 C \nANISOU 3578 CA CYS B 137 9548 9800 11033 -1444 -764 26 C \nATOM 3579 C CYS B 137 10.780 8.306 22.240 1.00 78.43 C \nANISOU 3579 C CYS B 137 9287 9697 10818 -1447 -768 27 C \nATOM 3580 O CYS B 137 9.635 8.657 22.494 1.00 83.35 O \nANISOU 3580 O CYS B 137 9874 10423 11372 -1383 -775 6 O \nATOM 3581 CB CYS B 137 12.188 10.116 21.497 1.00 73.98 C \nANISOU 3581 CB CYS B 137 8889 8971 10250 -1434 -780 18 C \nATOM 3582 SG CYS B 137 13.010 10.967 20.168 1.00 81.40 S \nANISOU 3582 SG CYS B 137 9938 9819 11171 -1478 -788 23 S \nATOM 3583 N PHE B 138 11.489 7.473 22.989 1.00 74.17 N \nANISOU 3583 N PHE B 138 8728 9138 10316 -1515 -766 48 N \nATOM 3584 CA PHE B 138 11.008 7.010 24.257 1.00 73.67 C \nANISOU 3584 CA PHE B 138 8620 9146 10226 -1543 -773 55 C \nATOM 3585 C PHE B 138 11.876 7.633 25.358 1.00 75.73 C \nANISOU 3585 C PHE B 138 8909 9361 10505 -1532 -775 52 C \nATOM 3586 O PHE B 138 13.104 7.582 25.295 1.00 64.93 O \nANISOU 3586 O PHE B 138 7570 7921 9179 -1558 -772 60 O \nATOM 3587 CB PHE B 138 11.107 5.489 24.359 1.00 83.44 C \nANISOU 3587 CB PHE B 138 9857 10376 11472 -1635 -787 83 C \nATOM 3588 CG PHE B 138 10.407 4.732 23.256 1.00 81.92 C \nANISOU 3588 CG PHE B 138 9667 10205 11254 -1677 -794 94 C \nATOM 3589 CD1 PHE B 138 9.074 4.399 23.367 1.00 78.11 C \nANISOU 3589 CD1 PHE B 138 9129 9860 10689 -1738 -800 101 C \nATOM 3590 CD2 PHE B 138 11.112 4.314 22.132 1.00 80.21 C \nANISOU 3590 CD2 PHE B 138 9501 9896 11078 -1663 -797 96 C \nATOM 3591 CE1 PHE B 138 8.446 3.686 22.375 1.00 83.79 C \nANISOU 3591 CE1 PHE B 138 9858 10608 11372 -1801 -810 115 C \nATOM 3592 CE2 PHE B 138 10.489 3.602 21.134 1.00 78.56 C \nANISOU 3592 CE2 PHE B 138 9312 9696 10843 -1703 -809 106 C \nATOM 3593 CZ PHE B 138 9.155 3.285 21.258 1.00 86.03 C \nANISOU 3593 CZ PHE B 138 10216 10760 11710 -1781 -816 118 C \nATOM 3594 N GLU B 139 11.235 8.219 26.368 1.00 75.49 N \nANISOU 3594 N GLU B 139 8859 9398 10425 -1489 -783 37 N \nATOM 3595 CA GLU B 139 11.930 8.588 27.590 1.00 78.03 C \nANISOU 3595 CA GLU B 139 9202 9686 10758 -1495 -787 39 C \nATOM 3596 C GLU B 139 11.876 7.389 28.510 1.00 76.81 C \nANISOU 3596 C GLU B 139 8993 9578 10612 -1572 -789 61 C \nATOM 3597 O GLU B 139 10.813 7.036 29.046 1.00 64.44 O \nANISOU 3597 O GLU B 139 7365 8133 8986 -1591 -794 61 O \nATOM 3598 CB GLU B 139 11.316 9.819 28.275 1.00 86.26 C \nANISOU 3598 CB GLU B 139 10278 10767 11730 -1393 -806 7 C \nATOM 3599 CG GLU B 139 12.071 10.233 29.533 1.00 86.14 C \nANISOU 3599 CG GLU B 139 10300 10706 11724 -1407 -814 10 C \nATOM 3600 CD GLU B 139 11.749 11.631 30.042 1.00 89.00 C \nANISOU 3600 CD GLU B 139 10763 11048 12005 -1292 -848 -24 C \nATOM 3601 OE1 GLU B 139 11.140 12.451 29.327 1.00 89.94 O \nANISOU 3601 OE1 GLU B 139 10961 11157 12055 -1186 -874 -55 O \nATOM 3602 OE2 GLU B 139 12.134 11.924 31.186 1.00 96.17 O \nANISOU 3602 OE2 GLU B 139 11694 11940 12907 -1297 -858 -23 O \nATOM 3603 N PHE B 140 13.037 6.768 28.702 1.00 81.16 N \nANISOU 3603 N PHE B 140 9571 10051 11214 -1617 -791 78 N \nATOM 3604 CA PHE B 140 13.156 5.616 29.566 1.00 77.99 C \nANISOU 3604 CA PHE B 140 9169 9653 10809 -1679 -809 98 C \nATOM 3605 C PHE B 140 12.747 6.062 30.940 1.00 85.81 C \nANISOU 3605 C PHE B 140 10125 10708 11770 -1681 -809 95 C \nATOM 3606 O PHE B 140 13.006 7.189 31.370 1.00 91.72 O \nANISOU 3606 O PHE B 140 10878 11449 12522 -1623 -801 77 O \nATOM 3607 CB PHE B 140 14.585 5.139 29.680 1.00 74.18 C \nANISOU 3607 CB PHE B 140 8725 9095 10365 -1670 -819 99 C \nATOM 3608 CG PHE B 140 15.061 4.388 28.502 1.00 80.26 C \nANISOU 3608 CG PHE B 140 9531 9823 11142 -1652 -830 97 C \nATOM 3609 CD1 PHE B 140 15.441 5.049 27.347 1.00 74.42 C \nANISOU 3609 CD1 PHE B 140 8774 9082 10421 -1619 -809 84 C \nATOM 3610 CD2 PHE B 140 15.155 3.010 28.551 1.00 79.78 C \nANISOU 3610 CD2 PHE B 140 9545 9715 11051 -1665 -874 107 C \nATOM 3611 CE1 PHE B 140 15.873 4.337 26.257 1.00 80.62 C \nANISOU 3611 CE1 PHE B 140 9582 9847 11203 -1590 -821 78 C \nATOM 3612 CE2 PHE B 140 15.609 2.296 27.460 1.00 81.52 C \nANISOU 3612 CE2 PHE B 140 9820 9893 11262 -1617 -896 97 C \nATOM 3613 CZ PHE B 140 15.964 2.958 26.307 1.00 78.03 C \nANISOU 3613 CZ PHE B 140 9325 9475 10846 -1575 -865 81 C \nATOM 3614 N TYR B 141 12.095 5.178 31.660 1.00 96.01 N \nANISOU 3614 N TYR B 141 11401 12063 13016 -1759 -826 114 N \nATOM 3615 CA TYR B 141 11.819 5.496 33.032 1.00 97.97 C \nANISOU 3615 CA TYR B 141 11608 12384 13231 -1766 -827 111 C \nATOM 3616 C TYR B 141 13.181 5.362 33.670 1.00106.16 C \nANISOU 3616 C TYR B 141 12699 13307 14330 -1757 -833 116 C \nATOM 3617 O TYR B 141 13.768 6.349 34.134 1.00124.83 O \nANISOU 3617 O TYR B 141 15060 15649 16720 -1700 -820 100 O \nATOM 3618 CB TYR B 141 10.750 4.576 33.619 1.00 93.55 C \nANISOU 3618 CB TYR B 141 11013 11953 12580 -1888 -847 135 C \nATOM 3619 CG TYR B 141 9.360 5.061 33.276 1.00 86.89 C \nANISOU 3619 CG TYR B 141 10061 11310 11643 -1871 -834 116 C \nATOM 3620 CD1 TYR B 141 8.997 6.373 33.543 1.00 82.08 C \nANISOU 3620 CD1 TYR B 141 9391 10789 11008 -1725 -819 72 C \nATOM 3621 CD2 TYR B 141 8.415 4.230 32.681 1.00 92.74 C \nANISOU 3621 CD2 TYR B 141 10774 12163 12299 -1991 -847 137 C \nATOM 3622 CE1 TYR B 141 7.753 6.846 33.224 1.00 82.56 C \nANISOU 3622 CE1 TYR B 141 9350 11059 10958 -1660 -817 40 C \nATOM 3623 CE2 TYR B 141 7.146 4.694 32.373 1.00 91.87 C \nANISOU 3623 CE2 TYR B 141 10536 12290 12080 -1964 -835 112 C \nATOM 3624 CZ TYR B 141 6.832 6.005 32.652 1.00 92.52 C \nANISOU 3624 CZ TYR B 141 10545 12473 12137 -1779 -819 59 C \nATOM 3625 OH TYR B 141 5.578 6.492 32.363 1.00115.92 O \nANISOU 3625 OH TYR B 141 13378 15700 14966 -1703 -816 19 O \nATOM 3626 N HIS B 142 13.741 4.166 33.565 1.00 96.95 N \nANISOU 3626 N HIS B 142 11600 12066 13170 -1803 -861 134 N \nATOM 3627 CA HIS B 142 15.055 3.892 34.153 1.00 89.34 C \nANISOU 3627 CA HIS B 142 10678 11028 12239 -1769 -874 130 C \nATOM 3628 C HIS B 142 16.304 4.519 33.515 1.00 90.55 C \nANISOU 3628 C HIS B 142 10815 11152 12436 -1692 -855 108 C \nATOM 3629 O HIS B 142 16.276 5.201 32.486 1.00 99.44 O \nANISOU 3629 O HIS B 142 11920 12286 13577 -1671 -832 98 O \nATOM 3630 CB HIS B 142 15.257 2.383 34.343 1.00 83.69 C \nANISOU 3630 CB HIS B 142 10077 10242 11481 -1808 -931 147 C \nATOM 3631 CG HIS B 142 15.234 1.578 33.095 1.00 80.13 C \nANISOU 3631 CG HIS B 142 9706 9733 11009 -1798 -959 148 C \nATOM 3632 ND1 HIS B 142 14.053 1.124 32.545 1.00 89.83 N \nANISOU 3632 ND1 HIS B 142 10962 10983 12186 -1897 -972 171 N \nATOM 3633 CD2 HIS B 142 16.230 1.058 32.344 1.00 75.66 C \nANISOU 3633 CD2 HIS B 142 9202 9102 10443 -1701 -984 126 C \nATOM 3634 CE1 HIS B 142 14.323 0.398 31.476 1.00 92.07 C \nANISOU 3634 CE1 HIS B 142 11341 11188 12454 -1865 -1005 168 C \nATOM 3635 NE2 HIS B 142 15.636 0.347 31.329 1.00 88.59 N \nANISOU 3635 NE2 HIS B 142 10921 10695 12043 -1733 -1013 137 N \nATOM 3636 N LYS B 143 17.397 4.311 34.227 1.00 88.60 N \nANISOU 3636 N LYS B 143 10576 10897 12193 -1664 -866 100 N \nATOM 3637 CA LYS B 143 18.725 4.587 33.752 1.00 86.41 C \nANISOU 3637 CA LYS B 143 10266 10648 11917 -1611 -857 78 C \nATOM 3638 C LYS B 143 19.086 3.489 32.791 1.00 85.78 C \nANISOU 3638 C LYS B 143 10233 10550 11809 -1546 -889 64 C \nATOM 3639 O LYS B 143 18.982 2.304 33.136 1.00 89.76 O \nANISOU 3639 O LYS B 143 10832 10994 12278 -1519 -940 66 O \nATOM 3640 CB LYS B 143 19.690 4.536 34.926 1.00 88.04 C \nANISOU 3640 CB LYS B 143 10454 10886 12109 -1592 -867 69 C \nATOM 3641 CG LYS B 143 21.155 4.690 34.552 1.00 96.26 C \nANISOU 3641 CG LYS B 143 11433 12025 13115 -1542 -862 41 C \nATOM 3642 CD LYS B 143 22.066 4.314 35.708 1.00104.21 C \nANISOU 3642 CD LYS B 143 12423 13083 14088 -1498 -882 26 C \nATOM 3643 CE LYS B 143 21.860 5.250 36.893 1.00106.43 C \nANISOU 3643 CE LYS B 143 12685 13354 14398 -1582 -859 46 C \nATOM 3644 NZ LYS B 143 22.805 4.974 37.999 1.00102.39 N \nANISOU 3644 NZ LYS B 143 12145 12905 13853 -1546 -875 31 N \nATOM 3645 N CYS B 144 19.540 3.886 31.608 1.00 82.12 N \nANISOU 3645 N CYS B 144 9726 10132 11345 -1521 -869 50 N \nATOM 3646 CA CYS B 144 19.856 2.944 30.554 1.00 74.82 C \nANISOU 3646 CA CYS B 144 8841 9202 10386 -1440 -899 30 C \nATOM 3647 C CYS B 144 21.255 3.207 30.040 1.00 76.00 C \nANISOU 3647 C CYS B 144 8900 9489 10489 -1372 -889 -5 C \nATOM 3648 O CYS B 144 21.460 4.013 29.122 1.00 65.00 O \nANISOU 3648 O CYS B 144 7438 8162 9096 -1416 -853 -5 O \nATOM 3649 CB CYS B 144 18.837 3.032 29.421 1.00 70.38 C \nANISOU 3649 CB CYS B 144 8302 8591 9848 -1481 -886 46 C \nATOM 3650 SG CYS B 144 18.768 1.630 28.253 1.00 77.47 S \nANISOU 3650 SG CYS B 144 9308 9427 10698 -1399 -941 32 S \nATOM 3651 N ASP B 145 22.224 2.511 30.641 1.00 87.83 N \nANISOU 3651 N ASP B 145 10398 11050 11924 -1266 -925 -37 N \nATOM 3652 CA ASP B 145 23.638 2.626 30.226 1.00 91.70 C \nANISOU 3652 CA ASP B 145 10768 11744 12328 -1182 -921 -81 C \nATOM 3653 C ASP B 145 23.828 2.191 28.774 1.00 87.20 C \nANISOU 3653 C ASP B 145 10192 11228 11713 -1096 -934 -109 C \nATOM 3654 O ASP B 145 22.930 1.639 28.155 1.00 88.85 O \nANISOU 3654 O ASP B 145 10512 11290 11956 -1084 -955 -95 O \nATOM 3655 CB ASP B 145 24.593 1.861 31.178 1.00 99.75 C \nANISOU 3655 CB ASP B 145 11791 12845 13265 -1040 -969 -123 C \nATOM 3656 CG ASP B 145 24.229 0.381 31.354 1.00102.08 C \nANISOU 3656 CG ASP B 145 12282 12982 13522 -893 -1055 -140 C \nATOM 3657 OD1 ASP B 145 23.685 -0.242 30.432 1.00107.40 O \nANISOU 3657 OD1 ASP B 145 13062 13555 14189 -853 -1087 -140 O \nATOM 3658 OD2 ASP B 145 24.512 -0.177 32.433 1.00106.54 O \nANISOU 3658 OD2 ASP B 145 12919 13513 14047 -822 -1101 -154 O \nATOM 3659 N ASN B 146 25.001 2.458 28.230 1.00 90.67 N \nANISOU 3659 N ASN B 146 10489 11902 12059 -1047 -920 -147 N \nATOM 3660 CA ASN B 146 25.289 2.115 26.847 1.00 89.98 C \nANISOU 3660 CA ASN B 146 10369 11908 11912 -959 -929 -179 C \nATOM 3661 C ASN B 146 24.948 0.671 26.500 1.00 89.65 C \nANISOU 3661 C ASN B 146 10495 11730 11839 -762 -1007 -210 C \nATOM 3662 O ASN B 146 24.431 0.408 25.425 1.00 87.69 O \nANISOU 3662 O ASN B 146 10303 11408 11606 -749 -1014 -206 O \nATOM 3663 CB ASN B 146 26.755 2.412 26.516 1.00 90.44 C \nANISOU 3663 CB ASN B 146 10229 12310 11826 -909 -916 -229 C \nATOM 3664 CG ASN B 146 27.073 3.881 26.583 1.00 98.98 C \nANISOU 3664 CG ASN B 146 11182 13519 12907 -1156 -850 -189 C \nATOM 3665 OD1 ASN B 146 28.082 4.283 27.161 1.00116.04 O \nANISOU 3665 OD1 ASN B 146 13209 15911 14970 -1198 -839 -205 O \nATOM 3666 ND2 ASN B 146 26.198 4.704 26.019 1.00105.22 N \nANISOU 3666 ND2 ASN B 146 12033 14157 13790 -1325 -815 -136 N \nATOM 3667 N GLU B 147 25.240 -0.257 27.405 1.00 96.57 N \nANISOU 3667 N GLU B 147 11477 12560 12656 -615 -1075 -240 N \nATOM 3668 CA GLU B 147 24.950 -1.670 27.157 1.00102.26 C \nANISOU 3668 CA GLU B 147 12426 13116 13311 -433 -1174 -269 C \nATOM 3669 C GLU B 147 23.454 -1.946 27.183 1.00100.66 C \nANISOU 3669 C GLU B 147 12411 12627 13210 -588 -1186 -202 C \nATOM 3670 O GLU B 147 22.973 -2.785 26.430 1.00102.73 O \nANISOU 3670 O GLU B 147 12841 12758 13435 -529 -1245 -206 O \nATOM 3671 CB GLU B 147 25.710 -2.584 28.126 1.00106.22 C \nANISOU 3671 CB GLU B 147 13031 13636 13692 -223 -1261 -323 C \nATOM 3672 CG GLU B 147 27.204 -2.613 27.846 1.00115.37 C \nANISOU 3672 CG GLU B 147 14012 15129 14693 0 -1273 -411 C \nATOM 3673 CD GLU B 147 27.956 -3.630 28.687 1.00126.22 C \nANISOU 3673 CD GLU B 147 15514 16528 15916 273 -1378 -481 C \nATOM 3674 OE1 GLU B 147 28.434 -3.253 29.778 1.00128.24 O \nANISOU 3674 OE1 GLU B 147 15672 16883 16169 241 -1356 -482 O \nATOM 3675 OE2 GLU B 147 28.065 -4.808 28.272 1.00134.93 O \nANISOU 3675 OE2 GLU B 147 16838 17539 16891 527 -1492 -538 O \nATOM 3676 N CYS B 148 22.724 -1.245 28.047 1.00 98.79 N \nANISOU 3676 N CYS B 148 12141 12316 13077 -786 -1134 -144 N \nATOM 3677 CA CYS B 148 21.262 -1.319 28.066 1.00 91.41 C \nANISOU 3677 CA CYS B 148 11320 11193 12218 -955 -1130 -83 C \nATOM 3678 C CYS B 148 20.700 -0.798 26.743 1.00 96.00 C \nANISOU 3678 C CYS B 148 11834 11788 12852 -1025 -1082 -67 C \nATOM 3679 O CYS B 148 19.741 -1.344 26.210 1.00107.10 O \nANISOU 3679 O CYS B 148 13365 13068 14261 -1079 -1110 -41 O \nATOM 3680 CB CYS B 148 20.689 -0.512 29.250 1.00 93.48 C \nANISOU 3680 CB CYS B 148 11516 11441 12563 -1120 -1080 -38 C \nATOM 3681 SG CYS B 148 18.913 -0.145 29.285 1.00 96.93 S \nANISOU 3681 SG CYS B 148 11980 11774 13074 -1332 -1046 27 S \nATOM 3682 N MET B 149 21.327 0.237 26.199 1.00 90.10 N \nANISOU 3682 N MET B 149 10903 11201 12129 -1036 -1015 -81 N \nATOM 3683 CA MET B 149 20.928 0.792 24.928 1.00 83.48 C \nANISOU 3683 CA MET B 149 10007 10383 11329 -1094 -973 -69 C \nATOM 3684 C MET B 149 21.265 -0.160 23.792 1.00 82.94 C \nANISOU 3684 C MET B 149 10006 10320 11186 -945 -1023 -108 C \nATOM 3685 O MET B 149 20.433 -0.398 22.907 1.00 84.45 O \nANISOU 3685 O MET B 149 10270 10414 11403 -984 -1028 -89 O \nATOM 3686 CB MET B 149 21.608 2.147 24.684 1.00 87.12 C \nANISOU 3686 CB MET B 149 10290 11010 11802 -1170 -903 -71 C \nATOM 3687 CG MET B 149 20.645 3.303 24.520 1.00 87.79 C \nANISOU 3687 CG MET B 149 10358 11028 11969 -1331 -851 -26 C \nATOM 3688 SD MET B 149 20.281 4.031 26.100 1.00104.44 S \nANISOU 3688 SD MET B 149 12469 13090 14122 -1426 -833 2 S \nATOM 3689 CE MET B 149 19.059 5.264 25.699 1.00 76.04 C \nANISOU 3689 CE MET B 149 8891 9420 10582 -1538 -795 35 C \nATOM 3690 N GLU B 150 22.486 -0.688 23.772 1.00 85.41 N \nANISOU 3690 N GLU B 150 10294 10768 11391 -761 -1064 -168 N \nATOM 3691 CA GLU B 150 22.843 -1.658 22.731 1.00 93.42 C \nANISOU 3691 CA GLU B 150 11393 11794 12308 -572 -1128 -217 C \nATOM 3692 C GLU B 150 21.814 -2.778 22.745 1.00 92.55 C \nANISOU 3692 C GLU B 150 11556 11418 12191 -571 -1208 -193 C \nATOM 3693 O GLU B 150 21.434 -3.283 21.680 1.00 99.66 O \nANISOU 3693 O GLU B 150 12554 12246 13067 -533 -1239 -197 O \nATOM 3694 CB GLU B 150 24.260 -2.209 22.903 1.00 99.77 C \nANISOU 3694 CB GLU B 150 12152 12798 12959 -323 -1181 -299 C \nATOM 3695 CG GLU B 150 24.722 -3.175 21.805 1.00109.41 C \nANISOU 3695 CG GLU B 150 13458 14065 14047 -77 -1256 -367 C \nATOM 3696 CD GLU B 150 24.757 -2.547 20.412 1.00116.33 C \nANISOU 3696 CD GLU B 150 14177 15078 14945 -133 -1193 -366 C \nATOM 3697 OE1 GLU B 150 25.378 -1.468 20.257 1.00128.78 O \nANISOU 3697 OE1 GLU B 150 15505 16900 16527 -237 -1111 -364 O \nATOM 3698 OE2 GLU B 150 24.181 -3.126 19.469 1.00109.97 O \nANISOU 3698 OE2 GLU B 150 13509 14137 14138 -90 -1230 -365 O \nATOM 3699 N SER B 151 21.366 -3.130 23.953 1.00 88.47 N \nANISOU 3699 N SER B 151 11165 10766 11683 -638 -1243 -163 N \nATOM 3700 CA SER B 151 20.482 -4.271 24.162 1.00 91.95 C \nANISOU 3700 CA SER B 151 11895 10968 12074 -675 -1336 -135 C \nATOM 3701 C SER B 151 19.121 -4.044 23.526 1.00 95.03 C \nANISOU 3701 C SER B 151 12303 11264 12539 -886 -1299 -73 C \nATOM 3702 O SER B 151 18.553 -4.975 22.950 1.00106.14 O \nANISOU 3702 O SER B 151 13924 12526 13878 -896 -1374 -62 O \nATOM 3703 CB SER B 151 20.306 -4.626 25.649 1.00 93.74 C \nANISOU 3703 CB SER B 151 12240 11097 12279 -735 -1378 -112 C \nATOM 3704 OG SER B 151 19.251 -3.909 26.241 1.00100.11 O \nANISOU 3704 OG SER B 151 12962 11884 13193 -983 -1308 -44 O \nATOM 3705 N VAL B 152 18.612 -2.818 23.607 1.00 90.07 N \nANISOU 3705 N VAL B 152 11465 10725 12031 -1044 -1194 -38 N \nATOM 3706 CA VAL B 152 17.317 -2.510 22.990 1.00 93.14 C \nANISOU 3706 CA VAL B 152 11841 11072 12476 -1215 -1156 10 C \nATOM 3707 C VAL B 152 17.398 -2.431 21.458 1.00 93.11 C \nANISOU 3707 C VAL B 152 11801 11098 12478 -1153 -1141 -9 C \nATOM 3708 O VAL B 152 16.396 -2.609 20.773 1.00104.73 O \nANISOU 3708 O VAL B 152 13327 12508 13956 -1254 -1142 22 O \nATOM 3709 CB VAL B 152 16.658 -1.217 23.537 1.00 94.23 C \nANISOU 3709 CB VAL B 152 11798 11293 12713 -1362 -1065 44 C \nATOM 3710 CG1 VAL B 152 16.571 -1.247 25.048 1.00 93.55 C \nANISOU 3710 CG1 VAL B 152 11731 11193 12620 -1421 -1076 61 C \nATOM 3711 CG2 VAL B 152 17.382 0.028 23.077 1.00 97.72 C \nANISOU 3711 CG2 VAL B 152 12048 11865 13216 -1317 -989 21 C \nATOM 3712 N ARG B 153 18.589 -2.167 20.932 1.00 91.08 N \nANISOU 3712 N ARG B 153 11441 10961 12203 -996 -1125 -60 N \nATOM 3713 CA ARG B 153 18.788 -2.097 19.484 1.00 90.87 C \nANISOU 3713 CA ARG B 153 11369 10988 12169 -929 -1112 -83 C \nATOM 3714 C ARG B 153 18.806 -3.468 18.838 1.00 98.16 C \nANISOU 3714 C ARG B 153 12517 11794 12987 -797 -1214 -108 C \nATOM 3715 O ARG B 153 18.233 -3.651 17.775 1.00 89.39 O \nANISOU 3715 O ARG B 153 11452 10631 11881 -828 -1217 -97 O \nATOM 3716 CB ARG B 153 20.099 -1.378 19.133 1.00 85.91 C \nANISOU 3716 CB ARG B 153 10542 10578 11521 -825 -1066 -130 C \nATOM 3717 CG ARG B 153 20.129 0.100 19.506 1.00 78.37 C \nANISOU 3717 CG ARG B 153 9401 9727 10649 -977 -974 -102 C \nATOM 3718 CD ARG B 153 21.266 0.808 18.802 1.00 79.98 C \nANISOU 3718 CD ARG B 153 9430 10154 10805 -941 -933 -135 C \nATOM 3719 NE ARG B 153 21.956 1.781 19.647 1.00 83.23 N \nANISOU 3719 NE ARG B 153 9710 10699 11213 -1025 -890 -130 N \nATOM 3720 CZ ARG B 153 23.150 1.589 20.207 1.00 89.55 C \nANISOU 3720 CZ ARG B 153 10427 11678 11919 -928 -907 -172 C \nATOM 3721 NH1 ARG B 153 23.829 0.466 20.003 1.00 90.36 N \nANISOU 3721 NH1 ARG B 153 10563 11855 11914 -707 -971 -232 N \nATOM 3722 NH2 ARG B 153 23.685 2.536 20.959 1.00 95.05 N \nANISOU 3722 NH2 ARG B 153 11013 12491 12610 -1043 -867 -159 N \nATOM 3723 N ASN B 154 19.479 -4.421 19.480 1.00111.76 N \nANISOU 3723 N ASN B 154 14397 13467 14598 -639 -1306 -146 N \nATOM 3724 CA ASN B 154 19.647 -5.778 18.920 1.00116.70 C \nANISOU 3724 CA ASN B 154 15297 13960 15083 -465 -1432 -184 C \nATOM 3725 C ASN B 154 18.572 -6.769 19.371 1.00111.68 C \nANISOU 3725 C ASN B 154 14977 13065 14390 -607 -1526 -131 C \nATOM 3726 O ASN B 154 18.716 -7.966 19.152 1.00113.71 O \nANISOU 3726 O ASN B 154 15538 13164 14500 -476 -1657 -157 O \nATOM 3727 CB ASN B 154 21.040 -6.331 19.264 1.00123.89 C \nANISOU 3727 CB ASN B 154 16247 14970 15857 -164 -1505 -270 C \nATOM 3728 CG ASN B 154 21.353 -6.234 20.742 1.00131.45 C \nANISOU 3728 CG ASN B 154 17196 15935 16814 -181 -1510 -265 C \nATOM 3729 OD1 ASN B 154 20.492 -5.828 21.515 1.00131.56 O \nANISOU 3729 OD1 ASN B 154 17196 15863 16926 -419 -1465 -196 O \nATOM 3730 ND2 ASN B 154 22.591 -6.555 21.150 1.00146.28 N \nANISOU 3730 ND2 ASN B 154 19058 17947 18574 78 -1561 -342 N \nATOM 3731 N GLY B 155 17.520 -6.273 20.025 1.00107.30 N \nANISOU 3731 N GLY B 155 14364 12480 13924 -874 -1468 -59 N \nATOM 3732 CA GLY B 155 16.434 -7.124 20.500 1.00102.99 C \nANISOU 3732 CA GLY B 155 14081 11747 13304 -1072 -1548 1 C \nATOM 3733 C GLY B 155 16.735 -7.852 21.804 1.00107.43 C \nANISOU 3733 C GLY B 155 14855 12197 13766 -1052 -1641 1 C \nATOM 3734 O GLY B 155 15.828 -8.318 22.491 1.00110.30 O \nANISOU 3734 O GLY B 155 15385 12450 14074 -1277 -1687 62 O \nATOM 3735 N THR B 156 18.006 -7.938 22.167 1.00106.71 N \nANISOU 3735 N THR B 156 14749 12158 13637 -792 -1669 -67 N \nATOM 3736 CA THR B 156 18.422 -8.691 23.326 1.00113.84 C \nANISOU 3736 CA THR B 156 15878 12948 14429 -720 -1771 -81 C \nATOM 3737 C THR B 156 18.349 -7.855 24.591 1.00104.06 C \nANISOU 3737 C THR B 156 14428 11815 13296 -853 -1683 -50 C \nATOM 3738 O THR B 156 19.318 -7.775 25.329 1.00 99.47 O \nANISOU 3738 O THR B 156 13797 11303 12694 -685 -1692 -96 O \nATOM 3739 CB THR B 156 19.864 -9.175 23.142 1.00125.14 C \nANISOU 3739 CB THR B 156 17375 14428 15744 -338 -1848 -182 C \nATOM 3740 OG1 THR B 156 20.739 -8.045 23.126 1.00126.62 O \nANISOU 3740 OG1 THR B 156 17173 14898 16038 -235 -1723 -223 O \nATOM 3741 CG2 THR B 156 20.014 -9.947 21.840 1.00125.91 C \nANISOU 3741 CG2 THR B 156 17669 14444 15727 -161 -1936 -225 C \nATOM 3742 N TYR B 157 17.186 -7.263 24.850 1.00105.53 N \nANISOU 3742 N TYR B 157 14494 12027 13574 -1142 -1605 23 N \nATOM 3743 CA TYR B 157 16.984 -6.398 26.017 1.00103.47 C \nANISOU 3743 CA TYR B 157 14032 11874 13409 -1270 -1520 52 C \nATOM 3744 C TYR B 157 16.190 -7.118 27.081 1.00109.24 C \nANISOU 3744 C TYR B 157 14981 12478 14048 -1475 -1595 108 C \nATOM 3745 O TYR B 157 15.113 -7.644 26.805 1.00126.83 O \nANISOU 3745 O TYR B 157 17357 14629 16205 -1689 -1636 163 O \nATOM 3746 CB TYR B 157 16.248 -5.117 25.614 1.00102.57 C \nANISOU 3746 CB TYR B 157 13617 11918 13439 -1416 -1385 82 C \nATOM 3747 CG TYR B 157 15.618 -4.326 26.766 1.00 93.08 C \nANISOU 3747 CG TYR B 157 12259 10804 12302 -1585 -1316 121 C \nATOM 3748 CD1 TYR B 157 16.381 -3.474 27.571 1.00 94.40 C \nANISOU 3748 CD1 TYR B 157 12252 11072 12545 -1504 -1256 97 C \nATOM 3749 CD2 TYR B 157 14.265 -4.416 27.030 1.00 87.90 C \nANISOU 3749 CD2 TYR B 157 11622 10160 11614 -1824 -1313 179 C \nATOM 3750 CE1 TYR B 157 15.809 -2.742 28.605 1.00 89.91 C \nANISOU 3750 CE1 TYR B 157 11556 10579 12026 -1636 -1201 127 C \nATOM 3751 CE2 TYR B 157 13.678 -3.692 28.063 1.00 88.90 C \nANISOU 3751 CE2 TYR B 157 11595 10402 11780 -1949 -1254 205 C \nATOM 3752 CZ TYR B 157 14.458 -2.853 28.848 1.00 92.77 C \nANISOU 3752 CZ TYR B 157 11935 10958 12354 -1843 -1200 177 C \nATOM 3753 OH TYR B 157 13.877 -2.144 29.868 1.00 82.10 O \nANISOU 3753 OH TYR B 157 10451 9715 11031 -1947 -1150 198 O \nATOM 3754 N ASP B 158 16.711 -7.123 28.305 1.00115.78 N \nANISOU 3754 N ASP B 158 15822 13305 14866 -1433 -1611 99 N \nATOM 3755 CA ASP B 158 16.056 -7.787 29.440 1.00117.31 C \nANISOU 3755 CA ASP B 158 16223 13389 14960 -1635 -1684 152 C \nATOM 3756 C ASP B 158 15.113 -6.829 30.170 1.00111.28 C \nANISOU 3756 C ASP B 158 15201 12788 14291 -1872 -1575 204 C \nATOM 3757 O ASP B 158 15.554 -5.952 30.904 1.00104.85 O \nANISOU 3757 O ASP B 158 14168 12092 13578 -1809 -1496 186 O \nATOM 3758 CB ASP B 158 17.099 -8.333 30.425 1.00120.05 C \nANISOU 3758 CB ASP B 158 16735 13647 15231 -1452 -1768 111 C \nATOM 3759 CG ASP B 158 16.475 -9.111 31.563 1.00121.57 C \nANISOU 3759 CG ASP B 158 17192 13702 15298 -1667 -1862 168 C \nATOM 3760 OD1 ASP B 158 15.748 -10.086 31.271 1.00131.89 O \nANISOU 3760 OD1 ASP B 158 18813 14844 16456 -1837 -1970 213 O \nATOM 3761 OD2 ASP B 158 16.713 -8.747 32.733 1.00104.31 O \nANISOU 3761 OD2 ASP B 158 14909 11574 13151 -1682 -1830 171 O \nATOM 3762 N TYR B 159 13.813 -7.018 29.970 1.00115.67 N \nANISOU 3762 N TYR B 159 15790 13368 14791 -2138 -1577 265 N \nATOM 3763 CA TYR B 159 12.791 -6.196 30.631 1.00110.72 C \nANISOU 3763 CA TYR B 159 14923 12937 14210 -2348 -1487 306 C \nATOM 3764 C TYR B 159 12.779 -6.320 32.153 1.00114.36 C \nANISOU 3764 C TYR B 159 15421 13406 14626 -2445 -1510 329 C \nATOM 3765 O TYR B 159 12.741 -5.298 32.841 1.00109.13 O \nANISOU 3765 O TYR B 159 14501 12900 14062 -2427 -1416 319 O \nATOM 3766 CB TYR B 159 11.389 -6.507 30.061 1.00107.82 C \nANISOU 3766 CB TYR B 159 14581 12642 13743 -2618 -1497 362 C \nATOM 3767 CG TYR B 159 10.255 -5.804 30.795 1.00102.70 C \nANISOU 3767 CG TYR B 159 13693 12244 13084 -2826 -1422 397 C \nATOM 3768 CD1 TYR B 159 9.841 -4.517 30.413 1.00104.73 C \nANISOU 3768 CD1 TYR B 159 13623 12713 13458 -2755 -1302 371 C \nATOM 3769 CD2 TYR B 159 9.614 -6.408 31.868 1.00 99.74 C \nANISOU 3769 CD2 TYR B 159 13429 11905 12562 -3078 -1479 449 C \nATOM 3770 CE1 TYR B 159 8.817 -3.858 31.075 1.00100.82 C \nANISOU 3770 CE1 TYR B 159 12909 12471 12927 -2891 -1243 387 C \nATOM 3771 CE2 TYR B 159 8.590 -5.765 32.541 1.00100.39 C \nANISOU 3771 CE2 TYR B 159 13267 12267 12611 -3247 -1412 472 C \nATOM 3772 CZ TYR B 159 8.196 -4.493 32.145 1.00108.22 C \nANISOU 3772 CZ TYR B 159 13926 13478 13714 -3133 -1295 436 C \nATOM 3773 OH TYR B 159 7.193 -3.846 32.828 1.00102.80 O \nANISOU 3773 OH TYR B 159 13000 13090 12969 -3249 -1238 443 O \nATOM 3774 N PRO B 160 12.787 -7.567 32.687 1.00125.57 N \nANISOU 3774 N PRO B 160 17185 14646 15880 -2551 -1643 359 N \nATOM 3775 CA PRO B 160 12.578 -7.716 34.137 1.00123.16 C \nANISOU 3775 CA PRO B 160 16920 14362 15511 -2699 -1667 392 C \nATOM 3776 C PRO B 160 13.642 -7.108 35.031 1.00114.62 C \nANISOU 3776 C PRO B 160 15708 13296 14545 -2479 -1622 344 C \nATOM 3777 O PRO B 160 13.348 -6.813 36.192 1.00124.45 O \nANISOU 3777 O PRO B 160 16865 14631 15788 -2595 -1596 367 O \nATOM 3778 CB PRO B 160 12.508 -9.238 34.345 1.00135.26 C \nANISOU 3778 CB PRO B 160 18920 15650 16824 -2838 -1841 430 C \nATOM 3779 CG PRO B 160 13.119 -9.837 33.128 1.00135.33 C \nANISOU 3779 CG PRO B 160 19140 15474 16804 -2637 -1914 391 C \nATOM 3780 CD PRO B 160 12.839 -8.878 32.010 1.00126.46 C \nANISOU 3780 CD PRO B 160 17689 14527 15832 -2575 -1786 371 C \nATOM 3781 N GLN B 161 14.847 -6.899 34.511 1.00108.02 N \nANISOU 3781 N GLN B 161 14843 12405 13795 -2179 -1611 278 N \nATOM 3782 CA GLN B 161 15.909 -6.261 35.312 1.00100.95 C \nANISOU 3782 CA GLN B 161 13797 11563 12995 -1983 -1564 231 C \nATOM 3783 C GLN B 161 15.459 -4.926 35.854 1.00 88.80 C \nANISOU 3783 C GLN B 161 11922 10232 11586 -2064 -1432 243 C \nATOM 3784 O GLN B 161 15.643 -4.641 37.017 1.00 81.01 O \nANISOU 3784 O GLN B 161 10877 9284 10617 -2080 -1416 246 O \nATOM 3785 CB GLN B 161 17.183 -6.043 34.490 1.00103.56 C \nANISOU 3785 CB GLN B 161 14066 11898 13385 -1678 -1550 158 C \nATOM 3786 CG GLN B 161 18.447 -6.512 35.172 1.00113.51 C \nANISOU 3786 CG GLN B 161 15445 13095 14589 -1452 -1619 105 C \nATOM 3787 CD GLN B 161 19.673 -6.082 34.410 1.00124.40 C \nANISOU 3787 CD GLN B 161 16669 14584 16014 -1173 -1583 29 C \nATOM 3788 OE1 GLN B 161 19.570 -5.450 33.363 1.00126.26 O \nANISOU 3788 OE1 GLN B 161 16730 14915 16326 -1166 -1509 22 O \nATOM 3789 NE2 GLN B 161 20.847 -6.423 34.932 1.00138.44 N \nANISOU 3789 NE2 GLN B 161 18504 16372 17725 -944 -1637 -30 N \nATOM 3790 N TYR B 162 14.861 -4.117 34.983 1.00 90.04 N \nANISOU 3790 N TYR B 162 11878 10513 11821 -2098 -1348 246 N \nATOM 3791 CA TYR B 162 14.523 -2.730 35.317 1.00 92.00 C \nANISOU 3791 CA TYR B 162 11833 10945 12180 -2111 -1234 241 C \nATOM 3792 C TYR B 162 13.070 -2.600 35.713 1.00 91.93 C \nANISOU 3792 C TYR B 162 11750 11071 12107 -2338 -1214 287 C \nATOM 3793 O TYR B 162 12.575 -1.484 35.887 1.00 91.05 O \nANISOU 3793 O TYR B 162 11416 11125 12055 -2335 -1133 277 O \nATOM 3794 CB TYR B 162 14.830 -1.793 34.127 1.00 87.66 C \nANISOU 3794 CB TYR B 162 11117 10456 11734 -1979 -1160 206 C \nATOM 3795 CG TYR B 162 16.165 -2.069 33.482 1.00 82.13 C \nANISOU 3795 CG TYR B 162 10478 9674 11053 -1778 -1186 161 C \nATOM 3796 CD1 TYR B 162 16.249 -2.934 32.394 1.00 79.70 C \nANISOU 3796 CD1 TYR B 162 10325 9272 10687 -1730 -1245 153 C \nATOM 3797 CD2 TYR B 162 17.352 -1.510 33.975 1.00 76.02 C \nANISOU 3797 CD2 TYR B 162 9609 8944 10330 -1636 -1157 123 C \nATOM 3798 CE1 TYR B 162 17.457 -3.217 31.803 1.00 81.70 C \nANISOU 3798 CE1 TYR B 162 10620 9493 10929 -1520 -1274 102 C \nATOM 3799 CE2 TYR B 162 18.572 -1.804 33.388 1.00 71.71 C \nANISOU 3799 CE2 TYR B 162 9090 8390 9765 -1450 -1184 75 C \nATOM 3800 CZ TYR B 162 18.609 -2.650 32.306 1.00 77.27 C \nANISOU 3800 CZ TYR B 162 9933 9017 10407 -1380 -1241 61 C \nATOM 3801 OH TYR B 162 19.786 -2.955 31.686 1.00 87.56 O \nANISOU 3801 OH TYR B 162 11249 10352 11667 -1170 -1271 4 O \nATOM 3802 N SER B 163 12.410 -3.745 35.882 1.00 97.10 N \nANISOU 3802 N SER B 163 12607 11670 12616 -2535 -1299 333 N \nATOM 3803 CA SER B 163 10.976 -3.784 36.146 1.00101.40 C \nANISOU 3803 CA SER B 163 13079 12396 13052 -2791 -1290 379 C \nATOM 3804 C SER B 163 10.505 -2.881 37.270 1.00 98.66 C \nANISOU 3804 C SER B 163 12504 12259 12722 -2826 -1223 377 C \nATOM 3805 O SER B 163 9.763 -1.930 37.015 1.00 96.90 O \nANISOU 3805 O SER B 163 12049 12246 12523 -2810 -1148 360 O \nATOM 3806 CB SER B 163 10.536 -5.205 36.405 1.00114.14 C \nANISOU 3806 CB SER B 163 14989 13903 14476 -3034 -1408 437 C \nATOM 3807 OG SER B 163 10.729 -5.958 35.232 1.00124.34 O \nANISOU 3807 OG SER B 163 16488 15026 15729 -3008 -1472 438 O \nATOM 3808 N GLU B 164 10.931 -3.170 38.500 1.00101.48 N \nANISOU 3808 N GLU B 164 12940 12561 13056 -2854 -1257 387 N \nATOM 3809 CA GLU B 164 10.426 -2.425 39.661 1.00104.22 C \nANISOU 3809 CA GLU B 164 13091 13113 13397 -2903 -1204 387 C \nATOM 3810 C GLU B 164 11.068 -1.063 39.775 1.00 94.06 C \nANISOU 3810 C GLU B 164 11606 11860 12272 -2658 -1119 332 C \nATOM 3811 O GLU B 164 10.441 -0.109 40.232 1.00 81.75 O \nANISOU 3811 O GLU B 164 9845 10503 10713 -2640 -1061 315 O \nATOM 3812 CB GLU B 164 10.563 -3.210 40.969 1.00111.34 C \nANISOU 3812 CB GLU B 164 14148 13954 14201 -3045 -1272 422 C \nATOM 3813 CG GLU B 164 11.968 -3.493 41.458 1.00110.60 C \nANISOU 3813 CG GLU B 164 14213 13622 14187 -2871 -1311 399 C \nATOM 3814 CD GLU B 164 11.952 -4.380 42.694 1.00110.77 C \nANISOU 3814 CD GLU B 164 14427 13577 14085 -3036 -1393 439 C \nATOM 3815 OE1 GLU B 164 10.865 -4.840 43.098 1.00104.47 O \nANISOU 3815 OE1 GLU B 164 13655 12909 13128 -3317 -1424 492 O \nATOM 3816 OE2 GLU B 164 13.027 -4.627 43.264 1.00119.28 O \nANISOU 3816 OE2 GLU B 164 15629 14487 15203 -2895 -1430 417 O \nATOM 3817 N GLU B 165 12.321 -0.979 39.344 1.00 96.92 N \nANISOU 3817 N GLU B 165 12040 12039 12747 -2471 -1120 301 N \nATOM 3818 CA GLU B 165 12.983 0.316 39.154 1.00 89.62 C \nANISOU 3818 CA GLU B 165 10958 11137 11956 -2274 -1047 255 C \nATOM 3819 C GLU B 165 12.086 1.235 38.338 1.00 89.16 C \nANISOU 3819 C GLU B 165 10742 11227 11907 -2253 -991 240 C \nATOM 3820 O GLU B 165 11.834 2.374 38.746 1.00 88.52 O \nANISOU 3820 O GLU B 165 10520 11260 11854 -2179 -943 214 O \nATOM 3821 CB GLU B 165 14.321 0.141 38.446 1.00 87.19 C \nANISOU 3821 CB GLU B 165 10736 10670 11724 -2116 -1061 227 C \nATOM 3822 CG GLU B 165 15.097 1.447 38.308 1.00 86.71 C \nANISOU 3822 CG GLU B 165 10535 10641 11770 -1968 -995 189 C \nATOM 3823 CD GLU B 165 16.544 1.220 37.901 1.00 82.35 C \nANISOU 3823 CD GLU B 165 10036 9997 11255 -1833 -1011 160 C \nATOM 3824 OE1 GLU B 165 16.997 0.041 38.025 1.00 85.48 O \nANISOU 3824 OE1 GLU B 165 10588 10297 11594 -1814 -1080 162 O \nATOM 3825 OE2 GLU B 165 17.200 2.206 37.436 1.00 70.91 O \nANISOU 3825 OE2 GLU B 165 8487 8588 9868 -1750 -963 135 O \nATOM 3826 N ALA B 166 11.578 0.716 37.209 1.00 85.87 N \nANISOU 3826 N ALA B 166 10370 10805 11450 -2311 -1007 252 N \nATOM 3827 CA ALA B 166 10.688 1.482 36.338 1.00 82.20 C \nANISOU 3827 CA ALA B 166 9769 10486 10978 -2284 -962 235 C \nATOM 3828 C ALA B 166 9.396 1.803 37.046 1.00 93.58 C \nANISOU 3828 C ALA B 166 11068 12183 12307 -2378 -947 239 C \nATOM 3829 O ALA B 166 8.877 2.918 36.904 1.00 80.36 O \nANISOU 3829 O ALA B 166 9247 10654 10632 -2262 -903 201 O \nATOM 3830 CB ALA B 166 10.401 0.727 35.061 1.00 94.15 C \nANISOU 3830 CB ALA B 166 11368 11947 12459 -2346 -988 252 C \nATOM 3831 N ARG B 167 8.888 0.819 37.806 1.00105.09 N \nANISOU 3831 N ARG B 167 12580 13704 13643 -2584 -991 283 N \nATOM 3832 CA ARG B 167 7.612 0.937 38.508 1.00111.52 C \nANISOU 3832 CA ARG B 167 13243 14823 14306 -2717 -983 291 C \nATOM 3833 C ARG B 167 7.743 1.932 39.647 1.00105.14 C \nANISOU 3833 C ARG B 167 12310 14110 13529 -2586 -948 255 C \nATOM 3834 O ARG B 167 6.906 2.824 39.836 1.00 98.24 O \nANISOU 3834 O ARG B 167 11252 13487 12587 -2503 -914 216 O \nATOM 3835 CB ARG B 167 7.158 -0.465 39.017 1.00125.47 C \nANISOU 3835 CB ARG B 167 15145 16614 15915 -3022 -1052 357 C \nATOM 3836 CG ARG B 167 6.622 -0.556 40.451 1.00128.64 C \nANISOU 3836 CG ARG B 167 15469 17217 16193 -3168 -1062 376 C \nATOM 3837 CD ARG B 167 6.374 -2.007 40.882 1.00133.01 C \nANISOU 3837 CD ARG B 167 16231 17722 16583 -3494 -1149 450 C \nATOM 3838 NE ARG B 167 7.304 -2.501 41.913 1.00137.27 N \nANISOU 3838 NE ARG B 167 16957 18036 17164 -3502 -1196 469 N \nATOM 3839 CZ ARG B 167 7.589 -3.786 42.150 1.00134.83 C \nANISOU 3839 CZ ARG B 167 16947 17523 16758 -3696 -1295 524 C \nATOM 3840 NH1 ARG B 167 7.075 -4.756 41.402 1.00132.96 N \nANISOU 3840 NH1 ARG B 167 16890 17248 16381 -3917 -1364 572 N \nATOM 3841 NH2 ARG B 167 8.433 -4.106 43.130 1.00135.91 N \nANISOU 3841 NH2 ARG B 167 17234 17475 16929 -3660 -1335 529 N \nATOM 3842 N LEU B 168 8.821 1.773 40.392 1.00101.37 N \nANISOU 3842 N LEU B 168 11943 13431 13142 -2549 -963 262 N \nATOM 3843 CA LEU B 168 9.041 2.595 41.575 1.00112.46 C \nANISOU 3843 CA LEU B 168 13260 14894 14573 -2449 -938 236 C \nATOM 3844 C LEU B 168 9.300 4.056 41.204 1.00112.53 C \nANISOU 3844 C LEU B 168 13186 14898 14672 -2205 -893 178 C \nATOM 3845 O LEU B 168 8.863 4.972 41.897 1.00105.93 O \nANISOU 3845 O LEU B 168 12240 14214 13792 -2105 -875 142 O \nATOM 3846 CB LEU B 168 10.200 2.045 42.408 1.00110.49 C \nANISOU 3846 CB LEU B 168 13157 14428 14395 -2467 -968 257 C \nATOM 3847 CG LEU B 168 10.259 2.498 43.861 1.00109.42 C \nANISOU 3847 CG LEU B 168 12954 14374 14247 -2450 -959 248 C \nATOM 3848 CD1 LEU B 168 8.916 2.348 44.579 1.00105.70 C \nANISOU 3848 CD1 LEU B 168 12352 14206 13603 -2603 -962 261 C \nATOM 3849 CD2 LEU B 168 11.358 1.714 44.571 1.00112.51 C \nANISOU 3849 CD2 LEU B 168 13511 14552 14687 -2487 -1000 273 C \nATOM 3850 N LYS B 169 9.989 4.268 40.089 1.00113.05 N \nANISOU 3850 N LYS B 169 13324 14789 14840 -2112 -884 168 N \nATOM 3851 CA LYS B 169 10.297 5.621 39.670 1.00111.73 C \nANISOU 3851 CA LYS B 169 13130 14584 14736 -1918 -855 122 C \nATOM 3852 C LYS B 169 9.190 6.204 38.818 1.00 98.81 C \nANISOU 3852 C LYS B 169 11405 13116 13023 -1845 -844 90 C \nATOM 3853 O LYS B 169 9.224 7.385 38.482 1.00 78.70 O \nANISOU 3853 O LYS B 169 8862 10552 10489 -1675 -835 47 O \nATOM 3854 CB LYS B 169 11.606 5.637 38.926 1.00129.65 C \nANISOU 3854 CB LYS B 169 15509 16623 17129 -1869 -853 125 C \nATOM 3855 CG LYS B 169 12.317 6.996 38.877 1.00135.70 C \nANISOU 3855 CG LYS B 169 16298 17307 17953 -1728 -836 92 C \nATOM 3856 CD LYS B 169 12.812 7.242 37.455 1.00136.78 C \nANISOU 3856 CD LYS B 169 16486 17341 18143 -1688 -828 87 C \nATOM 3857 CE LYS B 169 12.811 5.946 36.613 1.00149.44 C \nANISOU 3857 CE LYS B 169 18112 18911 19757 -1775 -837 114 C \nATOM 3858 NZ LYS B 169 13.774 4.820 36.897 1.00152.65 N \nANISOU 3858 NZ LYS B 169 18592 19212 20196 -1832 -861 137 N \nATOM 3859 N ARG B 170 8.214 5.363 38.477 1.00108.66 N \nANISOU 3859 N ARG B 170 12591 14527 14169 -1980 -852 112 N \nATOM 3860 CA ARG B 170 6.961 5.806 37.866 1.00110.81 C \nANISOU 3860 CA ARG B 170 12734 15046 14321 -1924 -843 78 C \nATOM 3861 C ARG B 170 6.182 6.398 39.024 1.00113.36 C \nANISOU 3861 C ARG B 170 12921 15634 14518 -1857 -843 42 C \nATOM 3862 O ARG B 170 5.741 7.544 39.002 1.00 97.24 O \nANISOU 3862 O ARG B 170 10821 13706 12419 -1641 -841 -21 O \nATOM 3863 CB ARG B 170 6.210 4.609 37.311 1.00116.30 C \nANISOU 3863 CB ARG B 170 13404 15862 14922 -2141 -857 122 C \nATOM 3864 CG ARG B 170 5.210 4.878 36.198 1.00122.90 C \nANISOU 3864 CG ARG B 170 14139 16887 15669 -2096 -846 95 C \nATOM 3865 CD ARG B 170 4.635 3.540 35.718 1.00120.96 C \nANISOU 3865 CD ARG B 170 13909 16721 15329 -2368 -869 153 C \nATOM 3866 NE ARG B 170 5.711 2.622 35.302 1.00114.11 N \nANISOU 3866 NE ARG B 170 13257 15513 14586 -2463 -895 202 N \nATOM 3867 CZ ARG B 170 5.652 1.288 35.333 1.00106.97 C \nANISOU 3867 CZ ARG B 170 12478 14552 13613 -2711 -942 263 C \nATOM 3868 NH1 ARG B 170 4.549 0.665 35.738 1.00118.29 N \nANISOU 3868 NH1 ARG B 170 13840 16255 14851 -2949 -965 296 N \nATOM 3869 NH2 ARG B 170 6.696 0.566 34.940 1.00 89.09 N \nANISOU 3869 NH2 ARG B 170 10426 11973 11450 -2723 -976 289 N \nATOM 3870 N GLU B 171 6.095 5.598 40.082 1.00121.18 N \nANISOU 3870 N GLU B 171 13886 16703 15455 -2036 -854 81 N \nATOM 3871 CA GLU B 171 5.367 5.948 41.299 1.00124.58 C \nANISOU 3871 CA GLU B 171 14172 17415 15748 -2014 -855 54 C \nATOM 3872 C GLU B 171 5.864 7.210 42.013 1.00119.60 C \nANISOU 3872 C GLU B 171 13565 16707 15171 -1767 -852 -1 C \nATOM 3873 O GLU B 171 5.178 7.716 42.905 1.00117.57 O \nANISOU 3873 O GLU B 171 13183 16704 14783 -1679 -857 -42 O \nATOM 3874 CB GLU B 171 5.342 4.746 42.250 1.00124.14 C \nANISOU 3874 CB GLU B 171 14130 17405 15633 -2293 -874 118 C \nATOM 3875 CG GLU B 171 4.463 3.611 41.729 1.00123.69 C \nANISOU 3875 CG GLU B 171 14038 17529 15431 -2565 -893 167 C \nATOM 3876 CD GLU B 171 4.776 2.260 42.347 1.00127.80 C \nANISOU 3876 CD GLU B 171 14703 17934 15920 -2866 -936 246 C \nATOM 3877 OE1 GLU B 171 4.478 1.231 41.702 1.00120.67 O \nANISOU 3877 OE1 GLU B 171 13894 17012 14944 -3092 -970 298 O \nATOM 3878 OE2 GLU B 171 5.315 2.225 43.479 1.00134.50 O \nANISOU 3878 OE2 GLU B 171 15598 18701 16805 -2875 -945 256 O \nATOM 3879 N GLU B 172 7.024 7.731 41.620 1.00114.44 N \nANISOU 3879 N GLU B 172 13071 15727 14683 -1662 -850 -2 N \nATOM 3880 CA GLU B 172 7.381 9.105 42.004 1.00120.28 C \nANISOU 3880 CA GLU B 172 13871 16388 15441 -1426 -860 -57 C \nATOM 3881 C GLU B 172 6.396 10.141 41.445 1.00130.81 C \nANISOU 3881 C GLU B 172 15154 17906 16642 -1193 -877 -132 C \nATOM 3882 O GLU B 172 6.193 11.181 42.069 1.00140.19 O \nANISOU 3882 O GLU B 172 16363 19152 17752 -986 -904 -191 O \nATOM 3883 CB GLU B 172 8.794 9.498 41.599 1.00120.43 C \nANISOU 3883 CB GLU B 172 14073 16058 15628 -1399 -860 -40 C \nATOM 3884 CG GLU B 172 9.230 10.813 42.250 1.00115.79 C \nANISOU 3884 CG GLU B 172 13584 15378 15035 -1222 -883 -82 C \nATOM 3885 CD GLU B 172 10.714 11.106 42.141 1.00115.78 C \nANISOU 3885 CD GLU B 172 13741 15081 15169 -1264 -883 -55 C \nATOM 3886 OE1 GLU B 172 11.528 10.240 42.518 1.00117.91 O \nANISOU 3886 OE1 GLU B 172 14006 15265 15530 -1412 -865 -8 O \nATOM 3887 OE2 GLU B 172 11.071 12.219 41.707 1.00109.89 O \nANISOU 3887 OE2 GLU B 172 13134 14204 14416 -1150 -908 -81 O \nATOM 3888 N ILE B 173 5.811 9.871 40.274 1.00135.17 N \nANISOU 3888 N ILE B 173 15660 18540 17159 -1208 -870 -134 N \nATOM 3889 CA ILE B 173 4.766 10.749 39.713 1.00139.98 C \nANISOU 3889 CA ILE B 173 16206 19366 17613 -973 -891 -212 C \nATOM 3890 C ILE B 173 3.397 10.443 40.337 1.00135.43 C \nANISOU 3890 C ILE B 173 15382 19258 16817 -976 -891 -245 C \nATOM 3891 O ILE B 173 2.969 11.096 41.296 1.00130.50 O \nANISOU 3891 O ILE B 173 14693 18823 16066 -807 -913 -302 O \nATOM 3892 CB ILE B 173 4.684 10.702 38.160 1.00136.68 C \nANISOU 3892 CB ILE B 173 15836 18861 17235 -965 -886 -208 C \nATOM 3893 CG1 ILE B 173 3.793 11.836 37.623 1.00137.36 C \nANISOU 3893 CG1 ILE B 173 15916 19111 17165 -662 -923 -300 C \nATOM 3894 CG2 ILE B 173 4.147 9.381 37.640 1.00140.38 C \nANISOU 3894 CG2 ILE B 173 16173 19486 17680 -1212 -858 -155 C \nATOM 3895 CD1 ILE B 173 4.284 13.225 37.977 1.00135.00 C \nANISOU 3895 CD1 ILE B 173 15823 18615 16856 -405 -975 -355 C \nTER 3896 ILE B 173 \nHETATM 3897 C1 NAG A 401 22.977 -19.859 -66.680 1.00 83.68 C \nHETATM 3898 C2 NAG A 401 23.300 -21.348 -66.364 1.00 90.43 C \nHETATM 3899 C3 NAG A 401 22.099 -22.328 -66.439 1.00 98.70 C \nHETATM 3900 C4 NAG A 401 20.740 -21.714 -66.142 1.00 98.24 C \nHETATM 3901 C5 NAG A 401 20.704 -20.361 -66.848 1.00 96.14 C \nHETATM 3902 C6 NAG A 401 19.388 -19.613 -66.749 1.00 96.77 C \nHETATM 3903 C7 NAG A 401 24.735 -23.065 -67.433 1.00 96.37 C \nHETATM 3904 C8 NAG A 401 25.782 -23.325 -68.484 1.00 91.89 C \nHETATM 3905 N2 NAG A 401 24.308 -21.793 -67.319 1.00 98.43 N \nHETATM 3906 O3 NAG A 401 22.254 -23.429 -65.565 1.00109.88 O \nHETATM 3907 O4 NAG A 401 19.757 -22.606 -66.614 1.00 88.78 O \nHETATM 3908 O5 NAG A 401 21.679 -19.568 -66.215 1.00 93.39 O \nHETATM 3909 O6 NAG A 401 19.208 -19.149 -68.069 1.00 86.27 O \nHETATM 3910 O7 NAG A 401 24.325 -23.993 -66.729 1.00 82.71 O \nHETATM 3911 C1 NAG B 201 23.733 -7.140 20.478 1.00139.78 C \nHETATM 3912 C2 NAG B 201 24.856 -7.195 19.448 1.00152.91 C \nHETATM 3913 C3 NAG B 201 24.999 -8.641 18.949 1.00145.45 C \nHETATM 3914 C4 NAG B 201 25.108 -9.639 20.111 1.00144.30 C \nHETATM 3915 C5 NAG B 201 24.021 -9.375 21.154 1.00151.00 C \nHETATM 3916 C6 NAG B 201 24.136 -10.225 22.425 1.00150.19 C \nHETATM 3917 C7 NAG B 201 25.501 -5.536 17.716 1.00154.15 C \nHETATM 3918 C8 NAG B 201 25.007 -4.653 16.601 1.00138.57 C \nHETATM 3919 N2 NAG B 201 24.576 -6.284 18.344 1.00167.86 N \nHETATM 3920 O3 NAG B 201 26.121 -8.748 18.095 1.00132.58 O \nHETATM 3921 O4 NAG B 201 25.052 -10.973 19.647 1.00138.55 O \nHETATM 3922 O5 NAG B 201 24.207 -8.013 21.495 1.00150.86 O \nHETATM 3923 O6 NAG B 201 23.268 -9.746 23.442 1.00134.09 O \nHETATM 3924 O7 NAG B 201 26.703 -5.531 17.996 1.00142.23 O \nHETATM 3925 O HOH A 501 8.447 2.486 -54.237 1.00 31.99 O \nHETATM 3926 O HOH A 502 11.798 -0.482 -60.932 1.00 31.51 O \nHETATM 3927 O HOH A 503 7.610 4.429 -68.956 1.00 32.53 O \nHETATM 3928 O HOH A 504 13.118 -1.114 -86.140 1.00 46.03 O \nHETATM 3929 O HOH A 505 18.048 -3.423 -41.933 1.00 48.80 O \nHETATM 3930 O HOH A 506 20.879 10.872 -6.059 1.00 55.30 O \nHETATM 3931 O HOH A 507 28.888 4.157 -58.123 1.00 53.39 O \nHETATM 3932 O HOH A 508 16.509 -12.363 -53.601 1.00 57.16 O \nHETATM 3933 O HOH A 509 5.244 -1.566 -49.620 1.00 19.76 O \nHETATM 3934 O HOH A 510 11.971 -3.594 -51.498 1.00 30.40 O \nHETATM 3935 O HOH A 511 26.271 -2.751 -80.663 1.00 46.19 O \nHETATM 3936 O HOH A 512 5.287 1.865 -71.495 1.00 53.73 O \nHETATM 3937 O HOH A 513 13.669 -6.940 -43.271 1.00 49.29 O \nHETATM 3938 O HOH A 514 9.996 1.954 -85.354 1.00 45.37 O \nHETATM 3939 O HOH A 515 5.116 4.962 -83.670 1.00 31.59 O \nHETATM 3940 O HOH A 516 16.018 -13.181 -60.468 1.00 24.07 O \nHETATM 3941 O HOH A 517 6.691 4.125 -70.839 1.00 33.39 O \nHETATM 3942 O HOH A 518 6.610 8.033 -66.919 1.00 48.02 O \nHETATM 3943 O HOH A 519 6.559 5.579 -79.177 1.00 30.05 O \nHETATM 3944 O HOH A 520 17.096 15.689 -54.297 1.00 59.15 O \nHETATM 3945 O HOH A 521 10.721 -2.250 -59.558 1.00 31.17 O \nHETATM 3946 O HOH A 522 7.243 3.606 -58.475 1.00 62.33 O \nHETATM 3947 O HOH A 523 3.669 8.357 -77.759 1.00 39.73 O \nHETATM 3948 O HOH A 524 6.273 -0.159 -79.745 1.00 39.76 O \nHETATM 3949 O HOH A 525 8.894 5.799 -56.488 1.00 54.88 O \nHETATM 3950 O HOH A 526 9.546 -8.863 -72.184 1.00 56.61 O \nHETATM 3951 O HOH A 527 30.738 7.276 -46.407 1.00 59.63 O \nHETATM 3952 O HOH A 528 9.164 5.080 -80.075 1.00 69.83 O \nHETATM 3953 O HOH A 529 16.530 10.819 -52.670 1.00 62.21 O \nHETATM 3954 O HOH A 530 14.716 9.739 35.056 1.00 54.80 O \nHETATM 3955 O HOH A 531 19.135 18.657 -57.881 1.00 80.59 O \nHETATM 3956 O HOH A 532 31.453 2.923 -44.042 1.00 54.44 O \nHETATM 3957 O HOH A 533 34.120 -1.633 -70.831 1.00 64.06 O \nHETATM 3958 O HOH A 534 6.854 -8.094 -65.090 1.00 49.74 O \nHETATM 3959 O HOH A 535 25.919 -14.209 -68.898 1.00 76.55 O \nHETATM 3960 O HOH A 536 13.721 -8.935 -73.586 1.00 57.63 O \nHETATM 3961 O HOH A 537 12.079 -3.918 -58.992 1.00 52.13 O \nHETATM 3962 O HOH A 538 6.856 9.370 -64.661 1.00 59.98 O \nHETATM 3963 O HOH A 539 22.465 5.257 -16.014 1.00 57.50 O \nHETATM 3964 O HOH B 301 1.329 12.125 -42.737 1.00 32.60 O \nHETATM 3965 O HOH B 302 7.798 9.850 -46.582 1.00 29.21 O \nHETATM 3966 O HOH B 303 6.744 8.592 21.045 1.00 46.54 O \nHETATM 3967 O HOH B 304 14.820 10.928 11.821 1.00 48.88 O \nHETATM 3968 O HOH B 305 0.530 11.792 -44.863 1.00 42.66 O \nHETATM 3969 O HOH B 306 7.917 9.283 -44.178 1.00 37.94 O \nHETATM 3970 O HOH B 307 5.026 8.329 2.088 1.00 36.93 O \nHETATM 3971 O HOH B 308 1.572 1.625 -52.116 1.00 23.26 O \nHETATM 3972 O HOH B 309 6.169 8.268 -42.204 1.00 55.67 O \nHETATM 3973 O HOH B 310 20.435 -4.861 12.617 1.00 58.09 O \nHETATM 3974 O HOH B 311 0.000 0.000 -21.930 0.33 55.81 O \nHETATM 3975 O HOH B 312 26.537 6.825 25.208 1.00 76.02 O \nHETATM 3976 O HOH B 313 13.711 -3.926 38.528 1.00 74.49 O \nHETATM 3977 O HOH B 314 14.179 -9.387 7.576 1.00 67.10 O \nHETATM 3978 O HOH B 315 22.396 6.168 19.677 1.00 66.83 O \nHETATM 3979 O HOH B 316 -0.643 13.466 -46.099 1.00 84.95 O \nHETATM 3980 O HOH B 317 3.801 11.485 -42.559 1.00 51.73 O \nHETATM 3981 O HOH B 318 0.000 0.000 -18.054 0.33 75.84 O \nENDMDL \nMODEL 2 \nATOM 1 N PRO A -1 -21.268 6.795 33.812 1.00108.74 N \nANISOU 1 N PRO A -1 13644 13962 13711 -3983 -1018 181 N \nATOM 2 CA PRO A -1 -20.214 6.132 33.040 1.00107.88 C \nANISOU 2 CA PRO A -1 13518 13817 13656 -3861 -1014 198 C \nATOM 3 C PRO A -1 -18.915 6.964 33.107 1.00112.82 C \nANISOU 3 C PRO A -1 14031 14488 14346 -3841 -1113 272 C \nATOM 4 O PRO A -1 -18.542 7.398 34.202 1.00118.90 O \nANISOU 4 O PRO A -1 14761 15326 15088 -3913 -1170 308 O \nATOM 5 CB PRO A -1 -20.814 6.100 31.636 1.00101.66 C \nANISOU 5 CB PRO A -1 12763 12951 12912 -3793 -964 163 C \nATOM 6 CG PRO A -1 -21.530 7.420 31.560 1.00104.61 C \nANISOU 6 CG PRO A -1 13094 13350 13303 -3869 -1001 171 C \nATOM 7 CD PRO A -1 -22.086 7.673 32.955 1.00106.32 C \nANISOU 7 CD PRO A -1 13326 13631 13440 -3997 -1015 167 C \nATOM 8 N GLY A 0 -18.235 7.176 31.973 1.00102.11 N \nANISOU 8 N GLY A 0 12632 13095 13071 -3746 -1132 293 N \nATOM 9 CA GLY A 0 -17.125 8.125 31.903 1.00 89.42 C \nANISOU 9 CA GLY A 0 10930 11519 11529 -3726 -1226 361 C \nATOM 10 C GLY A 0 -17.146 8.855 30.578 1.00 79.86 C \nANISOU 10 C GLY A 0 9680 10264 10401 -3657 -1239 366 C \nATOM 11 O GLY A 0 -17.802 8.419 29.641 1.00 73.60 O \nANISOU 11 O GLY A 0 8934 9413 9619 -3611 -1172 320 O \nATOM 12 N ASP A 1 -16.421 9.969 30.515 1.00 76.06 N \nANISOU 12 N ASP A 1 9117 9808 9973 -3648 -1324 421 N \nATOM 13 CA ASP A 1 -16.373 10.797 29.313 1.00 76.02 C \nANISOU 13 CA ASP A 1 9067 9771 10046 -3582 -1346 430 C \nATOM 14 C ASP A 1 -15.698 10.033 28.209 1.00 72.75 C \nANISOU 14 C ASP A 1 8670 9292 9681 -3475 -1313 423 C \nATOM 15 O ASP A 1 -14.909 9.126 28.463 1.00 79.13 O \nANISOU 15 O ASP A 1 9497 10097 10471 -3450 -1304 433 O \nATOM 16 CB ASP A 1 -15.622 12.114 29.566 1.00 76.89 C \nANISOU 16 CB ASP A 1 9092 9925 10199 -3584 -1449 495 C \nATOM 17 CG ASP A 1 -16.203 12.919 30.712 1.00 77.18 C \nANISOU 17 CG ASP A 1 9101 10039 10185 -3688 -1489 509 C \nATOM 18 OD1 ASP A 1 -17.388 12.715 31.093 1.00 79.02 O \nANISOU 18 OD1 ASP A 1 9375 10290 10361 -3763 -1437 463 O \nATOM 19 OD2 ASP A 1 -15.464 13.769 31.224 1.00 76.73 O \nANISOU 19 OD2 ASP A 1 8986 10024 10142 -3696 -1573 566 O \nATOM 20 N GLN A 2 -15.990 10.420 26.977 1.00 73.15 N \nANISOU 20 N GLN A 2 8707 9298 9789 -3414 -1298 407 N \nATOM 21 CA GLN A 2 -15.490 9.708 25.812 1.00 68.19 C \nANISOU 21 CA GLN A 2 8096 8606 9206 -3312 -1260 395 C \nATOM 22 C GLN A 2 -15.078 10.634 24.695 1.00 65.93 C \nANISOU 22 C GLN A 2 7752 8293 9004 -3243 -1301 418 C \nATOM 23 O GLN A 2 -15.753 11.619 24.441 1.00 72.46 O \nANISOU 23 O GLN A 2 8547 9134 9850 -3264 -1318 413 O \nATOM 24 CB GLN A 2 -16.567 8.758 25.288 1.00 67.85 C \nANISOU 24 CB GLN A 2 8133 8516 9130 -3299 -1160 329 C \nATOM 25 CG GLN A 2 -16.718 7.489 26.117 1.00 69.48 C \nANISOU 25 CG GLN A 2 8410 8731 9258 -3326 -1106 302 C \nATOM 26 CD GLN A 2 -17.565 6.450 25.426 1.00 65.59 C \nANISOU 26 CD GLN A 2 8003 8178 8739 -3282 -1008 241 C \nATOM 27 OE1 GLN A 2 -17.739 6.483 24.205 1.00 59.84 O \nANISOU 27 OE1 GLN A 2 7279 7399 8061 -3215 -981 225 O \nATOM 28 NE2 GLN A 2 -18.129 5.536 26.210 1.00 66.69 N \nANISOU 28 NE2 GLN A 2 8217 8324 8798 -3321 -953 206 N \nATOM 29 N ILE A 3 -14.003 10.284 23.994 1.00 63.89 N \nANISOU 29 N ILE A 3 7482 8001 8793 -3162 -1313 439 N \nATOM 30 CA ILE A 3 -13.731 10.865 22.689 1.00 60.05 C \nANISOU 30 CA ILE A 3 6961 7472 8383 -3081 -1327 445 C \nATOM 31 C ILE A 3 -13.642 9.753 21.677 1.00 60.33 C \nANISOU 31 C ILE A 3 7039 7450 8432 -3006 -1257 411 C \nATOM 32 O ILE A 3 -13.159 8.675 21.989 1.00 63.82 O \nANISOU 32 O ILE A 3 7515 7895 8840 -2996 -1229 409 O \nATOM 33 CB ILE A 3 -12.483 11.773 22.695 1.00 57.90 C \nANISOU 33 CB ILE A 3 6627 7209 8161 -3052 -1421 507 C \nATOM 34 CG1 ILE A 3 -12.519 12.693 21.484 1.00 57.67 C \nANISOU 34 CG1 ILE A 3 6557 7149 8205 -2984 -1439 508 C \nATOM 35 CG2 ILE A 3 -11.201 10.952 22.699 1.00 58.66 C \nANISOU 35 CG2 ILE A 3 6737 7290 8259 -3016 -1431 534 C \nATOM 36 CD1 ILE A 3 -11.717 13.950 21.654 1.00 56.73 C \nANISOU 36 CD1 ILE A 3 6379 7050 8126 -2969 -1535 564 C \nATOM 37 N CYS A 4 -14.075 10.028 20.451 1.00 66.68 N \nANISOU 37 N CYS A 4 7838 8211 9285 -2950 -1229 387 N \nATOM 38 CA CYS A 4 -14.058 9.018 19.354 1.00 68.22 C \nANISOU 38 CA CYS A 4 8074 8351 9496 -2871 -1161 354 C \nATOM 39 C CYS A 4 -13.388 9.523 18.070 1.00 66.44 C \nANISOU 39 C CYS A 4 7806 8088 9352 -2786 -1186 371 C \nATOM 40 O CYS A 4 -13.414 10.697 17.766 1.00 63.02 O \nANISOU 40 O CYS A 4 7322 7659 8963 -2783 -1234 388 O \nATOM 41 CB CYS A 4 -15.469 8.561 19.046 1.00 68.04 C \nANISOU 41 CB CYS A 4 8113 8301 9438 -2886 -1078 295 C \nATOM 42 SG CYS A 4 -16.327 7.790 20.454 1.00 72.81 S \nANISOU 42 SG CYS A 4 8788 8937 9940 -2979 -1034 266 S \nATOM 43 N ILE A 5 -12.747 8.616 17.338 1.00 72.56 N \nANISOU 43 N ILE A 5 8599 8830 10141 -2715 -1154 366 N \nATOM 44 CA ILE A 5 -12.193 8.935 16.024 1.00 67.14 C \nANISOU 44 CA ILE A 5 7882 8102 9526 -2634 -1165 374 C \nATOM 45 C ILE A 5 -13.082 8.336 14.990 1.00 62.66 C \nANISOU 45 C ILE A 5 7355 7489 8962 -2588 -1084 323 C \nATOM 46 O ILE A 5 -13.433 7.176 15.079 1.00 64.50 O \nANISOU 46 O ILE A 5 7645 7715 9148 -2579 -1019 293 O \nATOM 47 CB ILE A 5 -10.770 8.390 15.852 1.00 73.95 C \nANISOU 47 CB ILE A 5 8733 8963 10403 -2590 -1191 408 C \nATOM 48 CG1 ILE A 5 -9.899 8.778 17.057 1.00 81.95 C \nANISOU 48 CG1 ILE A 5 9723 10022 11395 -2648 -1266 458 C \nATOM 49 CG2 ILE A 5 -10.142 8.929 14.577 1.00 71.79 C \nANISOU 49 CG2 ILE A 5 8426 8648 10204 -2515 -1215 420 C \nATOM 50 CD1 ILE A 5 -9.877 10.259 17.403 1.00 84.12 C \nANISOU 50 CD1 ILE A 5 9952 10309 11701 -2678 -1343 491 C \nATOM 51 N GLY A 6 -13.478 9.147 14.021 1.00 66.85 N \nANISOU 51 N GLY A 6 7860 7994 9546 -2558 -1087 312 N \nATOM 52 CA GLY A 6 -14.443 8.720 13.008 1.00 68.04 C \nANISOU 52 CA GLY A 6 8051 8100 9699 -2523 -1012 263 C \nATOM 53 C GLY A 6 -14.272 9.466 11.691 1.00 69.78 C \nANISOU 53 C GLY A 6 8229 8289 9993 -2460 -1027 265 C \nATOM 54 O GLY A 6 -13.314 10.238 11.511 1.00 67.75 O \nANISOU 54 O GLY A 6 7915 8041 9788 -2433 -1095 303 O \nATOM 55 N TYR A 7 -15.226 9.266 10.782 1.00 68.78 N \nANISOU 55 N TYR A 7 8135 8127 9871 -2439 -965 222 N \nATOM 56 CA TYR A 7 -15.131 9.838 9.436 1.00 69.70 C \nANISOU 56 CA TYR A 7 8216 8213 10053 -2375 -969 217 C \nATOM 57 C TYR A 7 -16.491 10.176 8.808 1.00 78.28 C \nANISOU 57 C TYR A 7 9324 9284 11134 -2397 -921 174 C \nATOM 58 O TYR A 7 -17.545 9.831 9.331 1.00 82.04 O \nANISOU 58 O TYR A 7 9857 9763 11553 -2459 -876 145 O \nATOM 59 CB TYR A 7 -14.330 8.910 8.514 1.00 65.47 C \nANISOU 59 CB TYR A 7 7695 7638 9542 -2288 -940 218 C \nATOM 60 CG TYR A 7 -14.881 7.496 8.370 1.00 64.07 C \nANISOU 60 CG TYR A 7 7597 7434 9313 -2268 -855 182 C \nATOM 61 CD1 TYR A 7 -15.729 7.171 7.325 1.00 66.90 C \nANISOU 61 CD1 TYR A 7 7996 7747 9675 -2232 -791 142 C \nATOM 62 CD2 TYR A 7 -14.527 6.491 9.249 1.00 60.43 C \nANISOU 62 CD2 TYR A 7 7170 6993 8796 -2279 -840 188 C \nATOM 63 CE1 TYR A 7 -16.202 5.892 7.157 1.00 68.07 C \nANISOU 63 CE1 TYR A 7 8222 7867 9774 -2202 -715 111 C \nATOM 64 CE2 TYR A 7 -15.015 5.205 9.099 1.00 65.66 C \nANISOU 64 CE2 TYR A 7 7906 7634 9408 -2248 -763 154 C \nATOM 65 CZ TYR A 7 -15.851 4.914 8.043 1.00 68.68 C \nANISOU 65 CZ TYR A 7 8332 7966 9796 -2206 -701 117 C \nATOM 66 OH TYR A 7 -16.369 3.646 7.881 1.00 76.12 O \nANISOU 66 OH TYR A 7 9355 8882 10685 -2166 -624 84 O \nATOM 67 N HIS A 8 -16.440 10.871 7.683 1.00 80.73 N \nANISOU 67 N HIS A 8 9591 9578 11502 -2350 -932 172 N \nATOM 68 CA HIS A 8 -17.634 11.360 7.013 1.00 81.79 C \nANISOU 68 CA HIS A 8 9733 9708 11637 -2373 -896 135 C \nATOM 69 C HIS A 8 -18.551 10.238 6.552 1.00 85.24 C \nANISOU 69 C HIS A 8 10264 10094 12031 -2370 -805 90 C \nATOM 70 O HIS A 8 -18.104 9.152 6.186 1.00 95.04 O \nANISOU 70 O HIS A 8 11547 11295 13269 -2309 -768 86 O \nATOM 71 CB HIS A 8 -17.225 12.224 5.829 1.00 83.51 C \nANISOU 71 CB HIS A 8 9884 9919 11926 -2309 -926 143 C \nATOM 72 CG HIS A 8 -18.281 13.177 5.358 1.00 94.32 C \nANISOU 72 CG HIS A 8 11226 11313 13298 -2347 -919 117 C \nATOM 73 ND1 HIS A 8 -19.563 12.790 5.043 1.00 95.94 N \nANISOU 73 ND1 HIS A 8 11492 11500 13461 -2391 -849 73 N \nATOM 74 CD2 HIS A 8 -18.225 14.508 5.110 1.00 99.29 C \nANISOU 74 CD2 HIS A 8 11772 11989 13964 -2344 -973 130 C \nATOM 75 CE1 HIS A 8 -20.254 13.838 4.640 1.00 99.71 C \nANISOU 75 CE1 HIS A 8 11923 12016 13947 -2424 -860 60 C \nATOM 76 NE2 HIS A 8 -19.464 14.895 4.673 1.00 98.21 N \nANISOU 76 NE2 HIS A 8 11640 11870 13804 -2392 -935 93 N \nATOM 77 N ALA A 9 -19.848 10.492 6.622 1.00 85.74 N \nANISOU 77 N ALA A 9 10362 10161 12054 -2440 -769 57 N \nATOM 78 CA ALA A 9 -20.837 9.626 5.988 1.00 91.53 C \nANISOU 78 CA ALA A 9 11189 10838 12750 -2437 -684 12 C \nATOM 79 C ALA A 9 -21.909 10.510 5.370 1.00 94.22 C \nANISOU 79 C ALA A 9 11518 11190 13091 -2487 -671 -14 C \nATOM 80 O ALA A 9 -22.055 11.668 5.751 1.00 97.60 O \nANISOU 80 O ALA A 9 11875 11680 13527 -2543 -722 -2 O \nATOM 81 CB ALA A 9 -21.457 8.659 6.982 1.00 92.44 C \nANISOU 81 CB ALA A 9 11401 10939 12783 -2489 -637 -8 C \nATOM 82 N ASN A 10 -22.622 9.965 4.390 1.00 88.75 N \nANISOU 82 N ASN A 10 10892 10441 12388 -2465 -604 -49 N \nATOM 83 CA ASN A 10 -23.756 10.652 3.791 1.00 87.25 C \nANISOU 83 CA ASN A 10 10708 10258 12185 -2524 -581 -79 C \nATOM 84 C ASN A 10 -24.758 9.659 3.170 1.00 93.65 C \nANISOU 84 C ASN A 10 11643 10993 12947 -2526 -492 -122 C \nATOM 85 O ASN A 10 -24.733 8.463 3.465 1.00100.06 O \nANISOU 85 O ASN A 10 12544 11753 13720 -2495 -447 -131 O \nATOM 86 CB ASN A 10 -23.322 11.778 2.830 1.00 76.62 C \nANISOU 86 CB ASN A 10 9253 8947 10913 -2482 -627 -66 C \nATOM 87 CG ASN A 10 -22.536 11.274 1.615 1.00 81.72 C \nANISOU 87 CG ASN A 10 9892 9539 11618 -2365 -612 -61 C \nATOM 88 OD1 ASN A 10 -22.628 10.111 1.239 1.00 84.90 O \nANISOU 88 OD1 ASN A 10 10379 9879 12001 -2322 -554 -77 O \nATOM 89 ND2 ASN A 10 -21.786 12.176 0.968 1.00 70.36 N \nANISOU 89 ND2 ASN A 10 8355 8130 10249 -2312 -665 -40 N \nATOM 90 N ASN A 11 -25.657 10.173 2.348 1.00102.82 N \nANISOU 90 N ASN A 11 12812 12150 14103 -2563 -466 -148 N \nATOM 91 CA ASN A 11 -26.712 9.375 1.731 1.00112.57 C \nANISOU 91 CA ASN A 11 14172 13312 15287 -2577 -384 -189 C \nATOM 92 C ASN A 11 -26.373 9.040 0.275 1.00117.73 C \nANISOU 92 C ASN A 11 14824 13916 15993 -2474 -358 -193 C \nATOM 93 O ASN A 11 -27.181 8.446 -0.443 1.00120.99 O \nANISOU 93 O ASN A 11 15333 14266 16372 -2472 -293 -223 O \nATOM 94 CB ASN A 11 -28.051 10.124 1.820 1.00113.91 C \nANISOU 94 CB ASN A 11 14367 13512 15403 -2706 -368 -218 C \nATOM 95 CG ASN A 11 -27.948 11.578 1.369 1.00110.15 C \nANISOU 95 CG ASN A 11 13756 13120 14975 -2731 -424 -206 C \nATOM 96 OD1 ASN A 11 -26.945 11.999 0.779 1.00 99.60 O \nANISOU 96 OD1 ASN A 11 12323 11804 13718 -2641 -467 -181 O \nATOM 97 ND2 ASN A 11 -28.988 12.360 1.663 1.00109.74 N \nANISOU 97 ND2 ASN A 11 13700 13123 14872 -2853 -423 -225 N \nATOM 98 N SER A 12 -25.174 9.435 -0.147 1.00118.09 N \nANISOU 98 N SER A 12 14763 13989 16117 -2391 -410 -161 N \nATOM 99 CA SER A 12 -24.684 9.175 -1.496 1.00111.27 C \nANISOU 99 CA SER A 12 13883 13087 15309 -2291 -394 -161 C \nATOM 100 C SER A 12 -24.761 7.693 -1.814 1.00106.06 C \nANISOU 100 C SER A 12 13335 12348 14616 -2225 -326 -175 C \nATOM 101 O SER A 12 -24.517 6.850 -0.945 1.00108.41 O \nANISOU 101 O SER A 12 13683 12633 14876 -2214 -315 -169 O \nATOM 102 CB SER A 12 -23.242 9.670 -1.642 1.00113.56 C \nANISOU 102 CB SER A 12 14055 13414 15678 -2214 -463 -122 C \nATOM 103 OG SER A 12 -22.603 9.037 -2.720 1.00121.50 O \nANISOU 103 OG SER A 12 15064 14374 16725 -2110 -441 -119 O \nATOM 104 N THR A 13 -25.105 7.394 -3.062 1.00 99.86 N \nANISOU 104 N THR A 13 12587 11515 13842 -2179 -281 -194 N \nATOM 105 CA THR A 13 -25.272 6.012 -3.524 1.00 98.16 C \nANISOU 105 CA THR A 13 12482 11224 13591 -2107 -213 -209 C \nATOM 106 C THR A 13 -24.326 5.686 -4.687 1.00 91.16 C \nANISOU 106 C THR A 13 11547 10322 12768 -1989 -215 -195 C \nATOM 107 O THR A 13 -24.394 4.610 -5.260 1.00 86.71 O \nANISOU 107 O THR A 13 11059 9704 12182 -1917 -162 -205 O \nATOM 108 CB THR A 13 -26.704 5.782 -4.013 1.00 98.65 C \nANISOU 108 CB THR A 13 12661 11229 13593 -2161 -146 -249 C \nATOM 109 OG1 THR A 13 -27.026 6.814 -4.946 1.00103.60 O \nANISOU 109 OG1 THR A 13 13225 11879 14259 -2193 -160 -256 O \nATOM 110 CG2 THR A 13 -27.682 5.816 -2.861 1.00101.45 C \nANISOU 110 CG2 THR A 13 13093 11583 13869 -2275 -130 -267 C \nATOM 111 N GLU A 14 -23.456 6.623 -5.027 1.00 88.48 N \nANISOU 111 N GLU A 14 11084 10032 12503 -1969 -277 -171 N \nATOM 112 CA GLU A 14 -22.467 6.415 -6.066 1.00 93.03 C \nANISOU 112 CA GLU A 14 11606 10600 13140 -1865 -286 -155 C \nATOM 113 C GLU A 14 -21.535 5.274 -5.663 1.00 95.31 C \nANISOU 113 C GLU A 14 11914 10882 13418 -1790 -281 -135 C \nATOM 114 O GLU A 14 -20.926 5.278 -4.585 1.00 96.87 O \nANISOU 114 O GLU A 14 12081 11115 13609 -1809 -320 -113 O \nATOM 115 CB GLU A 14 -21.655 7.680 -6.331 1.00 94.45 C \nANISOU 115 CB GLU A 14 11656 10834 13396 -1862 -359 -133 C \nATOM 116 CG GLU A 14 -22.483 8.844 -6.864 1.00 99.20 C \nANISOU 116 CG GLU A 14 12222 11459 14012 -1923 -366 -152 C \nATOM 117 CD GLU A 14 -21.760 10.179 -6.777 1.00 97.35 C \nANISOU 117 CD GLU A 14 11861 11289 13837 -1927 -444 -129 C \nATOM 118 OE1 GLU A 14 -20.989 10.377 -5.821 1.00 87.98 O \nANISOU 118 OE1 GLU A 14 10633 10135 12662 -1930 -495 -101 O \nATOM 119 OE2 GLU A 14 -21.960 11.031 -7.665 1.00 98.69 O \nANISOU 119 OE2 GLU A 14 11977 11479 14042 -1925 -453 -139 O \nATOM 120 N GLN A 15 -21.481 4.273 -6.527 1.00 87.84 N \nANISOU 120 N GLN A 15 11020 9892 12462 -1708 -230 -144 N \nATOM 121 CA GLN A 15 -20.627 3.132 -6.326 1.00 82.06 C \nANISOU 121 CA GLN A 15 10301 9163 11715 -1628 -219 -128 C \nATOM 122 C GLN A 15 -19.326 3.308 -7.099 1.00 84.99 C \nANISOU 122 C GLN A 15 10576 9561 12155 -1557 -258 -101 C \nATOM 123 O GLN A 15 -19.199 4.182 -7.956 1.00 86.16 O \nANISOU 123 O GLN A 15 10664 9712 12361 -1556 -282 -101 O \nATOM 124 CB GLN A 15 -21.332 1.870 -6.751 1.00 80.23 C \nANISOU 124 CB GLN A 15 10186 8875 11422 -1575 -139 -152 C \nATOM 125 CG GLN A 15 -22.393 1.422 -5.772 1.00 90.71 C \nANISOU 125 CG GLN A 15 11624 10174 12669 -1633 -100 -175 C \nATOM 126 CD GLN A 15 -23.175 0.220 -6.280 1.00 94.03 C \nANISOU 126 CD GLN A 15 12175 10528 13026 -1573 -19 -201 C \nATOM 127 OE1 GLN A 15 -22.878 -0.321 -7.350 1.00 90.17 O \nANISOU 127 OE1 GLN A 15 11688 10021 12553 -1483 7 -199 O \nATOM 128 NE2 GLN A 15 -24.168 -0.210 -5.508 1.00 93.41 N \nANISOU 128 NE2 GLN A 15 12209 10411 12870 -1620 21 -224 N \nATOM 129 N VAL A 16 -18.362 2.455 -6.785 1.00 78.41 N \nANISOU 129 N VAL A 16 9730 8751 11310 -1500 -264 -80 N \nATOM 130 CA VAL A 16 -17.017 2.579 -7.319 1.00 70.53 C \nANISOU 130 CA VAL A 16 8645 7785 10368 -1446 -306 -52 C \nATOM 131 C VAL A 16 -16.370 1.236 -7.235 1.00 72.90 C \nANISOU 131 C VAL A 16 8968 8102 10628 -1375 -278 -42 C \nATOM 132 O VAL A 16 -16.704 0.440 -6.359 1.00 80.06 O \nANISOU 132 O VAL A 16 9935 9014 11471 -1380 -250 -48 O \nATOM 133 CB VAL A 16 -16.217 3.621 -6.517 1.00 73.84 C \nANISOU 133 CB VAL A 16 8980 8248 10828 -1501 -387 -23 C \nATOM 134 CG1 VAL A 16 -14.852 3.101 -6.126 1.00 75.37 C \nANISOU 134 CG1 VAL A 16 9131 8483 11023 -1466 -420 9 C \nATOM 135 CG2 VAL A 16 -16.111 4.919 -7.287 1.00 69.16 C \nANISOU 135 CG2 VAL A 16 8318 7653 10305 -1513 -427 -22 C \nATOM 136 N ASP A 17 -15.481 0.952 -8.171 1.00 73.77 N \nANISOU 136 N ASP A 17 9033 8226 10771 -1306 -283 -29 N \nATOM 137 CA ASP A 17 -14.813 -0.360 -8.170 1.00 79.02 C \nANISOU 137 CA ASP A 17 9709 8923 11392 -1234 -256 -19 C \nATOM 138 C ASP A 17 -13.342 -0.380 -7.765 1.00 71.97 C \nANISOU 138 C ASP A 17 8738 8093 10516 -1233 -312 17 C \nATOM 139 O ASP A 17 -12.662 0.659 -7.713 1.00 67.50 O \nANISOU 139 O ASP A 17 8103 7536 10006 -1274 -375 37 O \nATOM 140 CB ASP A 17 -14.955 -1.003 -9.541 1.00 87.52 C \nANISOU 140 CB ASP A 17 10808 9976 12470 -1150 -206 -32 C \nATOM 141 CG ASP A 17 -16.317 -1.604 -9.745 1.00 88.39 C \nANISOU 141 CG ASP A 17 11026 10030 12527 -1130 -134 -64 C \nATOM 142 OD1 ASP A 17 -17.317 -0.858 -9.833 1.00 93.76 O \nANISOU 142 OD1 ASP A 17 11741 10663 13219 -1186 -127 -85 O \nATOM 143 OD2 ASP A 17 -16.380 -2.847 -9.807 1.00 89.54 O \nANISOU 143 OD2 ASP A 17 11224 10182 12614 -1058 -85 -70 O \nATOM 144 N THR A 18 -12.906 -1.605 -7.480 1.00 66.87 N \nANISOU 144 N THR A 18 8107 7488 9812 -1184 -284 24 N \nATOM 145 CA THR A 18 -11.591 -1.910 -6.957 1.00 66.87 C \nANISOU 145 CA THR A 18 8046 7558 9803 -1186 -326 56 C \nATOM 146 C THR A 18 -11.196 -3.290 -7.481 1.00 70.20 C \nANISOU 146 C THR A 18 8476 8024 10174 -1098 -278 55 C \nATOM 147 O THR A 18 -12.057 -4.119 -7.830 1.00 72.57 O \nANISOU 147 O THR A 18 8845 8301 10429 -1038 -212 31 O \nATOM 148 CB THR A 18 -11.639 -1.905 -5.404 1.00 68.47 C \nANISOU 148 CB THR A 18 8262 7789 9966 -1252 -349 64 C \nATOM 149 OG1 THR A 18 -11.657 -0.554 -4.927 1.00 76.74 O \nANISOU 149 OG1 THR A 18 9277 8816 11064 -1333 -408 75 O \nATOM 150 CG2 THR A 18 -10.473 -2.586 -4.780 1.00 74.10 C \nANISOU 150 CG2 THR A 18 8933 8581 10641 -1248 -372 92 C \nATOM 151 N ILE A 19 -9.898 -3.553 -7.509 1.00 75.39 N \nANISOU 151 N ILE A 19 9067 8747 10831 -1090 -312 84 N \nATOM 152 CA ILE A 19 -9.359 -4.860 -7.965 1.00 82.57 C \nANISOU 152 CA ILE A 19 9967 9721 11685 -1011 -274 88 C \nATOM 153 C ILE A 19 -9.821 -6.039 -7.118 1.00 86.42 C \nANISOU 153 C ILE A 19 10506 10248 12083 -975 -226 76 C \nATOM 154 O ILE A 19 -9.885 -7.149 -7.605 1.00 94.85 O \nANISOU 154 O ILE A 19 11592 11350 13098 -889 -174 67 O \nATOM 155 CB ILE A 19 -7.817 -4.851 -8.091 1.00 83.86 C \nANISOU 155 CB ILE A 19 10047 9956 11861 -1028 -324 121 C \nATOM 156 CG1 ILE A 19 -7.184 -4.552 -6.748 1.00 93.97 C \nANISOU 156 CG1 ILE A 19 11301 11277 13125 -1108 -378 145 C \nATOM 157 CG2 ILE A 19 -7.366 -3.799 -9.096 1.00 79.08 C \nANISOU 157 CG2 ILE A 19 9400 9307 11339 -1044 -363 129 C \nATOM 158 CD1 ILE A 19 -6.762 -5.800 -6.023 1.00 99.86 C \nANISOU 158 CD1 ILE A 19 12042 12118 13783 -1086 -355 153 C \nATOM 159 N MET A 20 -10.169 -5.779 -5.862 1.00 92.36 N \nANISOU 159 N MET A 20 11284 10996 12815 -1038 -242 75 N \nATOM 160 CA MET A 20 -10.624 -6.808 -4.921 1.00 91.38 C \nANISOU 160 CA MET A 20 11212 10906 12603 -1013 -200 62 C \nATOM 161 C MET A 20 -12.090 -6.689 -4.544 1.00 89.12 C \nANISOU 161 C MET A 20 11023 10539 12298 -1024 -160 29 C \nATOM 162 O MET A 20 -12.645 -7.606 -3.941 1.00 88.33 O \nANISOU 162 O MET A 20 10987 10451 12123 -986 -113 12 O \nATOM 163 CB MET A 20 -9.810 -6.739 -3.624 1.00 96.50 C \nANISOU 163 CB MET A 20 11816 11624 13227 -1083 -249 87 C \nATOM 164 CG MET A 20 -8.456 -7.407 -3.683 1.00 94.25 C \nANISOU 164 CG MET A 20 11455 11443 12911 -1064 -269 114 C \nATOM 165 SD MET A 20 -7.656 -7.167 -2.096 1.00105.99 S \nANISOU 165 SD MET A 20 12903 12999 14371 -1164 -329 143 S \nATOM 166 CE MET A 20 -6.039 -7.844 -2.447 1.00114.92 C \nANISOU 166 CE MET A 20 13945 14249 15472 -1150 -353 175 C \nATOM 167 N GLU A 21 -12.701 -5.549 -4.841 1.00 91.25 N \nANISOU 167 N GLU A 21 11307 10733 12632 -1079 -179 21 N \nATOM 168 CA GLU A 21 -14.093 -5.301 -4.446 1.00 95.53 C \nANISOU 168 CA GLU A 21 11940 11201 13156 -1111 -146 -9 C \nATOM 169 C GLU A 21 -14.880 -4.587 -5.544 1.00 81.26 C \nANISOU 169 C GLU A 21 10159 9314 11402 -1112 -131 -27 C \nATOM 170 O GLU A 21 -14.405 -3.628 -6.133 1.00 69.74 O \nANISOU 170 O GLU A 21 8633 7848 10016 -1141 -176 -13 O \nATOM 171 CB GLU A 21 -14.149 -4.473 -3.155 1.00107.67 C \nANISOU 171 CB GLU A 21 13464 12743 14701 -1217 -195 -1 C \nATOM 172 CG GLU A 21 -13.912 -5.255 -1.873 1.00115.80 C \nANISOU 172 CG GLU A 21 14509 13833 15658 -1226 -190 4 C \nATOM 173 CD GLU A 21 -14.214 -4.439 -0.620 1.00122.34 C \nANISOU 173 CD GLU A 21 15341 14654 16488 -1333 -230 7 C \nATOM 174 OE1 GLU A 21 -15.273 -4.675 -0.001 1.00126.19 O \nANISOU 174 OE1 GLU A 21 15913 15106 16926 -1353 -192 -19 O \nATOM 175 OE2 GLU A 21 -13.407 -3.551 -0.258 1.00114.17 O \nANISOU 175 OE2 GLU A 21 14229 13649 15503 -1397 -300 37 O \nATOM 176 N LYS A 22 -16.096 -5.057 -5.771 1.00 83.38 N \nANISOU 176 N LYS A 22 10531 9521 11628 -1082 -68 -59 N \nATOM 177 CA LYS A 22 -16.966 -4.532 -6.795 1.00 92.47 C \nANISOU 177 CA LYS A 22 11723 10598 12814 -1083 -44 -79 C \nATOM 178 C LYS A 22 -18.169 -3.885 -6.113 1.00102.06 C \nANISOU 178 C LYS A 22 13009 11755 14014 -1172 -37 -102 C \nATOM 179 O LYS A 22 -18.640 -4.373 -5.091 1.00109.16 O \nANISOU 179 O LYS A 22 13973 12654 14850 -1191 -16 -114 O \nATOM 180 CB LYS A 22 -17.373 -5.676 -7.743 1.00103.61 C \nANISOU 180 CB LYS A 22 13204 11984 14180 -972 26 -96 C \nATOM 181 CG LYS A 22 -18.627 -5.432 -8.611 1.00110.35 C \nANISOU 181 CG LYS A 22 14146 12746 15036 -972 71 -125 C \nATOM 182 CD LYS A 22 -18.272 -4.620 -9.860 1.00110.72 C \nANISOU 182 CD LYS A 22 14121 12784 15164 -973 46 -116 C \nATOM 183 CE LYS A 22 -19.468 -4.259 -10.759 1.00105.57 C \nANISOU 183 CE LYS A 22 13544 12048 14518 -985 85 -143 C \nATOM 184 NZ LYS A 22 -19.305 -2.892 -11.356 1.00 97.45 N \nANISOU 184 NZ LYS A 22 12435 11016 13575 -1050 38 -138 N \nATOM 185 N ASN A 23 -18.654 -2.780 -6.683 1.00110.43 N \nANISOU 185 N ASN A 23 14055 12775 15130 -1229 -55 -110 N \nATOM 186 CA ASN A 23 -19.881 -2.100 -6.215 1.00110.96 C \nANISOU 186 CA ASN A 23 14187 12793 15181 -1320 -45 -134 C \nATOM 187 C ASN A 23 -19.750 -1.589 -4.782 1.00105.13 C \nANISOU 187 C ASN A 23 13422 12091 14431 -1408 -90 -124 C \nATOM 188 O ASN A 23 -20.519 -1.953 -3.902 1.00 99.02 O \nANISOU 188 O ASN A 23 12731 11297 13594 -1445 -61 -142 O \nATOM 189 CB ASN A 23 -21.133 -2.991 -6.373 1.00107.65 C \nANISOU 189 CB ASN A 23 13914 12304 14685 -1290 35 -168 C \nATOM 190 CG ASN A 23 -21.490 -3.278 -7.831 1.00114.09 C \nANISOU 190 CG ASN A 23 14766 13072 15513 -1221 78 -180 C \nATOM 191 OD1 ASN A 23 -21.536 -4.443 -8.250 1.00123.92 O \nANISOU 191 OD1 ASN A 23 16073 14301 16711 -1122 129 -186 O \nATOM 192 ND2 ASN A 23 -21.763 -2.230 -8.606 1.00113.90 N \nANISOU 192 ND2 ASN A 23 14702 13027 15546 -1269 58 -184 N \nATOM 193 N VAL A 24 -18.748 -0.748 -4.565 1.00106.45 N \nANISOU 193 N VAL A 24 13477 12311 14660 -1441 -161 -94 N \nATOM 194 CA VAL A 24 -18.465 -0.193 -3.235 1.00 97.07 C \nANISOU 194 CA VAL A 24 12251 11164 13468 -1521 -212 -78 C \nATOM 195 C VAL A 24 -18.973 1.229 -3.109 1.00 85.94 C \nANISOU 195 C VAL A 24 10807 9748 12100 -1615 -252 -81 C \nATOM 196 O VAL A 24 -18.477 2.132 -3.788 1.00 77.13 O \nANISOU 196 O VAL A 24 9610 8642 11053 -1615 -295 -67 O \nATOM 197 CB VAL A 24 -16.954 -0.208 -2.941 1.00 98.85 C \nANISOU 197 CB VAL A 24 12379 11456 13725 -1498 -269 -39 C \nATOM 198 CG1 VAL A 24 -16.631 0.618 -1.699 1.00 96.83 C \nANISOU 198 CG1 VAL A 24 12075 11238 13477 -1587 -332 -19 C \nATOM 199 CG2 VAL A 24 -16.492 -1.647 -2.785 1.00 97.62 C \nANISOU 199 CG2 VAL A 24 12252 11327 13510 -1420 -230 -37 C \nATOM 200 N THR A 25 -19.955 1.423 -2.227 1.00 82.14 N \nANISOU 200 N THR A 25 10386 9253 11572 -1694 -239 -99 N \nATOM 201 CA THR A 25 -20.622 2.707 -2.112 1.00 77.97 C \nANISOU 201 CA THR A 25 9832 8725 11068 -1788 -269 -106 C \nATOM 202 C THR A 25 -19.663 3.730 -1.519 1.00 75.38 C \nANISOU 202 C THR A 25 9390 8457 10792 -1826 -353 -71 C \nATOM 203 O THR A 25 -18.933 3.431 -0.582 1.00 75.32 O \nANISOU 203 O THR A 25 9361 8488 10770 -1829 -382 -49 O \nATOM 204 CB THR A 25 -21.900 2.592 -1.275 1.00 73.10 C \nANISOU 204 CB THR A 25 9314 8084 10378 -1869 -232 -135 C \nATOM 205 OG1 THR A 25 -22.533 1.331 -1.535 1.00 78.39 O \nANISOU 205 OG1 THR A 25 10104 8696 10984 -1816 -155 -162 O \nATOM 206 CG2 THR A 25 -22.856 3.724 -1.607 1.00 67.26 C \nANISOU 206 CG2 THR A 25 8568 7335 9652 -1954 -238 -153 C \nATOM 207 N VAL A 26 -19.655 4.931 -2.079 1.00 71.56 N \nANISOU 207 N VAL A 26 8837 7985 10367 -1851 -392 -66 N \nATOM 208 CA VAL A 26 -18.673 5.927 -1.695 1.00 72.27 C \nANISOU 208 CA VAL A 26 8822 8127 10511 -1868 -474 -32 C \nATOM 209 C VAL A 26 -19.355 7.256 -1.388 1.00 80.10 C \nANISOU 209 C VAL A 26 9776 9144 11514 -1953 -508 -37 C \nATOM 210 O VAL A 26 -20.513 7.465 -1.747 1.00 84.30 O \nANISOU 210 O VAL A 26 10352 9657 12023 -1995 -469 -68 O \nATOM 211 CB VAL A 26 -17.577 6.074 -2.787 1.00 75.81 C \nANISOU 211 CB VAL A 26 9203 8574 11028 -1786 -499 -12 C \nATOM 212 CG1 VAL A 26 -17.770 7.325 -3.653 1.00 76.72 C \nANISOU 212 CG1 VAL A 26 9257 8692 11202 -1794 -527 -17 C \nATOM 213 CG2 VAL A 26 -16.191 6.058 -2.168 1.00 76.17 C \nANISOU 213 CG2 VAL A 26 9189 8657 11093 -1768 -558 28 C \nATOM 214 N THR A 27 -18.623 8.139 -0.713 1.00 80.37 N \nANISOU 214 N THR A 27 9730 9228 11579 -1980 -582 -5 N \nATOM 215 CA THR A 27 -19.151 9.392 -0.239 1.00 74.19 C \nANISOU 215 CA THR A 27 8901 8487 10800 -2057 -623 -5 C \nATOM 216 C THR A 27 -19.078 10.465 -1.329 1.00 78.11 C \nANISOU 216 C THR A 27 9325 8994 11360 -2030 -649 -6 C \nATOM 217 O THR A 27 -20.044 11.190 -1.538 1.00 79.94 O \nANISOU 217 O THR A 27 9549 9244 11581 -2083 -640 -28 O \nATOM 218 CB THR A 27 -18.483 9.761 1.089 1.00 76.71 C \nANISOU 218 CB THR A 27 9180 8855 11113 -2097 -686 29 C \nATOM 219 OG1 THR A 27 -19.463 10.247 2.009 1.00 87.66 O \nANISOU 219 OG1 THR A 27 10581 10274 12451 -2195 -688 17 O \nATOM 220 CG2 THR A 27 -17.360 10.759 0.938 1.00 73.22 C \nANISOU 220 CG2 THR A 27 8640 8443 10736 -2062 -765 66 C \nATOM 221 N HIS A 28 -17.954 10.543 -2.042 1.00 84.49 N \nANISOU 221 N HIS A 28 10083 9793 12227 -1949 -679 15 N \nATOM 222 CA HIS A 28 -17.775 11.452 -3.183 1.00 80.07 C \nANISOU 222 CA HIS A 28 9459 9237 11728 -1908 -700 12 C \nATOM 223 C HIS A 28 -17.006 10.709 -4.272 1.00 82.77 C \nANISOU 223 C HIS A 28 9810 9535 12105 -1816 -676 14 C \nATOM 224 O HIS A 28 -16.078 9.941 -3.995 1.00 71.41 O \nANISOU 224 O HIS A 28 8384 8085 10665 -1779 -684 36 O \nATOM 225 CB HIS A 28 -16.984 12.720 -2.816 1.00 81.45 C \nANISOU 225 CB HIS A 28 9541 9459 11946 -1905 -785 44 C \nATOM 226 CG HIS A 28 -17.659 13.636 -1.841 1.00 88.38 C \nANISOU 226 CG HIS A 28 10390 10395 12796 -1988 -818 46 C \nATOM 227 ND1 HIS A 28 -17.736 15.001 -2.037 1.00 89.12 N \nANISOU 227 ND1 HIS A 28 10404 10540 12920 -1993 -866 50 N \nATOM 228 CD2 HIS A 28 -18.243 13.398 -0.644 1.00 91.11 C \nANISOU 228 CD2 HIS A 28 10772 10762 13082 -2067 -811 44 C \nATOM 229 CE1 HIS A 28 -18.362 15.555 -1.012 1.00 91.86 C \nANISOU 229 CE1 HIS A 28 10737 10942 13226 -2073 -887 52 C \nATOM 230 NE2 HIS A 28 -18.681 14.605 -0.155 1.00 91.06 N \nANISOU 230 NE2 HIS A 28 10707 10822 13071 -2123 -854 48 N \nATOM 231 N ALA A 29 -17.357 10.991 -5.520 1.00 89.36 N \nANISOU 231 N ALA A 29 10633 10352 12969 -1783 -651 -7 N \nATOM 232 CA ALA A 29 -16.717 10.343 -6.643 1.00 91.12 C \nANISOU 232 CA ALA A 29 10862 10536 13224 -1699 -627 -8 C \nATOM 233 C ALA A 29 -16.688 11.246 -7.874 1.00 93.60 C \nANISOU 233 C ALA A 29 11119 10851 13594 -1663 -639 -18 C \nATOM 234 O ALA A 29 -17.424 12.226 -7.948 1.00 98.89 O \nANISOU 234 O ALA A 29 11756 11551 14266 -1705 -650 -33 O \nATOM 235 CB ALA A 29 -17.431 9.035 -6.945 1.00 88.96 C \nANISOU 235 CB ALA A 29 10682 10220 12901 -1688 -546 -33 C \nATOM 236 N GLN A 30 -15.817 10.910 -8.825 1.00 92.96 N \nANISOU 236 N GLN A 30 11023 10744 13552 -1586 -638 -11 N \nATOM 237 CA GLN A 30 -15.773 11.584 -10.122 1.00 89.35 C \nANISOU 237 CA GLN A 30 10521 10282 13145 -1543 -640 -24 C \nATOM 238 C GLN A 30 -15.897 10.584 -11.274 1.00 94.69 C \nANISOU 238 C GLN A 30 11244 10915 13819 -1489 -576 -43 C \nATOM 239 O GLN A 30 -15.095 9.664 -11.416 1.00 92.94 O \nANISOU 239 O GLN A 30 11043 10674 13597 -1441 -566 -28 O \nATOM 240 CB GLN A 30 -14.498 12.391 -10.290 1.00 84.39 C \nANISOU 240 CB GLN A 30 9823 9667 12575 -1497 -710 3 C \nATOM 241 CG GLN A 30 -14.629 13.843 -9.897 1.00 84.48 C \nANISOU 241 CG GLN A 30 9768 9724 12608 -1524 -768 9 C \nATOM 242 CD GLN A 30 -13.566 14.719 -10.552 1.00 82.37 C \nANISOU 242 CD GLN A 30 9438 9456 12402 -1459 -824 24 C \nATOM 243 OE1 GLN A 30 -13.523 14.853 -11.773 1.00 88.05 O \nANISOU 243 OE1 GLN A 30 10142 10159 13153 -1411 -804 6 O \nATOM 244 NE2 GLN A 30 -12.719 15.336 -9.742 1.00 78.42 N \nANISOU 244 NE2 GLN A 30 8908 8972 11915 -1457 -893 57 N \nATOM 245 N ASP A 31 -16.938 10.756 -12.073 1.00 95.43 N \nANISOU 245 N ASP A 31 11355 10998 13905 -1503 -532 -75 N \nATOM 246 CA ASP A 31 -17.042 10.074 -13.348 1.00 93.72 C \nANISOU 246 CA ASP A 31 11169 10744 13697 -1447 -479 -92 C \nATOM 247 C ASP A 31 -16.089 10.821 -14.262 1.00 85.58 C \nANISOU 247 C ASP A 31 10061 9722 12733 -1390 -521 -83 C \nATOM 248 O ASP A 31 -16.124 12.055 -14.317 1.00 90.46 O \nANISOU 248 O ASP A 31 10615 10372 13382 -1406 -563 -85 O \nATOM 249 CB ASP A 31 -18.481 10.127 -13.897 1.00 91.48 C \nANISOU 249 CB ASP A 31 10930 10447 13381 -1489 -423 -128 C \nATOM 250 CG ASP A 31 -18.690 9.227 -15.119 1.00 93.00 C \nANISOU 250 CG ASP A 31 11173 10594 13568 -1433 -361 -145 C \nATOM 251 OD1 ASP A 31 -17.951 8.242 -15.288 1.00 94.87 O \nANISOU 251 OD1 ASP A 31 11433 10809 13804 -1371 -347 -130 O \nATOM 252 OD2 ASP A 31 -19.605 9.497 -15.931 1.00 99.73 O \nANISOU 252 OD2 ASP A 31 12042 11436 14413 -1453 -326 -172 O \nATOM 253 N ILE A 32 -15.245 10.075 -14.962 1.00 75.45 N \nANISOU 253 N ILE A 32 8785 8415 11468 -1322 -508 -73 N \nATOM 254 CA ILE A 32 -14.377 10.658 -15.991 1.00 74.12 C \nANISOU 254 CA ILE A 32 8558 8247 11360 -1265 -538 -69 C \nATOM 255 C ILE A 32 -14.773 10.230 -17.430 1.00 76.04 C \nANISOU 255 C ILE A 32 8819 8464 11610 -1223 -482 -94 C \nATOM 256 O ILE A 32 -14.445 10.904 -18.378 1.00 68.42 O \nANISOU 256 O ILE A 32 7805 7500 10690 -1189 -498 -101 O \nATOM 257 CB ILE A 32 -12.895 10.327 -15.708 1.00 75.54 C \nANISOU 257 CB ILE A 32 8719 8425 11558 -1227 -580 -35 C \nATOM 258 CG1 ILE A 32 -12.683 8.809 -15.488 1.00 68.92 C \nANISOU 258 CG1 ILE A 32 7939 7574 10675 -1209 -537 -27 C \nATOM 259 CG2 ILE A 32 -12.409 11.140 -14.514 1.00 75.50 C \nANISOU 259 CG2 ILE A 32 8680 8446 11561 -1264 -649 -10 C \nATOM 260 CD1 ILE A 32 -11.248 8.427 -15.200 1.00 60.33 C \nANISOU 260 CD1 ILE A 32 6833 6496 9595 -1183 -576 6 C \nATOM 261 N LEU A 33 -15.471 9.099 -17.574 1.00 79.05 N \nANISOU 261 N LEU A 33 9274 8819 11944 -1221 -417 -107 N \nATOM 262 CA LEU A 33 -16.041 8.666 -18.865 1.00 78.69 C \nANISOU 262 CA LEU A 33 9258 8746 11895 -1188 -359 -130 C \nATOM 263 C LEU A 33 -17.236 9.488 -19.363 1.00 76.79 C \nANISOU 263 C LEU A 33 9015 8510 11654 -1234 -340 -161 C \nATOM 264 O LEU A 33 -18.322 9.467 -18.781 1.00 84.27 O \nANISOU 264 O LEU A 33 10009 9454 12555 -1297 -315 -175 O \nATOM 265 CB LEU A 33 -16.472 7.203 -18.771 1.00 82.59 C \nANISOU 265 CB LEU A 33 9842 9210 12330 -1169 -297 -133 C \nATOM 266 CG LEU A 33 -17.046 6.563 -20.028 1.00 79.39 C \nANISOU 266 CG LEU A 33 9482 8772 11911 -1128 -234 -154 C \nATOM 267 CD1 LEU A 33 -15.972 6.375 -21.053 1.00 81.35 C \nANISOU 267 CD1 LEU A 33 9684 9026 12201 -1056 -244 -143 C \nATOM 268 CD2 LEU A 33 -17.684 5.229 -19.723 1.00 84.77 C \nANISOU 268 CD2 LEU A 33 10263 9422 12522 -1115 -173 -158 C \nATOM 269 N GLU A 34 -17.043 10.208 -20.456 1.00 80.36 N \nANISOU 269 N GLU A 34 9412 8971 12151 -1206 -350 -172 N \nATOM 270 CA GLU A 34 -18.134 11.013 -21.053 1.00 79.29 C \nANISOU 270 CA GLU A 34 9263 8849 12012 -1249 -331 -203 C \nATOM 271 C GLU A 34 -19.016 10.144 -21.933 1.00 71.49 C \nANISOU 271 C GLU A 34 8353 7822 10989 -1243 -257 -224 C \nATOM 272 O GLU A 34 -18.512 9.332 -22.684 1.00 70.67 O \nANISOU 272 O GLU A 34 8269 7690 10892 -1178 -232 -218 O \nATOM 273 CB GLU A 34 -17.573 12.160 -21.867 1.00 83.60 C \nANISOU 273 CB GLU A 34 9719 9427 12619 -1216 -372 -208 C \nATOM 274 CG GLU A 34 -18.629 12.969 -22.589 1.00 88.35 C \nANISOU 274 CG GLU A 34 10298 10054 13216 -1256 -351 -240 C \nATOM 275 CD GLU A 34 -19.625 13.568 -21.630 1.00 97.59 C \nANISOU 275 CD GLU A 34 11471 11263 14347 -1346 -358 -249 C \nATOM 276 OE1 GLU A 34 -19.155 14.120 -20.612 1.00108.34 O \nANISOU 276 OE1 GLU A 34 12791 12655 15719 -1359 -412 -230 O \nATOM 277 OE2 GLU A 34 -20.847 13.494 -21.895 1.00 89.27 O \nANISOU 277 OE2 GLU A 34 10460 10209 13249 -1405 -312 -274 O \nATOM 278 N LYS A 35 -20.333 10.282 -21.800 1.00 67.54 N \nANISOU 278 N LYS A 35 7900 7319 10442 -1315 -222 -247 N \nATOM 279 CA LYS A 35 -21.274 9.368 -22.467 1.00 69.50 C \nANISOU 279 CA LYS A 35 8245 7519 10643 -1317 -150 -265 C \nATOM 280 C LYS A 35 -22.376 10.046 -23.293 1.00 73.33 C \nANISOU 280 C LYS A 35 8733 8016 11115 -1372 -122 -296 C \nATOM 281 O LYS A 35 -23.183 9.372 -23.906 1.00 70.62 O \nANISOU 281 O LYS A 35 8473 7629 10731 -1379 -64 -311 O \nATOM 282 CB LYS A 35 -21.912 8.457 -21.430 1.00 70.11 C \nANISOU 282 CB LYS A 35 8424 7563 10653 -1354 -117 -263 C \nATOM 283 CG LYS A 35 -20.991 7.367 -20.906 1.00 73.32 C \nANISOU 283 CG LYS A 35 8856 7949 11054 -1287 -119 -237 C \nATOM 284 CD LYS A 35 -21.526 6.714 -19.630 1.00 73.99 C \nANISOU 284 CD LYS A 35 9022 8016 11076 -1329 -101 -234 C \nATOM 285 CE LYS A 35 -21.395 7.669 -18.447 1.00 72.43 C \nANISOU 285 CE LYS A 35 8766 7865 10889 -1397 -159 -225 C \nATOM 286 NZ LYS A 35 -22.093 7.167 -17.251 1.00 74.90 N \nANISOU 286 NZ LYS A 35 9159 8161 11136 -1454 -139 -228 N \nATOM 287 N THR A 36 -22.395 11.372 -23.324 1.00 74.68 N \nANISOU 287 N THR A 36 8811 8246 11316 -1409 -165 -305 N \nATOM 288 CA THR A 36 -23.493 12.089 -23.928 1.00 76.50 C \nANISOU 288 CA THR A 36 9035 8505 11525 -1477 -142 -334 C \nATOM 289 C THR A 36 -23.035 12.889 -25.111 1.00 82.70 C \nANISOU 289 C THR A 36 9730 9327 12366 -1432 -161 -344 C \nATOM 290 O THR A 36 -21.958 13.471 -25.078 1.00 93.31 O \nANISOU 290 O THR A 36 10987 10700 13767 -1376 -214 -330 O \nATOM 291 CB THR A 36 -24.144 13.059 -22.906 1.00 80.83 C \nANISOU 291 CB THR A 36 9551 9115 12048 -1574 -172 -341 C \nATOM 292 OG1 THR A 36 -24.238 12.422 -21.629 1.00 87.60 O \nANISOU 292 OG1 THR A 36 10472 9946 12866 -1604 -172 -326 O \nATOM 293 CG2 THR A 36 -25.542 13.476 -23.349 1.00 83.00 C \nANISOU 293 CG2 THR A 36 9854 9411 12269 -1669 -133 -373 C \nATOM 294 N HIS A 37 -23.878 12.976 -26.138 1.00 84.03 N \nANISOU 294 N HIS A 37 9920 9493 12514 -1459 -118 -369 N \nATOM 295 CA HIS A 37 -23.609 13.834 -27.293 1.00 75.86 C \nANISOU 295 CA HIS A 37 8798 8502 11525 -1428 -132 -384 C \nATOM 296 C HIS A 37 -24.861 14.506 -27.773 1.00 77.47 C \nANISOU 296 C HIS A 37 8998 8749 11687 -1516 -105 -416 C \nATOM 297 O HIS A 37 -25.951 14.001 -27.542 1.00 78.25 O \nANISOU 297 O HIS A 37 9192 8819 11720 -1592 -59 -426 O \nATOM 298 CB HIS A 37 -23.006 13.001 -28.410 1.00 74.18 C \nANISOU 298 CB HIS A 37 8611 8236 11339 -1340 -104 -380 C \nATOM 299 CG HIS A 37 -23.886 11.903 -28.906 1.00 67.63 C \nANISOU 299 CG HIS A 37 7900 7343 10454 -1358 -33 -388 C \nATOM 300 ND1 HIS A 37 -24.626 12.019 -30.058 1.00 65.45 N \nANISOU 300 ND1 HIS A 37 7641 7067 10161 -1380 7 -411 N \nATOM 301 CD2 HIS A 37 -24.086 10.648 -28.453 1.00 68.45 C \nANISOU 301 CD2 HIS A 37 8113 7381 10515 -1346 4 -375 C \nATOM 302 CE1 HIS A 37 -25.256 10.887 -30.288 1.00 69.90 C \nANISOU 302 CE1 HIS A 37 8325 7561 10673 -1382 65 -411 C \nATOM 303 NE2 HIS A 37 -24.957 10.038 -29.319 1.00 72.47 N \nANISOU 303 NE2 HIS A 37 8709 7847 10981 -1359 65 -390 N \nATOM 304 N ASN A 38 -24.707 15.620 -28.485 1.00 77.50 N \nANISOU 304 N ASN A 38 8899 8823 11727 -1506 -131 -431 N \nATOM 305 CA ASN A 38 -25.862 16.434 -28.905 1.00 72.29 C \nANISOU 305 CA ASN A 38 8214 8228 11025 -1597 -113 -462 C \nATOM 306 C ASN A 38 -26.577 15.943 -30.158 1.00 76.18 C \nANISOU 306 C ASN A 38 8769 8687 11491 -1613 -51 -482 C \nATOM 307 O ASN A 38 -27.446 16.624 -30.685 1.00 81.37 O \nANISOU 307 O ASN A 38 9400 9402 12116 -1685 -35 -509 O \nATOM 308 CB ASN A 38 -25.448 17.900 -29.073 1.00 70.63 C \nANISOU 308 CB ASN A 38 7860 8121 10856 -1579 -168 -472 C \nATOM 309 CG ASN A 38 -24.809 18.182 -30.401 1.00 71.46 C \nANISOU 309 CG ASN A 38 7905 8233 11014 -1496 -170 -482 C \nATOM 310 OD1 ASN A 38 -24.314 17.278 -31.068 1.00 81.12 O \nANISOU 310 OD1 ASN A 38 9181 9382 12260 -1432 -144 -474 O \nATOM 311 ND2 ASN A 38 -24.802 19.438 -30.790 1.00 65.50 N \nANISOU 311 ND2 ASN A 38 7039 7572 10276 -1494 -200 -501 N \nATOM 312 N GLY A 39 -26.198 14.771 -30.644 1.00 80.17 N \nANISOU 312 N GLY A 39 9352 9104 12004 -1547 -18 -470 N \nATOM 313 CA GLY A 39 -26.871 14.124 -31.773 1.00 73.42 C \nANISOU 313 CA GLY A 39 8575 8203 11118 -1556 44 -484 C \nATOM 314 C GLY A 39 -26.836 14.885 -33.083 1.00 68.53 C \nANISOU 314 C GLY A 39 7875 7636 10527 -1540 44 -505 C \nATOM 315 O GLY A 39 -27.531 14.499 -34.016 1.00 65.38 O \nANISOU 315 O GLY A 39 7536 7210 10094 -1565 94 -520 O \nATOM 316 N LYS A 40 -26.064 15.976 -33.161 1.00 70.71 N \nANISOU 316 N LYS A 40 8020 7987 10860 -1499 -10 -509 N \nATOM 317 CA LYS A 40 -26.062 16.841 -34.364 1.00 71.54 C \nANISOU 317 CA LYS A 40 8038 8155 10989 -1486 -12 -534 C \nATOM 318 C LYS A 40 -24.674 17.036 -34.922 1.00 69.08 C \nANISOU 318 C LYS A 40 7649 7841 10757 -1366 -49 -524 C \nATOM 319 O LYS A 40 -23.710 16.808 -34.233 1.00 92.50 O \nANISOU 319 O LYS A 40 10607 10779 13760 -1307 -85 -500 O \nATOM 320 CB LYS A 40 -26.672 18.222 -34.066 1.00 69.88 C \nANISOU 320 CB LYS A 40 7733 8060 10759 -1562 -40 -556 C \nATOM 321 CG LYS A 40 -28.167 18.213 -33.821 1.00 71.60 C \nANISOU 321 CG LYS A 40 8016 8299 10891 -1699 0 -574 C \nATOM 322 CD LYS A 40 -28.938 17.696 -35.019 1.00 76.80 C \nANISOU 322 CD LYS A 40 8746 8923 11511 -1733 62 -591 C \nATOM 323 CE LYS A 40 -30.018 16.704 -34.599 1.00 82.52 C \nANISOU 323 CE LYS A 40 9626 9571 12158 -1822 115 -588 C \nATOM 324 NZ LYS A 40 -30.670 16.062 -35.785 1.00 89.51 N \nANISOU 324 NZ LYS A 40 10598 10404 13007 -1841 176 -599 N \nATOM 325 N LEU A 41 -24.592 17.480 -36.169 1.00 58.71 N \nANISOU 325 N LEU A 41 6282 6559 9465 -1337 -39 -545 N \nATOM 326 CA LEU A 41 -23.361 17.911 -36.747 1.00 55.01 C \nANISOU 326 CA LEU A 41 5732 6103 9067 -1235 -77 -543 C \nATOM 327 C LEU A 41 -23.252 19.421 -36.554 1.00 60.81 C \nANISOU 327 C LEU A 41 6344 6942 9821 -1238 -127 -561 C \nATOM 328 O LEU A 41 -24.171 20.167 -36.861 1.00 62.15 O \nANISOU 328 O LEU A 41 6471 7188 9954 -1305 -115 -588 O \nATOM 329 CB LEU A 41 -23.277 17.591 -38.238 1.00 51.69 C \nANISOU 329 CB LEU A 41 5318 5662 8659 -1196 -40 -557 C \nATOM 330 CG LEU A 41 -23.409 16.124 -38.644 1.00 53.22 C \nANISOU 330 CG LEU A 41 5629 5763 8831 -1182 13 -542 C \nATOM 331 CD1 LEU A 41 -23.094 15.982 -40.122 1.00 52.82 C \nANISOU 331 CD1 LEU A 41 5561 5705 8803 -1129 37 -554 C \nATOM 332 CD2 LEU A 41 -22.530 15.189 -37.830 1.00 50.58 C \nANISOU 332 CD2 LEU A 41 5343 5360 8514 -1125 -2 -507 C \nATOM 333 N CYS A 42 -22.109 19.857 -36.033 1.00 63.73 N \nANISOU 333 N CYS A 42 6657 7314 10242 -1163 -185 -545 N \nATOM 334 CA CYS A 42 -21.927 21.252 -35.650 1.00 72.51 C \nANISOU 334 CA CYS A 42 7660 8521 11371 -1152 -239 -556 C \nATOM 335 C CYS A 42 -20.688 21.854 -36.263 1.00 68.05 C \nANISOU 335 C CYS A 42 7023 7961 10871 -1042 -280 -559 C \nATOM 336 O CYS A 42 -19.850 21.124 -36.807 1.00 71.39 O \nANISOU 336 O CYS A 42 7486 8310 11329 -978 -271 -547 O \nATOM 337 CB CYS A 42 -21.852 21.351 -34.122 1.00 78.66 C \nANISOU 337 CB CYS A 42 8445 9304 12138 -1180 -277 -532 C \nATOM 338 SG CYS A 42 -23.156 20.469 -33.246 1.00 98.90 S \nANISOU 338 SG CYS A 42 11115 11838 14624 -1305 -230 -525 S \nATOM 339 N ASP A 43 -20.550 23.170 -36.120 1.00 64.35 N \nANISOU 339 N ASP A 43 6454 7582 10413 -1018 -325 -573 N \nATOM 340 CA ASP A 43 -19.313 23.829 -36.516 1.00 75.14 C \nANISOU 340 CA ASP A 43 7761 8949 11840 -907 -372 -574 C \nATOM 341 C ASP A 43 -18.152 23.322 -35.669 1.00 77.96 C \nANISOU 341 C ASP A 43 8164 9226 12233 -854 -411 -536 C \nATOM 342 O ASP A 43 -18.370 22.663 -34.656 1.00 86.10 O \nANISOU 342 O ASP A 43 9252 10221 13242 -903 -408 -511 O \nATOM 343 CB ASP A 43 -19.418 25.329 -36.364 1.00 75.10 C \nANISOU 343 CB ASP A 43 7645 9058 11833 -887 -416 -594 C \nATOM 344 CG ASP A 43 -20.567 25.896 -37.154 1.00 83.21 C \nANISOU 344 CG ASP A 43 8617 10182 12817 -946 -379 -632 C \nATOM 345 OD1 ASP A 43 -21.225 25.087 -37.851 1.00 90.38 O \nANISOU 345 OD1 ASP A 43 9583 11056 13701 -1002 -320 -641 O \nATOM 346 OD2 ASP A 43 -20.808 27.121 -37.094 1.00 78.93 O \nANISOU 346 OD2 ASP A 43 7975 9752 12262 -936 -409 -652 O \nATOM 347 N LEU A 44 -16.931 23.580 -36.123 1.00 78.04 N \nANISOU 347 N LEU A 44 8153 9204 12295 -758 -444 -532 N \nATOM 348 CA LEU A 44 -15.755 23.511 -35.263 1.00 78.33 C \nANISOU 348 CA LEU A 44 8211 9186 12363 -705 -497 -499 C \nATOM 349 C LEU A 44 -15.211 24.913 -35.097 1.00 82.47 C \nANISOU 349 C LEU A 44 8654 9769 12911 -637 -559 -508 C \nATOM 350 O LEU A 44 -14.796 25.536 -36.087 1.00 86.28 O \nANISOU 350 O LEU A 44 9092 10270 13419 -570 -565 -532 O \nATOM 351 CB LEU A 44 -14.636 22.648 -35.861 1.00 78.90 C \nANISOU 351 CB LEU A 44 8339 9168 12472 -648 -491 -485 C \nATOM 352 CG LEU A 44 -14.703 21.125 -35.753 1.00 77.92 C \nANISOU 352 CG LEU A 44 8305 8969 12330 -686 -447 -462 C \nATOM 353 CD1 LEU A 44 -13.431 20.489 -36.324 1.00 60.88 C \nANISOU 353 CD1 LEU A 44 6182 6741 10208 -622 -453 -448 C \nATOM 354 CD2 LEU A 44 -14.914 20.713 -34.304 1.00 79.31 C \nANISOU 354 CD2 LEU A 44 8521 9133 12482 -737 -462 -433 C \nATOM 355 N ASP A 45 -15.145 25.382 -33.853 1.00 80.61 N \nANISOU 355 N ASP A 45 8404 9558 12667 -647 -605 -487 N \nATOM 356 CA ASP A 45 -14.457 26.637 -33.547 1.00 90.22 C \nANISOU 356 CA ASP A 45 9557 10817 13906 -568 -671 -487 C \nATOM 357 C ASP A 45 -14.991 27.748 -34.432 1.00 84.94 C \nANISOU 357 C ASP A 45 8795 10249 13230 -540 -666 -528 C \nATOM 358 O ASP A 45 -14.228 28.421 -35.120 1.00 82.09 O \nANISOU 358 O ASP A 45 8401 9888 12900 -447 -691 -543 O \nATOM 359 CB ASP A 45 -12.936 26.489 -33.759 1.00 97.87 C \nANISOU 359 CB ASP A 45 10566 11696 14924 -478 -707 -469 C \nATOM 360 CG ASP A 45 -12.391 25.143 -33.248 1.00102.52 C \nANISOU 360 CG ASP A 45 11250 12185 15517 -510 -695 -433 C \nATOM 361 OD1 ASP A 45 -12.799 24.701 -32.151 1.00 93.69 O \nANISOU 361 OD1 ASP A 45 10159 11065 14372 -573 -696 -410 O \nATOM 362 OD2 ASP A 45 -11.557 24.540 -33.959 1.00111.66 O \nANISOU 362 OD2 ASP A 45 12452 13273 16702 -473 -684 -430 O \nATOM 363 N GLY A 46 -16.318 27.883 -34.454 1.00 80.99 N \nANISOU 363 N GLY A 46 8259 9832 12682 -624 -630 -549 N \nATOM 364 CA GLY A 46 -17.000 28.913 -35.244 1.00 77.84 C \nANISOU 364 CA GLY A 46 7765 9549 12263 -617 -620 -590 C \nATOM 365 C GLY A 46 -16.930 28.770 -36.753 1.00 80.35 C \nANISOU 365 C GLY A 46 8077 9854 12599 -585 -580 -620 C \nATOM 366 O GLY A 46 -17.320 29.686 -37.481 1.00 81.20 O \nANISOU 366 O GLY A 46 8101 10057 12694 -563 -576 -655 O \nATOM 367 N VAL A 47 -16.414 27.634 -37.228 1.00 85.68 N \nANISOU 367 N VAL A 47 8837 10418 13301 -581 -550 -607 N \nATOM 368 CA VAL A 47 -16.317 27.356 -38.665 1.00 81.17 C \nANISOU 368 CA VAL A 47 8270 9826 12746 -555 -509 -633 C \nATOM 369 C VAL A 47 -17.183 26.174 -39.111 1.00 81.80 C \nANISOU 369 C VAL A 47 8416 9870 12797 -645 -440 -634 C \nATOM 370 O VAL A 47 -16.935 25.028 -38.758 1.00 85.16 O \nANISOU 370 O VAL A 47 8927 10204 13226 -668 -423 -606 O \nATOM 371 CB VAL A 47 -14.858 27.086 -39.093 1.00 82.91 C \nANISOU 371 CB VAL A 47 8531 9950 13021 -458 -534 -621 C \nATOM 372 CG1 VAL A 47 -14.797 26.659 -40.554 1.00 81.30 C \nANISOU 372 CG1 VAL A 47 8338 9722 12829 -442 -487 -645 C \nATOM 373 CG2 VAL A 47 -14.000 28.329 -38.852 1.00 78.85 C \nANISOU 373 CG2 VAL A 47 7961 9467 12533 -358 -600 -625 C \nATOM 374 N LYS A 48 -18.168 26.480 -39.949 1.00 80.05 N \nANISOU 374 N LYS A 48 8151 9721 12542 -691 -399 -668 N \nATOM 375 CA LYS A 48 -19.126 25.503 -40.429 1.00 75.42 C \nANISOU 375 CA LYS A 48 7627 9110 11920 -779 -333 -672 C \nATOM 376 C LYS A 48 -18.426 24.436 -41.261 1.00 74.19 C \nANISOU 376 C LYS A 48 7542 8850 11795 -738 -304 -662 C \nATOM 377 O LYS A 48 -17.330 24.687 -41.793 1.00 79.50 O \nANISOU 377 O LYS A 48 8196 9496 12516 -646 -330 -665 O \nATOM 378 CB LYS A 48 -20.168 26.212 -41.269 1.00 75.07 C \nANISOU 378 CB LYS A 48 7515 9173 11837 -827 -302 -712 C \nATOM 379 CG LYS A 48 -21.390 25.393 -41.642 1.00 80.20 C \nANISOU 379 CG LYS A 48 8227 9814 12433 -937 -236 -719 C \nATOM 380 CD LYS A 48 -22.497 26.277 -42.227 1.00 83.56 C \nANISOU 380 CD LYS A 48 8575 10366 12809 -1002 -214 -757 C \nATOM 381 CE LYS A 48 -23.294 25.513 -43.277 1.00 85.67 C \nANISOU 381 CE LYS A 48 8901 10608 13043 -1069 -147 -771 C \nATOM 382 NZ LYS A 48 -24.031 24.358 -42.693 1.00 87.11 N \nANISOU 382 NZ LYS A 48 9200 10713 13184 -1160 -108 -747 N \nATOM 383 N PRO A 49 -19.024 23.223 -41.332 1.00 61.62 N \nANISOU 383 N PRO A 49 6037 7200 10174 -803 -252 -649 N \nATOM 384 CA PRO A 49 -18.450 22.237 -42.223 1.00 59.03 C \nANISOU 384 CA PRO A 49 5767 6791 9869 -764 -222 -642 C \nATOM 385 C PRO A 49 -19.026 22.326 -43.604 1.00 66.71 C \nANISOU 385 C PRO A 49 6721 7798 10828 -778 -176 -674 C \nATOM 386 O PRO A 49 -19.860 23.188 -43.890 1.00 77.54 O \nANISOU 386 O PRO A 49 8029 9260 12172 -819 -169 -704 O \nATOM 387 CB PRO A 49 -18.859 20.915 -41.604 1.00 58.26 C \nANISOU 387 CB PRO A 49 5774 6622 9742 -819 -188 -612 C \nATOM 388 CG PRO A 49 -20.100 21.221 -40.847 1.00 57.39 C \nANISOU 388 CG PRO A 49 5662 6564 9578 -914 -178 -618 C \nATOM 389 CD PRO A 49 -19.986 22.630 -40.392 1.00 55.42 C \nANISOU 389 CD PRO A 49 5312 6404 9340 -898 -230 -633 C \nATOM 390 N LEU A 50 -18.549 21.456 -44.476 1.00 68.84 N \nANISOU 390 N LEU A 50 7038 8002 11115 -743 -147 -668 N \nATOM 391 CA LEU A 50 -18.998 21.432 -45.843 1.00 69.08 C \nANISOU 391 CA LEU A 50 7058 8057 11134 -752 -104 -696 C \nATOM 392 C LEU A 50 -19.900 20.243 -46.046 1.00 66.84 C \nANISOU 392 C LEU A 50 6867 7726 10804 -821 -43 -684 C \nATOM 393 O LEU A 50 -19.422 19.112 -46.220 1.00 75.30 O \nANISOU 393 O LEU A 50 8009 8717 11883 -792 -24 -660 O \nATOM 394 CB LEU A 50 -17.800 21.354 -46.790 1.00 76.64 C \nANISOU 394 CB LEU A 50 8001 8979 12141 -661 -114 -700 C \nATOM 395 CG LEU A 50 -18.132 21.178 -48.278 1.00 79.56 C \nANISOU 395 CG LEU A 50 8365 9362 12501 -663 -67 -725 C \nATOM 396 CD1 LEU A 50 -18.952 22.336 -48.785 1.00 86.25 C \nANISOU 396 CD1 LEU A 50 9130 10315 13327 -695 -61 -765 C \nATOM 397 CD2 LEU A 50 -16.866 21.073 -49.097 1.00 82.63 C \nANISOU 397 CD2 LEU A 50 8745 9714 12938 -575 -80 -727 C \nATOM 398 N ILE A 51 -21.210 20.469 -46.024 1.00 60.37 N \nANISOU 398 N ILE A 51 6052 6957 9931 -912 -13 -700 N \nATOM 399 CA ILE A 51 -22.155 19.370 -46.220 1.00 57.64 C \nANISOU 399 CA ILE A 51 5808 6560 9533 -980 46 -689 C \nATOM 400 C ILE A 51 -22.488 19.203 -47.681 1.00 62.46 C \nANISOU 400 C ILE A 51 6421 7179 10131 -983 90 -710 C \nATOM 401 O ILE A 51 -23.213 20.007 -48.248 1.00 73.30 O \nANISOU 401 O ILE A 51 7740 8631 11478 -1031 102 -741 O \nATOM 402 CB ILE A 51 -23.437 19.501 -45.391 1.00 62.41 C \nANISOU 402 CB ILE A 51 6444 7195 10075 -1090 61 -691 C \nATOM 403 CG1 ILE A 51 -23.149 19.693 -43.877 1.00 58.48 C \nANISOU 403 CG1 ILE A 51 5941 6694 9586 -1092 16 -670 C \nATOM 404 CG2 ILE A 51 -24.257 18.230 -45.522 1.00 71.53 C \nANISOU 404 CG2 ILE A 51 7726 8274 11177 -1145 119 -676 C \nATOM 405 CD1 ILE A 51 -23.106 21.136 -43.449 1.00 61.05 C \nANISOU 405 CD1 ILE A 51 6151 7123 9922 -1094 -32 -690 C \nATOM 406 N LEU A 52 -21.900 18.189 -48.325 1.00 65.42 N \nANISOU 406 N LEU A 52 6852 7480 10523 -929 112 -693 N \nATOM 407 CA LEU A 52 -22.401 17.737 -49.627 1.00 69.17 C \nANISOU 407 CA LEU A 52 7360 7949 10974 -944 164 -706 C \nATOM 408 C LEU A 52 -23.580 16.832 -49.254 1.00 74.12 C \nANISOU 408 C LEU A 52 8100 8529 11532 -1027 210 -690 C \nATOM 409 O LEU A 52 -23.439 15.896 -48.432 1.00 97.83 O \nANISOU 409 O LEU A 52 11183 11461 14527 -1016 213 -658 O \nATOM 410 CB LEU A 52 -21.342 16.972 -50.422 1.00 67.42 C \nANISOU 410 CB LEU A 52 7155 7671 10789 -856 169 -692 C \nATOM 411 CG LEU A 52 -20.008 17.496 -50.982 1.00 59.80 C \nANISOU 411 CG LEU A 52 6111 6721 9888 -765 132 -702 C \nATOM 412 CD1 LEU A 52 -19.553 18.752 -50.314 1.00 58.22 C \nANISOU 412 CD1 LEU A 52 5822 6576 9722 -745 76 -717 C \nATOM 413 CD2 LEU A 52 -18.932 16.417 -50.862 1.00 56.12 C \nANISOU 413 CD2 LEU A 52 5696 6179 9447 -698 126 -668 C \nATOM 414 N ARG A 53 -24.754 17.116 -49.765 1.00 61.50 N \nANISOU 414 N ARG A 53 6515 6970 9882 -1112 246 -712 N \nATOM 415 CA ARG A 53 -25.904 16.483 -49.168 1.00 65.20 C \nANISOU 415 CA ARG A 53 7091 7399 10282 -1201 281 -699 C \nATOM 416 C ARG A 53 -26.061 15.103 -49.751 1.00 58.81 C \nANISOU 416 C ARG A 53 6401 6498 9446 -1180 330 -677 C \nATOM 417 O ARG A 53 -25.913 14.135 -49.039 1.00 59.12 O \nANISOU 417 O ARG A 53 6524 6464 9477 -1156 336 -647 O \nATOM 418 CB ARG A 53 -27.208 17.358 -49.191 1.00 67.81 C \nANISOU 418 CB ARG A 53 7400 7812 10553 -1323 296 -729 C \nATOM 419 CG ARG A 53 -27.692 17.828 -50.549 1.00 75.18 C \nANISOU 419 CG ARG A 53 8295 8804 11467 -1356 325 -759 C \nATOM 420 CD ARG A 53 -29.047 18.535 -50.458 1.00 71.51 C \nANISOU 420 CD ARG A 53 7824 8417 10930 -1491 343 -784 C \nATOM 421 NE ARG A 53 -28.904 19.857 -49.850 1.00 68.90 N \nANISOU 421 NE ARG A 53 7365 8198 10617 -1503 296 -806 N \nATOM 422 CZ ARG A 53 -29.550 20.276 -48.759 1.00 80.26 C \nANISOU 422 CZ ARG A 53 8802 9677 12016 -1585 281 -806 C \nATOM 423 NH1 ARG A 53 -30.423 19.476 -48.137 1.00 83.18 N \nANISOU 423 NH1 ARG A 53 9299 9979 12325 -1669 313 -789 N \nATOM 424 NH2 ARG A 53 -29.348 21.511 -48.286 1.00 78.88 N \nANISOU 424 NH2 ARG A 53 8500 9614 11858 -1582 236 -825 N \nATOM 425 N ASP A 54 -26.395 15.021 -51.023 1.00 58.64 N \nANISOU 425 N ASP A 54 6386 6486 9407 -1189 365 -691 N \nATOM 426 CA ASP A 54 -26.492 13.744 -51.705 1.00 62.14 C \nANISOU 426 CA ASP A 54 6936 6849 9826 -1157 410 -669 C \nATOM 427 C ASP A 54 -25.403 13.649 -52.750 1.00 59.54 C \nANISOU 427 C ASP A 54 6545 6526 9551 -1061 402 -670 C \nATOM 428 O ASP A 54 -25.379 12.720 -53.534 1.00 59.26 O \nANISOU 428 O ASP A 54 6575 6442 9499 -1026 437 -656 O \nATOM 429 CB ASP A 54 -27.871 13.619 -52.356 1.00 70.55 C \nANISOU 429 CB ASP A 54 8079 7912 10815 -1255 462 -682 C \nATOM 430 CG ASP A 54 -28.905 13.088 -51.396 1.00 81.97 C \nANISOU 430 CG ASP A 54 9646 9304 12193 -1335 485 -668 C \nATOM 431 OD1 ASP A 54 -28.548 12.158 -50.621 1.00 85.96 O \nANISOU 431 OD1 ASP A 54 10224 9735 12702 -1283 484 -638 O \nATOM 432 OD2 ASP A 54 -30.056 13.599 -51.415 1.00 81.82 O \nANISOU 432 OD2 ASP A 54 9650 9320 12115 -1450 505 -688 O \nATOM 433 N CYS A 55 -24.499 14.630 -52.751 1.00 63.62 N \nANISOU 433 N CYS A 55 6940 7104 10130 -1017 356 -688 N \nATOM 434 CA CYS A 55 -23.356 14.654 -53.670 1.00 66.71 C \nANISOU 434 CA CYS A 55 7268 7503 10575 -927 342 -692 C \nATOM 435 C CYS A 55 -22.076 14.034 -53.075 1.00 51.29 C \nANISOU 435 C CYS A 55 5319 5501 8668 -838 311 -662 C \nATOM 436 O CYS A 55 -21.845 14.103 -51.871 1.00 43.03 O \nANISOU 436 O CYS A 55 4275 4443 7633 -838 280 -648 O \nATOM 437 CB CYS A 55 -23.111 16.082 -54.171 1.00 69.45 C \nANISOU 437 CB CYS A 55 7488 7943 10956 -927 313 -731 C \nATOM 438 SG CYS A 55 -24.355 16.544 -55.388 1.00 75.47 S \nANISOU 438 SG CYS A 55 8245 8767 11665 -1012 360 -765 S \nATOM 439 N SER A 56 -21.281 13.416 -53.928 1.00 48.75 N \nANISOU 439 N SER A 56 5000 5156 8368 -769 320 -652 N \nATOM 440 CA SER A 56 -19.962 12.884 -53.526 1.00 55.29 C \nANISOU 440 CA SER A 56 5819 5950 9237 -688 289 -627 C \nATOM 441 C SER A 56 -18.857 13.821 -53.895 1.00 54.32 C \nANISOU 441 C SER A 56 5595 5870 9175 -638 246 -648 C \nATOM 442 O SER A 56 -19.063 14.761 -54.676 1.00 69.05 O \nANISOU 442 O SER A 56 7395 7788 11051 -652 246 -682 O \nATOM 443 CB SER A 56 -19.706 11.553 -54.217 1.00 57.07 C \nANISOU 443 CB SER A 56 6112 6130 9441 -641 326 -602 C \nATOM 444 OG SER A 56 -19.485 11.769 -55.598 1.00 61.85 O \nANISOU 444 OG SER A 56 6677 6764 10059 -621 341 -621 O \nATOM 445 N VAL A 57 -17.659 13.545 -53.396 1.00 53.50 N \nANISOU 445 N VAL A 57 5479 5740 9107 -579 211 -628 N \nATOM 446 CA VAL A 57 -16.497 14.440 -53.674 1.00 46.53 C \nANISOU 446 CA VAL A 57 4512 4886 8282 -528 165 -646 C \nATOM 447 C VAL A 57 -16.218 14.582 -55.159 1.00 43.40 C \nANISOU 447 C VAL A 57 4081 4513 7896 -501 185 -669 C \nATOM 448 O VAL A 57 -15.962 15.704 -55.697 1.00 48.93 O \nANISOU 448 O VAL A 57 4706 5259 8626 -488 165 -703 O \nATOM 449 CB VAL A 57 -15.243 13.968 -52.982 1.00 41.07 C \nANISOU 449 CB VAL A 57 3829 4157 7617 -477 129 -617 C \nATOM 450 CG1 VAL A 57 -14.052 14.726 -53.467 1.00 37.55 C \nANISOU 450 CG1 VAL A 57 3319 3728 7222 -426 90 -635 C \nATOM 451 CG2 VAL A 57 -15.362 14.159 -51.482 1.00 41.39 C \nANISOU 451 CG2 VAL A 57 3882 4186 7658 -501 97 -601 C \nATOM 452 N ALA A 58 -16.395 13.486 -55.871 1.00 37.79 N \nANISOU 452 N ALA A 58 3427 3776 7155 -495 228 -652 N \nATOM 453 CA ALA A 58 -16.213 13.542 -57.316 1.00 34.55 C \nANISOU 453 CA ALA A 58 2989 3389 6749 -475 252 -672 C \nATOM 454 C ALA A 58 -17.304 14.309 -58.014 1.00 35.15 C \nANISOU 454 C ALA A 58 3038 3513 6806 -526 277 -707 C \nATOM 455 O ALA A 58 -17.050 15.226 -58.808 1.00 35.21 O \nANISOU 455 O ALA A 58 2974 3568 6838 -514 267 -741 O \nATOM 456 CB ALA A 58 -16.121 12.161 -57.859 1.00 34.81 C \nANISOU 456 CB ALA A 58 3088 3387 6751 -452 290 -643 C \nATOM 457 N GLY A 59 -18.555 13.934 -57.711 1.00 39.95 N \nANISOU 457 N GLY A 59 3707 4109 7363 -589 311 -698 N \nATOM 458 CA GLY A 59 -19.762 14.736 -58.149 1.00 40.19 C \nANISOU 458 CA GLY A 59 3716 4193 7363 -661 334 -730 C \nATOM 459 C GLY A 59 -19.635 16.235 -57.907 1.00 36.07 C \nANISOU 459 C GLY A 59 3091 3739 6873 -668 294 -767 C \nATOM 460 O GLY A 59 -19.904 17.007 -58.763 1.00 34.26 O \nANISOU 460 O GLY A 59 2804 3570 6643 -682 302 -801 O \nATOM 461 N TRP A 60 -19.089 16.607 -56.778 1.00 35.57 N \nANISOU 461 N TRP A 60 3006 3670 6840 -647 248 -758 N \nATOM 462 CA TRP A 60 -18.862 17.987 -56.443 1.00 37.68 C \nANISOU 462 CA TRP A 60 3180 4000 7137 -638 205 -788 C \nATOM 463 C TRP A 60 -17.751 18.597 -57.247 1.00 43.88 C \nANISOU 463 C TRP A 60 3896 4807 7971 -564 180 -811 C \nATOM 464 O TRP A 60 -17.911 19.695 -57.808 1.00 44.98 O \nANISOU 464 O TRP A 60 3957 5018 8116 -562 173 -850 O \nATOM 465 CB TRP A 60 -18.583 18.143 -54.933 1.00 38.49 C \nANISOU 465 CB TRP A 60 3287 4083 7254 -635 163 -767 C \nATOM 466 CG TRP A 60 -17.886 19.428 -54.558 1.00 39.91 C \nANISOU 466 CG TRP A 60 3376 4309 7476 -591 107 -789 C \nATOM 467 CD1 TRP A 60 -18.181 20.659 -54.988 1.00 43.25 C \nANISOU 467 CD1 TRP A 60 3714 4816 7902 -594 97 -829 C \nATOM 468 CD2 TRP A 60 -16.865 19.584 -53.585 1.00 40.79 C \nANISOU 468 CD2 TRP A 60 3482 4390 7628 -539 55 -771 C \nATOM 469 NE1 TRP A 60 -17.368 21.607 -54.393 1.00 47.19 N \nANISOU 469 NE1 TRP A 60 4152 5337 8440 -537 40 -838 N \nATOM 470 CE2 TRP A 60 -16.514 20.952 -53.559 1.00 43.83 C \nANISOU 470 CE2 TRP A 60 3779 4836 8040 -503 14 -801 C \nATOM 471 CE3 TRP A 60 -16.174 18.698 -52.771 1.00 40.17 C \nANISOU 471 CE3 TRP A 60 3463 4239 7560 -518 39 -732 C \nATOM 472 CZ2 TRP A 60 -15.491 21.441 -52.793 1.00 45.83 C \nANISOU 472 CZ2 TRP A 60 4010 5070 8332 -444 -42 -793 C \nATOM 473 CZ3 TRP A 60 -15.141 19.193 -51.987 1.00 42.54 C \nANISOU 473 CZ3 TRP A 60 3738 4525 7900 -468 -17 -723 C \nATOM 474 CH2 TRP A 60 -14.822 20.543 -51.982 1.00 46.73 C \nANISOU 474 CH2 TRP A 60 4190 5107 8457 -432 -57 -752 C \nATOM 475 N LEU A 61 -16.602 17.904 -57.339 1.00 48.90 N \nANISOU 475 N LEU A 61 4559 5385 8636 -502 168 -789 N \nATOM 476 CA LEU A 61 -15.423 18.539 -58.003 1.00 40.09 C \nANISOU 476 CA LEU A 61 3385 4281 7567 -431 138 -811 C \nATOM 477 C LEU A 61 -15.591 18.569 -59.497 1.00 41.42 C \nANISOU 477 C LEU A 61 3531 4481 7725 -429 175 -838 C \nATOM 478 O LEU A 61 -15.137 19.508 -60.156 1.00 48.33 O \nANISOU 478 O LEU A 61 4340 5398 8626 -391 158 -874 O \nATOM 479 CB LEU A 61 -14.134 17.859 -57.620 1.00 37.98 C \nANISOU 479 CB LEU A 61 3154 3950 7328 -378 111 -781 C \nATOM 480 CG LEU A 61 -13.656 18.042 -56.195 1.00 38.55 C \nANISOU 480 CG LEU A 61 3234 3995 7419 -366 64 -759 C \nATOM 481 CD1 LEU A 61 -12.352 17.277 -55.993 1.00 36.18 C \nANISOU 481 CD1 LEU A 61 2972 3636 7140 -322 42 -730 C \nATOM 482 CD2 LEU A 61 -13.418 19.506 -55.895 1.00 40.12 C \nANISOU 482 CD2 LEU A 61 3359 4238 7647 -339 18 -790 C \nATOM 483 N LEU A 62 -16.257 17.586 -60.054 1.00 38.39 N \nANISOU 483 N LEU A 62 3204 4078 7303 -466 224 -822 N \nATOM 484 CA LEU A 62 -16.453 17.599 -61.526 1.00 46.23 C \nANISOU 484 CA LEU A 62 4178 5103 8284 -467 260 -847 C \nATOM 485 C LEU A 62 -17.711 18.361 -61.959 1.00 49.07 C \nANISOU 485 C LEU A 62 4501 5534 8609 -532 286 -879 C \nATOM 486 O LEU A 62 -18.012 18.434 -63.134 1.00 43.42 O \nANISOU 486 O LEU A 62 3768 4853 7878 -543 317 -901 O \nATOM 487 CB LEU A 62 -16.533 16.146 -62.040 1.00 43.82 C \nANISOU 487 CB LEU A 62 3953 4747 7949 -471 303 -813 C \nATOM 488 CG LEU A 62 -15.344 15.266 -61.807 1.00 39.28 C \nANISOU 488 CG LEU A 62 3412 4118 7396 -414 286 -781 C \nATOM 489 CD1 LEU A 62 -15.693 13.855 -62.132 1.00 37.53 C \nANISOU 489 CD1 LEU A 62 3269 3859 7133 -422 329 -745 C \nATOM 490 CD2 LEU A 62 -14.217 15.752 -62.677 1.00 40.11 C \nANISOU 490 CD2 LEU A 62 3463 4240 7539 -361 266 -805 C \nATOM 491 N GLY A 63 -18.507 18.798 -60.985 1.00 55.29 N \nANISOU 491 N GLY A 63 5285 6344 9378 -582 276 -879 N \nATOM 492 CA GLY A 63 -19.691 19.594 -61.247 1.00 57.27 C \nANISOU 492 CA GLY A 63 5495 6674 9590 -653 295 -910 C \nATOM 493 C GLY A 63 -20.864 18.800 -61.780 1.00 60.84 C \nANISOU 493 C GLY A 63 6021 7114 9982 -731 352 -899 C \nATOM 494 O GLY A 63 -21.524 19.213 -62.722 1.00 57.30 O \nANISOU 494 O GLY A 63 5542 6725 9505 -773 381 -927 O \nATOM 495 N ASN A 64 -21.126 17.640 -61.200 1.00 64.41 N \nANISOU 495 N ASN A 64 6573 7489 10411 -749 370 -857 N \nATOM 496 CA ASN A 64 -22.343 16.908 -61.536 1.00 65.85 C \nANISOU 496 CA ASN A 64 6842 7651 10528 -826 423 -845 C \nATOM 497 C ASN A 64 -23.518 17.905 -61.430 1.00 63.41 C \nANISOU 497 C ASN A 64 6493 7423 10178 -920 430 -876 C \nATOM 498 O ASN A 64 -23.653 18.558 -60.416 1.00 57.59 O \nANISOU 498 O ASN A 64 5720 6715 9446 -941 400 -881 O \nATOM 499 CB ASN A 64 -22.525 15.722 -60.567 1.00 64.44 C \nANISOU 499 CB ASN A 64 6773 7383 10327 -830 432 -799 C \nATOM 500 CG ASN A 64 -23.807 14.929 -60.810 1.00 61.36 C \nANISOU 500 CG ASN A 64 6492 6959 9865 -906 485 -784 C \nATOM 501 OD1 ASN A 64 -24.886 15.481 -60.867 1.00 67.28 O \nANISOU 501 OD1 ASN A 64 7241 7752 10570 -994 503 -804 O \nATOM 502 ND2 ASN A 64 -23.688 13.616 -60.889 1.00 59.44 N \nANISOU 502 ND2 ASN A 64 6345 6637 9603 -871 511 -747 N \nATOM 503 N PRO A 65 -24.392 17.959 -62.454 1.00 62.05 N \nANISOU 503 N PRO A 65 6330 7287 9958 -982 472 -894 N \nATOM 504 CA PRO A 65 -25.502 18.895 -62.597 1.00 66.49 C \nANISOU 504 CA PRO A 65 6849 7942 10473 -1080 484 -927 C \nATOM 505 C PRO A 65 -26.459 18.999 -61.403 1.00 71.44 C \nANISOU 505 C PRO A 65 7519 8571 11055 -1168 482 -917 C \nATOM 506 O PRO A 65 -27.139 20.026 -61.227 1.00 77.49 O \nANISOU 506 O PRO A 65 8217 9434 11792 -1239 475 -947 O \nATOM 507 CB PRO A 65 -26.262 18.365 -63.803 1.00 64.14 C \nANISOU 507 CB PRO A 65 6609 7639 10123 -1134 538 -928 C \nATOM 508 CG PRO A 65 -25.269 17.642 -64.599 1.00 59.21 C \nANISOU 508 CG PRO A 65 5999 6961 9538 -1040 543 -914 C \nATOM 509 CD PRO A 65 -24.352 17.013 -63.580 1.00 62.75 C \nANISOU 509 CD PRO A 65 6480 7331 10031 -964 512 -880 C \nATOM 510 N MET A 66 -26.484 17.963 -60.576 1.00 69.01 N \nANISOU 510 N MET A 66 7316 8164 10739 -1163 487 -877 N \nATOM 511 CA MET A 66 -27.332 17.927 -59.396 1.00 68.48 C \nANISOU 511 CA MET A 66 7305 8085 10630 -1242 487 -865 C \nATOM 512 C MET A 66 -26.619 18.425 -58.159 1.00 63.34 C \nANISOU 512 C MET A 66 6596 7444 10027 -1196 433 -860 C \nATOM 513 O MET A 66 -27.161 18.448 -57.076 1.00 72.96 O \nANISOU 513 O MET A 66 7848 8654 11218 -1252 425 -850 O \nATOM 514 CB MET A 66 -27.857 16.510 -59.222 1.00 76.72 C \nANISOU 514 CB MET A 66 8506 9016 11629 -1264 526 -825 C \nATOM 515 CG MET A 66 -28.580 16.047 -60.507 1.00 89.60 C \nANISOU 515 CG MET A 66 10199 10637 13207 -1309 579 -829 C \nATOM 516 SD MET A 66 -29.726 14.671 -60.333 1.00115.98 S \nANISOU 516 SD MET A 66 13738 13867 16463 -1375 633 -792 S \nATOM 517 CE MET A 66 -28.601 13.265 -60.559 1.00123.35 C \nANISOU 517 CE MET A 66 14733 14696 17439 -1234 637 -750 C \nATOM 518 N CYS A 67 -25.399 18.888 -58.337 1.00 67.35 N \nANISOU 518 N CYS A 67 7014 7971 10604 -1096 395 -870 N \nATOM 519 CA CYS A 67 -24.544 19.340 -57.244 1.00 60.23 C \nANISOU 519 CA CYS A 67 6061 7070 9754 -1038 341 -863 C \nATOM 520 C CYS A 67 -24.310 20.848 -57.347 1.00 57.63 C \nANISOU 520 C CYS A 67 5594 6855 9449 -1022 304 -904 C \nATOM 521 O CYS A 67 -23.505 21.409 -56.611 1.00 51.53 O \nANISOU 521 O CYS A 67 4764 6094 8722 -961 255 -903 O \nATOM 522 CB CYS A 67 -23.203 18.558 -57.303 1.00 56.76 C \nANISOU 522 CB CYS A 67 5645 6549 9373 -928 324 -836 C \nATOM 523 SG CYS A 67 -23.372 16.755 -57.128 1.00 61.86 S \nANISOU 523 SG CYS A 67 6444 7073 9989 -927 364 -787 S \nATOM 524 N ASP A 68 -25.075 21.494 -58.208 1.00 63.28 N \nANISOU 524 N ASP A 68 6260 7658 10126 -1080 329 -937 N \nATOM 525 CA ASP A 68 -24.951 22.949 -58.428 1.00 71.76 C \nANISOU 525 CA ASP A 68 7198 8857 11212 -1064 299 -980 C \nATOM 526 C ASP A 68 -24.867 23.823 -57.188 1.00 73.29 C \nANISOU 526 C ASP A 68 7327 9104 11415 -1059 251 -984 C \nATOM 527 O ASP A 68 -24.252 24.884 -57.230 1.00 70.50 O \nANISOU 527 O ASP A 68 6867 8824 11095 -992 212 -1010 O \nATOM 528 CB ASP A 68 -26.072 23.456 -59.321 1.00 78.87 C \nANISOU 528 CB ASP A 68 8063 9853 12049 -1157 337 -1013 C \nATOM 529 CG ASP A 68 -25.696 23.425 -60.779 1.00 79.49 C \nANISOU 529 CG ASP A 68 8116 9943 12143 -1114 360 -1034 C \nATOM 530 OD1 ASP A 68 -26.067 22.445 -61.464 1.00 82.21 O \nANISOU 530 OD1 ASP A 68 8551 10224 12462 -1148 404 -1017 O \nATOM 531 OD2 ASP A 68 -25.030 24.381 -61.235 1.00 84.84 O \nANISOU 531 OD2 ASP A 68 8685 10694 12856 -1043 333 -1067 O \nATOM 532 N GLU A 69 -25.471 23.390 -56.089 1.00 75.05 N \nANISOU 532 N GLU A 69 7617 9292 11607 -1126 252 -958 N \nATOM 533 CA GLU A 69 -25.389 24.161 -54.852 1.00 72.76 C \nANISOU 533 CA GLU A 69 7270 9051 11324 -1124 205 -957 C \nATOM 534 C GLU A 69 -23.984 24.298 -54.315 1.00 76.33 C \nANISOU 534 C GLU A 69 7694 9457 11852 -1001 153 -943 C \nATOM 535 O GLU A 69 -23.748 24.997 -53.324 1.00 67.01 O \nANISOU 535 O GLU A 69 6461 8315 10684 -981 108 -942 O \nATOM 536 CB GLU A 69 -26.291 23.555 -53.780 1.00 76.02 C \nANISOU 536 CB GLU A 69 7774 9424 11687 -1223 220 -930 C \nATOM 537 CG GLU A 69 -26.120 22.077 -53.535 1.00 80.19 C \nANISOU 537 CG GLU A 69 8439 9808 12221 -1213 244 -889 C \nATOM 538 CD GLU A 69 -26.988 21.568 -52.387 1.00 92.21 C \nANISOU 538 CD GLU A 69 10049 11293 13692 -1305 255 -865 C \nATOM 539 OE1 GLU A 69 -26.997 22.190 -51.276 1.00 74.16 O \nANISOU 539 OE1 GLU A 69 7719 9051 11407 -1319 217 -864 O \nATOM 540 OE2 GLU A 69 -27.677 20.542 -52.629 1.00101.36 O \nANISOU 540 OE2 GLU A 69 11326 12379 14806 -1361 302 -849 O \nATOM 541 N PHE A 70 -23.049 23.572 -54.936 1.00 86.21 N \nANISOU 541 N PHE A 70 8986 10620 13148 -922 158 -930 N \nATOM 542 CA PHE A 70 -21.640 23.551 -54.480 1.00 80.85 C \nANISOU 542 CA PHE A 70 8299 9883 12538 -812 111 -913 C \nATOM 543 C PHE A 70 -20.744 24.076 -55.582 1.00 83.94 C \nANISOU 543 C PHE A 70 8626 10296 12970 -723 101 -941 C \nATOM 544 O PHE A 70 -19.545 23.751 -55.638 1.00 83.07 O \nANISOU 544 O PHE A 70 8534 10116 12911 -638 78 -927 O \nATOM 545 CB PHE A 70 -21.199 22.138 -54.045 1.00 76.85 C \nANISOU 545 CB PHE A 70 7905 9248 12044 -798 122 -868 C \nATOM 546 CG PHE A 70 -22.178 21.449 -53.123 1.00 67.09 C \nANISOU 546 CG PHE A 70 6752 7979 10759 -888 144 -842 C \nATOM 547 CD1 PHE A 70 -22.380 21.920 -51.816 1.00 60.56 C \nANISOU 547 CD1 PHE A 70 5908 7178 9926 -915 110 -833 C \nATOM 548 CD2 PHE A 70 -22.911 20.339 -53.573 1.00 62.31 C \nANISOU 548 CD2 PHE A 70 6246 7318 10111 -944 198 -826 C \nATOM 549 CE1 PHE A 70 -23.282 21.281 -50.950 1.00 59.80 C \nANISOU 549 CE1 PHE A 70 5893 7049 9781 -1000 130 -811 C \nATOM 550 CE2 PHE A 70 -23.829 19.717 -52.734 1.00 62.29 C \nANISOU 550 CE2 PHE A 70 6329 7280 10059 -1024 220 -805 C \nATOM 551 CZ PHE A 70 -24.012 20.194 -51.412 1.00 61.54 C \nANISOU 551 CZ PHE A 70 6216 7210 9958 -1055 186 -798 C \nATOM 552 N ILE A 71 -21.338 24.894 -56.455 1.00 84.95 N \nANISOU 552 N ILE A 71 8680 10526 13072 -749 118 -981 N \nATOM 553 CA ILE A 71 -20.616 25.476 -57.554 1.00 83.54 C \nANISOU 553 CA ILE A 71 8436 10381 12926 -671 112 -1014 C \nATOM 554 C ILE A 71 -19.511 26.413 -57.019 1.00 87.10 C \nANISOU 554 C ILE A 71 8822 10846 13426 -565 50 -1023 C \nATOM 555 O ILE A 71 -18.471 26.531 -57.640 1.00 89.58 O \nANISOU 555 O ILE A 71 9124 11129 13783 -478 35 -1033 O \nATOM 556 CB ILE A 71 -21.547 26.221 -58.538 1.00 88.90 C \nANISOU 556 CB ILE A 71 9041 11178 13558 -724 143 -1057 C \nATOM 557 CG1 ILE A 71 -20.799 26.598 -59.818 1.00 89.04 C \nANISOU 557 CG1 ILE A 71 9010 11216 13607 -644 146 -1089 C \nATOM 558 CG2 ILE A 71 -22.101 27.495 -57.900 1.00 97.13 C \nANISOU 558 CG2 ILE A 71 9985 12348 14573 -747 115 -1082 C \nATOM 559 CD1 ILE A 71 -21.714 27.062 -60.938 1.00 90.94 C \nANISOU 559 CD1 ILE A 71 9195 11560 13799 -704 187 -1128 C \nATOM 560 N ASN A 72 -19.731 27.076 -55.882 1.00 84.62 N \nANISOU 560 N ASN A 72 8470 10578 13104 -574 14 -1019 N \nATOM 561 CA ASN A 72 -18.723 27.999 -55.326 1.00 86.61 C \nANISOU 561 CA ASN A 72 8667 10843 13399 -471 -47 -1025 C \nATOM 562 C ASN A 72 -18.814 28.141 -53.823 1.00 86.19 C \nANISOU 562 C ASN A 72 8622 10785 13343 -488 -85 -998 C \nATOM 563 O ASN A 72 -19.201 29.163 -53.284 1.00 93.92 O \nANISOU 563 O ASN A 72 9522 11862 14300 -490 -112 -1014 O \nATOM 564 CB ASN A 72 -18.747 29.346 -56.042 1.00 86.21 C \nANISOU 564 CB ASN A 72 8500 10914 13342 -420 -59 -1076 C \nATOM 565 CG ASN A 72 -17.529 29.538 -56.907 1.00 89.59 C \nANISOU 565 CG ASN A 72 8923 11300 13819 -309 -73 -1094 C \nATOM 566 OD1 ASN A 72 -16.387 29.457 -56.430 1.00108.30 O \nANISOU 566 OD1 ASN A 72 11329 13587 16234 -230 -113 -1075 O \nATOM 567 ND2 ASN A 72 -17.746 29.779 -58.183 1.00 91.89 N \nANISOU 567 ND2 ASN A 72 9173 11644 14096 -307 -41 -1130 N \nATOM 568 N VAL A 73 -18.441 27.060 -53.164 1.00 89.20 N \nANISOU 568 N VAL A 73 9098 11052 13741 -500 -86 -955 N \nATOM 569 CA VAL A 73 -18.497 26.981 -51.722 1.00 82.56 C \nANISOU 569 CA VAL A 73 8282 10190 12897 -522 -118 -923 C \nATOM 570 C VAL A 73 -17.414 27.870 -51.081 1.00 78.32 C \nANISOU 570 C VAL A 73 7700 9655 12401 -420 -184 -923 C \nATOM 571 O VAL A 73 -16.406 28.180 -51.711 1.00 67.51 O \nANISOU 571 O VAL A 73 6318 8261 11072 -328 -203 -937 O \nATOM 572 CB VAL A 73 -18.356 25.509 -51.233 1.00 80.74 C \nANISOU 572 CB VAL A 73 8168 9837 12670 -558 -98 -878 C \nATOM 573 CG1 VAL A 73 -19.461 24.637 -51.808 1.00 82.94 C \nANISOU 573 CG1 VAL A 73 8502 10108 12902 -653 -34 -877 C \nATOM 574 CG2 VAL A 73 -16.980 24.925 -51.553 1.00 77.31 C \nANISOU 574 CG2 VAL A 73 7780 9304 12288 -473 -114 -861 C \nATOM 575 N PRO A 74 -17.608 28.234 -49.807 1.00 80.98 N \nANISOU 575 N PRO A 74 8024 10016 12728 -437 -219 -905 N \nATOM 576 CA PRO A 74 -16.606 28.931 -49.020 1.00 80.10 C \nANISOU 576 CA PRO A 74 7891 9892 12652 -346 -284 -895 C \nATOM 577 C PRO A 74 -15.875 28.016 -48.073 1.00 82.69 C \nANISOU 577 C PRO A 74 8310 10102 13007 -342 -305 -848 C \nATOM 578 O PRO A 74 -16.063 26.807 -48.114 1.00 84.95 O \nANISOU 578 O PRO A 74 8676 10316 13287 -398 -268 -825 O \nATOM 579 CB PRO A 74 -17.440 29.944 -48.232 1.00 86.45 C \nANISOU 579 CB PRO A 74 8614 10817 13418 -379 -306 -906 C \nATOM 580 CG PRO A 74 -18.780 29.303 -48.071 1.00 86.55 C \nANISOU 580 CG PRO A 74 8653 10855 13376 -512 -257 -900 C \nATOM 581 CD PRO A 74 -18.918 28.233 -49.131 1.00 87.25 C \nANISOU 581 CD PRO A 74 8810 10875 13466 -547 -200 -901 C \nATOM 582 N GLU A 75 -15.036 28.608 -47.227 1.00 86.70 N \nANISOU 582 N GLU A 75 8807 10594 13541 -273 -364 -834 N \nATOM 583 CA GLU A 75 -14.145 27.856 -46.345 1.00 84.61 C \nANISOU 583 CA GLU A 75 8624 10219 13303 -258 -392 -791 C \nATOM 584 C GLU A 75 -14.887 26.882 -45.439 1.00 83.01 C \nANISOU 584 C GLU A 75 8479 9988 13072 -357 -369 -758 C \nATOM 585 O GLU A 75 -16.029 27.120 -45.089 1.00 97.18 O \nANISOU 585 O GLU A 75 10241 11857 14825 -429 -352 -765 O \nATOM 586 CB GLU A 75 -13.347 28.846 -45.518 1.00 83.48 C \nANISOU 586 CB GLU A 75 8451 10086 13182 -178 -461 -784 C \nATOM 587 CG GLU A 75 -12.353 28.219 -44.565 1.00 91.48 C \nANISOU 587 CG GLU A 75 9544 10993 14220 -160 -497 -739 C \nATOM 588 CD GLU A 75 -11.513 29.261 -43.857 1.00101.19 C \nANISOU 588 CD GLU A 75 10751 12227 15470 -73 -567 -734 C \nATOM 589 OE1 GLU A 75 -11.516 30.439 -44.299 1.00 98.84 O \nANISOU 589 OE1 GLU A 75 10380 12004 15172 -5 -586 -767 O \nATOM 590 OE2 GLU A 75 -10.836 28.878 -42.868 1.00116.84 O \nANISOU 590 OE2 GLU A 75 12791 14137 17464 -71 -602 -695 O \nATOM 591 N TRP A 76 -14.224 25.795 -45.041 1.00 75.90 N \nANISOU 591 N TRP A 76 7665 8984 12189 -360 -369 -721 N \nATOM 592 CA TRP A 76 -14.864 24.777 -44.210 1.00 70.83 C \nANISOU 592 CA TRP A 76 7087 8308 11519 -445 -345 -690 C \nATOM 593 C TRP A 76 -13.942 24.139 -43.166 1.00 74.52 C \nANISOU 593 C TRP A 76 7619 8691 12007 -427 -379 -648 C \nATOM 594 O TRP A 76 -12.735 24.073 -43.350 1.00 84.77 O \nANISOU 594 O TRP A 76 8938 9932 13340 -361 -407 -638 O \nATOM 595 CB TRP A 76 -15.477 23.674 -45.091 1.00 70.33 C \nANISOU 595 CB TRP A 76 7075 8214 11434 -498 -277 -693 C \nATOM 596 CG TRP A 76 -14.413 22.783 -45.779 1.00 65.53 C \nANISOU 596 CG TRP A 76 6522 7520 10856 -448 -268 -679 C \nATOM 597 CD1 TRP A 76 -13.708 21.797 -45.210 1.00 58.45 C \nANISOU 597 CD1 TRP A 76 5695 6543 9970 -442 -275 -643 C \nATOM 598 CD2 TRP A 76 -13.975 22.854 -47.143 1.00 54.58 C \nANISOU 598 CD2 TRP A 76 5117 6131 9489 -402 -249 -704 C \nATOM 599 NE1 TRP A 76 -12.849 21.263 -46.113 1.00 56.48 N \nANISOU 599 NE1 TRP A 76 5471 6247 9743 -398 -264 -642 N \nATOM 600 CE2 TRP A 76 -13.005 21.893 -47.314 1.00 56.28 C \nANISOU 600 CE2 TRP A 76 5395 6265 9725 -373 -248 -679 C \nATOM 601 CE3 TRP A 76 -14.317 23.648 -48.221 1.00 49.71 C \nANISOU 601 CE3 TRP A 76 4437 5580 8871 -385 -234 -745 C \nATOM 602 CZ2 TRP A 76 -12.378 21.683 -48.534 1.00 56.17 C \nANISOU 602 CZ2 TRP A 76 5383 6230 9729 -331 -231 -694 C \nATOM 603 CZ3 TRP A 76 -13.714 23.446 -49.416 1.00 50.61 C \nANISOU 603 CZ3 TRP A 76 4554 5669 9005 -341 -217 -760 C \nATOM 604 CH2 TRP A 76 -12.748 22.486 -49.570 1.00 52.81 C \nANISOU 604 CH2 TRP A 76 4897 5864 9304 -314 -216 -735 C \nATOM 605 N SER A 77 -14.548 23.608 -42.101 1.00 71.33 N \nANISOU 605 N SER A 77 7252 8278 11574 -495 -373 -623 N \nATOM 606 CA SER A 77 -13.827 22.945 -41.038 1.00 72.43 C \nANISOU 606 CA SER A 77 7450 8347 11722 -492 -401 -582 C \nATOM 607 C SER A 77 -13.629 21.444 -41.325 1.00 67.20 C \nANISOU 607 C SER A 77 6872 7608 11055 -512 -359 -560 C \nATOM 608 O SER A 77 -12.516 20.940 -41.218 1.00 70.95 O \nANISOU 608 O SER A 77 7383 8021 11553 -472 -379 -538 O \nATOM 609 CB SER A 77 -14.550 23.170 -39.706 1.00 78.18 C \nANISOU 609 CB SER A 77 8173 9110 12421 -551 -418 -567 C \nATOM 610 OG SER A 77 -15.877 22.660 -39.716 1.00 81.24 O \nANISOU 610 OG SER A 77 8582 9523 12762 -640 -365 -574 O \nATOM 611 N TYR A 78 -14.692 20.759 -41.738 1.00 64.36 N \nANISOU 611 N TYR A 78 6540 7255 10659 -573 -300 -568 N \nATOM 612 CA TYR A 78 -14.599 19.365 -42.235 1.00 64.38 C \nANISOU 612 CA TYR A 78 6617 7195 10651 -581 -254 -551 C \nATOM 613 C TYR A 78 -15.657 19.099 -43.294 1.00 59.79 C \nANISOU 613 C TYR A 78 6041 6637 10039 -619 -193 -576 C \nATOM 614 O TYR A 78 -16.405 19.979 -43.634 1.00 64.05 O \nANISOU 614 O TYR A 78 6527 7242 10567 -644 -188 -605 O \nATOM 615 CB TYR A 78 -14.725 18.355 -41.094 1.00 69.85 C \nANISOU 615 CB TYR A 78 7380 7843 11318 -619 -248 -516 C \nATOM 616 CG TYR A 78 -16.046 18.449 -40.333 1.00 73.98 C \nANISOU 616 CG TYR A 78 7915 8399 11796 -699 -230 -519 C \nATOM 617 CD1 TYR A 78 -17.042 17.504 -40.548 1.00 78.78 C \nANISOU 617 CD1 TYR A 78 8588 8986 12359 -753 -170 -518 C \nATOM 618 CD2 TYR A 78 -16.285 19.472 -39.424 1.00 69.12 C \nANISOU 618 CD2 TYR A 78 7250 7833 11179 -720 -271 -523 C \nATOM 619 CE1 TYR A 78 -18.240 17.576 -39.882 1.00 78.76 C \nANISOU 619 CE1 TYR A 78 8608 9008 12310 -832 -152 -522 C \nATOM 620 CE2 TYR A 78 -17.467 19.551 -38.739 1.00 78.22 C \nANISOU 620 CE2 TYR A 78 8414 9020 12287 -800 -254 -526 C \nATOM 621 CZ TYR A 78 -18.448 18.603 -38.978 1.00 84.91 C \nANISOU 621 CZ TYR A 78 9332 9841 13089 -860 -194 -527 C \nATOM 622 OH TYR A 78 -19.628 18.666 -38.292 1.00 89.70 O \nANISOU 622 OH TYR A 78 9962 10476 13645 -947 -176 -531 O \nATOM 623 N ILE A 79 -15.670 17.899 -43.863 1.00 55.85 N \nANISOU 623 N ILE A 79 5606 6089 9526 -621 -149 -564 N \nATOM 624 CA ILE A 79 -16.550 17.576 -44.971 1.00 49.94 C \nANISOU 624 CA ILE A 79 4872 5354 8750 -650 -92 -584 C \nATOM 625 C ILE A 79 -17.365 16.377 -44.569 1.00 56.21 C \nANISOU 625 C ILE A 79 5756 6106 9495 -701 -46 -563 C \nATOM 626 O ILE A 79 -16.869 15.444 -43.981 1.00 67.96 O \nANISOU 626 O ILE A 79 7298 7543 10980 -683 -48 -532 O \nATOM 627 CB ILE A 79 -15.773 17.267 -46.276 1.00 51.42 C \nANISOU 627 CB ILE A 79 5052 5522 8962 -591 -77 -592 C \nATOM 628 CG1 ILE A 79 -15.031 18.543 -46.795 1.00 51.56 C \nANISOU 628 CG1 ILE A 79 4985 5581 9025 -537 -119 -619 C \nATOM 629 CG2 ILE A 79 -16.711 16.740 -47.375 1.00 50.58 C \nANISOU 629 CG2 ILE A 79 4976 5421 8821 -623 -15 -606 C \nATOM 630 CD1 ILE A 79 -13.989 18.262 -47.857 1.00 49.26 C \nANISOU 630 CD1 ILE A 79 4690 5262 8763 -475 -117 -623 C \nATOM 631 N VAL A 80 -18.646 16.427 -44.878 1.00 56.68 N \nANISOU 631 N VAL A 80 5835 6190 9512 -766 -5 -580 N \nATOM 632 CA VAL A 80 -19.517 15.341 -44.504 1.00 53.74 C \nANISOU 632 CA VAL A 80 5559 5772 9085 -816 40 -563 C \nATOM 633 C VAL A 80 -20.174 14.820 -45.754 1.00 48.98 C \nANISOU 633 C VAL A 80 4996 5160 8453 -829 96 -575 C \nATOM 634 O VAL A 80 -20.708 15.594 -46.538 1.00 40.49 O \nANISOU 634 O VAL A 80 3875 4137 7374 -858 107 -605 O \nATOM 635 CB VAL A 80 -20.563 15.768 -43.426 1.00 59.73 C \nANISOU 635 CB VAL A 80 6332 6558 9806 -900 36 -566 C \nATOM 636 CG1 VAL A 80 -20.709 17.287 -43.377 1.00 59.03 C \nANISOU 636 CG1 VAL A 80 6140 6556 9734 -920 -1 -595 C \nATOM 637 CG2 VAL A 80 -21.909 15.067 -43.619 1.00 54.63 C \nANISOU 637 CG2 VAL A 80 5777 5887 9092 -974 97 -569 C \nATOM 638 N GLU A 81 -20.127 13.498 -45.894 1.00 46.50 N \nANISOU 638 N GLU A 81 4768 4783 8116 -807 131 -551 N \nATOM 639 CA GLU A 81 -20.568 12.816 -47.074 1.00 53.06 C \nANISOU 639 CA GLU A 81 5647 5595 8920 -802 184 -555 C \nATOM 640 C GLU A 81 -21.406 11.692 -46.585 1.00 56.55 C \nANISOU 640 C GLU A 81 6205 5980 9302 -834 226 -534 C \nATOM 641 O GLU A 81 -21.276 11.287 -45.425 1.00 72.75 O \nANISOU 641 O GLU A 81 8293 8005 11345 -835 211 -513 O \nATOM 642 CB GLU A 81 -19.346 12.274 -47.814 1.00 56.46 C \nANISOU 642 CB GLU A 81 6058 6008 9387 -715 178 -542 C \nATOM 643 CG GLU A 81 -19.575 11.926 -49.278 1.00 53.56 C \nANISOU 643 CG GLU A 81 5703 5641 9007 -701 220 -554 C \nATOM 644 CD GLU A 81 -18.316 11.399 -49.937 1.00 47.54 C \nANISOU 644 CD GLU A 81 4918 4868 8278 -620 211 -541 C \nATOM 645 OE1 GLU A 81 -17.497 10.842 -49.187 1.00 40.79 O \nANISOU 645 OE1 GLU A 81 4076 3989 7434 -582 188 -514 O \nATOM 646 OE2 GLU A 81 -18.197 11.464 -51.185 1.00 42.65 O \nANISOU 646 OE2 GLU A 81 4274 4264 7665 -600 230 -556 O \nATOM 647 N LYS A 82 -22.311 11.212 -47.392 1.00 58.93 N \nANISOU 647 N LYS A 82 6571 6262 9557 -862 278 -540 N \nATOM 648 CA LYS A 82 -23.120 10.095 -46.949 1.00 72.32 C \nANISOU 648 CA LYS A 82 8393 7895 11190 -884 320 -520 C \nATOM 649 C LYS A 82 -22.333 8.862 -47.284 1.00 74.24 C \nANISOU 649 C LYS A 82 8676 8096 11436 -794 334 -492 C \nATOM 650 O LYS A 82 -21.267 8.947 -47.904 1.00 84.02 O \nANISOU 650 O LYS A 82 9845 9357 12721 -731 314 -491 O \nATOM 651 CB LYS A 82 -24.495 10.093 -47.619 1.00 81.91 C \nANISOU 651 CB LYS A 82 9675 9101 12344 -959 370 -538 C \nATOM 652 CG LYS A 82 -25.175 11.467 -47.499 1.00 86.38 C \nANISOU 652 CG LYS A 82 10175 9736 12911 -1051 353 -570 C \nATOM 653 CD LYS A 82 -26.564 11.457 -46.877 1.00 89.80 C \nANISOU 653 CD LYS A 82 10696 10153 13272 -1158 380 -576 C \nATOM 654 CE LYS A 82 -26.938 12.858 -46.372 1.00 89.84 C \nANISOU 654 CE LYS A 82 10609 10242 13283 -1238 347 -603 C \nATOM 655 NZ LYS A 82 -26.242 13.222 -45.088 1.00 89.87 N \nANISOU 655 NZ LYS A 82 10559 10262 13325 -1215 295 -592 N \nATOM 656 N ALA A 83 -22.839 7.713 -46.879 1.00 77.01 N \nANISOU 656 N ALA A 83 9140 8389 11732 -786 370 -470 N \nATOM 657 CA ALA A 83 -22.149 6.458 -47.160 1.00 78.31 C \nANISOU 657 CA ALA A 83 9344 8523 11888 -696 387 -441 C \nATOM 658 C ALA A 83 -22.286 6.097 -48.648 1.00 78.77 C \nANISOU 658 C ALA A 83 9416 8579 11933 -666 424 -446 C \nATOM 659 O ALA A 83 -21.307 5.676 -49.274 1.00 71.15 O \nANISOU 659 O ALA A 83 8410 7630 10994 -592 418 -434 O \nATOM 660 CB ALA A 83 -22.704 5.354 -46.292 1.00 82.82 C \nANISOU 660 CB ALA A 83 10033 9035 12398 -688 415 -419 C \nATOM 661 N ASN A 84 -23.489 6.270 -49.206 1.00 81.27 N \nANISOU 661 N ASN A 84 9791 8880 12207 -728 462 -462 N \nATOM 662 CA ASN A 84 -23.741 6.036 -50.638 1.00 88.11 C \nANISOU 662 CA ASN A 84 10673 9747 13058 -712 498 -468 C \nATOM 663 C ASN A 84 -24.463 7.205 -51.320 1.00 86.62 C \nANISOU 663 C ASN A 84 10440 9598 12873 -796 501 -503 C \nATOM 664 O ASN A 84 -25.675 7.131 -51.574 1.00 93.94 O \nANISOU 664 O ASN A 84 11451 10499 13742 -863 540 -511 O \nATOM 665 CB ASN A 84 -24.570 4.764 -50.848 1.00 99.95 C \nANISOU 665 CB ASN A 84 12318 11178 14481 -693 553 -447 C \nATOM 666 CG ASN A 84 -23.799 3.491 -50.553 1.00101.26 C \nANISOU 666 CG ASN A 84 12519 11320 14636 -590 558 -412 C \nATOM 667 OD1 ASN A 84 -22.811 3.491 -49.832 1.00109.47 O \nANISOU 667 OD1 ASN A 84 13494 12383 15715 -552 520 -402 O \nATOM 668 ND2 ASN A 84 -24.264 2.392 -51.117 1.00110.90 N \nANISOU 668 ND2 ASN A 84 13842 12496 15798 -544 604 -394 N \nATOM 669 N PRO A 85 -23.732 8.298 -51.599 1.00 81.09 N \nANISOU 669 N PRO A 85 9610 8963 12236 -795 461 -525 N \nATOM 670 CA PRO A 85 -24.299 9.482 -52.246 1.00 73.66 C \nANISOU 670 CA PRO A 85 8609 8078 11302 -866 460 -561 C \nATOM 671 C PRO A 85 -24.934 9.144 -53.554 1.00 71.71 C \nANISOU 671 C PRO A 85 8408 7822 11017 -879 507 -567 C \nATOM 672 O PRO A 85 -24.355 8.401 -54.348 1.00 74.50 O \nANISOU 672 O PRO A 85 8772 8159 11377 -806 522 -552 O \nATOM 673 CB PRO A 85 -23.079 10.385 -52.476 1.00 73.98 C \nANISOU 673 CB PRO A 85 8511 8178 11419 -818 410 -576 C \nATOM 674 CG PRO A 85 -21.899 9.680 -51.886 1.00 74.51 C \nANISOU 674 CG PRO A 85 8574 8218 11518 -736 384 -547 C \nATOM 675 CD PRO A 85 -22.421 8.596 -51.006 1.00 78.92 C \nANISOU 675 CD PRO A 85 9246 8714 12025 -739 408 -518 C \nATOM 676 N ALA A 86 -26.121 9.679 -53.787 1.00 75.69 N \nANISOU 676 N ALA A 86 8942 8341 11477 -975 530 -589 N \nATOM 677 CA ALA A 86 -26.856 9.369 -55.010 1.00 78.23 C \nANISOU 677 CA ALA A 86 9320 8651 11752 -1001 577 -595 C \nATOM 678 C ALA A 86 -26.273 10.095 -56.225 1.00 79.05 C \nANISOU 678 C ALA A 86 9311 8822 11901 -978 567 -619 C \nATOM 679 O ALA A 86 -26.485 9.684 -57.367 1.00 85.29 O \nANISOU 679 O ALA A 86 10134 9605 12669 -967 601 -618 O \nATOM 680 CB ALA A 86 -28.326 9.714 -54.846 1.00 81.05 C \nANISOU 680 CB ALA A 86 9750 9004 12040 -1124 606 -610 C \nATOM 681 N ASN A 87 -25.526 11.162 -55.980 1.00 69.72 N \nANISOU 681 N ASN A 87 8002 7708 10782 -966 520 -640 N \nATOM 682 CA ASN A 87 -24.996 11.981 -57.041 1.00 67.26 C \nANISOU 682 CA ASN A 87 7582 7464 10512 -945 507 -668 C \nATOM 683 C ASN A 87 -23.472 11.930 -57.108 1.00 70.42 C \nANISOU 683 C ASN A 87 7905 7868 10981 -842 470 -661 C \nATOM 684 O ASN A 87 -22.774 12.822 -56.646 1.00 68.35 O \nANISOU 684 O ASN A 87 7550 7648 10770 -823 424 -676 O \nATOM 685 CB ASN A 87 -25.456 13.412 -56.838 1.00 75.95 C \nANISOU 685 CB ASN A 87 8592 8647 11618 -1019 485 -706 C \nATOM 686 CG ASN A 87 -26.967 13.532 -56.825 1.00 70.63 C \nANISOU 686 CG ASN A 87 7989 7980 10869 -1137 521 -716 C \nATOM 687 OD1 ASN A 87 -27.659 12.940 -57.661 1.00 63.42 O \nANISOU 687 OD1 ASN A 87 7155 7037 9905 -1167 567 -712 O \nATOM 688 ND2 ASN A 87 -27.480 14.339 -55.905 1.00 69.58 N \nANISOU 688 ND2 ASN A 87 7825 7891 10723 -1208 501 -731 N \nATOM 689 N ASP A 88 -22.966 10.872 -57.724 1.00 70.49 N \nANISOU 689 N ASP A 88 7959 7837 10988 -776 491 -637 N \nATOM 690 CA ASP A 88 -21.551 10.648 -57.849 1.00 61.21 C \nANISOU 690 CA ASP A 88 6728 6663 9866 -686 461 -626 C \nATOM 691 C ASP A 88 -21.136 10.952 -59.290 1.00 61.48 C \nANISOU 691 C ASP A 88 6702 6737 9920 -660 470 -647 C \nATOM 692 O ASP A 88 -21.375 12.053 -59.839 1.00 56.82 O \nANISOU 692 O ASP A 88 6040 6205 9344 -697 464 -684 O \nATOM 693 CB ASP A 88 -21.258 9.195 -57.468 1.00 73.38 C \nANISOU 693 CB ASP A 88 8357 8141 11382 -630 477 -583 C \nATOM 694 CG ASP A 88 -19.777 8.930 -57.179 1.00 80.61 C \nANISOU 694 CG ASP A 88 9221 9060 12347 -551 440 -567 C \nATOM 695 OD1 ASP A 88 -18.940 9.871 -57.202 1.00 92.05 O \nANISOU 695 OD1 ASP A 88 10576 10549 13852 -538 398 -587 O \nATOM 696 OD2 ASP A 88 -19.457 7.759 -56.953 1.00 80.03 O \nANISOU 696 OD2 ASP A 88 9205 8951 12251 -502 453 -533 O \nATOM 697 N LEU A 89 -20.514 9.993 -59.942 1.00 55.22 N \nANISOU 697 N LEU A 89 5935 5921 9124 -597 486 -625 N \nATOM 698 CA LEU A 89 -20.348 10.089 -61.379 1.00 53.39 C \nANISOU 698 CA LEU A 89 5669 5721 8895 -582 506 -641 C \nATOM 699 C LEU A 89 -21.711 9.810 -62.019 1.00 50.38 C \nANISOU 699 C LEU A 89 5363 5328 8450 -643 558 -643 C \nATOM 700 O LEU A 89 -22.556 9.154 -61.466 1.00 54.28 O \nANISOU 700 O LEU A 89 5954 5774 8894 -672 582 -622 O \nATOM 701 CB LEU A 89 -19.289 9.080 -61.902 1.00 47.51 C \nANISOU 701 CB LEU A 89 4931 4961 8160 -500 509 -615 C \nATOM 702 CG LEU A 89 -17.957 9.103 -61.169 1.00 46.50 C \nANISOU 702 CG LEU A 89 4754 4834 8081 -447 462 -604 C \nATOM 703 CD1 LEU A 89 -16.990 8.092 -61.763 1.00 41.47 C \nANISOU 703 CD1 LEU A 89 4122 4193 7440 -378 469 -579 C \nATOM 704 CD2 LEU A 89 -17.359 10.540 -61.172 1.00 43.06 C \nANISOU 704 CD2 LEU A 89 4215 4443 7705 -454 418 -643 C \nATOM 705 N CYS A 90 -21.874 10.281 -63.223 1.00 55.37 N \nANISOU 705 N CYS A 90 5953 6002 9081 -661 574 -669 N \nATOM 706 CA CYS A 90 -23.092 10.070 -63.967 1.00 60.82 C \nANISOU 706 CA CYS A 90 6712 6687 9711 -722 622 -672 C \nATOM 707 C CYS A 90 -22.829 9.222 -65.204 1.00 61.07 C \nANISOU 707 C CYS A 90 6772 6709 9724 -674 653 -656 C \nATOM 708 O CYS A 90 -23.737 8.742 -65.894 1.00 74.54 O \nANISOU 708 O CYS A 90 8555 8396 11372 -707 696 -648 O \nATOM 709 CB CYS A 90 -23.647 11.436 -64.353 1.00 62.18 C \nANISOU 709 CB CYS A 90 6807 6931 9888 -796 616 -718 C \nATOM 710 SG CYS A 90 -22.572 12.538 -65.285 1.00 70.46 S \nANISOU 710 SG CYS A 90 7708 8061 11002 -754 586 -759 S \nATOM 711 N TYR A 91 -21.567 9.083 -65.524 1.00 57.38 N \nANISOU 711 N TYR A 91 6240 6259 9302 -598 630 -653 N \nATOM 712 CA TYR A 91 -21.161 8.080 -66.443 1.00 59.22 C \nANISOU 712 CA TYR A 91 6505 6480 9516 -541 655 -629 C \nATOM 713 C TYR A 91 -20.403 7.067 -65.601 1.00 55.15 C \nANISOU 713 C TYR A 91 6023 5925 9004 -470 641 -590 C \nATOM 714 O TYR A 91 -19.635 7.452 -64.730 1.00 62.43 O \nANISOU 714 O TYR A 91 6894 6853 9972 -452 600 -593 O \nATOM 715 CB TYR A 91 -20.265 8.699 -67.503 1.00 57.43 C \nANISOU 715 CB TYR A 91 6176 6312 9334 -515 641 -658 C \nATOM 716 CG TYR A 91 -20.579 8.289 -68.916 1.00 56.27 C \nANISOU 716 CG TYR A 91 6049 6180 9151 -515 681 -657 C \nATOM 717 CD1 TYR A 91 -21.716 8.783 -69.584 1.00 49.98 C \nANISOU 717 CD1 TYR A 91 5271 5401 8318 -589 711 -679 C \nATOM 718 CD2 TYR A 91 -19.687 7.455 -69.633 1.00 48.12 C \nANISOU 718 CD2 TYR A 91 5011 5152 8119 -445 686 -636 C \nATOM 719 CE1 TYR A 91 -21.965 8.416 -70.910 1.00 53.69 C \nANISOU 719 CE1 TYR A 91 5759 5887 8755 -590 746 -678 C \nATOM 720 CE2 TYR A 91 -19.920 7.094 -70.988 1.00 54.47 C \nANISOU 720 CE2 TYR A 91 5828 5976 8891 -443 721 -635 C \nATOM 721 CZ TYR A 91 -21.040 7.570 -71.615 1.00 58.73 C \nANISOU 721 CZ TYR A 91 6390 6527 9398 -513 750 -656 C \nATOM 722 OH TYR A 91 -21.261 7.178 -72.921 1.00 69.93 O \nANISOU 722 OH TYR A 91 7826 7963 10782 -510 784 -652 O \nATOM 723 N PRO A 92 -20.628 5.776 -65.832 1.00 51.57 N \nANISOU 723 N PRO A 92 5659 5436 8500 -430 674 -552 N \nATOM 724 CA PRO A 92 -19.859 4.773 -65.087 1.00 50.97 C \nANISOU 724 CA PRO A 92 5606 5336 8421 -357 661 -515 C \nATOM 725 C PRO A 92 -18.366 4.746 -65.478 1.00 44.32 C \nANISOU 725 C PRO A 92 4674 4541 7626 -299 632 -516 C \nATOM 726 O PRO A 92 -18.018 5.025 -66.606 1.00 48.35 O \nANISOU 726 O PRO A 92 5134 5089 8149 -294 637 -533 O \nATOM 727 CB PRO A 92 -20.528 3.440 -65.477 1.00 50.16 C \nANISOU 727 CB PRO A 92 5619 5196 8246 -322 708 -478 C \nATOM 728 CG PRO A 92 -21.126 3.690 -66.827 1.00 51.28 C \nANISOU 728 CG PRO A 92 5766 5354 8365 -354 740 -494 C \nATOM 729 CD PRO A 92 -21.314 5.191 -66.986 1.00 55.64 C \nANISOU 729 CD PRO A 92 6236 5944 8962 -432 720 -543 C \nATOM 730 N GLY A 93 -17.496 4.449 -64.527 1.00 38.26 N \nANISOU 730 N GLY A 93 3887 3769 6879 -261 600 -498 N \nATOM 731 CA GLY A 93 -16.084 4.528 -64.780 1.00 39.91 C \nANISOU 731 CA GLY A 93 4015 4019 7129 -221 569 -501 C \nATOM 732 C GLY A 93 -15.272 4.674 -63.536 1.00 43.49 C \nANISOU 732 C GLY A 93 4440 4466 7616 -210 525 -493 C \nATOM 733 O GLY A 93 -15.801 4.712 -62.425 1.00 45.79 O \nANISOU 733 O GLY A 93 4772 4725 7903 -231 518 -486 O \nATOM 734 N ASN A 94 -13.955 4.711 -63.721 1.00 45.00 N \nANISOU 734 N ASN A 94 4568 4691 7839 -180 495 -494 N \nATOM 735 CA ASN A 94 -13.046 4.828 -62.609 1.00 51.33 C \nANISOU 735 CA ASN A 94 5344 5490 8671 -171 451 -485 C \nATOM 736 C ASN A 94 -12.630 6.284 -62.352 1.00 52.85 C \nANISOU 736 C ASN A 94 5468 5684 8926 -204 408 -523 C \nATOM 737 O ASN A 94 -12.334 7.051 -63.278 1.00 70.53 O \nANISOU 737 O ASN A 94 7656 7949 11195 -212 403 -555 O \nATOM 738 CB ASN A 94 -11.787 3.994 -62.926 1.00 60.33 C \nANISOU 738 CB ASN A 94 6457 6665 9799 -124 442 -461 C \nATOM 739 CG ASN A 94 -10.878 3.813 -61.719 1.00 74.23 C \nANISOU 739 CG ASN A 94 8206 8423 11573 -115 402 -442 C \nATOM 740 OD1 ASN A 94 -9.700 4.212 -61.762 1.00 69.04 O \nANISOU 740 OD1 ASN A 94 7496 7787 10948 -116 366 -451 O \nATOM 741 ND2 ASN A 94 -11.419 3.250 -60.626 1.00 81.60 N \nANISOU 741 ND2 ASN A 94 9195 9330 12481 -109 408 -418 N \nATOM 742 N PHE A 95 -12.538 6.653 -61.090 1.00 51.55 N \nANISOU 742 N PHE A 95 5306 5499 8784 -219 375 -519 N \nATOM 743 CA PHE A 95 -11.865 7.872 -60.705 1.00 36.28 C \nANISOU 743 CA PHE A 95 3311 3568 6906 -233 326 -547 C \nATOM 744 C PHE A 95 -10.529 7.488 -60.139 1.00 34.40 C \nANISOU 744 C PHE A 95 3058 3331 6680 -206 290 -526 C \nATOM 745 O PHE A 95 -10.409 7.074 -58.975 1.00 38.15 O \nANISOU 745 O PHE A 95 3560 3788 7147 -205 274 -500 O \nATOM 746 CB PHE A 95 -12.667 8.639 -59.702 1.00 40.50 C \nANISOU 746 CB PHE A 95 3852 4082 7454 -271 312 -559 C \nATOM 747 CG PHE A 95 -12.315 10.089 -59.595 1.00 37.50 C \nANISOU 747 CG PHE A 95 3406 3716 7126 -285 271 -595 C \nATOM 748 CD1 PHE A 95 -13.246 11.032 -59.827 1.00 46.25 C \nANISOU 748 CD1 PHE A 95 4492 4841 8241 -321 279 -627 C \nATOM 749 CD2 PHE A 95 -11.101 10.493 -59.150 1.00 38.92 C \nANISOU 749 CD2 PHE A 95 3551 3892 7343 -263 223 -596 C \nATOM 750 CE1 PHE A 95 -12.949 12.398 -59.729 1.00 49.79 C \nANISOU 750 CE1 PHE A 95 4875 5311 8734 -324 242 -662 C \nATOM 751 CE2 PHE A 95 -10.773 11.860 -59.006 1.00 43.63 C \nANISOU 751 CE2 PHE A 95 4093 4497 7986 -265 183 -630 C \nATOM 752 CZ PHE A 95 -11.705 12.824 -59.322 1.00 45.16 C \nANISOU 752 CZ PHE A 95 4257 4716 8187 -291 193 -664 C \nATOM 753 N ASN A 96 -9.465 7.631 -60.949 1.00 33.07 N \nANISOU 753 N ASN A 96 2848 3187 6530 -188 276 -537 N \nATOM 754 CA ASN A 96 -8.099 7.270 -60.555 1.00 33.01 C \nANISOU 754 CA ASN A 96 2829 3186 6528 -172 242 -518 C \nATOM 755 C ASN A 96 -7.627 7.950 -59.253 1.00 33.89 C \nANISOU 755 C ASN A 96 2934 3270 6673 -186 191 -517 C \nATOM 756 O ASN A 96 -7.900 9.115 -58.995 1.00 45.85 O \nANISOU 756 O ASN A 96 4425 4768 8225 -201 168 -546 O \nATOM 757 CB ASN A 96 -7.152 7.564 -61.680 1.00 36.62 C \nANISOU 757 CB ASN A 96 3246 3668 7000 -163 235 -538 C \nATOM 758 CG ASN A 96 -5.906 6.699 -61.629 1.00 41.93 C \nANISOU 758 CG ASN A 96 3919 4363 7650 -151 221 -510 C \nATOM 759 OD1 ASN A 96 -6.000 5.452 -61.628 1.00 38.89 O \nANISOU 759 OD1 ASN A 96 3558 4004 7215 -134 248 -476 O \nATOM 760 ND2 ASN A 96 -4.725 7.343 -61.528 1.00 45.59 N \nANISOU 760 ND2 ASN A 96 4359 4820 8144 -160 177 -524 N \nATOM 761 N ASP A 97 -6.925 7.185 -58.419 1.00 36.12 N \nANISOU 761 N ASP A 97 3235 3552 6937 -180 173 -484 N \nATOM 762 CA ASP A 97 -6.424 7.591 -57.099 1.00 31.35 C \nANISOU 762 CA ASP A 97 2633 2923 6354 -194 126 -474 C \nATOM 763 C ASP A 97 -7.418 8.468 -56.385 1.00 32.58 C \nANISOU 763 C ASP A 97 2793 3052 6534 -213 118 -491 C \nATOM 764 O ASP A 97 -7.079 9.495 -55.826 1.00 40.77 O \nANISOU 764 O ASP A 97 3809 4072 7611 -222 75 -507 O \nATOM 765 CB ASP A 97 -5.071 8.294 -57.229 1.00 32.25 C \nANISOU 765 CB ASP A 97 2719 3033 6503 -196 79 -488 C \nATOM 766 CG ASP A 97 -3.964 7.380 -57.672 1.00 36.04 C \nANISOU 766 CG ASP A 97 3198 3543 6950 -191 80 -467 C \nATOM 767 OD1 ASP A 97 -3.694 6.318 -57.021 1.00 33.92 O \nANISOU 767 OD1 ASP A 97 2951 3294 6643 -191 83 -430 O \nATOM 768 OD2 ASP A 97 -3.360 7.697 -58.670 1.00 45.68 O \nANISOU 768 OD2 ASP A 97 4399 4776 8183 -188 78 -488 O \nATOM 769 N TYR A 98 -8.651 8.018 -56.332 1.00 33.33 N \nANISOU 769 N TYR A 98 2920 3144 6601 -220 158 -484 N \nATOM 770 CA TYR A 98 -9.745 8.719 -55.615 1.00 33.40 C \nANISOU 770 CA TYR A 98 2938 3132 6619 -249 157 -497 C \nATOM 771 C TYR A 98 -9.494 8.948 -54.204 1.00 35.19 C \nANISOU 771 C TYR A 98 3172 3340 6858 -262 117 -483 C \nATOM 772 O TYR A 98 -9.640 10.062 -53.716 1.00 44.12 O \nANISOU 772 O TYR A 98 4277 4464 8024 -279 86 -503 O \nATOM 773 CB TYR A 98 -11.082 7.926 -55.815 1.00 33.46 C \nANISOU 773 CB TYR A 98 2999 3135 6579 -258 212 -486 C \nATOM 774 CG TYR A 98 -12.303 8.725 -55.464 1.00 40.52 C \nANISOU 774 CG TYR A 98 3900 4018 7476 -299 220 -508 C \nATOM 775 CD1 TYR A 98 -12.316 10.143 -55.577 1.00 36.40 C \nANISOU 775 CD1 TYR A 98 3321 3511 6998 -319 191 -544 C \nATOM 776 CD2 TYR A 98 -13.466 8.088 -54.988 1.00 41.16 C \nANISOU 776 CD2 TYR A 98 4048 4078 7513 -321 255 -492 C \nATOM 777 CE1 TYR A 98 -13.444 10.875 -55.193 1.00 37.65 C \nANISOU 777 CE1 TYR A 98 3479 3674 7154 -363 196 -563 C \nATOM 778 CE2 TYR A 98 -14.581 8.825 -54.633 1.00 44.18 C \nANISOU 778 CE2 TYR A 98 4438 4455 7893 -370 261 -512 C \nATOM 779 CZ TYR A 98 -14.570 10.206 -54.778 1.00 41.44 C \nANISOU 779 CZ TYR A 98 4025 4134 7587 -394 232 -547 C \nATOM 780 OH TYR A 98 -15.711 10.904 -54.467 1.00 47.79 O \nANISOU 780 OH TYR A 98 4833 4946 8381 -448 240 -567 O \nATOM 781 N GLU A 99 -9.089 7.861 -53.507 1.00 36.43 N \nANISOU 781 N GLU A 99 3364 3494 6985 -251 118 -446 N \nATOM 782 CA GLU A 99 -8.936 7.888 -52.041 1.00 36.32 C \nANISOU 782 CA GLU A 99 3365 3461 6972 -267 85 -426 C \nATOM 783 C GLU A 99 -7.766 8.764 -51.654 1.00 36.83 C \nANISOU 783 C GLU A 99 3392 3520 7080 -269 26 -433 C \nATOM 784 O GLU A 99 -7.790 9.404 -50.617 1.00 45.25 O \nANISOU 784 O GLU A 99 4456 4569 8167 -286 -10 -433 O \nATOM 785 CB GLU A 99 -8.748 6.494 -51.495 1.00 37.33 C \nANISOU 785 CB GLU A 99 3535 3596 7052 -251 102 -387 C \nATOM 786 CG GLU A 99 -9.908 5.560 -51.730 1.00 37.12 C \nANISOU 786 CG GLU A 99 3561 3567 6976 -240 159 -377 C \nATOM 787 CD GLU A 99 -9.971 5.035 -53.137 1.00 45.73 C \nANISOU 787 CD GLU A 99 4651 4680 8046 -212 198 -381 C \nATOM 788 OE1 GLU A 99 -8.965 5.136 -53.885 1.00 43.44 O \nANISOU 788 OE1 GLU A 99 4319 4415 7773 -198 184 -386 O \nATOM 789 OE2 GLU A 99 -11.049 4.499 -53.515 1.00 58.19 O \nANISOU 789 OE2 GLU A 99 6275 6248 9588 -205 245 -378 O \nATOM 790 N GLU A 100 -6.793 8.864 -52.533 1.00 35.41 N \nANISOU 790 N GLU A 100 3188 3353 6915 -252 16 -442 N \nATOM 791 CA GLU A 100 -5.643 9.764 -52.270 1.00 37.89 C \nANISOU 791 CA GLU A 100 3477 3652 7268 -252 -41 -452 C \nATOM 792 C GLU A 100 -6.018 11.170 -52.420 1.00 36.62 C \nANISOU 792 C GLU A 100 3285 3481 7150 -251 -61 -488 C \nATOM 793 O GLU A 100 -5.679 12.020 -51.579 1.00 50.09 O \nANISOU 793 O GLU A 100 4982 5167 8883 -255 -107 -492 O \nATOM 794 CB GLU A 100 -4.480 9.411 -53.208 1.00 43.53 C \nANISOU 794 CB GLU A 100 4181 4381 7976 -239 -43 -451 C \nATOM 795 CG GLU A 100 -3.676 8.186 -52.761 1.00 41.40 C \nANISOU 795 CG GLU A 100 3934 4130 7665 -245 -45 -412 C \nATOM 796 CD GLU A 100 -2.717 8.526 -51.669 1.00 44.03 C \nANISOU 796 CD GLU A 100 4277 4442 8011 -264 -101 -397 C \nATOM 797 OE1 GLU A 100 -2.203 9.690 -51.721 1.00 49.52 O \nANISOU 797 OE1 GLU A 100 4960 5107 8747 -264 -140 -420 O \nATOM 798 OE2 GLU A 100 -2.527 7.654 -50.755 1.00 34.34 O \nANISOU 798 OE2 GLU A 100 3071 3227 6749 -277 -104 -363 O \nATOM 799 N LEU A 101 -6.800 11.449 -53.442 1.00 37.39 N \nANISOU 799 N LEU A 101 3363 3596 7249 -246 -25 -516 N \nATOM 800 CA LEU A 101 -7.506 12.816 -53.589 1.00 38.64 C \nANISOU 800 CA LEU A 101 3482 3760 7438 -249 -35 -554 C \nATOM 801 C LEU A 101 -8.347 13.159 -52.372 1.00 39.59 C \nANISOU 801 C LEU A 101 3610 3875 7557 -275 -47 -547 C \nATOM 802 O LEU A 101 -8.188 14.204 -51.768 1.00 40.24 O \nANISOU 802 O LEU A 101 3667 3954 7668 -272 -89 -560 O \nATOM 803 CB LEU A 101 -8.387 12.842 -54.807 1.00 33.86 C \nANISOU 803 CB LEU A 101 2861 3181 6822 -251 13 -579 C \nATOM 804 CG LEU A 101 -9.063 14.155 -55.075 1.00 37.64 C \nANISOU 804 CG LEU A 101 3293 3682 7324 -256 7 -619 C \nATOM 805 CD1 LEU A 101 -8.097 15.356 -55.037 1.00 40.88 C \nANISOU 805 CD1 LEU A 101 3665 4089 7778 -223 -46 -643 C \nATOM 806 CD2 LEU A 101 -9.799 14.124 -56.417 1.00 35.79 C \nANISOU 806 CD2 LEU A 101 3044 3479 7076 -261 55 -644 C \nATOM 807 N LYS A 102 -9.233 12.254 -52.013 1.00 37.69 N \nANISOU 807 N LYS A 102 3408 3633 7278 -299 -10 -526 N \nATOM 808 CA LYS A 102 -10.033 12.414 -50.813 1.00 40.86 C \nANISOU 808 CA LYS A 102 3827 4028 7671 -330 -18 -517 C \nATOM 809 C LYS A 102 -9.150 12.742 -49.591 1.00 42.17 C \nANISOU 809 C LYS A 102 3991 4176 7858 -327 -75 -499 C \nATOM 810 O LYS A 102 -9.465 13.573 -48.727 1.00 45.62 O \nANISOU 810 O LYS A 102 4411 4613 8309 -343 -105 -504 O \nATOM 811 CB LYS A 102 -10.830 11.127 -50.525 1.00 41.20 C \nANISOU 811 CB LYS A 102 3930 4061 7663 -348 28 -490 C \nATOM 812 CG LYS A 102 -12.291 11.193 -50.950 1.00 45.48 C \nANISOU 812 CG LYS A 102 4490 4613 8180 -380 74 -507 C \nATOM 813 CD LYS A 102 -12.898 9.796 -50.990 1.00 46.81 C \nANISOU 813 CD LYS A 102 4729 4763 8294 -380 124 -481 C \nATOM 814 CE LYS A 102 -14.385 9.879 -51.044 1.00 47.93 C \nANISOU 814 CE LYS A 102 4906 4902 8403 -424 163 -493 C \nATOM 815 NZ LYS A 102 -14.914 10.226 -49.717 1.00 48.21 N \nANISOU 815 NZ LYS A 102 4958 4927 8433 -464 143 -488 N \nATOM 816 N HIS A 103 -8.051 12.036 -49.463 1.00 39.58 N \nANISOU 816 N HIS A 103 3682 3833 7525 -310 -90 -474 N \nATOM 817 CA HIS A 103 -7.193 12.219 -48.281 1.00 35.63 C \nANISOU 817 CA HIS A 103 3188 3312 7036 -314 -142 -452 C \nATOM 818 C HIS A 103 -6.512 13.593 -48.384 1.00 38.16 C \nANISOU 818 C HIS A 103 3471 3625 7402 -293 -192 -477 C \nATOM 819 O HIS A 103 -6.199 14.247 -47.442 1.00 33.51 O \nANISOU 819 O HIS A 103 2879 3022 6831 -296 -238 -471 O \nATOM 820 CB HIS A 103 -6.123 11.158 -48.225 1.00 32.71 C \nANISOU 820 CB HIS A 103 2845 2938 6646 -307 -146 -421 C \nATOM 821 CG HIS A 103 -5.172 11.359 -47.117 1.00 32.27 C \nANISOU 821 CG HIS A 103 2800 2863 6599 -316 -200 -400 C \nATOM 822 ND1 HIS A 103 -3.876 11.785 -47.312 1.00 31.62 N \nANISOU 822 ND1 HIS A 103 2712 2764 6536 -305 -242 -401 N \nATOM 823 CD2 HIS A 103 -5.318 11.191 -45.783 1.00 33.33 C \nANISOU 823 CD2 HIS A 103 2954 2987 6721 -338 -220 -376 C \nATOM 824 CE1 HIS A 103 -3.267 11.902 -46.143 1.00 33.11 C \nANISOU 824 CE1 HIS A 103 2919 2934 6726 -321 -287 -378 C \nATOM 825 NE2 HIS A 103 -4.111 11.509 -45.199 1.00 33.28 N \nANISOU 825 NE2 HIS A 103 2954 2963 6730 -341 -274 -362 N \nATOM 826 N LEU A 104 -6.291 14.042 -49.566 1.00 39.07 N \nANISOU 826 N LEU A 104 3561 3750 7535 -269 -183 -505 N \nATOM 827 CA LEU A 104 -5.702 15.342 -49.714 1.00 45.13 C \nANISOU 827 CA LEU A 104 4297 4510 8341 -241 -228 -531 C \nATOM 828 C LEU A 104 -6.625 16.463 -49.213 1.00 52.71 C \nANISOU 828 C LEU A 104 5220 5491 9316 -244 -242 -552 C \nATOM 829 O LEU A 104 -6.160 17.447 -48.619 1.00 54.75 O \nANISOU 829 O LEU A 104 5464 5740 9599 -223 -292 -558 O \nATOM 830 CB LEU A 104 -5.439 15.500 -51.191 1.00 46.51 C \nANISOU 830 CB LEU A 104 4451 4696 8524 -216 -205 -560 C \nATOM 831 CG LEU A 104 -4.774 16.764 -51.647 1.00 50.41 C \nANISOU 831 CG LEU A 104 4917 5183 9054 -176 -242 -593 C \nATOM 832 CD1 LEU A 104 -3.406 16.920 -51.041 1.00 50.33 C \nANISOU 832 CD1 LEU A 104 4940 5128 9055 -163 -296 -576 C \nATOM 833 CD2 LEU A 104 -4.698 16.713 -53.167 1.00 52.08 C \nANISOU 833 CD2 LEU A 104 5110 5412 9266 -158 -208 -622 C \nATOM 834 N LEU A 105 -7.935 16.283 -49.390 1.00 54.01 N \nANISOU 834 N LEU A 105 5374 5686 9460 -272 -198 -562 N \nATOM 835 CA LEU A 105 -8.911 17.215 -48.813 1.00 55.08 C \nANISOU 835 CA LEU A 105 5476 5853 9598 -290 -208 -578 C \nATOM 836 C LEU A 105 -9.048 17.173 -47.342 1.00 57.60 C \nANISOU 836 C LEU A 105 5815 6161 9910 -315 -236 -551 C \nATOM 837 O LEU A 105 -10.110 17.525 -46.804 1.00 73.55 O \nANISOU 837 O LEU A 105 7820 8209 11915 -349 -228 -557 O \nATOM 838 CB LEU A 105 -10.303 16.932 -49.329 1.00 52.18 C \nANISOU 838 CB LEU A 105 5106 5520 9202 -328 -152 -592 C \nATOM 839 CG LEU A 105 -10.432 16.903 -50.865 1.00 55.53 C \nANISOU 839 CG LEU A 105 5511 5964 9626 -313 -113 -620 C \nATOM 840 CD1 LEU A 105 -11.839 16.543 -51.199 1.00 56.67 C \nANISOU 840 CD1 LEU A 105 5665 6133 9733 -361 -60 -627 C \nATOM 841 CD2 LEU A 105 -10.048 18.207 -51.550 1.00 56.80 C \nANISOU 841 CD2 LEU A 105 5610 6154 9819 -272 -139 -659 C \nATOM 842 N SER A 106 -8.005 16.757 -46.668 1.00 55.02 N \nANISOU 842 N SER A 106 5522 5796 9589 -305 -270 -521 N \nATOM 843 CA SER A 106 -8.126 16.535 -45.254 1.00 56.99 C \nANISOU 843 CA SER A 106 5795 6033 9826 -333 -292 -492 C \nATOM 844 C SER A 106 -7.115 17.427 -44.645 1.00 54.76 C \nANISOU 844 C SER A 106 5502 5732 9572 -303 -357 -488 C \nATOM 845 O SER A 106 -6.942 17.443 -43.439 1.00 48.73 O \nANISOU 845 O SER A 106 4756 4955 8805 -319 -391 -463 O \nATOM 846 CB SER A 106 -7.820 15.084 -44.930 1.00 56.32 C \nANISOU 846 CB SER A 106 5764 5922 9711 -352 -271 -456 C \nATOM 847 OG SER A 106 -6.743 14.642 -45.716 1.00 60.13 O \nANISOU 847 OG SER A 106 6257 6388 10199 -325 -271 -452 O \nATOM 848 N ARG A 107 -6.402 18.131 -45.518 1.00 53.75 N \nANISOU 848 N ARG A 107 5353 5599 9472 -258 -375 -512 N \nATOM 849 CA ARG A 107 -5.406 19.056 -45.063 1.00 65.00 C \nANISOU 849 CA ARG A 107 6776 6998 10922 -219 -437 -511 C \nATOM 850 C ARG A 107 -5.724 20.376 -45.755 1.00 58.91 C \nANISOU 850 C ARG A 107 5948 6261 10173 -175 -446 -554 C \nATOM 851 O ARG A 107 -5.030 21.357 -45.629 1.00 56.89 O \nANISOU 851 O ARG A 107 5684 5992 9939 -127 -494 -564 O \nATOM 852 CB ARG A 107 -3.993 18.506 -45.418 1.00 73.17 C \nANISOU 852 CB ARG A 107 7857 7984 11960 -205 -453 -496 C \nATOM 853 CG ARG A 107 -3.052 18.330 -44.180 1.00 82.78 C \nANISOU 853 CG ARG A 107 9120 9160 13174 -219 -504 -457 C \nATOM 854 CD ARG A 107 -3.288 19.461 -43.131 1.00 90.52 C \nANISOU 854 CD ARG A 107 10080 10144 14168 -203 -553 -457 C \nATOM 855 NE ARG A 107 -2.354 20.597 -42.968 1.00 88.76 N \nANISOU 855 NE ARG A 107 9866 9889 13970 -151 -614 -464 N \nATOM 856 CZ ARG A 107 -1.546 21.114 -43.899 1.00 97.36 C \nANISOU 856 CZ ARG A 107 10964 10951 15075 -104 -627 -487 C \nATOM 857 NH1 ARG A 107 -1.456 20.609 -45.128 1.00 93.23 N \nANISOU 857 NH1 ARG A 107 10440 10434 14551 -104 -585 -506 N \nATOM 858 NH2 ARG A 107 -0.778 22.162 -43.580 1.00107.09 N \nANISOU 858 NH2 ARG A 107 12214 12150 16324 -54 -684 -491 N \nATOM 859 N ILE A 108 -6.839 20.364 -46.453 1.00 53.21 N \nANISOU 859 N ILE A 108 5189 5587 9440 -193 -398 -578 N \nATOM 860 CA ILE A 108 -7.309 21.503 -47.173 1.00 50.85 C \nANISOU 860 CA ILE A 108 4829 5339 9154 -159 -397 -621 C \nATOM 861 C ILE A 108 -8.569 21.985 -46.510 1.00 53.56 C \nANISOU 861 C ILE A 108 5131 5741 9480 -195 -391 -627 C \nATOM 862 O ILE A 108 -9.293 21.193 -45.922 1.00 52.39 O \nANISOU 862 O ILE A 108 5009 5593 9306 -254 -365 -605 O \nATOM 863 CB ILE A 108 -7.681 21.187 -48.595 1.00 45.27 C \nANISOU 863 CB ILE A 108 4106 4653 8441 -161 -345 -648 C \nATOM 864 CG1 ILE A 108 -6.428 20.775 -49.360 1.00 41.89 C \nANISOU 864 CG1 ILE A 108 3713 4175 8027 -127 -350 -646 C \nATOM 865 CG2 ILE A 108 -8.335 22.415 -49.234 1.00 47.31 C \nANISOU 865 CG2 ILE A 108 4292 4979 8706 -134 -342 -693 C \nATOM 866 CD1 ILE A 108 -6.655 20.519 -50.850 1.00 41.63 C \nANISOU 866 CD1 ILE A 108 3663 4162 7990 -122 -301 -674 C \nATOM 867 N ASN A 109 -8.775 23.294 -46.594 1.00 52.11 N \nANISOU 867 N ASN A 109 4886 5608 9307 -156 -417 -656 N \nATOM 868 CA ASN A 109 -9.788 23.975 -45.850 1.00 54.08 C \nANISOU 868 CA ASN A 109 5087 5922 9537 -184 -425 -662 C \nATOM 869 C ASN A 109 -10.693 24.828 -46.710 1.00 55.86 C \nANISOU 869 C ASN A 109 5238 6235 9753 -180 -401 -707 C \nATOM 870 O ASN A 109 -11.842 25.118 -46.311 1.00 63.78 O \nANISOU 870 O ASN A 109 6202 7304 10726 -232 -386 -714 O \nATOM 871 CB ASN A 109 -9.124 24.911 -44.879 1.00 60.08 C \nANISOU 871 CB ASN A 109 5835 6678 10314 -134 -492 -652 C \nATOM 872 CG ASN A 109 -8.886 24.296 -43.521 1.00 63.67 C \nANISOU 872 CG ASN A 109 6341 7087 10762 -171 -517 -608 C \nATOM 873 OD1 ASN A 109 -7.929 24.667 -42.806 1.00 71.56 O \nANISOU 873 OD1 ASN A 109 7364 8048 11778 -131 -572 -588 O \nATOM 874 ND2 ASN A 109 -9.757 23.394 -43.128 1.00 57.63 N \nANISOU 874 ND2 ASN A 109 5599 6328 9969 -247 -478 -591 N \nATOM 875 N HIS A 110 -10.156 25.241 -47.864 1.00 51.91 N \nANISOU 875 N HIS A 110 4715 5736 9271 -122 -397 -737 N \nATOM 876 CA HIS A 110 -10.853 26.120 -48.790 1.00 58.65 C \nANISOU 876 CA HIS A 110 5492 6675 10115 -108 -377 -782 C \nATOM 877 C HIS A 110 -10.260 26.141 -50.212 1.00 54.24 C \nANISOU 877 C HIS A 110 4932 6103 9575 -59 -357 -811 C \nATOM 878 O HIS A 110 -9.056 26.065 -50.398 1.00 47.31 O \nANISOU 878 O HIS A 110 4095 5158 8725 -4 -383 -805 O \nATOM 879 CB HIS A 110 -10.967 27.521 -48.208 1.00 66.69 C \nANISOU 879 CB HIS A 110 6442 7766 11134 -61 -423 -799 C \nATOM 880 CG HIS A 110 -11.767 28.465 -49.050 1.00 71.38 C \nANISOU 880 CG HIS A 110 6946 8468 11709 -50 -403 -847 C \nATOM 881 ND1 HIS A 110 -11.411 29.794 -49.212 1.00 75.44 N \nANISOU 881 ND1 HIS A 110 7393 9038 12231 38 -442 -877 N \nATOM 882 CD2 HIS A 110 -12.909 28.286 -49.757 1.00 69.97 C \nANISOU 882 CD2 HIS A 110 6732 8354 11499 -116 -350 -868 C \nATOM 883 CE1 HIS A 110 -12.296 30.389 -49.988 1.00 76.01 C \nANISOU 883 CE1 HIS A 110 7387 9215 12279 26 -412 -916 C \nATOM 884 NE2 HIS A 110 -13.215 29.499 -50.330 1.00 77.29 N \nANISOU 884 NE2 HIS A 110 7567 9382 12416 -72 -356 -912 N \nATOM 885 N PHE A 111 -11.152 26.182 -51.198 1.00 55.28 N \nANISOU 885 N PHE A 111 5022 6296 9687 -90 -309 -841 N \nATOM 886 CA PHE A 111 -10.817 26.189 -52.591 1.00 61.01 C \nANISOU 886 CA PHE A 111 5737 7020 10421 -57 -283 -871 C \nATOM 887 C PHE A 111 -11.114 27.519 -53.242 1.00 73.40 C \nANISOU 887 C PHE A 111 7218 8682 11988 -8 -290 -920 C \nATOM 888 O PHE A 111 -11.780 28.377 -52.666 1.00 89.25 O \nANISOU 888 O PHE A 111 9164 10769 13978 -12 -307 -932 O \nATOM 889 CB PHE A 111 -11.713 25.198 -53.306 1.00 69.28 C \nANISOU 889 CB PHE A 111 6805 8077 11443 -133 -218 -869 C \nATOM 890 CG PHE A 111 -11.188 23.781 -53.317 1.00 64.47 C \nANISOU 890 CG PHE A 111 6282 7378 10837 -157 -198 -832 C \nATOM 891 CD1 PHE A 111 -9.839 23.532 -53.228 1.00 65.93 C \nANISOU 891 CD1 PHE A 111 6509 7489 11050 -106 -230 -816 C \nATOM 892 CD2 PHE A 111 -12.062 22.721 -53.447 1.00 60.48 C \nANISOU 892 CD2 PHE A 111 5813 6866 10300 -229 -147 -815 C \nATOM 893 CE1 PHE A 111 -9.372 22.247 -53.248 1.00 68.32 C \nANISOU 893 CE1 PHE A 111 6881 7727 11350 -129 -212 -783 C \nATOM 894 CE2 PHE A 111 -11.605 21.426 -53.439 1.00 62.20 C \nANISOU 894 CE2 PHE A 111 6104 7014 10517 -243 -130 -781 C \nATOM 895 CZ PHE A 111 -10.253 21.179 -53.369 1.00 64.41 C \nANISOU 895 CZ PHE A 111 6416 7233 10825 -193 -161 -765 C \nATOM 896 N GLU A 112 -10.619 27.693 -54.461 1.00 73.60 N \nANISOU 896 N GLU A 112 7234 8705 12026 39 -275 -951 N \nATOM 897 CA GLU A 112 -11.082 28.786 -55.323 1.00 71.37 C \nANISOU 897 CA GLU A 112 6864 8523 11733 74 -266 -1002 C \nATOM 898 C GLU A 112 -11.152 28.325 -56.787 1.00 65.48 C \nANISOU 898 C GLU A 112 6120 7778 10983 60 -215 -1026 C \nATOM 899 O GLU A 112 -10.160 28.250 -57.494 1.00 63.54 O \nANISOU 899 O GLU A 112 5902 7478 10760 115 -221 -1037 O \nATOM 900 CB GLU A 112 -10.236 30.052 -55.155 1.00 72.80 C \nANISOU 900 CB GLU A 112 7010 8717 11934 185 -321 -1025 C \nATOM 901 CG GLU A 112 -10.885 31.288 -55.785 1.00 85.59 C \nANISOU 901 CG GLU A 112 8524 10464 13532 222 -315 -1077 C \nATOM 902 CD GLU A 112 -10.058 32.569 -55.653 1.00 87.10 C \nANISOU 902 CD GLU A 112 8682 10672 13739 347 -370 -1102 C \nATOM 903 OE1 GLU A 112 -9.183 32.624 -54.776 1.00 98.71 O \nANISOU 903 OE1 GLU A 112 10206 12066 15232 394 -418 -1075 O \nATOM 904 OE2 GLU A 112 -10.293 33.517 -56.426 1.00 81.47 O \nANISOU 904 OE2 GLU A 112 7892 10051 13013 400 -364 -1150 O \nATOM 905 N LYS A 113 -12.350 27.941 -57.184 1.00 62.54 N \nANISOU 905 N LYS A 113 5725 7461 10575 -22 -165 -1032 N \nATOM 906 CA LYS A 113 -12.648 27.482 -58.532 1.00 61.71 C \nANISOU 906 CA LYS A 113 5620 7370 10459 -49 -113 -1052 C \nATOM 907 C LYS A 113 -12.256 28.541 -59.566 1.00 64.66 C \nANISOU 907 C LYS A 113 5927 7800 10841 27 -119 -1104 C \nATOM 908 O LYS A 113 -12.738 29.640 -59.536 1.00 66.74 O \nANISOU 908 O LYS A 113 6109 8160 11088 50 -131 -1136 O \nATOM 909 CB LYS A 113 -14.124 27.185 -58.599 1.00 59.59 C \nANISOU 909 CB LYS A 113 5331 7166 10143 -150 -67 -1052 C \nATOM 910 CG LYS A 113 -14.635 26.530 -59.854 1.00 62.14 C \nANISOU 910 CG LYS A 113 5667 7497 10444 -198 -9 -1063 C \nATOM 911 CD LYS A 113 -16.163 26.666 -59.791 1.00 71.61 C \nANISOU 911 CD LYS A 113 6834 8784 11591 -294 26 -1072 C \nATOM 912 CE LYS A 113 -16.922 25.798 -60.765 1.00 71.75 C \nANISOU 912 CE LYS A 113 6888 8798 11575 -367 87 -1070 C \nATOM 913 NZ LYS A 113 -17.074 24.489 -60.116 1.00 75.41 N \nANISOU 913 NZ LYS A 113 7451 9170 12033 -415 102 -1021 N \nATOM 914 N ILE A 114 -11.325 28.184 -60.440 1.00 73.59 N \nANISOU 914 N ILE A 114 7095 8870 11995 70 -113 -1111 N \nATOM 915 CA ILE A 114 -10.785 29.085 -61.452 1.00 73.58 C \nANISOU 915 CA ILE A 114 7048 8905 12004 149 -119 -1160 C \nATOM 916 C ILE A 114 -11.052 28.544 -62.833 1.00 76.16 C \nANISOU 916 C ILE A 114 7374 9246 12318 114 -65 -1179 C \nATOM 917 O ILE A 114 -10.797 27.330 -63.098 1.00 77.02 O \nANISOU 917 O ILE A 114 7554 9280 12430 72 -39 -1148 O \nATOM 918 CB ILE A 114 -9.237 29.177 -61.377 1.00 85.37 C \nANISOU 918 CB ILE A 114 8599 10303 13537 235 -161 -1156 C \nATOM 919 CG1 ILE A 114 -8.809 29.997 -60.176 1.00 90.48 C \nANISOU 919 CG1 ILE A 114 9241 10941 14198 296 -221 -1147 C \nATOM 920 CG2 ILE A 114 -8.677 29.836 -62.639 1.00 86.45 C \nANISOU 920 CG2 ILE A 114 8707 10460 13679 306 -155 -1206 C \nATOM 921 CD1 ILE A 114 -7.305 30.111 -60.066 1.00 88.91 C \nANISOU 921 CD1 ILE A 114 9110 10641 14030 375 -265 -1142 C \nATOM 922 N GLN A 115 -11.453 29.428 -63.744 1.00 70.34 N \nANISOU 922 N GLN A 115 6559 8603 11564 138 -48 -1229 N \nATOM 923 CA GLN A 115 -11.503 29.023 -65.155 1.00 69.84 C \nANISOU 923 CA GLN A 115 6495 8549 11492 119 -2 -1252 C \nATOM 924 C GLN A 115 -10.092 28.945 -65.751 1.00 70.34 C \nANISOU 924 C GLN A 115 6605 8532 11588 195 -19 -1262 C \nATOM 925 O GLN A 115 -9.344 29.911 -65.715 1.00 69.79 O \nANISOU 925 O GLN A 115 6516 8465 11537 286 -57 -1290 O \nATOM 926 CB GLN A 115 -12.337 29.949 -65.961 1.00 67.21 C \nANISOU 926 CB GLN A 115 6066 8343 11128 117 22 -1302 C \nATOM 927 CG GLN A 115 -12.784 29.335 -67.264 1.00 69.55 C \nANISOU 927 CG GLN A 115 6365 8660 11403 62 78 -1315 C \nATOM 928 CD GLN A 115 -13.549 30.315 -68.126 1.00 67.72 C \nANISOU 928 CD GLN A 115 6033 8562 11137 61 101 -1369 C \nATOM 929 OE1 GLN A 115 -13.168 31.479 -68.205 1.00 75.43 O \nANISOU 929 OE1 GLN A 115 6946 9595 12120 146 72 -1410 O \nATOM 930 NE2 GLN A 115 -14.638 29.856 -68.744 1.00 61.37 N \nANISOU 930 NE2 GLN A 115 5215 7809 10292 -35 152 -1370 N \nATOM 931 N ILE A 116 -9.734 27.775 -66.275 1.00 72.32 N \nANISOU 931 N ILE A 116 6923 8714 11844 157 8 -1237 N \nATOM 932 CA ILE A 116 -8.349 27.448 -66.592 1.00 67.44 C \nANISOU 932 CA ILE A 116 6366 8004 11252 208 -11 -1232 C \nATOM 933 C ILE A 116 -8.125 27.423 -68.094 1.00 65.60 C \nANISOU 933 C ILE A 116 6121 7793 11013 218 24 -1269 C \nATOM 934 O ILE A 116 -7.049 27.798 -68.587 1.00 65.52 O \nANISOU 934 O ILE A 116 6130 7744 11021 284 5 -1293 O \nATOM 935 CB ILE A 116 -7.942 26.123 -65.879 1.00 70.09 C \nANISOU 935 CB ILE A 116 6790 8247 11596 160 -14 -1172 C \nATOM 936 CG1 ILE A 116 -6.533 26.219 -65.354 1.00 72.44 C \nANISOU 936 CG1 ILE A 116 7146 8457 11922 219 -63 -1160 C \nATOM 937 CG2 ILE A 116 -8.186 24.851 -66.699 1.00 67.51 C \nANISOU 937 CG2 ILE A 116 6497 7904 11250 97 37 -1152 C \nATOM 938 CD1 ILE A 116 -6.464 27.134 -64.158 1.00 71.30 C \nANISOU 938 CD1 ILE A 116 6985 8314 11790 264 -114 -1158 C \nATOM 939 N ILE A 117 -9.129 26.944 -68.819 1.00 62.30 N \nANISOU 939 N ILE A 117 5675 7430 10566 150 75 -1271 N \nATOM 940 CA ILE A 117 -9.204 27.065 -70.279 1.00 66.78 C \nANISOU 940 CA ILE A 117 6210 8043 11119 153 113 -1310 C \nATOM 941 C ILE A 117 -10.689 27.128 -70.665 1.00 78.62 C \nANISOU 941 C ILE A 117 7651 9641 12580 82 157 -1322 C \nATOM 942 O ILE A 117 -11.408 26.111 -70.598 1.00 85.19 O \nANISOU 942 O ILE A 117 8518 10459 13390 2 189 -1285 O \nATOM 943 CB ILE A 117 -8.477 25.932 -71.061 1.00 61.46 C \nANISOU 943 CB ILE A 117 5602 7300 10448 133 136 -1291 C \nATOM 944 CG1 ILE A 117 -8.613 24.589 -70.378 1.00 62.49 C \nANISOU 944 CG1 ILE A 117 5801 7369 10573 72 145 -1228 C \nATOM 945 CG2 ILE A 117 -6.996 26.254 -71.186 1.00 61.72 C \nANISOU 945 CG2 ILE A 117 5673 7266 10510 208 99 -1306 C \nATOM 946 CD1 ILE A 117 -7.945 23.429 -71.086 1.00 60.78 C \nANISOU 946 CD1 ILE A 117 5642 7100 10353 52 168 -1205 C \nATOM 947 N PRO A 118 -11.147 28.329 -71.074 1.00 85.28 N \nANISOU 947 N PRO A 118 8407 10584 13410 111 157 -1373 N \nATOM 948 CA PRO A 118 -12.550 28.616 -71.346 1.00 80.21 C \nANISOU 948 CA PRO A 118 7699 10050 12725 43 192 -1389 C \nATOM 949 C PRO A 118 -13.191 27.691 -72.369 1.00 78.19 C \nANISOU 949 C PRO A 118 7466 9804 12439 -37 249 -1380 C \nATOM 950 O PRO A 118 -12.536 27.238 -73.311 1.00 90.78 O \nANISOU 950 O PRO A 118 9089 11361 14043 -19 265 -1386 O \nATOM 951 CB PRO A 118 -12.517 30.047 -71.888 1.00 82.27 C \nANISOU 951 CB PRO A 118 7866 10413 12979 112 181 -1453 C \nATOM 952 CG PRO A 118 -11.270 30.641 -71.342 1.00 80.41 C \nANISOU 952 CG PRO A 118 7650 10118 12785 221 127 -1460 C \nATOM 953 CD PRO A 118 -10.291 29.514 -71.318 1.00 82.31 C \nANISOU 953 CD PRO A 118 7993 10226 13054 217 123 -1421 C \nATOM 954 N LYS A 119 -14.478 27.453 -72.173 1.00 73.71 N \nANISOU 954 N LYS A 119 6886 9288 11832 -127 278 -1366 N \nATOM 955 CA LYS A 119 -15.281 26.522 -72.954 1.00 72.76 C \nANISOU 955 CA LYS A 119 6799 9172 11675 -214 332 -1349 C \nATOM 956 C LYS A 119 -15.528 27.071 -74.337 1.00 74.88 C \nANISOU 956 C LYS A 119 7004 9527 11920 -215 362 -1399 C \nATOM 957 O LYS A 119 -15.800 26.325 -75.291 1.00 83.96 O \nANISOU 957 O LYS A 119 8184 10669 13048 -262 404 -1391 O \nATOM 958 CB LYS A 119 -16.622 26.272 -72.234 1.00 72.11 C \nANISOU 958 CB LYS A 119 6727 9121 11552 -310 349 -1323 C \nATOM 959 CG LYS A 119 -17.519 25.214 -72.854 1.00 76.56 C \nANISOU 959 CG LYS A 119 7347 9670 12071 -403 403 -1298 C \nATOM 960 CD LYS A 119 -18.931 25.267 -72.252 1.00 79.50 C \nANISOU 960 CD LYS A 119 7719 10093 12392 -503 420 -1286 C \nATOM 961 CE LYS A 119 -19.854 24.215 -72.868 1.00 81.55 C \nANISOU 961 CE LYS A 119 8050 10331 12604 -595 474 -1260 C \nATOM 962 NZ LYS A 119 -19.702 22.914 -72.168 1.00 93.01 N \nANISOU 962 NZ LYS A 119 9612 11665 14063 -603 476 -1200 N \nATOM 963 N SER A 120 -15.437 28.388 -74.451 1.00 78.87 N \nANISOU 963 N SER A 120 7420 10121 12427 -161 342 -1450 N \nATOM 964 CA SER A 120 -15.672 29.078 -75.724 1.00 73.77 C \nANISOU 964 CA SER A 120 6699 9574 11756 -154 369 -1504 C \nATOM 965 C SER A 120 -14.371 29.182 -76.567 1.00 70.95 C \nANISOU 965 C SER A 120 6353 9171 11435 -63 359 -1531 C \nATOM 966 O SER A 120 -14.407 29.612 -77.711 1.00 79.61 O \nANISOU 966 O SER A 120 7400 10333 12514 -53 383 -1574 O \nATOM 967 CB SER A 120 -16.291 30.436 -75.439 1.00 69.62 C \nANISOU 967 CB SER A 120 6068 9180 11206 -141 354 -1548 C \nATOM 968 OG SER A 120 -15.701 31.009 -74.281 1.00 73.20 O \nANISOU 968 OG SER A 120 6514 9607 11692 -66 301 -1543 O \nATOM 969 N SER A 121 -13.246 28.719 -76.036 1.00 62.73 N \nANISOU 969 N SER A 121 5381 8015 10438 -8 327 -1503 N \nATOM 970 CA SER A 121 -12.002 28.671 -76.807 1.00 65.36 C \nANISOU 970 CA SER A 121 5742 8293 10799 62 320 -1523 C \nATOM 971 C SER A 121 -11.983 27.554 -77.844 1.00 61.08 C \nANISOU 971 C SER A 121 5247 7717 10243 8 364 -1505 C \nATOM 972 O SER A 121 -11.295 27.652 -78.835 1.00 70.96 O \nANISOU 972 O SER A 121 6496 8965 11500 45 372 -1534 O \nATOM 973 CB SER A 121 -10.823 28.476 -75.877 1.00 66.20 C \nANISOU 973 CB SER A 121 5914 8290 10950 124 272 -1496 C \nATOM 974 OG SER A 121 -10.754 27.110 -75.528 1.00 77.55 O \nANISOU 974 OG SER A 121 7434 9641 12391 66 283 -1436 O \nATOM 975 N TRP A 122 -12.733 26.488 -77.610 1.00 63.73 N \nANISOU 975 N TRP A 122 5629 8027 10557 -77 390 -1456 N \nATOM 976 CA TRP A 122 -12.749 25.299 -78.495 1.00 66.18 C \nANISOU 976 CA TRP A 122 5993 8301 10850 -125 430 -1429 C \nATOM 977 C TRP A 122 -13.508 25.657 -79.768 1.00 70.67 C \nANISOU 977 C TRP A 122 6504 8967 11380 -164 473 -1468 C \nATOM 978 O TRP A 122 -14.669 25.273 -79.979 1.00 80.89 O \nANISOU 978 O TRP A 122 7800 10302 12633 -247 510 -1453 O \nATOM 979 CB TRP A 122 -13.373 24.057 -77.784 1.00 65.17 C \nANISOU 979 CB TRP A 122 5938 8116 10706 -195 445 -1364 C \nATOM 980 CG TRP A 122 -12.739 23.724 -76.443 1.00 57.49 C \nANISOU 980 CG TRP A 122 5017 7058 9767 -164 404 -1325 C \nATOM 981 CD1 TRP A 122 -13.296 23.859 -75.238 1.00 57.99 C \nANISOU 981 CD1 TRP A 122 5086 7118 9831 -185 385 -1303 C \nATOM 982 CD2 TRP A 122 -11.407 23.281 -76.224 1.00 54.09 C \nANISOU 982 CD2 TRP A 122 4636 6544 9372 -110 376 -1307 C \nATOM 983 NE1 TRP A 122 -12.399 23.537 -74.257 1.00 57.28 N \nANISOU 983 NE1 TRP A 122 5044 6946 9776 -144 346 -1273 N \nATOM 984 CE2 TRP A 122 -11.219 23.189 -74.848 1.00 52.15 C \nANISOU 984 CE2 TRP A 122 4422 6246 9147 -99 339 -1274 C \nATOM 985 CE3 TRP A 122 -10.337 22.998 -77.070 1.00 56.64 C \nANISOU 985 CE3 TRP A 122 4980 6835 9708 -75 377 -1317 C \nATOM 986 CZ2 TRP A 122 -10.019 22.768 -74.275 1.00 53.09 C \nANISOU 986 CZ2 TRP A 122 4594 6282 9297 -58 305 -1249 C \nATOM 987 CZ3 TRP A 122 -9.129 22.578 -76.497 1.00 56.12 C \nANISOU 987 CZ3 TRP A 122 4967 6685 9670 -36 342 -1292 C \nATOM 988 CH2 TRP A 122 -9.000 22.458 -75.109 1.00 55.26 C \nANISOU 988 CH2 TRP A 122 4890 6525 9579 -29 307 -1258 C \nATOM 989 N SER A 123 -12.821 26.383 -80.634 1.00 72.74 N \nANISOU 989 N SER A 123 6722 9263 11653 -104 470 -1519 N \nATOM 990 CA SER A 123 -13.379 26.859 -81.905 1.00 80.01 C \nANISOU 990 CA SER A 123 7579 10281 12538 -129 507 -1565 C \nATOM 991 C SER A 123 -13.542 25.778 -82.965 1.00 88.82 C \nANISOU 991 C SER A 123 8739 11380 13629 -186 552 -1543 C \nATOM 992 O SER A 123 -14.438 25.873 -83.803 1.00 99.52 O \nANISOU 992 O SER A 123 10058 12813 14942 -244 590 -1560 O \nATOM 993 CB SER A 123 -12.477 27.944 -82.467 1.00 81.84 C \nANISOU 993 CB SER A 123 7759 10547 12791 -36 487 -1627 C \nATOM 994 OG SER A 123 -11.956 28.700 -81.397 1.00 92.97 O \nANISOU 994 OG SER A 123 9158 11934 14233 37 438 -1635 O \nATOM 995 N ASP A 124 -12.677 24.760 -82.940 1.00 93.21 N \nANISOU 995 N ASP A 124 9371 11838 14207 -171 546 -1504 N \nATOM 996 CA ASP A 124 -12.639 23.757 -84.013 1.00 90.10 C \nANISOU 996 CA ASP A 124 9015 11430 13789 -210 585 -1485 C \nATOM 997 C ASP A 124 -13.258 22.430 -83.586 1.00 86.91 C \nANISOU 997 C ASP A 124 8685 10973 13363 -273 604 -1417 C \nATOM 998 O ASP A 124 -13.285 21.455 -84.364 1.00 83.48 O \nANISOU 998 O ASP A 124 8291 10523 12905 -304 636 -1391 O \nATOM 999 CB ASP A 124 -11.194 23.558 -84.484 1.00 90.61 C \nANISOU 999 CB ASP A 124 9106 11439 13883 -149 568 -1494 C \nATOM 1000 CG ASP A 124 -10.492 24.884 -84.772 1.00 97.37 C \nANISOU 1000 CG ASP A 124 9905 12330 14762 -73 544 -1561 C \nATOM 1001 OD1 ASP A 124 -11.082 25.723 -85.485 1.00102.63 O \nANISOU 1001 OD1 ASP A 124 10500 13090 15406 -78 563 -1610 O \nATOM 1002 OD2 ASP A 124 -9.372 25.101 -84.270 1.00 95.48 O \nANISOU 1002 OD2 ASP A 124 9693 12026 14558 -9 505 -1565 O \nATOM 1003 N HIS A 125 -13.754 22.385 -82.353 1.00 75.71 N \nANISOU 1003 N HIS A 125 7288 9530 11950 -290 586 -1388 N \nATOM 1004 CA HIS A 125 -14.388 21.183 -81.863 1.00 73.12 C \nANISOU 1004 CA HIS A 125 7033 9150 11597 -344 605 -1326 C \nATOM 1005 C HIS A 125 -15.750 21.556 -81.311 1.00 73.17 C \nANISOU 1005 C HIS A 125 7025 9203 11572 -409 616 -1325 C \nATOM 1006 O HIS A 125 -15.993 22.689 -80.885 1.00 69.97 O \nANISOU 1006 O HIS A 125 6555 8855 11175 -399 596 -1362 O \nATOM 1007 CB HIS A 125 -13.567 20.532 -80.754 1.00 71.18 C \nANISOU 1007 CB HIS A 125 6847 8812 11386 -306 570 -1283 C \nATOM 1008 CG HIS A 125 -12.148 20.244 -81.126 1.00 67.26 C \nANISOU 1008 CG HIS A 125 6367 8271 10919 -248 552 -1284 C \nATOM 1009 ND1 HIS A 125 -11.174 21.224 -81.163 1.00 61.50 N \nANISOU 1009 ND1 HIS A 125 5596 7546 10226 -185 519 -1329 N \nATOM 1010 CD2 HIS A 125 -11.526 19.071 -81.411 1.00 69.94 C \nANISOU 1010 CD2 HIS A 125 6762 8560 11251 -245 562 -1245 C \nATOM 1011 CE1 HIS A 125 -10.027 20.670 -81.521 1.00 69.89 C \nANISOU 1011 CE1 HIS A 125 6694 8560 11301 -154 510 -1319 C \nATOM 1012 NE2 HIS A 125 -10.205 19.362 -81.662 1.00 70.44 N \nANISOU 1012 NE2 HIS A 125 6818 8602 11346 -191 535 -1268 N \nATOM 1013 N GLU A 126 -16.642 20.585 -81.322 1.00 71.70 N \nANISOU 1013 N GLU A 126 6904 8994 11345 -475 649 -1282 N \nATOM 1014 CA GLU A 126 -17.980 20.797 -80.832 1.00 70.90 C \nANISOU 1014 CA GLU A 126 6806 8929 11205 -551 664 -1276 C \nATOM 1015 C GLU A 126 -18.046 20.506 -79.329 1.00 74.15 C \nANISOU 1015 C GLU A 126 7264 9277 11633 -548 636 -1238 C \nATOM 1016 O GLU A 126 -18.215 19.367 -78.922 1.00 78.04 O \nANISOU 1016 O GLU A 126 7842 9696 12111 -564 647 -1186 O \nATOM 1017 CB GLU A 126 -18.971 19.915 -81.591 1.00 68.36 C \nANISOU 1017 CB GLU A 126 6543 8606 10823 -627 715 -1249 C \nATOM 1018 CG GLU A 126 -20.410 20.325 -81.379 1.00 74.35 C \nANISOU 1018 CG GLU A 126 7299 9422 11530 -721 736 -1256 C \nATOM 1019 CD GLU A 126 -20.620 21.771 -81.770 1.00 76.82 C \nANISOU 1019 CD GLU A 126 7497 9850 11839 -729 729 -1320 C \nATOM 1020 OE1 GLU A 126 -20.888 22.545 -80.832 1.00 87.42 O \nANISOU 1020 OE1 GLU A 126 8800 11226 13190 -735 704 -1335 O \nATOM 1021 OE2 GLU A 126 -20.474 22.126 -82.981 1.00 73.42 O \nANISOU 1021 OE2 GLU A 126 7017 9482 11399 -725 748 -1356 O \nATOM 1022 N ALA A 127 -17.968 21.565 -78.523 1.00 82.80 N \nANISOU 1022 N ALA A 127 8300 10407 12753 -526 601 -1266 N \nATOM 1023 CA ALA A 127 -17.995 21.463 -77.060 1.00 86.86 C \nANISOU 1023 CA ALA A 127 8846 10872 13285 -522 571 -1237 C \nATOM 1024 C ALA A 127 -19.393 21.184 -76.501 1.00 89.41 C \nANISOU 1024 C ALA A 127 9210 11204 13557 -615 594 -1213 C \nATOM 1025 O ALA A 127 -19.592 20.267 -75.705 1.00 81.18 O \nANISOU 1025 O ALA A 127 8251 10087 12508 -632 595 -1164 O \nATOM 1026 CB ALA A 127 -17.412 22.731 -76.429 1.00 80.60 C \nANISOU 1026 CB ALA A 127 7973 10117 12532 -462 524 -1275 C \nATOM 1027 N SER A 128 -20.361 21.977 -76.951 1.00110.04 N \nANISOU 1027 N SER A 128 11768 13913 16129 -678 614 -1248 N \nATOM 1028 CA SER A 128 -21.716 21.985 -76.369 1.00116.37 C \nANISOU 1028 CA SER A 128 12597 14741 16878 -777 631 -1235 C \nATOM 1029 C SER A 128 -22.487 20.659 -76.476 1.00110.26 C \nANISOU 1029 C SER A 128 11943 13894 16056 -844 671 -1185 C \nATOM 1030 O SER A 128 -23.462 20.451 -75.727 1.00100.42 O \nANISOU 1030 O SER A 128 10749 12634 14770 -917 681 -1163 O \nATOM 1031 CB SER A 128 -22.539 23.093 -77.023 1.00119.22 C \nANISOU 1031 CB SER A 128 12869 15233 17197 -836 648 -1286 C \nATOM 1032 OG SER A 128 -22.735 22.813 -78.399 1.00120.95 O \nANISOU 1032 OG SER A 128 13092 15478 17386 -862 687 -1298 O \nATOM 1033 N SER A 129 -22.051 19.778 -77.385 1.00 98.09 N \nANISOU 1033 N SER A 129 10448 12306 14515 -816 694 -1166 N \nATOM 1034 CA SER A 129 -22.658 18.449 -77.521 1.00 97.01 C \nANISOU 1034 CA SER A 129 10431 12095 14335 -858 730 -1115 C \nATOM 1035 C SER A 129 -22.041 17.456 -76.535 1.00 91.46 C \nANISOU 1035 C SER A 129 9803 11286 13660 -802 711 -1065 C \nATOM 1036 O SER A 129 -22.287 16.253 -76.598 1.00 73.18 O \nANISOU 1036 O SER A 129 7588 8902 11316 -808 736 -1020 O \nATOM 1037 CB SER A 129 -22.528 17.923 -78.939 1.00104.37 C \nANISOU 1037 CB SER A 129 11377 13032 15247 -853 764 -1115 C \nATOM 1038 OG SER A 129 -22.596 16.509 -78.945 1.00113.76 O \nANISOU 1038 OG SER A 129 12679 14131 16413 -845 786 -1059 O \nATOM 1039 N GLY A 130 -21.228 17.974 -75.628 1.00 91.36 N \nANISOU 1039 N GLY A 130 9744 11267 13703 -745 666 -1074 N \nATOM 1040 CA GLY A 130 -20.693 17.167 -74.568 1.00 87.03 C \nANISOU 1040 CA GLY A 130 9257 10631 13178 -702 644 -1030 C \nATOM 1041 C GLY A 130 -21.754 16.791 -73.569 1.00 78.69 C \nANISOU 1041 C GLY A 130 8275 9540 12082 -767 654 -1001 C \nATOM 1042 O GLY A 130 -21.655 17.177 -72.405 1.00 75.64 O \nANISOU 1042 O GLY A 130 7876 9144 11719 -761 622 -999 O \nATOM 1043 N VAL A 131 -22.741 16.009 -74.023 1.00 71.60 N \nANISOU 1043 N VAL A 131 7463 8618 11123 -827 698 -977 N \nATOM 1044 CA VAL A 131 -23.962 15.755 -73.244 1.00 65.95 C \nANISOU 1044 CA VAL A 131 6828 7877 10355 -909 715 -956 C \nATOM 1045 C VAL A 131 -24.420 14.302 -73.399 1.00 61.88 C \nANISOU 1045 C VAL A 131 6446 7274 9791 -915 752 -905 C \nATOM 1046 O VAL A 131 -24.174 13.672 -74.427 1.00 56.66 O \nANISOU 1046 O VAL A 131 5808 6602 9119 -886 776 -894 O \nATOM 1047 CB VAL A 131 -25.073 16.730 -73.695 1.00 66.10 C \nANISOU 1047 CB VAL A 131 6803 7985 10328 -1009 734 -995 C \nATOM 1048 CG1 VAL A 131 -26.473 16.205 -73.347 1.00 73.34 C \nANISOU 1048 CG1 VAL A 131 7832 8866 11168 -1111 769 -970 C \nATOM 1049 CG2 VAL A 131 -24.845 18.098 -73.079 1.00 61.14 C \nANISOU 1049 CG2 VAL A 131 6060 7437 9735 -1007 695 -1037 C \nATOM 1050 N SER A 132 -25.092 13.772 -72.390 1.00 62.28 N \nANISOU 1050 N SER A 132 6587 7265 9810 -949 758 -875 N \nATOM 1051 CA SER A 132 -25.610 12.402 -72.468 1.00 77.03 C \nANISOU 1051 CA SER A 132 8594 9048 11626 -950 793 -827 C \nATOM 1052 C SER A 132 -26.778 12.146 -71.511 1.00 77.12 C \nANISOU 1052 C SER A 132 8707 9012 11581 -1027 808 -808 C \nATOM 1053 O SER A 132 -26.928 12.810 -70.493 1.00 62.42 O \nANISOU 1053 O SER A 132 6813 7167 9735 -1058 782 -822 O \nATOM 1054 CB SER A 132 -24.470 11.392 -72.191 1.00 87.12 C \nANISOU 1054 CB SER A 132 9894 10266 12940 -840 778 -790 C \nATOM 1055 OG SER A 132 -24.938 10.045 -72.188 1.00 93.84 O \nANISOU 1055 OG SER A 132 10878 11040 13738 -826 811 -742 O \nATOM 1056 N SER A 133 -27.568 11.136 -71.851 1.00 93.04 N \nANISOU 1056 N SER A 133 10855 10965 13532 -1052 849 -775 N \nATOM 1057 CA SER A 133 -28.756 10.732 -71.066 1.00 93.25 C \nANISOU 1057 CA SER A 133 11008 10931 13493 -1127 870 -754 C \nATOM 1058 C SER A 133 -28.353 10.059 -69.757 1.00 89.94 C \nANISOU 1058 C SER A 133 10640 10440 13094 -1068 850 -722 C \nATOM 1059 O SER A 133 -29.115 10.064 -68.793 1.00 79.48 O \nANISOU 1059 O SER A 133 9383 9080 11735 -1127 852 -716 O \nATOM 1060 CB SER A 133 -29.625 9.751 -71.865 1.00 93.82 C \nANISOU 1060 CB SER A 133 11218 10943 13485 -1155 920 -725 C \nATOM 1061 OG SER A 133 -29.558 10.014 -73.257 1.00106.53 O \nANISOU 1061 OG SER A 133 12778 12609 15090 -1164 938 -743 O \nATOM 1062 N ALA A 134 -27.159 9.457 -69.737 1.00 95.63 N \nANISOU 1062 N ALA A 134 11331 11140 13864 -954 831 -702 N \nATOM 1063 CA ALA A 134 -26.621 8.823 -68.518 1.00 86.44 C \nANISOU 1063 CA ALA A 134 10201 9919 12723 -890 809 -672 C \nATOM 1064 C ALA A 134 -26.469 9.849 -67.389 1.00 77.21 C \nANISOU 1064 C ALA A 134 8955 8785 11597 -923 768 -697 C \nATOM 1065 O ALA A 134 -26.527 9.507 -66.203 1.00 70.52 O \nANISOU 1065 O ALA A 134 8157 7891 10748 -916 755 -678 O \nATOM 1066 CB ALA A 134 -25.297 8.154 -68.814 1.00 75.39 C \nANISOU 1066 CB ALA A 134 8761 8515 11368 -774 794 -652 C \nATOM 1067 N CYS A 135 -26.288 11.107 -67.782 1.00 79.24 N \nANISOU 1067 N CYS A 135 9091 9128 11889 -956 748 -741 N \nATOM 1068 CA CYS A 135 -26.150 12.219 -66.848 1.00 88.59 C \nANISOU 1068 CA CYS A 135 10189 10361 13111 -985 708 -769 C \nATOM 1069 C CYS A 135 -27.330 13.198 -66.961 1.00 92.71 C \nANISOU 1069 C CYS A 135 10691 10945 13588 -1104 721 -802 C \nATOM 1070 O CYS A 135 -27.265 14.191 -67.681 1.00 90.21 O \nANISOU 1070 O CYS A 135 10273 10715 13287 -1126 715 -841 O \nATOM 1071 CB CYS A 135 -24.827 12.967 -67.110 1.00 85.79 C \nANISOU 1071 CB CYS A 135 9698 10064 12836 -910 667 -794 C \nATOM 1072 SG CYS A 135 -24.091 13.809 -65.694 1.00103.82 S \nANISOU 1072 SG CYS A 135 11900 12367 15181 -882 607 -805 S \nATOM 1073 N PRO A 136 -28.405 12.935 -66.220 1.00102.37 N \nANISOU 1073 N PRO A 136 12014 12130 14754 -1184 739 -789 N \nATOM 1074 CA PRO A 136 -29.516 13.859 -66.186 1.00109.90 C \nANISOU 1074 CA PRO A 136 12949 13148 15659 -1307 749 -819 C \nATOM 1075 C PRO A 136 -29.201 15.113 -65.376 1.00109.56 C \nANISOU 1075 C PRO A 136 12781 13188 15660 -1319 703 -851 C \nATOM 1076 O PRO A 136 -28.249 15.137 -64.601 1.00123.73 O \nANISOU 1076 O PRO A 136 14531 14966 17515 -1240 665 -842 O \nATOM 1077 CB PRO A 136 -30.634 13.039 -65.517 1.00116.42 C \nANISOU 1077 CB PRO A 136 13936 13890 16410 -1379 780 -789 C \nATOM 1078 CG PRO A 136 -30.176 11.615 -65.574 1.00117.29 C \nANISOU 1078 CG PRO A 136 14150 13893 16521 -1285 796 -744 C \nATOM 1079 CD PRO A 136 -28.694 11.716 -65.450 1.00115.07 C \nANISOU 1079 CD PRO A 136 13761 13631 16328 -1166 755 -744 C \nATOM 1080 N TYR A 137 -30.016 16.138 -65.567 1.00110.05 N \nANISOU 1080 N TYR A 137 12787 13343 15685 -1420 708 -886 N \nATOM 1081 CA TYR A 137 -29.921 17.395 -64.834 1.00110.16 C \nANISOU 1081 CA TYR A 137 12682 13452 15723 -1442 668 -918 C \nATOM 1082 C TYR A 137 -31.279 17.718 -64.233 1.00116.15 C \nANISOU 1082 C TYR A 137 13489 14240 16404 -1583 685 -925 C \nATOM 1083 O TYR A 137 -31.523 17.557 -63.031 1.00121.73 O \nANISOU 1083 O TYR A 137 14242 14909 17100 -1608 671 -908 O \nATOM 1084 CB TYR A 137 -29.490 18.538 -65.769 1.00103.23 C \nANISOU 1084 CB TYR A 137 11655 12693 14876 -1421 654 -964 C \nATOM 1085 CG TYR A 137 -29.820 19.948 -65.283 1.00 93.84 C \nANISOU 1085 CG TYR A 137 10345 11630 13680 -1476 626 -1003 C \nATOM 1086 CD1 TYR A 137 -29.793 20.278 -63.930 1.00 95.50 C \nANISOU 1086 CD1 TYR A 137 10541 11844 13903 -1481 592 -997 C \nATOM 1087 CD2 TYR A 137 -30.148 20.951 -66.190 1.00 95.91 C \nANISOU 1087 CD2 TYR A 137 10506 12017 13920 -1519 634 -1047 C \nATOM 1088 CE1 TYR A 137 -30.091 21.561 -63.498 1.00 93.12 C \nANISOU 1088 CE1 TYR A 137 10125 11666 13590 -1526 566 -1032 C \nATOM 1089 CE2 TYR A 137 -30.444 22.240 -65.769 1.00 94.89 C \nANISOU 1089 CE2 TYR A 137 10259 12016 13778 -1562 609 -1084 C \nATOM 1090 CZ TYR A 137 -30.408 22.536 -64.422 1.00 93.61 C \nANISOU 1090 CZ TYR A 137 10084 11855 13628 -1564 574 -1075 C \nATOM 1091 OH TYR A 137 -30.689 23.803 -64.000 1.00 95.91 O \nANISOU 1091 OH TYR A 137 10255 12281 13903 -1601 548 -1109 O \nATOM 1092 N GLN A 138 -32.153 18.213 -65.089 1.00105.69 N \nANISOU 1092 N GLN A 138 12148 12990 15020 -1681 713 -951 N \nATOM 1093 CA GLN A 138 -33.491 18.522 -64.693 1.00100.73 C \nANISOU 1093 CA GLN A 138 11569 12398 14305 -1830 734 -959 C \nATOM 1094 C GLN A 138 -34.350 17.724 -65.664 1.00 97.92 C \nANISOU 1094 C GLN A 138 11342 11987 13877 -1900 788 -945 C \nATOM 1095 O GLN A 138 -35.244 18.268 -66.332 1.00 87.06 O \nANISOU 1095 O GLN A 138 9952 10692 12437 -2013 813 -970 O \nATOM 1096 CB GLN A 138 -33.697 20.025 -64.805 1.00 97.01 C \nANISOU 1096 CB GLN A 138 10940 12094 13827 -1886 712 -1008 C \nATOM 1097 CG GLN A 138 -34.839 20.541 -63.979 1.00 97.74 C \nANISOU 1097 CG GLN A 138 11049 12244 13845 -2029 715 -1018 C \nATOM 1098 CD GLN A 138 -34.529 20.680 -62.502 1.00 88.57 C \nANISOU 1098 CD GLN A 138 9874 11064 12715 -2001 676 -1006 C \nATOM 1099 OE1 GLN A 138 -33.596 21.377 -62.108 1.00 85.11 O \nANISOU 1099 OE1 GLN A 138 9311 10680 12347 -1909 631 -1019 O \nATOM 1100 NE2 GLN A 138 -35.354 20.069 -61.674 1.00 90.71 N \nANISOU 1100 NE2 GLN A 138 10276 11262 12928 -2088 694 -981 N \nATOM 1101 N GLY A 139 -34.069 16.417 -65.728 1.00 92.23 N \nANISOU 1101 N GLY A 139 10747 11131 13164 -1830 806 -904 N \nATOM 1102 CA GLY A 139 -34.684 15.516 -66.696 1.00 95.76 C \nANISOU 1102 CA GLY A 139 11324 11509 13552 -1862 855 -884 C \nATOM 1103 C GLY A 139 -33.921 15.520 -68.012 1.00104.82 C \nANISOU 1103 C GLY A 139 12398 12687 14742 -1780 860 -893 C \nATOM 1104 O GLY A 139 -33.615 14.467 -68.582 1.00114.48 O \nANISOU 1104 O GLY A 139 13705 13823 15968 -1710 881 -862 O \nATOM 1105 N THR A 140 -33.621 16.721 -68.496 1.00105.65 N \nANISOU 1105 N THR A 140 12344 12922 14876 -1788 840 -937 N \nATOM 1106 CA THR A 140 -32.885 16.911 -69.734 1.00111.10 C \nANISOU 1106 CA THR A 140 12949 13658 15607 -1716 841 -954 C \nATOM 1107 C THR A 140 -31.543 16.184 -69.666 1.00108.80 C \nANISOU 1107 C THR A 140 12652 13289 15397 -1561 820 -929 C \nATOM 1108 O THR A 140 -30.953 16.072 -68.592 1.00111.94 O \nANISOU 1108 O THR A 140 13042 13649 15841 -1501 788 -915 O \nATOM 1109 CB THR A 140 -32.596 18.407 -69.994 1.00113.46 C \nANISOU 1109 CB THR A 140 13064 14110 15936 -1725 814 -1008 C \nATOM 1110 OG1 THR A 140 -31.746 18.910 -68.957 1.00124.97 O \nANISOU 1110 OG1 THR A 140 14436 15583 17463 -1648 764 -1014 O \nATOM 1111 CG2 THR A 140 -33.878 19.236 -70.034 1.00115.31 C \nANISOU 1111 CG2 THR A 140 13280 14447 16086 -1883 831 -1037 C \nATOM 1112 N PRO A 141 -31.058 15.690 -70.815 1.00105.42 N \nANISOU 1112 N PRO A 141 12228 12844 14983 -1500 838 -922 N \nATOM 1113 CA PRO A 141 -29.718 15.137 -70.838 1.00108.41 C \nANISOU 1113 CA PRO A 141 12582 13173 15438 -1360 816 -904 C \nATOM 1114 C PRO A 141 -28.663 16.221 -70.632 1.00109.79 C \nANISOU 1114 C PRO A 141 12597 13428 15691 -1294 768 -940 C \nATOM 1115 O PRO A 141 -28.624 17.195 -71.377 1.00119.55 O \nANISOU 1115 O PRO A 141 13726 14764 16933 -1312 765 -982 O \nATOM 1116 CB PRO A 141 -29.602 14.540 -72.246 1.00104.30 C \nANISOU 1116 CB PRO A 141 12090 12639 14900 -1334 848 -896 C \nATOM 1117 CG PRO A 141 -30.582 15.284 -73.070 1.00100.54 C \nANISOU 1117 CG PRO A 141 11587 12247 14365 -1447 874 -929 C \nATOM 1118 CD PRO A 141 -31.713 15.601 -72.134 1.00106.28 C \nANISOU 1118 CD PRO A 141 12367 12980 15036 -1562 879 -931 C \nATOM 1119 N SER A 142 -27.840 16.063 -69.602 1.00110.56 N \nANISOU 1119 N SER A 142 12682 13482 15843 -1218 732 -923 N \nATOM 1120 CA SER A 142 -26.761 17.015 -69.314 1.00 98.64 C \nANISOU 1120 CA SER A 142 11040 12032 14409 -1145 684 -952 C \nATOM 1121 C SER A 142 -25.451 16.248 -69.086 1.00 85.82 C \nANISOU 1121 C SER A 142 9429 10332 12846 -1026 661 -923 C \nATOM 1122 O SER A 142 -25.286 15.113 -69.556 1.00 80.42 O \nANISOU 1122 O SER A 142 8827 9580 12149 -992 686 -891 O \nATOM 1123 CB SER A 142 -27.151 17.911 -68.136 1.00 99.38 C \nANISOU 1123 CB SER A 142 11086 12174 14501 -1194 654 -968 C \nATOM 1124 OG SER A 142 -27.219 17.121 -66.969 1.00105.97 O \nANISOU 1124 OG SER A 142 12014 12918 15333 -1188 648 -929 O \nATOM 1125 N PHE A 143 -24.535 16.873 -68.360 1.00 77.68 N \nANISOU 1125 N PHE A 143 8319 9319 11877 -965 614 -935 N \nATOM 1126 CA PHE A 143 -23.179 16.378 -68.186 1.00 69.93 C \nANISOU 1126 CA PHE A 143 7330 8286 10955 -858 587 -916 C \nATOM 1127 C PHE A 143 -22.443 17.246 -67.184 1.00 61.66 C \nANISOU 1127 C PHE A 143 6205 7261 9963 -816 533 -931 C \nATOM 1128 O PHE A 143 -22.874 18.319 -66.879 1.00 59.83 O \nANISOU 1128 O PHE A 143 5906 7100 9727 -855 518 -962 O \nATOM 1129 CB PHE A 143 -22.449 16.408 -69.508 1.00 63.84 C \nANISOU 1129 CB PHE A 143 6510 7539 10206 -806 595 -934 C \nATOM 1130 CG PHE A 143 -21.116 15.741 -69.470 1.00 61.83 C \nANISOU 1130 CG PHE A 143 6263 7231 10000 -710 574 -911 C \nATOM 1131 CD1 PHE A 143 -21.018 14.346 -69.499 1.00 61.68 C \nANISOU 1131 CD1 PHE A 143 6339 7136 9959 -686 597 -864 C \nATOM 1132 CD2 PHE A 143 -19.953 16.489 -69.424 1.00 60.18 C \nANISOU 1132 CD2 PHE A 143 5967 7047 9852 -643 532 -935 C \nATOM 1133 CE1 PHE A 143 -19.772 13.717 -69.502 1.00 51.67 C \nANISOU 1133 CE1 PHE A 143 5071 5832 8729 -603 578 -843 C \nATOM 1134 CE2 PHE A 143 -18.715 15.864 -69.416 1.00 52.19 C \nANISOU 1134 CE2 PHE A 143 4965 5987 8877 -566 514 -914 C \nATOM 1135 CZ PHE A 143 -18.626 14.487 -69.445 1.00 48.32 C \nANISOU 1135 CZ PHE A 143 4562 5434 8364 -550 536 -868 C \nATOM 1136 N PHE A 144 -21.349 16.750 -66.653 1.00 55.82 N \nANISOU 1136 N PHE A 144 5478 6463 9268 -738 505 -906 N \nATOM 1137 CA PHE A 144 -20.536 17.505 -65.705 1.00 57.88 C \nANISOU 1137 CA PHE A 144 5675 6735 9581 -691 451 -916 C \nATOM 1138 C PHE A 144 -20.353 18.943 -66.176 1.00 57.64 C \nANISOU 1138 C PHE A 144 5529 6798 9574 -680 430 -968 C \nATOM 1139 O PHE A 144 -20.210 19.206 -67.373 1.00 58.92 O \nANISOU 1139 O PHE A 144 5652 7001 9737 -668 447 -995 O \nATOM 1140 CB PHE A 144 -19.142 16.860 -65.544 1.00 58.15 C \nANISOU 1140 CB PHE A 144 5724 6708 9663 -602 426 -891 C \nATOM 1141 CG PHE A 144 -19.166 15.430 -65.044 1.00 49.70 C \nANISOU 1141 CG PHE A 144 4757 5556 8571 -596 444 -840 C \nATOM 1142 CD1 PHE A 144 -18.780 14.360 -65.879 1.00 44.33 C \nANISOU 1142 CD1 PHE A 144 4123 4841 7879 -562 471 -817 C \nATOM 1143 CD2 PHE A 144 -19.594 15.173 -63.774 1.00 44.60 C \nANISOU 1143 CD2 PHE A 144 4159 4875 7912 -623 433 -816 C \nATOM 1144 CE1 PHE A 144 -18.825 13.050 -65.409 1.00 52.12 C \nANISOU 1144 CE1 PHE A 144 5201 5762 8839 -549 487 -771 C \nATOM 1145 CE2 PHE A 144 -19.625 13.887 -63.278 1.00 48.27 C \nANISOU 1145 CE2 PHE A 144 4718 5269 8354 -612 449 -771 C \nATOM 1146 CZ PHE A 144 -19.250 12.816 -64.083 1.00 54.92 C \nANISOU 1146 CZ PHE A 144 5605 6080 9183 -572 476 -748 C \nATOM 1147 N ARG A 145 -20.362 19.866 -65.228 1.00 53.10 N \nANISOU 1147 N ARG A 145 4901 6260 9016 -681 393 -983 N \nATOM 1148 CA ARG A 145 -20.253 21.287 -65.539 1.00 53.25 C \nANISOU 1148 CA ARG A 145 4807 6376 9050 -664 370 -1032 C \nATOM 1149 C ARG A 145 -18.838 21.802 -65.570 1.00 49.47 C \nANISOU 1149 C ARG A 145 4275 5887 8633 -560 326 -1046 C \nATOM 1150 O ARG A 145 -18.587 22.834 -66.183 1.00 53.55 O \nANISOU 1150 O ARG A 145 4708 6476 9164 -527 314 -1090 O \nATOM 1151 CB ARG A 145 -21.058 22.083 -64.524 1.00 57.78 C \nANISOU 1151 CB ARG A 145 5345 7008 9600 -719 352 -1041 C \nATOM 1152 CG ARG A 145 -22.548 21.751 -64.567 1.00 68.12 C \nANISOU 1152 CG ARG A 145 6705 8340 10839 -837 396 -1035 C \nATOM 1153 CD ARG A 145 -23.375 22.782 -63.836 1.00 79.87 C \nANISOU 1153 CD ARG A 145 8131 9919 12296 -900 381 -1057 C \nATOM 1154 NE ARG A 145 -24.766 22.363 -63.695 1.00 92.62 N \nANISOU 1154 NE ARG A 145 9813 11540 13838 -1021 421 -1045 N \nATOM 1155 CZ ARG A 145 -25.710 22.481 -64.632 1.00 98.78 C \nANISOU 1155 CZ ARG A 145 10592 12378 14563 -1102 462 -1065 C \nATOM 1156 NH1 ARG A 145 -25.437 22.996 -65.839 1.00101.66 N \nANISOU 1156 NH1 ARG A 145 10884 12806 14936 -1072 472 -1100 N \nATOM 1157 NH2 ARG A 145 -26.945 22.075 -64.361 1.00 93.39 N \nANISOU 1157 NH2 ARG A 145 9984 11688 13810 -1217 495 -1052 N \nATOM 1158 N ASN A 146 -17.915 21.097 -64.895 1.00 44.55 N \nANISOU 1158 N ASN A 146 3705 5177 8045 -510 302 -1011 N \nATOM 1159 CA ASN A 146 -16.564 21.615 -64.697 1.00 42.09 C \nANISOU 1159 CA ASN A 146 3356 4847 7789 -420 254 -1021 C \nATOM 1160 C ASN A 146 -15.573 21.074 -65.719 1.00 42.18 C \nANISOU 1160 C ASN A 146 3386 4819 7822 -368 263 -1021 C \nATOM 1161 O ASN A 146 -14.346 21.251 -65.617 1.00 35.93 O \nANISOU 1161 O ASN A 146 2586 3993 7071 -299 228 -1023 O \nATOM 1162 CB ASN A 146 -16.061 21.285 -63.332 1.00 43.14 C \nANISOU 1162 CB ASN A 146 3530 4917 7944 -401 217 -985 C \nATOM 1163 CG ASN A 146 -16.595 22.168 -62.285 1.00 42.23 C \nANISOU 1163 CG ASN A 146 3374 4848 7823 -422 189 -993 C \nATOM 1164 OD1 ASN A 146 -16.880 23.317 -62.549 1.00 50.07 O \nANISOU 1164 OD1 ASN A 146 4286 5924 8813 -417 179 -1033 O \nATOM 1165 ND2 ASN A 146 -16.814 21.602 -61.072 1.00 47.67 N \nANISOU 1165 ND2 ASN A 146 4118 5489 8505 -451 178 -955 N \nATOM 1166 N VAL A 147 -16.119 20.401 -66.716 1.00 42.98 N \nANISOU 1166 N VAL A 147 3514 4925 7890 -407 312 -1018 N \nATOM 1167 CA VAL A 147 -15.351 19.567 -67.592 1.00 42.38 C \nANISOU 1167 CA VAL A 147 3472 4807 7823 -374 328 -1006 C \nATOM 1168 C VAL A 147 -16.107 19.410 -68.906 1.00 46.55 C \nANISOU 1168 C VAL A 147 3994 5380 8314 -415 378 -1024 C \nATOM 1169 O VAL A 147 -17.317 19.250 -68.929 1.00 60.91 O \nANISOU 1169 O VAL A 147 5833 7222 10088 -484 411 -1019 O \nATOM 1170 CB VAL A 147 -15.127 18.230 -66.849 1.00 44.27 C \nANISOU 1170 CB VAL A 147 3799 4965 8056 -376 331 -950 C \nATOM 1171 CG1 VAL A 147 -15.780 17.044 -67.536 1.00 42.60 C \nANISOU 1171 CG1 VAL A 147 3653 4734 7800 -414 383 -924 C \nATOM 1172 CG2 VAL A 147 -13.635 18.001 -66.613 1.00 44.14 C \nANISOU 1172 CG2 VAL A 147 3791 4899 8081 -309 294 -937 C \nATOM 1173 N VAL A 148 -15.382 19.518 -70.008 1.00 50.00 N \nANISOU 1173 N VAL A 148 4403 5830 8766 -374 384 -1047 N \nATOM 1174 CA VAL A 148 -15.964 19.523 -71.327 1.00 46.31 C \nANISOU 1174 CA VAL A 148 3917 5411 8267 -406 427 -1069 C \nATOM 1175 C VAL A 148 -15.719 18.216 -72.089 1.00 45.32 C \nANISOU 1175 C VAL A 148 3856 5240 8123 -405 460 -1037 C \nATOM 1176 O VAL A 148 -14.578 17.792 -72.255 1.00 41.59 O \nANISOU 1176 O VAL A 148 3395 4728 7677 -352 444 -1026 O \nATOM 1177 CB VAL A 148 -15.394 20.676 -72.156 1.00 41.66 C \nANISOU 1177 CB VAL A 148 3242 4884 7702 -361 413 -1125 C \nATOM 1178 CG1 VAL A 148 -16.206 20.831 -73.422 1.00 43.15 C \nANISOU 1178 CG1 VAL A 148 3403 5140 7852 -407 458 -1152 C \nATOM 1179 CG2 VAL A 148 -15.401 21.934 -71.327 1.00 43.40 C \nANISOU 1179 CG2 VAL A 148 3399 5147 7944 -339 373 -1154 C \nATOM 1180 N TRP A 149 -16.784 17.667 -72.640 1.00 42.57 N \nANISOU 1180 N TRP A 149 3545 4905 7726 -465 506 -1025 N \nATOM 1181 CA TRP A 149 -16.709 16.479 -73.486 1.00 42.92 C \nANISOU 1181 CA TRP A 149 3647 4918 7744 -464 541 -996 C \nATOM 1182 C TRP A 149 -16.682 16.852 -74.925 1.00 48.44 C \nANISOU 1182 C TRP A 149 4299 5672 8433 -467 565 -1032 C \nATOM 1183 O TRP A 149 -17.730 17.046 -75.553 1.00 57.95 O \nANISOU 1183 O TRP A 149 5499 6921 9597 -525 599 -1046 O \nATOM 1184 CB TRP A 149 -17.943 15.608 -73.246 1.00 40.77 C \nANISOU 1184 CB TRP A 149 3457 4618 7416 -526 579 -960 C \nATOM 1185 CG TRP A 149 -17.959 14.334 -73.975 1.00 42.16 C \nANISOU 1185 CG TRP A 149 3701 4760 7558 -518 614 -924 C \nATOM 1186 CD1 TRP A 149 -17.107 13.945 -74.928 1.00 43.79 C \nANISOU 1186 CD1 TRP A 149 3893 4971 7774 -475 620 -924 C \nATOM 1187 CD2 TRP A 149 -18.927 13.274 -73.842 1.00 43.35 C \nANISOU 1187 CD2 TRP A 149 3949 4868 7653 -556 651 -882 C \nATOM 1188 NE1 TRP A 149 -17.458 12.698 -75.391 1.00 44.14 N \nANISOU 1188 NE1 TRP A 149 4013 4986 7773 -479 656 -884 N \nATOM 1189 CE2 TRP A 149 -18.579 12.277 -74.738 1.00 44.23 C \nANISOU 1189 CE2 TRP A 149 4097 4965 7744 -524 676 -858 C \nATOM 1190 CE3 TRP A 149 -20.054 13.087 -73.048 1.00 47.20 C \nANISOU 1190 CE3 TRP A 149 4502 5330 8103 -612 664 -864 C \nATOM 1191 CZ2 TRP A 149 -19.275 11.081 -74.830 1.00 48.25 C \nANISOU 1191 CZ2 TRP A 149 4705 5430 8197 -535 712 -814 C \nATOM 1192 CZ3 TRP A 149 -20.766 11.921 -73.168 1.00 47.45 C \nANISOU 1192 CZ3 TRP A 149 4637 5312 8079 -629 701 -823 C \nATOM 1193 CH2 TRP A 149 -20.375 10.935 -74.043 1.00 49.34 C \nANISOU 1193 CH2 TRP A 149 4911 5535 8300 -586 724 -798 C \nATOM 1194 N LEU A 150 -15.481 17.014 -75.468 1.00 47.86 N \nANISOU 1194 N LEU A 150 4190 5599 8394 -408 547 -1049 N \nATOM 1195 CA LEU A 150 -15.318 17.573 -76.826 1.00 44.09 C \nANISOU 1195 CA LEU A 150 3656 5181 7915 -403 564 -1092 C \nATOM 1196 C LEU A 150 -15.678 16.531 -77.835 1.00 48.92 C \nANISOU 1196 C LEU A 150 4316 5789 8484 -429 609 -1067 C \nATOM 1197 O LEU A 150 -15.455 15.343 -77.602 1.00 67.14 O \nANISOU 1197 O LEU A 150 6690 8041 10779 -417 617 -1019 O \nATOM 1198 CB LEU A 150 -13.909 18.089 -77.025 1.00 46.03 C \nANISOU 1198 CB LEU A 150 3859 5421 8208 -333 529 -1119 C \nATOM 1199 CG LEU A 150 -13.477 19.223 -76.106 1.00 50.59 C \nANISOU 1199 CG LEU A 150 4390 6005 8827 -296 482 -1147 C \nATOM 1200 CD1 LEU A 150 -12.008 19.545 -76.331 1.00 57.50 C \nANISOU 1200 CD1 LEU A 150 5249 6856 9743 -227 449 -1167 C \nATOM 1201 CD2 LEU A 150 -14.305 20.472 -76.352 1.00 58.25 C \nANISOU 1201 CD2 LEU A 150 5287 7059 9787 -319 487 -1196 C \nATOM 1202 N ILE A 151 -16.240 16.959 -78.956 1.00 49.54 N \nANISOU 1202 N ILE A 151 4358 5929 8536 -462 639 -1099 N \nATOM 1203 CA ILE A 151 -16.493 16.091 -80.096 1.00 52.16 C \nANISOU 1203 CA ILE A 151 4726 6265 8828 -482 681 -1082 C \nATOM 1204 C ILE A 151 -16.149 16.811 -81.386 1.00 51.48 C \nANISOU 1204 C ILE A 151 4569 6244 8746 -474 691 -1132 C \nATOM 1205 O ILE A 151 -15.844 17.984 -81.369 1.00 49.78 O \nANISOU 1205 O ILE A 151 4281 6073 8561 -454 668 -1181 O \nATOM 1206 CB ILE A 151 -17.920 15.528 -80.152 1.00 58.08 C \nANISOU 1206 CB ILE A 151 5540 7011 9518 -554 721 -1054 C \nATOM 1207 CG1 ILE A 151 -18.962 16.621 -80.380 1.00 68.44 C \nANISOU 1207 CG1 ILE A 151 6801 8396 10807 -620 733 -1097 C \nATOM 1208 CG2 ILE A 151 -18.220 14.756 -78.890 1.00 56.04 C \nANISOU 1208 CG2 ILE A 151 5359 6682 9252 -557 713 -1005 C \nATOM 1209 CD1 ILE A 151 -20.241 16.125 -81.030 1.00 76.96 C \nANISOU 1209 CD1 ILE A 151 7937 9487 11817 -699 781 -1081 C \nATOM 1210 N LYS A 152 -16.158 16.062 -82.487 1.00 55.38 N \nANISOU 1210 N LYS A 152 5088 6744 9208 -483 724 -1118 N \nATOM 1211 CA LYS A 152 -15.751 16.587 -83.776 1.00 56.67 C \nANISOU 1211 CA LYS A 152 5192 6966 9373 -474 736 -1162 C \nATOM 1212 C LYS A 152 -16.678 17.643 -84.333 1.00 69.78 C \nANISOU 1212 C LYS A 152 6793 8708 11012 -524 754 -1210 C \nATOM 1213 O LYS A 152 -17.907 17.572 -84.171 1.00 73.36 O \nANISOU 1213 O LYS A 152 7274 9176 11424 -591 778 -1197 O \nATOM 1214 CB LYS A 152 -15.630 15.437 -84.785 1.00 50.98 C \nANISOU 1214 CB LYS A 152 4517 6236 8618 -477 769 -1129 C \nATOM 1215 CG LYS A 152 -16.903 14.757 -85.149 1.00 49.04 C \nANISOU 1215 CG LYS A 152 4330 5991 8311 -538 812 -1098 C \nATOM 1216 CD LYS A 152 -16.637 13.608 -86.111 1.00 54.03 C \nANISOU 1216 CD LYS A 152 5005 6613 8909 -525 839 -1064 C \nATOM 1217 CE LYS A 152 -17.909 12.915 -86.592 1.00 53.46 C \nANISOU 1217 CE LYS A 152 5003 6539 8770 -582 883 -1032 C \nATOM 1218 NZ LYS A 152 -17.681 12.261 -87.919 1.00 58.12 N \nANISOU 1218 NZ LYS A 152 5601 7155 9328 -576 912 -1021 N \nATOM 1219 N LYS A 153 -16.076 18.611 -85.017 1.00 82.99 N \nANISOU 1219 N LYS A 153 8387 10436 12708 -494 744 -1266 N \nATOM 1220 CA LYS A 153 -16.808 19.641 -85.744 1.00 83.60 C \nANISOU 1220 CA LYS A 153 8394 10609 12762 -534 763 -1318 C \nATOM 1221 C LYS A 153 -16.623 19.367 -87.230 1.00 83.52 C \nANISOU 1221 C LYS A 153 8372 10633 12726 -542 795 -1332 C \nATOM 1222 O LYS A 153 -15.514 19.094 -87.674 1.00 79.91 O \nANISOU 1222 O LYS A 153 7916 10152 12295 -489 786 -1335 O \nATOM 1223 CB LYS A 153 -16.263 21.008 -85.382 1.00 87.87 C \nANISOU 1223 CB LYS A 153 8850 11192 13343 -483 727 -1374 C \nATOM 1224 CG LYS A 153 -17.236 22.138 -85.632 1.00 91.94 C \nANISOU 1224 CG LYS A 153 9291 11812 13830 -528 739 -1421 C \nATOM 1225 CD LYS A 153 -16.550 23.473 -85.368 1.00100.23 C \nANISOU 1225 CD LYS A 153 10255 12908 14920 -457 703 -1478 C \nATOM 1226 CE LYS A 153 -17.510 24.513 -84.818 1.00 98.34 C \nANISOU 1226 CE LYS A 153 9952 12755 14660 -492 697 -1507 C \nATOM 1227 NZ LYS A 153 -16.803 25.501 -83.956 1.00101.96 N \nANISOU 1227 NZ LYS A 153 10360 13218 15164 -410 649 -1535 N \nATOM 1228 N ASN A 154 -17.709 19.448 -87.995 1.00 87.02 N \nANISOU 1228 N ASN A 154 8808 11137 13117 -613 834 -1341 N \nATOM 1229 CA ASN A 154 -17.762 18.826 -89.315 1.00 82.84 C \nANISOU 1229 CA ASN A 154 8297 10626 12553 -636 870 -1334 C \nATOM 1230 C ASN A 154 -17.422 17.368 -89.104 1.00 80.70 C \nANISOU 1230 C ASN A 154 8119 10267 12276 -617 875 -1267 C \nATOM 1231 O ASN A 154 -17.810 16.801 -88.079 1.00 83.62 O \nANISOU 1231 O ASN A 154 8552 10578 12644 -626 867 -1224 O \nATOM 1232 CB ASN A 154 -16.811 19.505 -90.303 1.00 84.47 C \nANISOU 1232 CB ASN A 154 8430 10882 12782 -589 865 -1389 C \nATOM 1233 CG ASN A 154 -17.399 20.771 -90.884 1.00 88.00 C \nANISOU 1233 CG ASN A 154 8788 11437 13210 -620 877 -1453 C \nATOM 1234 OD1 ASN A 154 -17.612 20.889 -92.101 1.00 82.64 O \nANISOU 1234 OD1 ASN A 154 8080 10820 12500 -649 907 -1477 O \nATOM 1235 ND2 ASN A 154 -17.648 21.742 -90.015 1.00 87.90 N \nANISOU 1235 ND2 ASN A 154 8728 11455 13216 -612 852 -1480 N \nATOM 1236 N ASN A 155 -16.726 16.748 -90.044 1.00 72.98 N \nANISOU 1236 N ASN A 155 7151 9285 11294 -592 887 -1259 N \nATOM 1237 CA ASN A 155 -16.117 15.465 -89.757 1.00 79.64 C \nANISOU 1237 CA ASN A 155 8064 10056 12139 -555 882 -1201 C \nATOM 1238 C ASN A 155 -14.614 15.623 -89.506 1.00 73.88 C \nANISOU 1238 C ASN A 155 7305 9302 11464 -483 845 -1216 C \nATOM 1239 O ASN A 155 -13.767 15.219 -90.306 1.00 71.20 O \nANISOU 1239 O ASN A 155 6960 8969 11123 -458 850 -1217 O \nATOM 1240 CB ASN A 155 -16.435 14.494 -90.874 1.00 86.10 C \nANISOU 1240 CB ASN A 155 8925 10886 12905 -580 922 -1170 C \nATOM 1241 CG ASN A 155 -17.917 14.235 -90.979 1.00 89.12 C \nANISOU 1241 CG ASN A 155 9359 11274 13229 -652 956 -1148 C \nATOM 1242 OD1 ASN A 155 -18.704 14.760 -90.187 1.00 81.04 O \nANISOU 1242 OD1 ASN A 155 8339 10248 12204 -689 950 -1155 O \nATOM 1243 ND2 ASN A 155 -18.308 13.435 -91.958 1.00 97.75 N \nANISOU 1243 ND2 ASN A 155 10495 12375 14270 -676 991 -1120 N \nATOM 1244 N THR A 156 -14.304 16.285 -88.403 1.00 63.08 N \nANISOU 1244 N THR A 156 5919 7910 10140 -455 808 -1231 N \nATOM 1245 CA THR A 156 -12.932 16.629 -88.088 1.00 70.55 C \nANISOU 1245 CA THR A 156 6839 8830 11135 -393 770 -1251 C \nATOM 1246 C THR A 156 -12.686 16.881 -86.583 1.00 72.45 C \nANISOU 1246 C THR A 156 7094 9018 11415 -364 729 -1239 C \nATOM 1247 O THR A 156 -13.274 17.780 -85.985 1.00 67.73 O \nANISOU 1247 O THR A 156 6465 8441 10830 -375 718 -1263 O \nATOM 1248 CB THR A 156 -12.485 17.865 -88.859 1.00 70.27 C \nANISOU 1248 CB THR A 156 6727 8853 11119 -373 764 -1323 C \nATOM 1249 OG1 THR A 156 -12.876 17.720 -90.223 1.00 83.70 O \nANISOU 1249 OG1 THR A 156 8410 10611 12780 -408 804 -1337 O \nATOM 1250 CG2 THR A 156 -10.958 18.024 -88.778 1.00 75.58 C \nANISOU 1250 CG2 THR A 156 7395 9491 11833 -311 730 -1340 C \nATOM 1251 N TYR A 157 -11.798 16.076 -86.003 1.00 69.12 N \nANISOU 1251 N TYR A 157 6716 8535 11009 -331 708 -1200 N \nATOM 1252 CA TYR A 157 -11.298 16.302 -84.652 1.00 57.87 C \nANISOU 1252 CA TYR A 157 5304 7059 9625 -298 665 -1190 C \nATOM 1253 C TYR A 157 -9.788 16.618 -84.812 1.00 60.10 C \nANISOU 1253 C TYR A 157 5570 7323 9942 -248 634 -1215 C \nATOM 1254 O TYR A 157 -8.942 15.742 -84.740 1.00 56.32 O \nANISOU 1254 O TYR A 157 5128 6809 9461 -234 625 -1182 O \nATOM 1255 CB TYR A 157 -11.553 15.068 -83.781 1.00 51.99 C \nANISOU 1255 CB TYR A 157 4631 6260 8863 -306 667 -1122 C \nATOM 1256 CG TYR A 157 -11.304 15.277 -82.269 1.00 43.14 C \nANISOU 1256 CG TYR A 157 3526 5088 7777 -285 627 -1107 C \nATOM 1257 CD1 TYR A 157 -12.309 15.136 -81.371 1.00 40.66 C \nANISOU 1257 CD1 TYR A 157 3241 4756 7451 -313 631 -1082 C \nATOM 1258 CD2 TYR A 157 -10.042 15.591 -81.773 1.00 37.98 C \nANISOU 1258 CD2 TYR A 157 2863 4403 7164 -240 585 -1118 C \nATOM 1259 CE1 TYR A 157 -12.111 15.344 -80.025 1.00 39.26 C \nANISOU 1259 CE1 TYR A 157 3077 4538 7304 -296 595 -1069 C \nATOM 1260 CE2 TYR A 157 -9.814 15.756 -80.416 1.00 35.86 C \nANISOU 1260 CE2 TYR A 157 2612 4088 6924 -223 548 -1102 C \nATOM 1261 CZ TYR A 157 -10.844 15.652 -79.558 1.00 36.45 C \nANISOU 1261 CZ TYR A 157 2708 4152 6989 -249 553 -1079 C \nATOM 1262 OH TYR A 157 -10.652 15.830 -78.200 1.00 35.95 O \nANISOU 1262 OH TYR A 157 2660 4048 6953 -234 517 -1063 O \nATOM 1263 N PRO A 158 -9.462 17.883 -85.066 1.00 62.35 N \nANISOU 1263 N PRO A 158 5801 7636 10254 -222 617 -1275 N \nATOM 1264 CA PRO A 158 -8.060 18.216 -85.200 1.00 58.68 C \nANISOU 1264 CA PRO A 158 5333 7144 9817 -176 587 -1300 C \nATOM 1265 C PRO A 158 -7.329 17.988 -83.906 1.00 54.77 C \nANISOU 1265 C PRO A 158 4880 6579 9352 -150 545 -1270 C \nATOM 1266 O PRO A 158 -7.951 17.943 -82.838 1.00 57.90 O \nANISOU 1266 O PRO A 158 5289 6955 9755 -157 534 -1244 O \nATOM 1267 CB PRO A 158 -8.086 19.747 -85.556 1.00 63.23 C \nANISOU 1267 CB PRO A 158 5846 7765 10415 -146 577 -1373 C \nATOM 1268 CG PRO A 158 -9.404 20.258 -85.083 1.00 59.38 C \nANISOU 1268 CG PRO A 158 5325 7317 9918 -172 587 -1377 C \nATOM 1269 CD PRO A 158 -10.338 19.086 -85.190 1.00 65.97 C \nANISOU 1269 CD PRO A 158 6199 8153 10714 -232 623 -1323 C \nATOM 1270 N THR A 159 -6.007 17.925 -83.978 1.00 52.84 N \nANISOU 1270 N THR A 159 4656 6298 9122 -122 520 -1276 N \nATOM 1271 CA THR A 159 -5.233 17.589 -82.803 1.00 48.72 C \nANISOU 1271 CA THR A 159 4180 5712 8621 -105 480 -1243 C \nATOM 1272 C THR A 159 -5.121 18.755 -81.849 1.00 54.89 C \nANISOU 1272 C THR A 159 4946 6466 9442 -66 440 -1271 C \nATOM 1273 O THR A 159 -4.693 19.812 -82.237 1.00 67.55 O \nANISOU 1273 O THR A 159 6524 8080 11064 -29 426 -1325 O \nATOM 1274 CB THR A 159 -3.878 17.005 -83.182 1.00 39.32 C \nANISOU 1274 CB THR A 159 3023 4493 7422 -102 469 -1234 C \nATOM 1275 OG1 THR A 159 -4.130 15.745 -83.820 1.00 37.96 O \nANISOU 1275 OG1 THR A 159 2864 4350 7208 -138 505 -1193 O \nATOM 1276 CG2 THR A 159 -3.050 16.739 -81.967 1.00 36.71 C \nANISOU 1276 CG2 THR A 159 2739 4100 7111 -90 426 -1203 C \nATOM 1277 N ILE A 160 -5.549 18.530 -80.600 1.00 59.82 N \nANISOU 1277 N ILE A 160 5592 7062 10077 -71 422 -1234 N \nATOM 1278 CA ILE A 160 -5.580 19.536 -79.568 1.00 51.68 C \nANISOU 1278 CA ILE A 160 4547 6010 9079 -37 384 -1252 C \nATOM 1279 C ILE A 160 -4.233 19.650 -78.923 1.00 60.84 C \nANISOU 1279 C ILE A 160 5750 7103 10264 -3 338 -1248 C \nATOM 1280 O ILE A 160 -3.610 18.638 -78.600 1.00 68.12 O \nANISOU 1280 O ILE A 160 6720 7986 11176 -23 331 -1205 O \nATOM 1281 CB ILE A 160 -6.606 19.175 -78.501 1.00 46.27 C \nANISOU 1281 CB ILE A 160 3870 5320 8389 -65 386 -1212 C \nATOM 1282 CG1 ILE A 160 -8.036 19.316 -79.095 1.00 43.67 C \nANISOU 1282 CG1 ILE A 160 3501 5059 8033 -104 429 -1224 C \nATOM 1283 CG2 ILE A 160 -6.515 20.102 -77.280 1.00 47.93 C \nANISOU 1283 CG2 ILE A 160 4072 5505 8633 -31 341 -1223 C \nATOM 1284 CD1 ILE A 160 -9.132 18.676 -78.241 1.00 42.86 C \nANISOU 1284 CD1 ILE A 160 3423 4949 7912 -146 442 -1179 C \nATOM 1285 N LYS A 161 -3.796 20.892 -78.718 1.00 59.70 N \nANISOU 1285 N LYS A 161 5589 6948 10148 49 305 -1294 N \nATOM 1286 CA LYS A 161 -2.518 21.182 -78.109 1.00 64.07 C \nANISOU 1286 CA LYS A 161 6190 7431 10723 85 258 -1295 C \nATOM 1287 C LYS A 161 -2.702 22.476 -77.342 1.00 60.12 C \nANISOU 1287 C LYS A 161 5664 6928 10252 139 223 -1326 C \nATOM 1288 O LYS A 161 -2.753 23.551 -77.903 1.00 76.59 O \nANISOU 1288 O LYS A 161 7710 9046 12344 184 222 -1380 O \nATOM 1289 CB LYS A 161 -1.433 21.296 -79.175 1.00 72.61 C \nANISOU 1289 CB LYS A 161 7291 8499 11796 98 260 -1329 C \nATOM 1290 CG LYS A 161 -0.238 20.393 -78.929 1.00 78.94 C \nANISOU 1290 CG LYS A 161 8164 9242 12589 73 241 -1293 C \nATOM 1291 CD LYS A 161 0.694 20.407 -80.132 1.00 81.26 C \nANISOU 1291 CD LYS A 161 8476 9536 12866 72 252 -1326 C \nATOM 1292 CE LYS A 161 1.905 19.506 -79.891 1.00 88.49 C \nANISOU 1292 CE LYS A 161 9459 10401 13763 36 233 -1290 C \nATOM 1293 NZ LYS A 161 2.821 20.073 -78.859 1.00 91.04 N \nANISOU 1293 NZ LYS A 161 9838 10645 14107 65 179 -1290 N \nATOM 1294 N ARG A 162 -2.856 22.338 -76.043 1.00 58.57 N \nANISOU 1294 N ARG A 162 5488 6698 10069 136 196 -1289 N \nATOM 1295 CA ARG A 162 -3.149 23.438 -75.142 1.00 56.09 C \nANISOU 1295 CA ARG A 162 5147 6386 9777 183 162 -1307 C \nATOM 1296 C ARG A 162 -2.281 23.251 -73.915 1.00 52.39 C \nANISOU 1296 C ARG A 162 4742 5836 9327 195 113 -1272 C \nATOM 1297 O ARG A 162 -2.068 22.109 -73.473 1.00 55.95 O \nANISOU 1297 O ARG A 162 5238 6254 9768 148 116 -1221 O \nATOM 1298 CB ARG A 162 -4.653 23.431 -74.708 1.00 53.98 C \nANISOU 1298 CB ARG A 162 4828 6180 9501 148 184 -1293 C \nATOM 1299 CG ARG A 162 -5.632 23.436 -75.860 1.00 58.85 C \nANISOU 1299 CG ARG A 162 5390 6878 10092 117 235 -1319 C \nATOM 1300 CD ARG A 162 -5.762 24.827 -76.500 1.00 64.55 C \nANISOU 1300 CD ARG A 162 6046 7661 10818 171 233 -1386 C \nATOM 1301 NE ARG A 162 -6.375 25.719 -75.527 1.00 67.61 N \nANISOU 1301 NE ARG A 162 6393 8080 11216 195 207 -1394 N \nATOM 1302 CZ ARG A 162 -7.631 26.112 -75.537 1.00 62.70 C \nANISOU 1302 CZ ARG A 162 5707 7542 10575 166 229 -1406 C \nATOM 1303 NH1 ARG A 162 -8.443 25.735 -76.504 1.00 62.02 N \nANISOU 1303 NH1 ARG A 162 5592 7513 10458 111 278 -1413 N \nATOM 1304 NH2 ARG A 162 -8.048 26.905 -74.573 1.00 63.82 N \nANISOU 1304 NH2 ARG A 162 5814 7710 10724 189 201 -1411 N \nATOM 1305 N SER A 163 -1.895 24.361 -73.300 1.00 46.57 N \nANISOU 1305 N SER A 163 4006 5076 8612 258 70 -1297 N \nATOM 1306 CA SER A 163 -1.118 24.284 -72.082 1.00 50.94 C \nANISOU 1306 CA SER A 163 4620 5554 9182 270 22 -1264 C \nATOM 1307 C SER A 163 -1.385 25.453 -71.178 1.00 46.18 C \nANISOU 1307 C SER A 163 3991 4956 8598 329 -16 -1281 C \nATOM 1308 O SER A 163 -1.785 26.491 -71.634 1.00 58.49 O \nANISOU 1308 O SER A 163 5494 6568 10160 380 -13 -1329 O \nATOM 1309 CB SER A 163 0.391 24.174 -72.410 1.00 59.30 C \nANISOU 1309 CB SER A 163 5754 6537 10239 285 -2 -1271 C \nATOM 1310 OG SER A 163 1.012 25.445 -72.453 1.00 64.41 O \nANISOU 1310 OG SER A 163 6414 7157 10901 365 -36 -1317 O \nATOM 1311 N TYR A 164 -1.170 25.259 -69.886 1.00 42.60 N \nANISOU 1311 N TYR A 164 3576 4455 8157 323 -52 -1241 N \nATOM 1312 CA TYR A 164 -1.524 26.222 -68.856 1.00 44.65 C \nANISOU 1312 CA TYR A 164 3809 4724 8432 371 -89 -1246 C \nATOM 1313 C TYR A 164 -0.403 26.381 -67.884 1.00 51.85 C \nANISOU 1313 C TYR A 164 4797 5546 9358 401 -145 -1224 C \nATOM 1314 O TYR A 164 0.052 25.396 -67.288 1.00 54.46 O \nANISOU 1314 O TYR A 164 5184 5823 9684 349 -153 -1176 O \nATOM 1315 CB TYR A 164 -2.778 25.802 -68.098 1.00 41.38 C \nANISOU 1315 CB TYR A 164 3353 4359 8012 318 -72 -1212 C \nATOM 1316 CG TYR A 164 -3.134 26.754 -66.966 1.00 44.08 C \nANISOU 1316 CG TYR A 164 3666 4715 8365 360 -112 -1214 C \nATOM 1317 CD1 TYR A 164 -3.724 27.991 -67.239 1.00 43.32 C \nANISOU 1317 CD1 TYR A 164 3495 4696 8269 415 -114 -1262 C \nATOM 1318 CD2 TYR A 164 -2.846 26.433 -65.614 1.00 38.07 C \nANISOU 1318 CD2 TYR A 164 2952 3899 7614 346 -149 -1168 C \nATOM 1319 CE1 TYR A 164 -4.044 28.874 -66.210 1.00 43.91 C \nANISOU 1319 CE1 TYR A 164 3538 4795 8350 456 -151 -1262 C \nATOM 1320 CE2 TYR A 164 -3.139 27.305 -64.621 1.00 40.67 C \nANISOU 1320 CE2 TYR A 164 3254 4244 7952 385 -186 -1169 C \nATOM 1321 CZ TYR A 164 -3.735 28.547 -64.926 1.00 45.72 C \nANISOU 1321 CZ TYR A 164 3816 4965 8590 443 -188 -1217 C \nATOM 1322 OH TYR A 164 -4.055 29.479 -63.923 1.00 54.81 O \nANISOU 1322 OH TYR A 164 4932 6146 9746 487 -226 -1218 O \nATOM 1323 N ASN A 165 0.038 27.622 -67.726 1.00 58.16 N \nANISOU 1323 N ASN A 165 5599 6331 10170 487 -183 -1260 N \nATOM 1324 CA ASN A 165 1.087 27.935 -66.799 1.00 68.71 C \nANISOU 1324 CA ASN A 165 7012 7579 11517 525 -239 -1243 C \nATOM 1325 C ASN A 165 0.426 28.520 -65.556 1.00 64.12 C \nANISOU 1325 C ASN A 165 6394 7024 10946 550 -270 -1227 C \nATOM 1326 O ASN A 165 -0.069 29.623 -65.584 1.00 71.22 O \nANISOU 1326 O ASN A 165 7233 7980 11848 617 -279 -1263 O \nATOM 1327 CB ASN A 165 2.089 28.906 -67.456 1.00 77.89 C \nANISOU 1327 CB ASN A 165 8216 8697 12680 610 -263 -1292 C \nATOM 1328 CG ASN A 165 3.368 29.083 -66.661 1.00 84.11 C \nANISOU 1328 CG ASN A 165 9110 9375 13472 638 -319 -1273 C \nATOM 1329 OD1 ASN A 165 3.407 28.759 -65.475 1.00 88.32 O \nANISOU 1329 OD1 ASN A 165 9670 9875 14011 611 -348 -1227 O \nATOM 1330 ND2 ASN A 165 4.415 29.617 -67.311 1.00 91.58 N \nANISOU 1330 ND2 ASN A 165 10123 10261 14413 691 -335 -1309 N \nATOM 1331 N ASN A 166 0.421 27.754 -64.471 1.00 55.69 N \nANISOU 1331 N ASN A 166 5360 5921 9880 495 -285 -1172 N \nATOM 1332 CA ASN A 166 -0.038 28.253 -63.194 1.00 57.53 C \nANISOU 1332 CA ASN A 166 5572 6165 10122 515 -319 -1152 C \nATOM 1333 C ASN A 166 0.721 29.559 -62.826 1.00 64.29 C \nANISOU 1333 C ASN A 166 6457 6983 10988 620 -375 -1178 C \nATOM 1334 O ASN A 166 1.852 29.545 -62.363 1.00 60.67 O \nANISOU 1334 O ASN A 166 6088 6431 10533 637 -416 -1161 O \nATOM 1335 CB ASN A 166 0.132 27.187 -62.114 1.00 54.10 C \nANISOU 1335 CB ASN A 166 5189 5681 9685 443 -332 -1089 C \nATOM 1336 CG ASN A 166 -0.490 27.566 -60.769 1.00 51.96 C \nANISOU 1336 CG ASN A 166 4891 5430 9420 448 -362 -1065 C \nATOM 1337 OD1 ASN A 166 -1.092 28.615 -60.626 1.00 60.18 O \nANISOU 1337 OD1 ASN A 166 5870 6530 10465 503 -373 -1093 O \nATOM 1338 ND2 ASN A 166 -0.245 26.747 -59.752 1.00 46.96 N \nANISOU 1338 ND2 ASN A 166 4307 4750 8786 395 -378 -1013 N \nATOM 1339 N THR A 167 0.051 30.687 -63.024 1.00 67.26 N \nANISOU 1339 N THR A 167 6754 7437 11364 689 -376 -1219 N \nATOM 1340 CA THR A 167 0.616 31.984 -62.698 1.00 64.52 C \nANISOU 1340 CA THR A 167 6423 7070 11022 802 -426 -1246 C \nATOM 1341 C THR A 167 0.430 32.367 -61.226 1.00 70.27 C \nANISOU 1341 C THR A 167 7150 7794 11756 821 -472 -1213 C \nATOM 1342 O THR A 167 0.792 33.474 -60.843 1.00 76.53 O \nANISOU 1342 O THR A 167 7949 8579 12550 921 -516 -1231 O \nATOM 1343 CB THR A 167 -0.004 33.072 -63.566 1.00 57.89 C \nANISOU 1343 CB THR A 167 5492 6330 10175 877 -407 -1308 C \nATOM 1344 OG1 THR A 167 -1.421 33.146 -63.361 1.00 61.48 O \nANISOU 1344 OG1 THR A 167 5838 6903 10620 838 -380 -1307 O \nATOM 1345 CG2 THR A 167 0.234 32.811 -65.007 1.00 56.47 C \nANISOU 1345 CG2 THR A 167 5315 6153 9988 867 -365 -1344 C \nATOM 1346 N ASN A 168 -0.127 31.465 -60.415 1.00 67.87 N \nANISOU 1346 N ASN A 168 6840 7497 11453 730 -463 -1164 N \nATOM 1347 CA ASN A 168 -0.490 31.785 -59.029 1.00 66.08 C \nANISOU 1347 CA ASN A 168 6598 7282 11228 737 -501 -1132 C \nATOM 1348 C ASN A 168 0.521 31.242 -58.065 1.00 67.43 C \nANISOU 1348 C ASN A 168 6874 7341 11406 714 -543 -1084 C \nATOM 1349 O ASN A 168 1.455 30.583 -58.495 1.00 74.47 O \nANISOU 1349 O ASN A 168 7846 8153 12298 686 -540 -1075 O \nATOM 1350 CB ASN A 168 -1.853 31.202 -58.708 1.00 68.60 C \nANISOU 1350 CB ASN A 168 6841 7686 11538 650 -464 -1112 C \nATOM 1351 CG ASN A 168 -2.922 31.640 -59.695 1.00 74.53 C \nANISOU 1351 CG ASN A 168 7490 8553 12276 653 -418 -1158 C \nATOM 1352 OD1 ASN A 168 -3.420 32.764 -59.624 1.00 99.43 O \nANISOU 1352 OD1 ASN A 168 10570 11788 15421 717 -432 -1189 O \nATOM 1353 ND2 ASN A 168 -3.301 30.748 -60.606 1.00 65.83 N \nANISOU 1353 ND2 ASN A 168 6380 7465 11167 582 -363 -1160 N \nATOM 1354 N GLN A 169 0.347 31.540 -56.783 1.00 71.45 N \nANISOU 1354 N GLN A 169 7382 7850 11917 723 -583 -1053 N \nATOM 1355 CA GLN A 169 1.290 31.110 -55.740 1.00 80.00 C \nANISOU 1355 CA GLN A 169 8563 8831 13003 702 -627 -1006 C \nATOM 1356 C GLN A 169 0.736 29.949 -54.957 1.00 77.17 C \nANISOU 1356 C GLN A 169 8199 8481 12641 594 -609 -956 C \nATOM 1357 O GLN A 169 1.298 29.556 -53.928 1.00 76.03 O \nANISOU 1357 O GLN A 169 8119 8272 12496 566 -644 -912 O \nATOM 1358 CB GLN A 169 1.654 32.258 -54.768 1.00 84.06 C \nANISOU 1358 CB GLN A 169 9095 9324 13519 793 -692 -1002 C \nATOM 1359 CG GLN A 169 2.724 33.208 -55.267 1.00 87.69 C \nANISOU 1359 CG GLN A 169 9619 9721 13979 902 -727 -1036 C \nATOM 1360 CD GLN A 169 2.164 34.251 -56.197 1.00 90.56 C \nANISOU 1360 CD GLN A 169 9897 10173 14339 991 -708 -1096 C \nATOM 1361 OE1 GLN A 169 1.532 35.217 -55.752 1.00 91.86 O \nANISOU 1361 OE1 GLN A 169 9989 10416 14499 1059 -728 -1110 O \nATOM 1362 NE2 GLN A 169 2.406 34.077 -57.494 1.00 85.41 N \nANISOU 1362 NE2 GLN A 169 9251 9516 13686 992 -671 -1133 N \nATOM 1363 N GLU A 170 -0.359 29.392 -55.454 1.00 73.73 N \nANISOU 1363 N GLU A 170 7692 8122 12199 534 -554 -962 N \nATOM 1364 CA GLU A 170 -0.964 28.242 -54.810 1.00 71.37 C \nANISOU 1364 CA GLU A 170 7392 7832 11892 436 -530 -918 C \nATOM 1365 C GLU A 170 -0.983 27.053 -55.724 1.00 65.72 C \nANISOU 1365 C GLU A 170 6691 7109 11169 368 -477 -914 C \nATOM 1366 O GLU A 170 -1.198 27.170 -56.922 1.00 73.81 O \nANISOU 1366 O GLU A 170 7683 8169 12191 381 -441 -951 O \nATOM 1367 CB GLU A 170 -2.394 28.553 -54.374 1.00 76.45 C \nANISOU 1367 CB GLU A 170 7946 8575 12528 416 -512 -922 C \nATOM 1368 CG GLU A 170 -2.530 29.790 -53.486 1.00 79.79 C \nANISOU 1368 CG GLU A 170 8334 9028 12953 484 -562 -928 C \nATOM 1369 CD GLU A 170 -2.793 31.040 -54.275 1.00 80.74 C \nANISOU 1369 CD GLU A 170 8386 9219 13072 571 -562 -983 C \nATOM 1370 OE1 GLU A 170 -2.455 31.053 -55.470 1.00 85.57 O \nANISOU 1370 OE1 GLU A 170 9003 9824 13687 594 -537 -1016 O \nATOM 1371 OE2 GLU A 170 -3.327 32.008 -53.699 1.00 90.42 O \nANISOU 1371 OE2 GLU A 170 9551 10514 14292 616 -588 -993 O \nATOM 1372 N ASP A 171 -0.765 25.889 -55.140 1.00 58.88 N \nANISOU 1372 N ASP A 171 5875 6203 10295 297 -472 -868 N \nATOM 1373 CA ASP A 171 -1.007 24.642 -55.835 1.00 55.83 C \nANISOU 1373 CA ASP A 171 5493 5827 9894 229 -419 -856 C \nATOM 1374 C ASP A 171 -2.406 24.679 -56.368 1.00 55.95 C \nANISOU 1374 C ASP A 171 5429 5929 9902 209 -369 -877 C \nATOM 1375 O ASP A 171 -3.322 25.103 -55.661 1.00 51.57 O \nANISOU 1375 O ASP A 171 4828 5421 9345 204 -374 -875 O \nATOM 1376 CB ASP A 171 -0.866 23.459 -54.871 1.00 55.63 C \nANISOU 1376 CB ASP A 171 5513 5768 9856 160 -421 -801 C \nATOM 1377 CG ASP A 171 0.536 23.366 -54.250 1.00 62.06 C \nANISOU 1377 CG ASP A 171 6410 6499 10671 165 -471 -775 C \nATOM 1378 OD1 ASP A 171 1.500 23.921 -54.821 1.00 78.24 O \nANISOU 1378 OD1 ASP A 171 8496 8505 12726 209 -493 -798 O \nATOM 1379 OD2 ASP A 171 0.684 22.731 -53.198 1.00 62.22 O \nANISOU 1379 OD2 ASP A 171 6463 6496 10681 122 -488 -732 O \nATOM 1380 N LEU A 172 -2.618 24.249 -57.609 1.00 59.69 N \nANISOU 1380 N LEU A 172 5885 6427 10367 193 -322 -899 N \nATOM 1381 CA LEU A 172 -4.003 24.078 -58.051 1.00 57.72 C \nANISOU 1381 CA LEU A 172 5573 6255 10104 157 -272 -911 C \nATOM 1382 C LEU A 172 -4.355 22.677 -58.570 1.00 54.67 C \nANISOU 1382 C LEU A 172 5207 5869 9696 90 -219 -887 C \nATOM 1383 O LEU A 172 -3.547 21.987 -59.178 1.00 48.71 O \nANISOU 1383 O LEU A 172 4493 5078 8938 83 -209 -880 O \nATOM 1384 CB LEU A 172 -4.443 25.180 -58.998 1.00 59.51 C \nANISOU 1384 CB LEU A 172 5732 6546 10334 205 -260 -966 C \nATOM 1385 CG LEU A 172 -3.761 25.448 -60.306 1.00 62.51 C \nANISOU 1385 CG LEU A 172 6114 6917 10720 246 -248 -1004 C \nATOM 1386 CD1 LEU A 172 -4.442 24.730 -61.435 1.00 69.36 C \nANISOU 1386 CD1 LEU A 172 6957 7828 11569 198 -187 -1014 C \nATOM 1387 CD2 LEU A 172 -3.824 26.941 -60.588 1.00 66.19 C \nANISOU 1387 CD2 LEU A 172 6526 7430 11196 326 -271 -1053 C \nATOM 1388 N LEU A 173 -5.591 22.270 -58.276 1.00 50.63 N \nANISOU 1388 N LEU A 173 4670 5402 9167 40 -186 -875 N \nATOM 1389 CA LEU A 173 -6.033 20.927 -58.547 1.00 45.02 C \nANISOU 1389 CA LEU A 173 3987 4688 8431 -17 -140 -846 C \nATOM 1390 C LEU A 173 -6.771 20.922 -59.847 1.00 45.13 C \nANISOU 1390 C LEU A 173 3963 4754 8431 -28 -89 -877 C \nATOM 1391 O LEU A 173 -7.809 21.539 -59.944 1.00 34.78 O \nANISOU 1391 O LEU A 173 2602 3500 7112 -39 -74 -900 O \nATOM 1392 CB LEU A 173 -6.908 20.429 -57.405 1.00 43.40 C \nANISOU 1392 CB LEU A 173 3794 4488 8209 -65 -134 -812 C \nATOM 1393 CG LEU A 173 -7.851 19.248 -57.701 1.00 43.76 C \nANISOU 1393 CG LEU A 173 3859 4548 8221 -122 -77 -792 C \nATOM 1394 CD1 LEU A 173 -7.038 17.927 -57.847 1.00 40.19 C \nANISOU 1394 CD1 LEU A 173 3464 4052 7756 -130 -66 -756 C \nATOM 1395 CD2 LEU A 173 -8.886 19.149 -56.617 1.00 39.27 C \nANISOU 1395 CD2 LEU A 173 3293 3992 7635 -164 -74 -772 C \nATOM 1396 N ILE A 174 -6.219 20.167 -60.841 1.00 46.52 N \nANISOU 1396 N ILE A 174 4163 4914 8599 -31 -63 -876 N \nATOM 1397 CA ILE A 174 -6.823 20.052 -62.184 1.00 36.24 C \nANISOU 1397 CA ILE A 174 2831 3657 7281 -43 -13 -903 C \nATOM 1398 C ILE A 174 -7.324 18.615 -62.386 1.00 39.09 C \nANISOU 1398 C ILE A 174 3229 4014 7610 -93 33 -866 C \nATOM 1399 O ILE A 174 -6.758 17.687 -61.894 1.00 45.82 O \nANISOU 1399 O ILE A 174 4129 4827 8454 -103 26 -828 O \nATOM 1400 CB ILE A 174 -5.822 20.392 -63.272 1.00 33.26 C \nANISOU 1400 CB ILE A 174 2449 3270 6916 -2 -19 -933 C \nATOM 1401 CG1 ILE A 174 -5.026 21.688 -62.882 1.00 32.31 C \nANISOU 1401 CG1 ILE A 174 2317 3132 6828 60 -74 -961 C \nATOM 1402 CG2 ILE A 174 -6.489 20.547 -64.613 1.00 30.96 C \nANISOU 1402 CG2 ILE A 174 2116 3036 6612 -9 27 -968 C \nATOM 1403 CD1 ILE A 174 -4.004 22.077 -63.929 1.00 31.16 C \nANISOU 1403 CD1 ILE A 174 2179 2969 6692 103 -80 -994 C \nATOM 1404 N LEU A 175 -8.445 18.459 -63.077 1.00 44.03 N \nANISOU 1404 N LEU A 175 3833 4684 8211 -123 79 -878 N \nATOM 1405 CA LEU A 175 -9.059 17.183 -63.316 1.00 42.29 C \nANISOU 1405 CA LEU A 175 3653 4461 7956 -163 125 -846 C \nATOM 1406 C LEU A 175 -9.480 17.066 -64.781 1.00 45.93 C \nANISOU 1406 C LEU A 175 4093 4961 8399 -172 171 -870 C \nATOM 1407 O LEU A 175 -9.985 18.019 -65.368 1.00 53.78 O \nANISOU 1407 O LEU A 175 5036 6001 9397 -171 178 -911 O \nATOM 1408 CB LEU A 175 -10.282 17.004 -62.460 1.00 44.51 C \nANISOU 1408 CB LEU A 175 3947 4750 8214 -207 139 -828 C \nATOM 1409 CG LEU A 175 -10.048 17.041 -60.949 1.00 51.03 C \nANISOU 1409 CG LEU A 175 4794 5541 9052 -207 99 -801 C \nATOM 1410 CD1 LEU A 175 -10.359 18.398 -60.364 1.00 49.90 C \nANISOU 1410 CD1 LEU A 175 4601 5429 8931 -200 66 -830 C \nATOM 1411 CD2 LEU A 175 -10.906 16.001 -60.244 1.00 49.41 C \nANISOU 1411 CD2 LEU A 175 4642 5320 8812 -250 126 -763 C \nATOM 1412 N TRP A 176 -9.251 15.889 -65.361 1.00 43.47 N \nANISOU 1412 N TRP A 176 3819 4636 8063 -179 201 -844 N \nATOM 1413 CA TRP A 176 -9.602 15.611 -66.752 1.00 35.11 C \nANISOU 1413 CA TRP A 176 2749 3611 6982 -188 245 -860 C \nATOM 1414 C TRP A 176 -9.985 14.176 -66.853 1.00 33.09 C \nANISOU 1414 C TRP A 176 2546 3341 6684 -208 283 -817 C \nATOM 1415 O TRP A 176 -9.905 13.420 -65.874 1.00 31.26 O \nANISOU 1415 O TRP A 176 2358 3077 6442 -211 274 -778 O \nATOM 1416 CB TRP A 176 -8.430 15.929 -67.693 1.00 33.33 C \nANISOU 1416 CB TRP A 176 2500 3388 6775 -152 232 -886 C \nATOM 1417 CG TRP A 176 -7.214 15.094 -67.470 1.00 33.58 C \nANISOU 1417 CG TRP A 176 2570 3383 6807 -137 214 -855 C \nATOM 1418 CD1 TRP A 176 -6.875 13.969 -68.119 1.00 31.68 C \nANISOU 1418 CD1 TRP A 176 2354 3146 6537 -142 240 -830 C \nATOM 1419 CD2 TRP A 176 -6.214 15.319 -66.504 1.00 34.36 C \nANISOU 1419 CD2 TRP A 176 2685 3441 6931 -118 164 -844 C \nATOM 1420 NE1 TRP A 176 -5.738 13.477 -67.622 1.00 32.22 N \nANISOU 1420 NE1 TRP A 176 2449 3186 6608 -132 212 -806 N \nATOM 1421 CE2 TRP A 176 -5.301 14.277 -66.614 1.00 32.15 C \nANISOU 1421 CE2 TRP A 176 2439 3145 6631 -120 164 -813 C \nATOM 1422 CE3 TRP A 176 -6.012 16.313 -65.522 1.00 38.50 C \nANISOU 1422 CE3 TRP A 176 3199 3944 7487 -101 118 -856 C \nATOM 1423 CZ2 TRP A 176 -4.180 14.184 -65.834 1.00 35.57 C \nANISOU 1423 CZ2 TRP A 176 2900 3541 7076 -113 122 -795 C \nATOM 1424 CZ3 TRP A 176 -4.877 16.202 -64.687 1.00 39.40 C \nANISOU 1424 CZ3 TRP A 176 3345 4011 7614 -88 74 -835 C \nATOM 1425 CH2 TRP A 176 -3.973 15.159 -64.873 1.00 40.41 C \nANISOU 1425 CH2 TRP A 176 3509 4123 7721 -98 77 -806 C \nATOM 1426 N GLY A 177 -10.397 13.773 -68.028 1.00 29.88 N \nANISOU 1426 N GLY A 177 2139 2961 6251 -218 325 -823 N \nATOM 1427 CA GLY A 177 -10.995 12.467 -68.197 1.00 33.12 C \nANISOU 1427 CA GLY A 177 2605 3365 6616 -233 366 -784 C \nATOM 1428 C GLY A 177 -10.799 11.895 -69.589 1.00 34.66 C \nANISOU 1428 C GLY A 177 2797 3585 6787 -225 400 -786 C \nATOM 1429 O GLY A 177 -10.334 12.590 -70.461 1.00 32.05 O \nANISOU 1429 O GLY A 177 2421 3282 6476 -216 396 -822 O \nATOM 1430 N ILE A 178 -11.225 10.628 -69.760 1.00 35.06 N \nANISOU 1430 N ILE A 178 2900 3629 6791 -227 436 -746 N \nATOM 1431 CA ILE A 178 -11.104 9.930 -71.019 1.00 35.84 C \nANISOU 1431 CA ILE A 178 3003 3754 6859 -217 470 -740 C \nATOM 1432 C ILE A 178 -12.400 9.149 -71.248 1.00 41.55 C \nANISOU 1432 C ILE A 178 3783 4474 7531 -237 517 -715 C \nATOM 1433 O ILE A 178 -13.002 8.665 -70.273 1.00 39.85 O \nANISOU 1433 O ILE A 178 3620 4225 7296 -243 521 -686 O \nATOM 1434 CB ILE A 178 -9.899 8.955 -71.053 1.00 37.25 C \nANISOU 1434 CB ILE A 178 3191 3935 7027 -183 459 -709 C \nATOM 1435 CG1 ILE A 178 -9.821 8.252 -72.390 1.00 38.42 C \nANISOU 1435 CG1 ILE A 178 3339 4119 7139 -174 495 -702 C \nATOM 1436 CG2 ILE A 178 -10.044 7.852 -70.043 1.00 37.21 C \nANISOU 1436 CG2 ILE A 178 3241 3904 6992 -170 462 -659 C \nATOM 1437 CD1 ILE A 178 -8.591 7.404 -72.581 1.00 40.10 C \nANISOU 1437 CD1 ILE A 178 3548 4351 7337 -147 485 -678 C \nATOM 1438 N HIS A 179 -12.856 9.089 -72.517 1.00 38.98 N \nANISOU 1438 N HIS A 179 3452 4178 7180 -249 553 -728 N \nATOM 1439 CA HIS A 179 -14.074 8.383 -72.822 1.00 37.50 C \nANISOU 1439 CA HIS A 179 3328 3982 6939 -269 598 -705 C \nATOM 1440 C HIS A 179 -13.763 7.128 -73.548 1.00 32.82 C \nANISOU 1440 C HIS A 179 2766 3399 6304 -233 625 -670 C \nATOM 1441 O HIS A 179 -13.366 7.168 -74.700 1.00 30.12 O \nANISOU 1441 O HIS A 179 2390 3094 5958 -226 636 -685 O \nATOM 1442 CB HIS A 179 -15.083 9.231 -73.671 1.00 37.13 C \nANISOU 1442 CB HIS A 179 3262 3963 6884 -319 624 -743 C \nATOM 1443 CG HIS A 179 -16.268 8.437 -74.166 1.00 32.78 C \nANISOU 1443 CG HIS A 179 2785 3399 6269 -343 672 -718 C \nATOM 1444 ND1 HIS A 179 -16.602 8.344 -75.501 1.00 38.18 N \nANISOU 1444 ND1 HIS A 179 3466 4116 6925 -356 706 -728 N \nATOM 1445 CD2 HIS A 179 -17.166 7.693 -73.503 1.00 30.68 C \nANISOU 1445 CD2 HIS A 179 2607 3089 5961 -353 692 -683 C \nATOM 1446 CE1 HIS A 179 -17.655 7.552 -75.634 1.00 33.37 C \nANISOU 1446 CE1 HIS A 179 2943 3480 6258 -373 744 -697 C \nATOM 1447 NE2 HIS A 179 -18.030 7.174 -74.431 1.00 37.02 N \nANISOU 1447 NE2 HIS A 179 3463 3893 6710 -372 737 -671 N \nATOM 1448 N HIS A 180 -14.066 6.014 -72.908 1.00 31.51 N \nANISOU 1448 N HIS A 180 2669 3203 6099 -209 638 -624 N \nATOM 1449 CA HIS A 180 -13.964 4.728 -73.551 1.00 29.63 C \nANISOU 1449 CA HIS A 180 2470 2980 5809 -168 667 -585 C \nATOM 1450 C HIS A 180 -15.269 4.509 -74.290 1.00 30.64 C \nANISOU 1450 C HIS A 180 2656 3098 5889 -193 713 -581 C \nATOM 1451 O HIS A 180 -16.292 4.246 -73.652 1.00 32.81 O \nANISOU 1451 O HIS A 180 3004 3328 6135 -209 730 -564 O \nATOM 1452 CB HIS A 180 -13.700 3.628 -72.506 1.00 30.56 C \nANISOU 1452 CB HIS A 180 2636 3075 5901 -124 661 -538 C \nATOM 1453 CG HIS A 180 -12.486 3.846 -71.648 1.00 27.12 C \nANISOU 1453 CG HIS A 180 2153 2645 5507 -110 615 -539 C \nATOM 1454 ND1 HIS A 180 -11.217 3.864 -72.155 1.00 27.17 N \nANISOU 1454 ND1 HIS A 180 2099 2693 5530 -94 594 -547 N \nATOM 1455 CD2 HIS A 180 -12.349 4.092 -70.339 1.00 27.36 C \nANISOU 1455 CD2 HIS A 180 2189 2644 5562 -116 584 -535 C \nATOM 1456 CE1 HIS A 180 -10.325 4.085 -71.204 1.00 25.89 C \nANISOU 1456 CE1 HIS A 180 1913 2524 5401 -91 553 -546 C \nATOM 1457 NE2 HIS A 180 -10.979 4.197 -70.074 1.00 29.56 N \nANISOU 1457 NE2 HIS A 180 2416 2946 5872 -101 546 -538 N \nATOM 1458 N SER A 181 -15.229 4.583 -75.614 1.00 30.78 N \nANISOU 1458 N SER A 181 2646 3154 5894 -198 734 -595 N \nATOM 1459 CA SER A 181 -16.330 4.248 -76.459 1.00 38.45 C \nANISOU 1459 CA SER A 181 3675 4121 6814 -218 778 -587 C \nATOM 1460 C SER A 181 -16.581 2.774 -76.581 1.00 42.55 C \nANISOU 1460 C SER A 181 4274 4625 7266 -165 807 -532 C \nATOM 1461 O SER A 181 -15.786 1.955 -76.078 1.00 53.02 O \nANISOU 1461 O SER A 181 5600 5959 8587 -107 793 -501 O \nATOM 1462 CB SER A 181 -16.088 4.850 -77.866 1.00 45.61 C \nANISOU 1462 CB SER A 181 4517 5081 7730 -240 788 -622 C \nATOM 1463 OG SER A 181 -14.705 4.702 -78.285 1.00 41.07 O \nANISOU 1463 OG SER A 181 3876 4549 7179 -200 767 -625 O \nATOM 1464 N ASN A 182 -17.654 2.402 -77.285 1.00 47.04 N \nANISOU 1464 N ASN A 182 4913 5179 7781 -180 848 -520 N \nATOM 1465 CA ASN A 182 -18.150 0.975 -77.312 1.00 53.62 C \nANISOU 1465 CA ASN A 182 5848 5985 8541 -123 880 -465 C \nATOM 1466 C ASN A 182 -17.730 0.158 -78.521 1.00 55.86 C \nANISOU 1466 C ASN A 182 6122 6317 8784 -75 901 -442 C \nATOM 1467 O ASN A 182 -17.448 -1.035 -78.394 1.00 62.84 O \nANISOU 1467 O ASN A 182 7044 7208 9624 -1 909 -397 O \nATOM 1468 CB ASN A 182 -19.640 0.933 -77.201 1.00 55.20 C \nANISOU 1468 CB ASN A 182 6155 6125 8695 -166 912 -458 C \nATOM 1469 CG ASN A 182 -20.098 1.313 -75.838 1.00 63.34 C \nANISOU 1469 CG ASN A 182 7219 7102 9743 -197 895 -463 C \nATOM 1470 OD1 ASN A 182 -19.489 0.891 -74.822 1.00 64.88 O \nANISOU 1470 OD1 ASN A 182 7410 7287 9954 -150 872 -445 O \nATOM 1471 ND2 ASN A 182 -21.186 2.067 -75.772 1.00 62.11 N \nANISOU 1471 ND2 ASN A 182 7100 6917 9581 -278 908 -488 N \nATOM 1472 N ASP A 183 -17.573 0.827 -79.649 1.00 56.74 N \nANISOU 1472 N ASP A 183 6172 6472 8912 -112 905 -474 N \nATOM 1473 CA ASP A 183 -17.196 0.173 -80.889 1.00 54.82 C \nANISOU 1473 CA ASP A 183 5915 6282 8633 -76 925 -457 C \nATOM 1474 C ASP A 183 -16.616 1.158 -81.892 1.00 56.47 C \nANISOU 1474 C ASP A 183 6024 6546 8884 -120 916 -505 C \nATOM 1475 O ASP A 183 -16.701 2.391 -81.712 1.00 51.94 O \nANISOU 1475 O ASP A 183 5403 5969 8363 -179 899 -553 O \nATOM 1476 CB ASP A 183 -18.427 -0.522 -81.522 1.00 59.41 C \nANISOU 1476 CB ASP A 183 6604 6832 9139 -72 970 -427 C \nATOM 1477 CG ASP A 183 -19.693 0.371 -81.549 1.00 59.81 C \nANISOU 1477 CG ASP A 183 6700 6835 9188 -160 986 -456 C \nATOM 1478 OD1 ASP A 183 -20.648 0.098 -80.824 1.00 64.21 O \nANISOU 1478 OD1 ASP A 183 7357 7327 9714 -171 999 -437 O \nATOM 1479 OD2 ASP A 183 -19.758 1.297 -82.321 1.00 64.51 O \nANISOU 1479 OD2 ASP A 183 7238 7465 9809 -220 987 -496 O \nATOM 1480 N ALA A 184 -16.069 0.612 -82.985 1.00 53.83 N \nANISOU 1480 N ALA A 184 5661 6269 8522 -89 928 -493 N \nATOM 1481 CA ALA A 184 -15.409 1.437 -83.992 1.00 54.24 C \nANISOU 1481 CA ALA A 184 5621 6377 8609 -123 921 -537 C \nATOM 1482 C ALA A 184 -16.365 2.504 -84.542 1.00 59.65 C \nANISOU 1482 C ALA A 184 6305 7052 9305 -198 937 -579 C \nATOM 1483 O ALA A 184 -15.963 3.623 -84.814 1.00 66.33 O \nANISOU 1483 O ALA A 184 7074 7927 10203 -238 919 -630 O \nATOM 1484 CB ALA A 184 -14.845 0.591 -85.118 1.00 45.80 C \nANISOU 1484 CB ALA A 184 4534 5371 7497 -83 937 -513 C \nATOM 1485 N ALA A 185 -17.628 2.136 -84.704 1.00 62.86 N \nANISOU 1485 N ALA A 185 6803 7422 9659 -216 970 -557 N \nATOM 1486 CA ALA A 185 -18.638 3.040 -85.275 1.00 62.59 C \nANISOU 1486 CA ALA A 185 6776 7385 9620 -296 989 -592 C \nATOM 1487 C ALA A 185 -18.842 4.278 -84.394 1.00 60.44 C \nANISOU 1487 C ALA A 185 6465 7095 9404 -350 964 -636 C \nATOM 1488 O ALA A 185 -18.744 5.419 -84.887 1.00 64.47 O \nANISOU 1488 O ALA A 185 6899 7648 9950 -399 957 -689 O \nATOM 1489 CB ALA A 185 -19.955 2.294 -85.499 1.00 63.16 C \nANISOU 1489 CB ALA A 185 6972 7411 9617 -307 1029 -553 C \nATOM 1490 N GLU A 186 -19.127 4.056 -83.109 1.00 54.32 N \nANISOU 1490 N GLU A 186 5741 6264 8633 -340 952 -617 N \nATOM 1491 CA GLU A 186 -19.272 5.158 -82.145 1.00 55.67 C \nANISOU 1491 CA GLU A 186 5875 6421 8855 -385 925 -654 C \nATOM 1492 C GLU A 186 -18.054 5.996 -82.118 1.00 56.18 C \nANISOU 1492 C GLU A 186 5827 6529 8989 -371 888 -694 C \nATOM 1493 O GLU A 186 -18.124 7.222 -82.044 1.00 62.03 O \nANISOU 1493 O GLU A 186 6506 7293 9770 -416 872 -742 O \nATOM 1494 CB GLU A 186 -19.539 4.679 -80.732 1.00 55.90 C \nANISOU 1494 CB GLU A 186 5972 6387 8880 -365 914 -623 C \nATOM 1495 CG GLU A 186 -19.872 5.789 -79.743 1.00 62.12 C \nANISOU 1495 CG GLU A 186 6732 7161 9711 -419 889 -658 C \nATOM 1496 CD GLU A 186 -19.971 5.324 -78.285 1.00 67.56 C \nANISOU 1496 CD GLU A 186 7478 7791 10401 -396 874 -629 C \nATOM 1497 OE1 GLU A 186 -19.725 4.125 -77.999 1.00 76.17 O \nANISOU 1497 OE1 GLU A 186 8628 8852 11462 -332 880 -582 O \nATOM 1498 OE2 GLU A 186 -20.334 6.173 -77.430 1.00 63.52 O \nANISOU 1498 OE2 GLU A 186 6951 7267 9917 -442 855 -653 O \nATOM 1499 N GLN A 187 -16.911 5.339 -82.193 1.00 59.45 N \nANISOU 1499 N GLN A 187 6216 6960 9414 -309 873 -674 N \nATOM 1500 CA GLN A 187 -15.655 6.082 -82.123 1.00 50.88 C \nANISOU 1500 CA GLN A 187 5035 5906 8391 -295 836 -710 C \nATOM 1501 C GLN A 187 -15.608 7.085 -83.249 1.00 49.53 C \nANISOU 1501 C GLN A 187 4795 5788 8237 -333 842 -762 C \nATOM 1502 O GLN A 187 -15.435 8.282 -83.005 1.00 62.90 O \nANISOU 1502 O GLN A 187 6428 7493 9978 -357 819 -809 O \nATOM 1503 CB GLN A 187 -14.456 5.147 -82.157 1.00 43.64 C \nANISOU 1503 CB GLN A 187 4105 5006 7469 -233 823 -679 C \nATOM 1504 CG GLN A 187 -13.102 5.889 -82.221 1.00 37.98 C \nANISOU 1504 CG GLN A 187 3301 4320 6809 -226 786 -716 C \nATOM 1505 CD GLN A 187 -12.768 6.644 -80.929 1.00 38.17 C \nANISOU 1505 CD GLN A 187 3305 4309 6887 -230 746 -735 C \nATOM 1506 OE1 GLN A 187 -13.280 6.349 -79.865 1.00 34.37 O \nANISOU 1506 OE1 GLN A 187 2873 3785 6401 -226 741 -709 O \nATOM 1507 NE2 GLN A 187 -11.854 7.599 -81.026 1.00 42.58 N \nANISOU 1507 NE2 GLN A 187 3797 4886 7497 -233 715 -778 N \nATOM 1508 N THR A 188 -15.791 6.605 -84.480 1.00 45.70 N \nANISOU 1508 N THR A 188 4320 5336 7710 -335 874 -753 N \nATOM 1509 CA THR A 188 -15.769 7.460 -85.681 1.00 44.14 C \nANISOU 1509 CA THR A 188 4058 5193 7520 -371 885 -801 C \nATOM 1510 C THR A 188 -16.806 8.560 -85.654 1.00 49.01 C \nANISOU 1510 C THR A 188 4662 5817 8143 -436 893 -841 C \nATOM 1511 O THR A 188 -16.533 9.677 -86.065 1.00 54.16 O \nANISOU 1511 O THR A 188 5237 6512 8829 -457 882 -895 O \nATOM 1512 CB THR A 188 -15.919 6.640 -86.979 1.00 48.63 C \nANISOU 1512 CB THR A 188 4650 5794 8033 -365 921 -778 C \nATOM 1513 OG1 THR A 188 -16.243 5.271 -86.699 1.00 52.50 O \nANISOU 1513 OG1 THR A 188 5226 6250 8471 -326 938 -714 O \nATOM 1514 CG2 THR A 188 -14.604 6.637 -87.770 1.00 52.58 C \nANISOU 1514 CG2 THR A 188 5080 6345 8553 -335 909 -795 C \nATOM 1515 N LYS A 189 -18.020 8.235 -85.206 1.00 62.38 N \nANISOU 1515 N LYS A 189 6434 7471 9795 -470 914 -815 N \nATOM 1516 CA LYS A 189 -19.126 9.223 -85.182 1.00 61.22 C \nANISOU 1516 CA LYS A 189 6281 7339 9641 -547 925 -849 C \nATOM 1517 C LYS A 189 -18.889 10.326 -84.186 1.00 62.87 C \nANISOU 1517 C LYS A 189 6430 7551 9906 -555 888 -887 C \nATOM 1518 O LYS A 189 -19.264 11.472 -84.429 1.00 59.86 O \nANISOU 1518 O LYS A 189 5989 7217 9537 -602 887 -936 O \nATOM 1519 CB LYS A 189 -20.495 8.598 -84.943 1.00 67.89 C \nANISOU 1519 CB LYS A 189 7236 8138 10422 -590 957 -812 C \nATOM 1520 CG LYS A 189 -20.716 7.873 -83.637 1.00 74.70 C \nANISOU 1520 CG LYS A 189 8178 8926 11277 -565 947 -769 C \nATOM 1521 CD LYS A 189 -22.219 7.816 -83.284 1.00 91.91 C \nANISOU 1521 CD LYS A 189 10453 11067 13402 -636 974 -756 C \nATOM 1522 CE LYS A 189 -22.706 6.408 -82.864 1.00 97.36 C \nANISOU 1522 CE LYS A 189 11277 11681 14036 -601 995 -692 C \nATOM 1523 NZ LYS A 189 -24.182 6.305 -82.628 1.00 92.15 N \nANISOU 1523 NZ LYS A 189 10726 10974 13313 -674 1024 -678 N \nATOM 1524 N LEU A 190 -18.273 9.991 -83.052 1.00 56.26 N \nANISOU 1524 N LEU A 190 5607 6668 9100 -509 858 -865 N \nATOM 1525 CA LEU A 190 -17.996 11.006 -82.068 1.00 53.11 C \nANISOU 1525 CA LEU A 190 5155 6270 8754 -511 821 -897 C \nATOM 1526 C LEU A 190 -16.782 11.811 -82.412 1.00 58.08 C \nANISOU 1526 C LEU A 190 5690 6939 9438 -475 791 -940 C \nATOM 1527 O LEU A 190 -16.763 13.041 -82.223 1.00 60.61 O \nANISOU 1527 O LEU A 190 5943 7292 9792 -489 771 -988 O \nATOM 1528 CB LEU A 190 -17.787 10.387 -80.697 1.00 48.52 C \nANISOU 1528 CB LEU A 190 4625 5626 8185 -479 799 -857 C \nATOM 1529 CG LEU A 190 -19.091 9.943 -80.052 1.00 50.96 C \nANISOU 1529 CG LEU A 190 5025 5891 8447 -523 821 -827 C \nATOM 1530 CD1 LEU A 190 -18.837 9.268 -78.706 1.00 46.91 C \nANISOU 1530 CD1 LEU A 190 4564 5317 7944 -486 800 -788 C \nATOM 1531 CD2 LEU A 190 -20.025 11.135 -79.841 1.00 50.50 C \nANISOU 1531 CD2 LEU A 190 4935 5863 8388 -598 821 -868 C \nATOM 1532 N TYR A 191 -15.755 11.110 -82.885 1.00 61.65 N \nANISOU 1532 N TYR A 191 6140 7388 9896 -425 788 -922 N \nATOM 1533 CA TYR A 191 -14.407 11.690 -82.871 1.00 58.40 C \nANISOU 1533 CA TYR A 191 5662 6990 9537 -383 751 -953 C \nATOM 1534 C TYR A 191 -13.669 11.680 -84.128 1.00 65.60 C \nANISOU 1534 C TYR A 191 6534 7944 10447 -368 761 -973 C \nATOM 1535 O TYR A 191 -12.673 12.370 -84.217 1.00 67.03 O \nANISOU 1535 O TYR A 191 6662 8138 10670 -343 734 -1009 O \nATOM 1536 CB TYR A 191 -13.529 10.941 -81.921 1.00 51.05 C \nANISOU 1536 CB TYR A 191 4761 6013 8624 -337 724 -915 C \nATOM 1537 CG TYR A 191 -14.084 10.773 -80.562 1.00 45.39 C \nANISOU 1537 CG TYR A 191 4090 5247 7910 -343 711 -888 C \nATOM 1538 CD1 TYR A 191 -14.177 11.859 -79.708 1.00 45.35 C \nANISOU 1538 CD1 TYR A 191 4049 5237 7944 -354 681 -919 C \nATOM 1539 CD2 TYR A 191 -14.509 9.556 -80.115 1.00 45.94 C \nANISOU 1539 CD2 TYR A 191 4236 5279 7939 -334 728 -832 C \nATOM 1540 CE1 TYR A 191 -14.710 11.741 -78.427 1.00 42.81 C \nANISOU 1540 CE1 TYR A 191 3769 4874 7624 -365 669 -895 C \nATOM 1541 CE2 TYR A 191 -15.055 9.431 -78.847 1.00 47.08 C \nANISOU 1541 CE2 TYR A 191 4427 5378 8085 -342 718 -810 C \nATOM 1542 CZ TYR A 191 -15.141 10.528 -78.023 1.00 43.77 C \nANISOU 1542 CZ TYR A 191 3969 4955 7706 -361 688 -842 C \nATOM 1543 OH TYR A 191 -15.671 10.378 -76.777 1.00 44.52 O \nANISOU 1543 OH TYR A 191 4109 5007 7798 -372 678 -820 O \nATOM 1544 N GLN A 192 -14.118 10.879 -85.085 1.00 70.75 N \nANISOU 1544 N GLN A 192 7218 8614 11049 -382 799 -950 N \nATOM 1545 CA GLN A 192 -13.493 10.878 -86.376 1.00 67.20 C \nANISOU 1545 CA GLN A 192 6730 8212 10592 -375 812 -970 C \nATOM 1546 C GLN A 192 -12.329 9.898 -86.317 1.00 61.55 C \nANISOU 1546 C GLN A 192 6029 7483 9876 -328 798 -935 C \nATOM 1547 O GLN A 192 -12.440 8.815 -86.873 1.00 57.70 O \nANISOU 1547 O GLN A 192 5577 7004 9340 -319 824 -895 O \nATOM 1548 CB GLN A 192 -13.020 12.263 -86.767 1.00 79.78 C \nANISOU 1548 CB GLN A 192 8242 9843 12227 -378 794 -1039 C \nATOM 1549 CG GLN A 192 -13.434 12.758 -88.166 1.00 93.15 C \nANISOU 1549 CG GLN A 192 9896 11601 13898 -411 825 -1077 C \nATOM 1550 CD GLN A 192 -13.944 11.667 -89.124 1.00 87.75 C \nANISOU 1550 CD GLN A 192 9256 10931 13152 -430 866 -1038 C \nATOM 1551 OE1 GLN A 192 -15.132 11.388 -89.157 1.00 92.08 O \nANISOU 1551 OE1 GLN A 192 9850 11476 13661 -469 894 -1017 O \nATOM 1552 NE2 GLN A 192 -13.052 11.079 -89.918 1.00 76.39 N \nANISOU 1552 NE2 GLN A 192 7809 9512 11704 -404 871 -1029 N \nATOM 1553 N ASN A 193 -11.251 10.225 -85.594 1.00 56.75 N \nANISOU 1553 N ASN A 193 5396 6853 9312 -298 758 -947 N \nATOM 1554 CA ASN A 193 -10.051 9.408 -85.648 1.00 52.85 C \nANISOU 1554 CA ASN A 193 4908 6361 8814 -265 744 -921 C \nATOM 1555 C ASN A 193 -10.261 8.075 -84.915 1.00 48.01 C \nANISOU 1555 C ASN A 193 4357 5720 8165 -244 750 -854 C \nATOM 1556 O ASN A 193 -10.784 8.065 -83.820 1.00 49.53 O \nANISOU 1556 O ASN A 193 4582 5870 8367 -243 740 -836 O \nATOM 1557 CB ASN A 193 -8.863 10.194 -85.065 1.00 60.58 C \nANISOU 1557 CB ASN A 193 5851 7321 9846 -247 699 -954 C \nATOM 1558 CG ASN A 193 -8.990 11.720 -85.290 1.00 52.95 C \nANISOU 1558 CG ASN A 193 4833 6366 8920 -258 687 -1020 C \nATOM 1559 OD1 ASN A 193 -9.232 12.129 -86.371 1.00 47.35 O \nANISOU 1559 OD1 ASN A 193 4092 5698 8199 -274 710 -1053 O \nATOM 1560 ND2 ASN A 193 -8.866 12.528 -84.247 1.00 51.51 N \nANISOU 1560 ND2 ASN A 193 4641 6149 8781 -246 653 -1039 N \nATOM 1561 N PRO A 194 -9.848 6.950 -85.520 1.00 42.76 N \nANISOU 1561 N PRO A 194 3707 5085 7456 -224 767 -816 N \nATOM 1562 CA PRO A 194 -10.032 5.624 -85.009 1.00 42.04 C \nANISOU 1562 CA PRO A 194 3671 4982 7322 -194 777 -754 C \nATOM 1563 C PRO A 194 -9.021 5.238 -83.936 1.00 47.42 C \nANISOU 1563 C PRO A 194 4352 5646 8020 -167 741 -732 C \nATOM 1564 O PRO A 194 -9.325 4.469 -83.024 1.00 44.21 O \nANISOU 1564 O PRO A 194 3992 5214 7594 -143 740 -688 O \nATOM 1565 CB PRO A 194 -9.802 4.737 -86.237 1.00 41.49 C \nANISOU 1565 CB PRO A 194 3597 4969 7198 -182 805 -731 C \nATOM 1566 CG PRO A 194 -8.895 5.513 -87.080 1.00 41.72 C \nANISOU 1566 CG PRO A 194 3562 5034 7254 -202 793 -780 C \nATOM 1567 CD PRO A 194 -9.304 6.926 -86.894 1.00 45.50 C \nANISOU 1567 CD PRO A 194 4016 5487 7784 -231 782 -836 C \nATOM 1568 N THR A 195 -7.821 5.792 -84.047 1.00 51.61 N \nANISOU 1568 N THR A 195 4835 6190 8584 -172 711 -763 N \nATOM 1569 CA THR A 195 -6.773 5.518 -83.051 1.00 51.68 C \nANISOU 1569 CA THR A 195 4845 6184 8608 -157 674 -746 C \nATOM 1570 C THR A 195 -6.352 6.804 -82.394 1.00 53.12 C \nANISOU 1570 C THR A 195 5004 6324 8854 -171 636 -792 C \nATOM 1571 O THR A 195 -5.901 7.751 -83.063 1.00 56.18 O \nANISOU 1571 O THR A 195 5354 6721 9270 -185 628 -842 O \nATOM 1572 CB THR A 195 -5.547 4.831 -83.706 1.00 47.16 C \nANISOU 1572 CB THR A 195 4248 5667 8004 -153 670 -733 C \nATOM 1573 OG1 THR A 195 -6.003 3.766 -84.513 1.00 47.24 O \nANISOU 1573 OG1 THR A 195 4271 5726 7953 -137 707 -697 O \nATOM 1574 CG2 THR A 195 -4.658 4.263 -82.630 1.00 44.97 C \nANISOU 1574 CG2 THR A 195 3981 5383 7723 -140 638 -702 C \nATOM 1575 N THR A 196 -6.514 6.864 -81.091 1.00 54.65 N \nANISOU 1575 N THR A 196 5223 6473 9070 -162 613 -776 N \nATOM 1576 CA THR A 196 -6.417 8.169 -80.388 1.00 57.96 C \nANISOU 1576 CA THR A 196 5624 6849 9549 -171 579 -818 C \nATOM 1577 C THR A 196 -5.727 8.018 -79.036 1.00 51.18 C \nANISOU 1577 C THR A 196 4785 5953 8710 -160 540 -796 C \nATOM 1578 O THR A 196 -5.482 6.906 -78.604 1.00 51.42 O \nANISOU 1578 O THR A 196 4840 5991 8705 -148 542 -749 O \nATOM 1579 CB THR A 196 -7.826 8.815 -80.172 1.00 58.57 C \nANISOU 1579 CB THR A 196 5709 6908 9638 -185 596 -834 C \nATOM 1580 OG1 THR A 196 -8.689 7.916 -79.464 1.00 55.29 O \nANISOU 1580 OG1 THR A 196 5344 6471 9191 -179 613 -785 O \nATOM 1581 CG2 THR A 196 -8.467 9.118 -81.441 1.00 68.02 C \nANISOU 1581 CG2 THR A 196 6884 8142 10818 -203 631 -860 C \nATOM 1582 N TYR A 197 -5.522 9.159 -78.353 1.00 42.85 N \nANISOU 1582 N TYR A 197 3717 4860 7706 -162 505 -830 N \nATOM 1583 CA TYR A 197 -4.728 9.226 -77.134 1.00 39.40 C \nANISOU 1583 CA TYR A 197 3295 4384 7293 -156 462 -817 C \nATOM 1584 C TYR A 197 -4.947 10.536 -76.434 1.00 36.71 C \nANISOU 1584 C TYR A 197 2941 4003 7003 -153 432 -854 C \nATOM 1585 O TYR A 197 -5.130 11.589 -77.105 1.00 35.07 O \nANISOU 1585 O TYR A 197 2701 3805 6820 -153 435 -903 O \nATOM 1586 CB TYR A 197 -3.193 9.084 -77.488 1.00 37.87 C \nANISOU 1586 CB TYR A 197 3093 4202 7094 -160 438 -823 C \nATOM 1587 CG TYR A 197 -2.708 10.214 -78.359 1.00 33.09 C \nANISOU 1587 CG TYR A 197 2459 3597 6517 -163 429 -881 C \nATOM 1588 CD1 TYR A 197 -2.047 11.261 -77.826 1.00 33.39 C \nANISOU 1588 CD1 TYR A 197 2497 3591 6598 -156 388 -914 C \nATOM 1589 CD2 TYR A 197 -2.935 10.232 -79.712 1.00 40.78 C \nANISOU 1589 CD2 TYR A 197 3409 4615 7473 -170 463 -904 C \nATOM 1590 CE1 TYR A 197 -1.653 12.342 -78.573 1.00 33.56 C \nANISOU 1590 CE1 TYR A 197 2498 3611 6644 -149 381 -970 C \nATOM 1591 CE2 TYR A 197 -2.521 11.312 -80.503 1.00 41.78 C \nANISOU 1591 CE2 TYR A 197 3508 4742 7623 -169 456 -961 C \nATOM 1592 CZ TYR A 197 -1.885 12.375 -79.890 1.00 40.43 C \nANISOU 1592 CZ TYR A 197 3341 4524 7496 -155 414 -995 C \nATOM 1593 OH TYR A 197 -1.428 13.449 -80.605 1.00 48.24 O \nANISOU 1593 OH TYR A 197 4310 5511 8508 -144 406 -1052 O \nATOM 1594 N ILE A 198 -4.858 10.520 -75.111 1.00 32.88 N \nANISOU 1594 N ILE A 198 2478 3479 6534 -148 403 -832 N \nATOM 1595 CA ILE A 198 -4.759 11.747 -74.367 1.00 34.73 C \nANISOU 1595 CA ILE A 198 2701 3677 6817 -141 365 -864 C \nATOM 1596 C ILE A 198 -3.365 11.747 -73.782 1.00 44.45 C \nANISOU 1596 C ILE A 198 3950 4879 8062 -135 322 -857 C \nATOM 1597 O ILE A 198 -2.890 10.709 -73.264 1.00 44.15 O \nANISOU 1597 O ILE A 198 3938 4840 7996 -143 317 -813 O \nATOM 1598 CB ILE A 198 -5.744 11.816 -73.196 1.00 40.86 C \nANISOU 1598 CB ILE A 198 3494 4430 7603 -145 361 -845 C \nATOM 1599 CG1 ILE A 198 -7.155 11.965 -73.673 1.00 40.33 C \nANISOU 1599 CG1 ILE A 198 3417 4387 7521 -160 401 -855 C \nATOM 1600 CG2 ILE A 198 -5.422 13.012 -72.277 1.00 39.50 C \nANISOU 1600 CG2 ILE A 198 3310 4222 7478 -132 314 -872 C \nATOM 1601 CD1 ILE A 198 -7.825 10.651 -74.022 1.00 45.52 C \nANISOU 1601 CD1 ILE A 198 4109 5060 8126 -169 444 -813 C \nATOM 1602 N SER A 199 -2.710 12.902 -73.812 1.00 48.47 N \nANISOU 1602 N SER A 199 4445 5364 8608 -122 289 -900 N \nATOM 1603 CA SER A 199 -1.309 13.005 -73.376 1.00 50.68 C \nANISOU 1603 CA SER A 199 4752 5609 8897 -121 246 -898 C \nATOM 1604 C SER A 199 -1.222 14.205 -72.468 1.00 53.02 C \nANISOU 1604 C SER A 199 5051 5858 9238 -98 204 -923 C \nATOM 1605 O SER A 199 -1.492 15.323 -72.874 1.00 56.47 O \nANISOU 1605 O SER A 199 5460 6296 9701 -74 201 -969 O \nATOM 1606 CB SER A 199 -0.385 13.126 -74.592 1.00 55.21 C \nANISOU 1606 CB SER A 199 5320 6198 9458 -127 251 -928 C \nATOM 1607 OG SER A 199 0.750 13.912 -74.292 1.00 56.18 O \nANISOU 1607 OG SER A 199 5467 6273 9604 -118 207 -953 O \nATOM 1608 N VAL A 200 -0.909 13.972 -71.200 1.00 55.55 N \nANISOU 1608 N VAL A 200 5401 6141 9564 -102 172 -890 N \nATOM 1609 CA VAL A 200 -0.895 15.053 -70.200 1.00 49.38 C \nANISOU 1609 CA VAL A 200 4623 5317 8822 -78 129 -907 C \nATOM 1610 C VAL A 200 0.465 15.061 -69.502 1.00 49.21 C \nANISOU 1610 C VAL A 200 4649 5246 8805 -83 82 -893 C \nATOM 1611 O VAL A 200 0.965 13.991 -69.106 1.00 45.25 O \nANISOU 1611 O VAL A 200 4175 4745 8273 -114 80 -851 O \nATOM 1612 CB VAL A 200 -1.924 14.837 -69.126 1.00 44.48 C \nANISOU 1612 CB VAL A 200 4000 4695 8204 -84 132 -878 C \nATOM 1613 CG1 VAL A 200 -2.052 16.074 -68.269 1.00 36.19 C \nANISOU 1613 CG1 VAL A 200 2941 3615 7193 -57 93 -900 C \nATOM 1614 CG2 VAL A 200 -3.226 14.465 -69.729 1.00 51.91 C \nANISOU 1614 CG2 VAL A 200 4914 5683 9127 -96 183 -877 C \nATOM 1615 N GLY A 201 1.061 16.245 -69.376 1.00 45.49 N \nANISOU 1615 N GLY A 201 4188 4733 8363 -52 44 -930 N \nATOM 1616 CA GLY A 201 2.407 16.399 -68.834 1.00 49.12 C \nANISOU 1616 CA GLY A 201 4703 5136 8824 -57 -3 -923 C \nATOM 1617 C GLY A 201 2.604 17.613 -67.956 1.00 51.06 C \nANISOU 1617 C GLY A 201 4966 5328 9106 -16 -51 -942 C \nATOM 1618 O GLY A 201 2.189 18.722 -68.273 1.00 49.41 O \nANISOU 1618 O GLY A 201 4727 5122 8923 31 -54 -986 O \nATOM 1619 N THR A 202 3.234 17.392 -66.812 1.00 51.17 N \nANISOU 1619 N THR A 202 5026 5299 9119 -32 -90 -909 N \nATOM 1620 CA THR A 202 3.733 18.472 -65.981 1.00 47.44 C \nANISOU 1620 CA THR A 202 4587 4765 8674 5 -143 -922 C \nATOM 1621 C THR A 202 5.255 18.250 -65.811 1.00 56.17 C \nANISOU 1621 C THR A 202 5770 5813 9759 -23 -179 -910 C \nATOM 1622 O THR A 202 5.889 17.550 -66.594 1.00 67.41 O \nANISOU 1622 O THR A 202 7211 7251 11152 -63 -161 -907 O \nATOM 1623 CB THR A 202 3.020 18.504 -64.644 1.00 45.05 C \nANISOU 1623 CB THR A 202 4272 4459 8386 8 -161 -892 C \nATOM 1624 OG1 THR A 202 3.458 17.430 -63.796 1.00 40.77 O \nANISOU 1624 OG1 THR A 202 3766 3906 7819 -43 -171 -839 O \nATOM 1625 CG2 THR A 202 1.578 18.346 -64.813 1.00 44.99 C \nANISOU 1625 CG2 THR A 202 4199 4511 8382 10 -119 -893 C \nATOM 1626 N SER A 203 5.845 18.838 -64.784 1.00 59.89 N \nANISOU 1626 N SER A 203 6291 6221 10244 -8 -231 -902 N \nATOM 1627 CA SER A 203 7.208 18.521 -64.424 1.00 57.40 C \nANISOU 1627 CA SER A 203 6056 5851 9902 -50 -266 -881 C \nATOM 1628 C SER A 203 7.319 17.127 -63.801 1.00 55.27 C \nANISOU 1628 C SER A 203 5790 5612 9597 -121 -257 -824 C \nATOM 1629 O SER A 203 8.375 16.471 -63.845 1.00 65.17 O \nANISOU 1629 O SER A 203 7093 6854 10813 -177 -268 -804 O \nATOM 1630 CB SER A 203 7.750 19.546 -63.465 1.00 57.83 C \nANISOU 1630 CB SER A 203 6167 5828 9978 -11 -324 -886 C \nATOM 1631 OG SER A 203 7.100 19.432 -62.235 1.00 61.19 O \nANISOU 1631 OG SER A 203 6571 6261 10417 -11 -339 -852 O \nATOM 1632 N THR A 204 6.233 16.679 -63.220 1.00 48.74 N \nANISOU 1632 N THR A 204 4912 4828 8778 -119 -237 -799 N \nATOM 1633 CA THR A 204 6.222 15.442 -62.423 1.00 46.28 C \nANISOU 1633 CA THR A 204 4604 4545 8436 -172 -232 -744 C \nATOM 1634 C THR A 204 5.426 14.353 -63.102 1.00 48.55 C \nANISOU 1634 C THR A 204 4838 4910 8699 -190 -174 -730 C \nATOM 1635 O THR A 204 5.655 13.193 -62.855 1.00 54.05 O \nANISOU 1635 O THR A 204 5539 5643 9357 -233 -162 -691 O \nATOM 1636 CB THR A 204 5.614 15.751 -61.035 1.00 55.68 C \nANISOU 1636 CB THR A 204 5790 5716 9650 -155 -258 -722 C \nATOM 1637 OG1 THR A 204 6.507 15.266 -60.003 1.00 60.65 O \nANISOU 1637 OG1 THR A 204 6472 6316 10255 -200 -295 -683 O \nATOM 1638 CG2 THR A 204 4.188 15.110 -60.867 1.00 56.02 C \nANISOU 1638 CG2 THR A 204 5773 5819 9694 -153 -214 -705 C \nATOM 1639 N LEU A 205 4.527 14.745 -64.013 1.00 47.42 N \nANISOU 1639 N LEU A 205 4646 4795 8574 -154 -138 -763 N \nATOM 1640 CA LEU A 205 3.565 13.861 -64.601 1.00 43.75 C \nANISOU 1640 CA LEU A 205 4136 4397 8091 -162 -84 -751 C \nATOM 1641 C LEU A 205 3.865 13.682 -66.092 1.00 44.08 C \nANISOU 1641 C LEU A 205 4163 4471 8114 -167 -53 -777 C \nATOM 1642 O LEU A 205 4.167 14.646 -66.791 1.00 42.87 O \nANISOU 1642 O LEU A 205 4013 4294 7983 -142 -61 -822 O \nATOM 1643 CB LEU A 205 2.141 14.448 -64.419 1.00 40.63 C \nANISOU 1643 CB LEU A 205 3697 4014 7728 -125 -66 -767 C \nATOM 1644 CG LEU A 205 1.029 13.567 -64.999 1.00 40.01 C \nANISOU 1644 CG LEU A 205 3581 3995 7626 -133 -9 -754 C \nATOM 1645 CD1 LEU A 205 0.753 12.370 -64.128 1.00 32.98 C \nANISOU 1645 CD1 LEU A 205 2703 3121 6705 -158 1 -701 C \nATOM 1646 CD2 LEU A 205 -0.233 14.436 -65.223 1.00 43.19 C \nANISOU 1646 CD2 LEU A 205 3942 4410 8058 -103 9 -786 C \nATOM 1647 N ASN A 206 3.634 12.459 -66.560 1.00 44.53 N \nANISOU 1647 N ASN A 206 4201 4587 8131 -193 -13 -750 N \nATOM 1648 CA ASN A 206 3.927 12.041 -67.894 1.00 47.04 C \nANISOU 1648 CA ASN A 206 4505 4947 8422 -206 19 -764 C \nATOM 1649 C ASN A 206 3.035 10.836 -68.199 1.00 47.75 C \nANISOU 1649 C ASN A 206 4561 5104 8477 -211 68 -732 C \nATOM 1650 O ASN A 206 3.475 9.695 -68.101 1.00 52.35 O \nANISOU 1650 O ASN A 206 5150 5727 9014 -240 76 -694 O \nATOM 1651 CB ASN A 206 5.428 11.677 -68.035 1.00 42.22 C \nANISOU 1651 CB ASN A 206 3936 4329 7777 -251 -6 -755 C \nATOM 1652 CG ASN A 206 5.839 11.389 -69.465 1.00 43.39 C \nANISOU 1652 CG ASN A 206 4071 4519 7896 -268 23 -776 C \nATOM 1653 OD1 ASN A 206 5.102 11.652 -70.439 1.00 57.03 O \nANISOU 1653 OD1 ASN A 206 5762 6272 9637 -241 58 -804 O \nATOM 1654 ND2 ASN A 206 7.000 10.838 -69.622 1.00 40.90 N \nANISOU 1654 ND2 ASN A 206 3785 4217 7539 -318 10 -762 N \nATOM 1655 N GLN A 207 1.792 11.108 -68.604 1.00 41.08 N \nANISOU 1655 N GLN A 207 3683 4274 7650 -182 101 -748 N \nATOM 1656 CA GLN A 207 0.872 10.058 -68.937 1.00 38.59 C \nANISOU 1656 CA GLN A 207 3349 4012 7303 -182 148 -720 C \nATOM 1657 C GLN A 207 0.454 10.028 -70.428 1.00 40.12 C \nANISOU 1657 C GLN A 207 3512 4248 7485 -175 191 -745 C \nATOM 1658 O GLN A 207 0.592 10.963 -71.166 1.00 37.12 O \nANISOU 1658 O GLN A 207 3118 3856 7129 -165 188 -790 O \nATOM 1659 CB GLN A 207 -0.354 10.101 -68.042 1.00 39.95 C \nANISOU 1659 CB GLN A 207 3520 4171 7490 -165 156 -705 C \nATOM 1660 CG GLN A 207 -1.445 10.991 -68.486 1.00 43.95 C \nANISOU 1660 CG GLN A 207 4000 4673 8027 -146 175 -741 C \nATOM 1661 CD GLN A 207 -2.747 10.858 -67.650 1.00 43.73 C \nANISOU 1661 CD GLN A 207 3975 4639 8001 -142 190 -722 C \nATOM 1662 OE1 GLN A 207 -3.796 11.420 -68.007 1.00 40.75 O \nANISOU 1662 OE1 GLN A 207 3578 4270 7637 -137 212 -746 O \nATOM 1663 NE2 GLN A 207 -2.672 10.157 -66.553 1.00 43.39 N \nANISOU 1663 NE2 GLN A 207 3960 4585 7943 -149 177 -682 N \nATOM 1664 N ARG A 208 0.003 8.878 -70.874 1.00 40.86 N \nANISOU 1664 N ARG A 208 3598 4393 7534 -177 231 -714 N \nATOM 1665 CA ARG A 208 -0.553 8.765 -72.177 1.00 38.51 C \nANISOU 1665 CA ARG A 208 3275 4135 7222 -171 273 -732 C \nATOM 1666 C ARG A 208 -1.653 7.730 -72.091 1.00 46.07 C \nANISOU 1666 C ARG A 208 4237 5123 8144 -158 313 -693 C \nATOM 1667 O ARG A 208 -1.382 6.588 -71.755 1.00 45.66 O \nANISOU 1667 O ARG A 208 4198 5102 8050 -159 319 -650 O \nATOM 1668 CB ARG A 208 0.450 8.336 -73.187 1.00 38.15 C \nANISOU 1668 CB ARG A 208 3221 4130 7144 -189 279 -736 C \nATOM 1669 CG ARG A 208 0.259 9.059 -74.506 1.00 36.59 C \nANISOU 1669 CG ARG A 208 2999 3944 6961 -185 300 -783 C \nATOM 1670 CD ARG A 208 1.181 8.572 -75.548 1.00 36.13 C \nANISOU 1670 CD ARG A 208 2933 3930 6865 -207 310 -786 C \nATOM 1671 NE ARG A 208 0.517 7.629 -76.448 1.00 38.35 N \nANISOU 1671 NE ARG A 208 3193 4275 7103 -202 358 -765 N \nATOM 1672 CZ ARG A 208 0.337 7.801 -77.755 1.00 39.50 C \nANISOU 1672 CZ ARG A 208 3315 4454 7240 -203 386 -792 C \nATOM 1673 NH1 ARG A 208 0.722 8.945 -78.346 1.00 42.19 N \nANISOU 1673 NH1 ARG A 208 3647 4770 7615 -207 374 -847 N \nATOM 1674 NH2 ARG A 208 -0.262 6.835 -78.457 1.00 37.42 N \nANISOU 1674 NH2 ARG A 208 3040 4248 6932 -197 428 -765 N \nATOM 1675 N LEU A 209 -2.904 8.153 -72.361 1.00 49.78 N \nANISOU 1675 N LEU A 209 4700 5587 8629 -147 340 -710 N \nATOM 1676 CA LEU A 209 -4.099 7.311 -72.148 1.00 38.61 C \nANISOU 1676 CA LEU A 209 3304 4183 7182 -136 376 -676 C \nATOM 1677 C LEU A 209 -4.645 6.937 -73.498 1.00 39.18 C \nANISOU 1677 C LEU A 209 3366 4298 7224 -133 422 -681 C \nATOM 1678 O LEU A 209 -4.674 7.725 -74.404 1.00 39.00 O \nANISOU 1678 O LEU A 209 3315 4282 7221 -140 428 -722 O \nATOM 1679 CB LEU A 209 -5.142 8.063 -71.411 1.00 42.78 C \nANISOU 1679 CB LEU A 209 3841 4671 7742 -138 372 -689 C \nATOM 1680 CG LEU A 209 -4.752 8.630 -70.045 1.00 45.17 C \nANISOU 1680 CG LEU A 209 4153 4929 8080 -140 326 -688 C \nATOM 1681 CD1 LEU A 209 -5.772 9.609 -69.493 1.00 40.48 C \nANISOU 1681 CD1 LEU A 209 3556 4307 7520 -145 321 -711 C \nATOM 1682 CD2 LEU A 209 -4.462 7.519 -69.084 1.00 46.37 C \nANISOU 1682 CD2 LEU A 209 4337 5081 8201 -136 319 -638 C \nATOM 1683 N VAL A 210 -4.949 5.656 -73.656 1.00 48.54 N \nANISOU 1683 N VAL A 210 4571 5515 8355 -117 452 -638 N \nATOM 1684 CA VAL A 210 -5.496 5.131 -74.920 1.00 47.03 C \nANISOU 1684 CA VAL A 210 4377 5367 8126 -110 497 -634 C \nATOM 1685 C VAL A 210 -6.831 4.519 -74.583 1.00 42.95 C \nANISOU 1685 C VAL A 210 3905 4835 7580 -94 529 -605 C \nATOM 1686 O VAL A 210 -6.922 3.773 -73.602 1.00 49.04 O \nANISOU 1686 O VAL A 210 4709 5594 8330 -75 525 -567 O \nATOM 1687 CB VAL A 210 -4.589 4.051 -75.538 1.00 46.45 C \nANISOU 1687 CB VAL A 210 4292 5355 8002 -100 505 -606 C \nATOM 1688 CG1 VAL A 210 -5.363 3.326 -76.623 1.00 56.48 C \nANISOU 1688 CG1 VAL A 210 5570 6665 9225 -82 553 -590 C \nATOM 1689 CG2 VAL A 210 -3.378 4.688 -76.167 1.00 49.41 C \nANISOU 1689 CG2 VAL A 210 4630 5747 8399 -125 481 -641 C \nATOM 1690 N PRO A 211 -7.876 4.887 -75.317 1.00 36.74 N \nANISOU 1690 N PRO A 211 3124 4043 6791 -104 561 -624 N \nATOM 1691 CA PRO A 211 -9.239 4.431 -75.016 1.00 35.36 C \nANISOU 1691 CA PRO A 211 3005 3844 6587 -98 592 -600 C \nATOM 1692 C PRO A 211 -9.369 2.973 -75.299 1.00 34.87 C \nANISOU 1692 C PRO A 211 2980 3810 6458 -60 623 -551 C \nATOM 1693 O PRO A 211 -8.869 2.512 -76.357 1.00 35.01 O \nANISOU 1693 O PRO A 211 2973 3880 6448 -48 637 -546 O \nATOM 1694 CB PRO A 211 -10.092 5.246 -75.987 1.00 32.38 C \nANISOU 1694 CB PRO A 211 2615 3469 6219 -128 617 -638 C \nATOM 1695 CG PRO A 211 -9.184 5.669 -77.066 1.00 34.49 C \nANISOU 1695 CG PRO A 211 2825 3778 6500 -134 610 -669 C \nATOM 1696 CD PRO A 211 -7.881 5.909 -76.355 1.00 35.37 C \nANISOU 1696 CD PRO A 211 2909 3883 6645 -127 565 -673 C \nATOM 1697 N LYS A 212 -9.941 2.238 -74.378 1.00 34.95 N \nANISOU 1697 N LYS A 212 3046 3793 6441 -36 630 -514 N \nATOM 1698 CA LYS A 212 -10.228 0.802 -74.535 1.00 37.25 C \nANISOU 1698 CA LYS A 212 3384 4108 6662 14 662 -464 C \nATOM 1699 C LYS A 212 -11.564 0.566 -75.198 1.00 39.21 C \nANISOU 1699 C LYS A 212 3691 4336 6872 16 706 -457 C \nATOM 1700 O LYS A 212 -12.612 0.658 -74.555 1.00 37.70 O \nANISOU 1700 O LYS A 212 3559 4089 6675 5 717 -453 O \nATOM 1701 CB LYS A 212 -10.315 0.150 -73.130 1.00 38.00 C \nANISOU 1701 CB LYS A 212 3522 4175 6741 42 650 -429 C \nATOM 1702 CG LYS A 212 -8.966 -0.296 -72.569 1.00 39.49 C \nANISOU 1702 CG LYS A 212 3669 4407 6930 59 618 -412 C \nATOM 1703 CD LYS A 212 -8.559 0.578 -71.422 1.00 38.10 C \nANISOU 1703 CD LYS A 212 3476 4190 6811 26 575 -433 C \nATOM 1704 CE LYS A 212 -8.203 -0.254 -70.217 1.00 41.59 C \nANISOU 1704 CE LYS A 212 3938 4636 7227 54 560 -395 C \nATOM 1705 NZ LYS A 212 -8.190 0.571 -68.948 1.00 39.97 N \nANISOU 1705 NZ LYS A 212 3737 4376 7073 23 524 -411 N \nATOM 1706 N ILE A 213 -11.535 0.296 -76.484 1.00 44.90 N \nANISOU 1706 N ILE A 213 4396 5099 7564 23 731 -457 N \nATOM 1707 CA ILE A 213 -12.777 0.189 -77.271 1.00 53.75 C \nANISOU 1707 CA ILE A 213 5572 6200 8649 15 772 -455 C \nATOM 1708 C ILE A 213 -13.273 -1.259 -77.070 1.00 61.81 C \nANISOU 1708 C ILE A 213 6672 7218 9596 81 801 -398 C \nATOM 1709 O ILE A 213 -12.704 -2.186 -77.633 1.00 67.48 O \nANISOU 1709 O ILE A 213 7376 7994 10271 130 810 -369 O \nATOM 1710 CB ILE A 213 -12.502 0.400 -78.784 1.00 49.61 C \nANISOU 1710 CB ILE A 213 5001 5729 8118 1 788 -474 C \nATOM 1711 CG1 ILE A 213 -11.623 1.629 -79.045 1.00 52.72 C \nANISOU 1711 CG1 ILE A 213 5309 6144 8580 -43 756 -527 C \nATOM 1712 CG2 ILE A 213 -13.800 0.422 -79.567 1.00 43.96 C \nANISOU 1712 CG2 ILE A 213 4342 4992 7368 -18 828 -475 C \nATOM 1713 CD1 ILE A 213 -12.382 2.941 -79.049 1.00 55.12 C \nANISOU 1713 CD1 ILE A 213 5605 6412 8926 -100 754 -574 C \nATOM 1714 N ALA A 214 -14.335 -1.452 -76.318 1.00 64.24 N \nANISOU 1714 N ALA A 214 7063 7461 9884 83 815 -383 N \nATOM 1715 CA ALA A 214 -14.905 -2.783 -76.180 1.00 68.63 C \nANISOU 1715 CA ALA A 214 7706 8005 10364 151 845 -332 C \nATOM 1716 C ALA A 214 -16.403 -2.766 -75.845 1.00 65.60 C \nANISOU 1716 C ALA A 214 7434 7540 9953 131 873 -326 C \nATOM 1717 O ALA A 214 -16.979 -1.730 -75.548 1.00 62.37 O \nANISOU 1717 O ALA A 214 7027 7087 9582 60 866 -361 O \nATOM 1718 CB ALA A 214 -14.149 -3.528 -75.100 1.00 69.60 C \nANISOU 1718 CB ALA A 214 7820 8146 10478 205 824 -303 C \nATOM 1719 N THR A 215 -17.001 -3.943 -75.870 1.00 71.25 N \nANISOU 1719 N THR A 215 8242 8237 10594 197 904 -282 N \nATOM 1720 CA THR A 215 -18.438 -4.135 -75.541 1.00 75.21 C \nANISOU 1720 CA THR A 215 8872 8653 11052 186 935 -270 C \nATOM 1721 C THR A 215 -18.599 -4.325 -74.031 1.00 75.77 C \nANISOU 1721 C THR A 215 8988 8673 11127 199 920 -259 C \nATOM 1722 O THR A 215 -17.834 -5.053 -73.402 1.00 76.49 O \nANISOU 1722 O THR A 215 9057 8796 11209 265 906 -234 O \nATOM 1723 CB THR A 215 -19.025 -5.374 -76.290 1.00 72.94 C \nANISOU 1723 CB THR A 215 8678 8361 10675 260 976 -224 C \nATOM 1724 OG1 THR A 215 -19.016 -5.131 -77.709 1.00 71.24 O \nANISOU 1724 OG1 THR A 215 8428 8186 10453 237 991 -235 O \nATOM 1725 CG2 THR A 215 -20.455 -5.684 -75.844 1.00 74.93 C \nANISOU 1725 CG2 THR A 215 9081 8515 10874 255 1006 -208 C \nATOM 1726 N ARG A 216 -19.572 -3.656 -73.439 1.00 83.59 N \nANISOU 1726 N ARG A 216 10038 9591 12130 133 924 -279 N \nATOM 1727 CA ARG A 216 -19.769 -3.777 -71.994 1.00 92.17 C \nANISOU 1727 CA ARG A 216 11170 10629 13220 138 911 -272 C \nATOM 1728 C ARG A 216 -21.220 -3.948 -71.626 1.00 87.39 C \nANISOU 1728 C ARG A 216 10706 9933 12564 113 942 -263 C \nATOM 1729 O ARG A 216 -22.113 -3.717 -72.446 1.00 79.92 O \nANISOU 1729 O ARG A 216 9817 8960 11590 68 970 -270 O \nATOM 1730 CB ARG A 216 -19.256 -2.547 -71.263 1.00 97.66 C \nANISOU 1730 CB ARG A 216 11774 11333 13999 68 869 -312 C \nATOM 1731 CG ARG A 216 -17.747 -2.379 -71.272 1.00 96.93 C \nANISOU 1731 CG ARG A 216 11557 11315 13958 91 831 -320 C \nATOM 1732 CD ARG A 216 -17.377 -0.952 -70.897 1.00 83.52 C \nANISOU 1732 CD ARG A 216 9773 9620 12339 15 794 -366 C \nATOM 1733 NE ARG A 216 -16.157 -0.484 -71.515 1.00 74.63 N \nANISOU 1733 NE ARG A 216 8535 8561 11260 14 768 -387 N \nATOM 1734 CZ ARG A 216 -16.105 0.354 -72.546 1.00 77.97 C \nANISOU 1734 CZ ARG A 216 8904 9010 11712 -30 769 -421 C \nATOM 1735 NH1 ARG A 216 -17.207 0.830 -73.112 1.00 84.24 N \nANISOU 1735 NH1 ARG A 216 9737 9778 12491 -79 795 -439 N \nATOM 1736 NH2 ARG A 216 -14.933 0.712 -73.027 1.00 78.28 N \nANISOU 1736 NH2 ARG A 216 8849 9104 11788 -26 744 -439 N \nATOM 1737 N SER A 217 -21.411 -4.365 -70.375 1.00 81.63 N \nANISOU 1737 N SER A 217 10035 9159 11820 138 937 -247 N \nATOM 1738 CA SER A 217 -22.723 -4.419 -69.739 1.00 81.49 C \nANISOU 1738 CA SER A 217 10153 9050 11761 102 960 -244 C \nATOM 1739 C SER A 217 -23.169 -3.006 -69.388 1.00 83.22 C \nANISOU 1739 C SER A 217 10336 9249 12033 -20 942 -289 C \nATOM 1740 O SER A 217 -22.388 -2.172 -68.948 1.00 81.85 O \nANISOU 1740 O SER A 217 10050 9117 11932 -52 904 -316 O \nATOM 1741 CB SER A 217 -22.688 -5.286 -68.471 1.00 81.21 C \nANISOU 1741 CB SER A 217 10182 8980 11695 170 958 -215 C \nATOM 1742 OG SER A 217 -21.523 -5.029 -67.668 1.00 77.25 O \nANISOU 1742 OG SER A 217 9566 8532 11254 182 915 -224 O \nATOM 1743 N LYS A 218 -24.447 -2.731 -69.595 1.00 91.05 N \nANISOU 1743 N LYS A 218 11429 10180 12985 -90 971 -298 N \nATOM 1744 CA LYS A 218 -24.970 -1.382 -69.419 1.00 87.34 C \nANISOU 1744 CA LYS A 218 10923 9706 12555 -211 958 -342 C \nATOM 1745 C LYS A 218 -25.093 -1.104 -67.935 1.00 84.18 C \nANISOU 1745 C LYS A 218 10537 9271 12175 -239 936 -348 C \nATOM 1746 O LYS A 218 -25.799 -1.812 -67.239 1.00 95.58 O \nANISOU 1746 O LYS A 218 12107 10646 13564 -221 956 -325 O \nATOM 1747 CB LYS A 218 -26.312 -1.214 -70.135 1.00 82.15 C \nANISOU 1747 CB LYS A 218 10370 9002 11839 -287 996 -347 C \nATOM 1748 CG LYS A 218 -26.166 -1.276 -71.646 1.00 90.82 C \nANISOU 1748 CG LYS A 218 11437 10145 12926 -275 1014 -347 C \nATOM 1749 CD LYS A 218 -27.481 -1.010 -72.372 1.00 97.53 C \nANISOU 1749 CD LYS A 218 12385 10954 13718 -363 1050 -355 C \nATOM 1750 CE LYS A 218 -27.295 -0.779 -73.866 1.00101.99 C \nANISOU 1750 CE LYS A 218 12891 11575 14284 -373 1062 -364 C \nATOM 1751 NZ LYS A 218 -26.976 -2.044 -74.569 1.00108.32 N \nANISOU 1751 NZ LYS A 218 13743 12375 15039 -262 1083 -321 N \nATOM 1752 N VAL A 219 -24.378 -0.082 -67.471 1.00 81.49 N \nANISOU 1752 N VAL A 219 10072 8980 11912 -277 895 -380 N \nATOM 1753 CA VAL A 219 -24.536 0.507 -66.142 1.00 76.75 C \nANISOU 1753 CA VAL A 219 9465 8357 11339 -327 869 -395 C \nATOM 1754 C VAL A 219 -25.255 1.856 -66.278 1.00 81.85 C \nANISOU 1754 C VAL A 219 10078 9017 12005 -447 864 -438 C \nATOM 1755 O VAL A 219 -24.721 2.773 -66.897 1.00 81.97 O \nANISOU 1755 O VAL A 219 9975 9096 12073 -474 844 -468 O \nATOM 1756 CB VAL A 219 -23.148 0.724 -65.489 1.00 72.57 C \nANISOU 1756 CB VAL A 219 8815 7879 10880 -280 822 -398 C \nATOM 1757 CG1 VAL A 219 -23.274 1.263 -64.068 1.00 71.17 C \nANISOU 1757 CG1 VAL A 219 8633 7679 10728 -324 794 -410 C \nATOM 1758 CG2 VAL A 219 -22.369 -0.569 -65.496 1.00 68.85 C \nANISOU 1758 CG2 VAL A 219 8358 7416 10385 -167 827 -358 C \nATOM 1759 N ASN A 220 -26.424 1.990 -65.641 1.00 98.59 N \nANISOU 1759 N ASN A 220 12298 11081 14081 -520 881 -441 N \nATOM 1760 CA ASN A 220 -27.359 3.135 -65.837 1.00103.14 C \nANISOU 1760 CA ASN A 220 12865 11671 14652 -646 886 -478 C \nATOM 1761 C ASN A 220 -27.840 3.248 -67.283 1.00100.26 C \nANISOU 1761 C ASN A 220 12512 11326 14255 -679 917 -486 C \nATOM 1762 O ASN A 220 -27.933 4.337 -67.841 1.00 99.18 O \nANISOU 1762 O ASN A 220 12289 11250 14146 -750 908 -523 O \nATOM 1763 CB ASN A 220 -26.733 4.467 -65.373 1.00112.72 C \nANISOU 1763 CB ASN A 220 13929 12954 15943 -688 839 -517 C \nATOM 1764 CG ASN A 220 -26.490 4.510 -63.875 1.00119.36 C \nANISOU 1764 CG ASN A 220 14769 13774 16808 -681 810 -511 C \nATOM 1765 OD1 ASN A 220 -27.090 3.739 -63.119 1.00124.55 O \nANISOU 1765 OD1 ASN A 220 15546 14363 17415 -677 828 -486 O \nATOM 1766 ND2 ASN A 220 -25.605 5.411 -63.434 1.00117.49 N \nANISOU 1766 ND2 ASN A 220 14402 13594 16645 -679 764 -534 N \nATOM 1767 N GLY A 221 -28.111 2.101 -67.891 1.00 98.07 N \nANISOU 1767 N GLY A 221 12342 11002 13920 -621 952 -452 N \nATOM 1768 CA GLY A 221 -28.470 2.038 -69.302 1.00 95.97 C \nANISOU 1768 CA GLY A 221 12094 10751 13620 -637 982 -453 C \nATOM 1769 C GLY A 221 -27.397 2.561 -70.239 1.00 93.61 C \nANISOU 1769 C GLY A 221 11641 10540 13385 -606 961 -473 C \nATOM 1770 O GLY A 221 -27.701 2.950 -71.362 1.00106.84 O \nANISOU 1770 O GLY A 221 13297 12249 15047 -649 978 -489 O \nATOM 1771 N GLN A 222 -26.138 2.532 -69.803 1.00 91.96 N \nANISOU 1771 N GLN A 222 11333 10369 13240 -531 925 -471 N \nATOM 1772 CA GLN A 222 -25.010 3.039 -70.611 1.00 90.14 C \nANISOU 1772 CA GLN A 222 10959 10218 13071 -500 902 -492 C \nATOM 1773 C GLN A 222 -23.791 2.084 -70.665 1.00 85.59 C \nANISOU 1773 C GLN A 222 10351 9658 12512 -383 890 -461 C \nATOM 1774 O GLN A 222 -23.144 1.782 -69.659 1.00 80.28 O \nANISOU 1774 O GLN A 222 9661 8976 11863 -336 865 -447 O \nATOM 1775 CB GLN A 222 -24.558 4.395 -70.094 1.00 86.34 C \nANISOU 1775 CB GLN A 222 10355 9788 12663 -551 861 -535 C \nATOM 1776 CG GLN A 222 -23.364 4.972 -70.863 1.00 89.90 C \nANISOU 1776 CG GLN A 222 10667 10314 13177 -518 835 -560 C \nATOM 1777 CD GLN A 222 -23.540 4.943 -72.388 1.00 89.03 C \nANISOU 1777 CD GLN A 222 10548 10238 13043 -527 864 -567 C \nATOM 1778 OE1 GLN A 222 -22.709 4.411 -73.123 1.00 85.21 O \nANISOU 1778 OE1 GLN A 222 10030 9779 12566 -460 865 -554 O \nATOM 1779 NE2 GLN A 222 -24.630 5.517 -72.859 1.00 93.89 N \nANISOU 1779 NE2 GLN A 222 11194 10857 13624 -615 888 -588 N \nATOM 1780 N SER A 223 -23.491 1.620 -71.867 1.00 79.44 N \nANISOU 1780 N SER A 223 9561 8909 11716 -342 908 -450 N \nATOM 1781 CA SER A 223 -22.446 0.628 -72.077 1.00 79.95 C \nANISOU 1781 CA SER A 223 9601 8998 11779 -237 903 -418 C \nATOM 1782 C SER A 223 -21.041 1.250 -72.105 1.00 78.27 C \nANISOU 1782 C SER A 223 9242 8855 11644 -219 861 -442 C \nATOM 1783 O SER A 223 -20.040 0.548 -72.015 1.00 86.57 O \nANISOU 1783 O SER A 223 10259 9932 12700 -144 848 -419 O \nATOM 1784 CB SER A 223 -22.736 -0.138 -73.381 1.00 78.27 C \nANISOU 1784 CB SER A 223 9438 8793 11509 -203 941 -395 C \nATOM 1785 OG SER A 223 -23.315 -1.408 -73.119 1.00 75.15 O \nANISOU 1785 OG SER A 223 9175 8340 11040 -141 970 -349 O \nATOM 1786 N GLY A 224 -20.976 2.567 -72.229 1.00 68.91 N \nANISOU 1786 N GLY A 224 7973 7699 10511 -288 840 -488 N \nATOM 1787 CA GLY A 224 -19.703 3.290 -72.277 1.00 53.20 C \nANISOU 1787 CA GLY A 224 5855 5765 8592 -276 800 -515 C \nATOM 1788 C GLY A 224 -19.151 3.485 -70.917 1.00 46.52 C \nANISOU 1788 C GLY A 224 4985 4905 7787 -264 762 -513 C \nATOM 1789 O GLY A 224 -19.808 3.151 -69.924 1.00 42.72 O \nANISOU 1789 O GLY A 224 4579 4373 7281 -272 767 -496 O \nATOM 1790 N ARG A 225 -17.935 4.027 -70.861 1.00 44.29 N \nANISOU 1790 N ARG A 225 4602 4664 7564 -246 724 -533 N \nATOM 1791 CA ARG A 225 -17.241 4.296 -69.594 1.00 41.24 C \nANISOU 1791 CA ARG A 225 4183 4268 7220 -236 682 -532 C \nATOM 1792 C ARG A 225 -16.499 5.565 -69.703 1.00 36.75 C \nANISOU 1792 C ARG A 225 3513 3735 6718 -260 645 -576 C \nATOM 1793 O ARG A 225 -16.170 6.038 -70.789 1.00 40.05 O \nANISOU 1793 O ARG A 225 3875 4193 7151 -266 648 -601 O \nATOM 1794 CB ARG A 225 -16.248 3.160 -69.217 1.00 49.95 C \nANISOU 1794 CB ARG A 225 5292 5378 8310 -162 672 -493 C \nATOM 1795 CG ARG A 225 -16.745 2.318 -68.081 1.00 67.45 C \nANISOU 1795 CG ARG A 225 7592 7548 10489 -139 680 -458 C \nATOM 1796 CD ARG A 225 -17.285 1.002 -68.536 1.00 77.28 C \nANISOU 1796 CD ARG A 225 8924 8779 11661 -89 723 -418 C \nATOM 1797 NE ARG A 225 -17.837 0.198 -67.432 1.00 82.06 N \nANISOU 1797 NE ARG A 225 9620 9334 12225 -63 733 -387 N \nATOM 1798 CZ ARG A 225 -19.046 -0.359 -67.441 1.00 75.68 C \nANISOU 1798 CZ ARG A 225 8924 8474 11357 -64 771 -369 C \nATOM 1799 NH1 ARG A 225 -19.877 -0.228 -68.471 1.00 66.84 N \nANISOU 1799 NH1 ARG A 225 7844 7344 10209 -95 804 -378 N \nATOM 1800 NH2 ARG A 225 -19.423 -1.074 -66.424 1.00 80.53 N \nANISOU 1800 NH2 ARG A 225 9617 9044 11936 -35 778 -343 N \nATOM 1801 N MET A 226 -16.153 6.122 -68.561 1.00 40.22 N \nANISOU 1801 N MET A 226 3926 4160 7196 -269 607 -584 N \nATOM 1802 CA MET A 226 -15.461 7.418 -68.523 1.00 43.79 C \nANISOU 1802 CA MET A 226 4286 4640 7710 -286 567 -625 C \nATOM 1803 C MET A 226 -14.566 7.456 -67.304 1.00 45.61 C \nANISOU 1803 C MET A 226 4499 4854 7975 -262 523 -613 C \nATOM 1804 O MET A 226 -15.060 7.418 -66.186 1.00 54.95 O \nANISOU 1804 O MET A 226 5720 6005 9153 -278 515 -601 O \nATOM 1805 CB MET A 226 -16.500 8.538 -68.492 1.00 46.12 C \nANISOU 1805 CB MET A 226 4568 4942 8012 -350 572 -661 C \nATOM 1806 CG MET A 226 -15.943 9.895 -68.809 1.00 52.90 C \nANISOU 1806 CG MET A 226 5332 5842 8925 -360 541 -709 C \nATOM 1807 SD MET A 226 -17.272 11.055 -69.180 1.00 57.12 S \nANISOU 1807 SD MET A 226 5844 6411 9448 -435 559 -751 S \nATOM 1808 CE MET A 226 -17.655 10.610 -70.865 1.00 44.87 C \nANISOU 1808 CE MET A 226 4306 4887 7857 -443 607 -756 C \nATOM 1809 N ASP A 227 -13.250 7.507 -67.497 1.00 46.53 N \nANISOU 1809 N ASP A 227 4564 4991 8122 -229 495 -617 N \nATOM 1810 CA ASP A 227 -12.323 7.542 -66.379 1.00 47.22 C \nANISOU 1810 CA ASP A 227 4637 5064 8239 -211 451 -605 C \nATOM 1811 C ASP A 227 -11.815 8.969 -66.157 1.00 46.52 C \nANISOU 1811 C ASP A 227 4483 4982 8209 -226 408 -646 C \nATOM 1812 O ASP A 227 -11.609 9.760 -67.102 1.00 46.09 O \nANISOU 1812 O ASP A 227 4380 4955 8177 -230 407 -682 O \nATOM 1813 CB ASP A 227 -11.144 6.612 -66.630 1.00 55.85 C \nANISOU 1813 CB ASP A 227 5724 6175 9319 -169 445 -578 C \nATOM 1814 CG ASP A 227 -11.561 5.124 -66.756 1.00 61.74 C \nANISOU 1814 CG ASP A 227 6534 6924 10002 -139 484 -533 C \nATOM 1815 OD1 ASP A 227 -12.737 4.763 -66.379 1.00 66.58 O \nANISOU 1815 OD1 ASP A 227 7209 7507 10582 -148 512 -519 O \nATOM 1816 OD2 ASP A 227 -10.692 4.333 -67.209 1.00 55.01 O \nANISOU 1816 OD2 ASP A 227 5668 6104 9128 -106 486 -513 O \nATOM 1817 N PHE A 228 -11.601 9.310 -64.880 1.00 35.82 N \nANISOU 1817 N PHE A 228 3130 3602 6878 -230 372 -640 N \nATOM 1818 CA PHE A 228 -11.103 10.596 -64.580 1.00 33.89 C \nANISOU 1818 CA PHE A 228 2831 3362 6685 -234 330 -674 C \nATOM 1819 C PHE A 228 -9.771 10.584 -63.902 1.00 34.46 C \nANISOU 1819 C PHE A 228 2892 3418 6783 -209 284 -662 C \nATOM 1820 O PHE A 228 -9.419 9.608 -63.284 1.00 46.57 O \nANISOU 1820 O PHE A 228 4462 4937 8295 -199 282 -624 O \nATOM 1821 CB PHE A 228 -12.137 11.352 -63.747 1.00 33.96 C \nANISOU 1821 CB PHE A 228 2842 3363 6700 -270 324 -687 C \nATOM 1822 CG PHE A 228 -13.327 11.745 -64.521 1.00 33.58 C \nANISOU 1822 CG PHE A 228 2789 3340 6631 -306 361 -711 C \nATOM 1823 CD1 PHE A 228 -13.326 12.871 -65.293 1.00 34.04 C \nANISOU 1823 CD1 PHE A 228 2783 3437 6712 -312 355 -756 C \nATOM 1824 CD2 PHE A 228 -14.429 10.929 -64.500 1.00 34.44 C \nANISOU 1824 CD2 PHE A 228 2962 3434 6690 -333 402 -688 C \nATOM 1825 CE1 PHE A 228 -14.427 13.174 -66.070 1.00 38.03 C \nANISOU 1825 CE1 PHE A 228 3284 3975 7193 -351 391 -778 C \nATOM 1826 CE2 PHE A 228 -15.528 11.217 -65.282 1.00 39.50 C \nANISOU 1826 CE2 PHE A 228 3607 4097 7304 -374 439 -708 C \nATOM 1827 CZ PHE A 228 -15.538 12.350 -66.064 1.00 38.48 C \nANISOU 1827 CZ PHE A 228 3408 4015 7198 -387 433 -753 C \nATOM 1828 N PHE A 229 -9.085 11.734 -63.922 1.00 34.85 N \nANISOU 1828 N PHE A 229 2896 3470 6878 -201 245 -695 N \nATOM 1829 CA PHE A 229 -7.723 11.793 -63.412 1.00 38.39 C \nANISOU 1829 CA PHE A 229 3340 3898 7349 -181 201 -686 C \nATOM 1830 C PHE A 229 -7.507 13.173 -62.817 1.00 36.13 C \nANISOU 1830 C PHE A 229 3021 3599 7107 -175 155 -716 C \nATOM 1831 O PHE A 229 -8.211 14.081 -63.143 1.00 32.60 O \nANISOU 1831 O PHE A 229 2540 3172 6672 -180 162 -750 O \nATOM 1832 CB PHE A 229 -6.734 11.569 -64.561 1.00 37.74 C \nANISOU 1832 CB PHE A 229 3242 3833 7263 -164 205 -696 C \nATOM 1833 CG PHE A 229 -6.776 10.212 -65.114 1.00 38.94 C \nANISOU 1833 CG PHE A 229 3420 4005 7369 -162 244 -664 C \nATOM 1834 CD1 PHE A 229 -7.603 9.899 -66.167 1.00 42.78 C \nANISOU 1834 CD1 PHE A 229 3906 4518 7830 -166 291 -671 C \nATOM 1835 CD2 PHE A 229 -5.967 9.233 -64.584 1.00 41.12 C \nANISOU 1835 CD2 PHE A 229 3722 4278 7623 -156 232 -626 C \nATOM 1836 CE1 PHE A 229 -7.599 8.611 -66.715 1.00 42.91 C \nANISOU 1836 CE1 PHE A 229 3948 4556 7799 -156 326 -639 C \nATOM 1837 CE2 PHE A 229 -5.944 7.939 -65.104 1.00 36.75 C \nANISOU 1837 CE2 PHE A 229 3187 3755 7020 -147 267 -594 C \nATOM 1838 CZ PHE A 229 -6.756 7.637 -66.174 1.00 39.67 C \nANISOU 1838 CZ PHE A 229 3557 4149 7366 -143 313 -601 C \nATOM 1839 N TRP A 230 -6.483 13.305 -61.991 1.00 35.27 N \nANISOU 1839 N TRP A 230 2922 3461 7017 -163 110 -704 N \nATOM 1840 CA TRP A 230 -6.220 14.551 -61.343 1.00 37.34 C \nANISOU 1840 CA TRP A 230 3162 3707 7317 -150 64 -727 C \nATOM 1841 C TRP A 230 -4.732 14.675 -61.037 1.00 40.87 C \nANISOU 1841 C TRP A 230 3625 4121 7782 -131 18 -721 C \nATOM 1842 O TRP A 230 -4.029 13.612 -60.865 1.00 37.01 O \nANISOU 1842 O TRP A 230 3170 3621 7269 -142 18 -686 O \nATOM 1843 CB TRP A 230 -6.998 14.630 -60.070 1.00 34.42 C \nANISOU 1843 CB TRP A 230 2804 3328 6946 -169 53 -709 C \nATOM 1844 CG TRP A 230 -6.636 13.626 -59.018 1.00 35.22 C \nANISOU 1844 CG TRP A 230 2951 3402 7029 -181 42 -662 C \nATOM 1845 CD1 TRP A 230 -7.066 12.321 -58.945 1.00 35.60 C \nANISOU 1845 CD1 TRP A 230 3035 3453 7036 -196 79 -627 C \nATOM 1846 CD2 TRP A 230 -5.767 13.836 -57.868 1.00 34.97 C \nANISOU 1846 CD2 TRP A 230 2936 3338 7015 -176 -9 -644 C \nATOM 1847 NE1 TRP A 230 -6.518 11.706 -57.785 1.00 40.51 N \nANISOU 1847 NE1 TRP A 230 3690 4053 7650 -201 54 -590 N \nATOM 1848 CE2 TRP A 230 -5.728 12.613 -57.123 1.00 34.46 C \nANISOU 1848 CE2 TRP A 230 2911 3263 6918 -194 0 -599 C \nATOM 1849 CE3 TRP A 230 -4.946 14.917 -57.450 1.00 33.72 C \nANISOU 1849 CE3 TRP A 230 2764 3155 6892 -155 -63 -661 C \nATOM 1850 CZ2 TRP A 230 -4.957 12.454 -56.014 1.00 30.11 C \nANISOU 1850 CZ2 TRP A 230 2384 2688 6370 -199 -40 -573 C \nATOM 1851 CZ3 TRP A 230 -4.219 14.814 -56.263 1.00 29.67 C \nANISOU 1851 CZ3 TRP A 230 2281 2609 6384 -160 -106 -633 C \nATOM 1852 CH2 TRP A 230 -4.209 13.570 -55.572 1.00 31.67 C \nANISOU 1852 CH2 TRP A 230 2570 2858 6604 -186 -94 -589 C \nATOM 1853 N THR A 231 -4.269 15.933 -60.942 1.00 33.64 N \nANISOU 1853 N THR A 231 2689 3191 6901 -104 -22 -753 N \nATOM 1854 CA THR A 231 -2.925 16.204 -60.453 1.00 37.51 C \nANISOU 1854 CA THR A 231 3207 3637 7406 -89 -72 -747 C \nATOM 1855 C THR A 231 -2.888 17.533 -59.767 1.00 40.20 C \nANISOU 1855 C THR A 231 3533 3961 7781 -58 -117 -769 C \nATOM 1856 O THR A 231 -3.803 18.360 -59.912 1.00 43.98 O \nANISOU 1856 O THR A 231 3968 4473 8272 -44 -108 -798 O \nATOM 1857 CB THR A 231 -1.873 16.160 -61.563 1.00 38.54 C \nANISOU 1857 CB THR A 231 3347 3762 7535 -77 -71 -765 C \nATOM 1858 OG1 THR A 231 -0.580 16.394 -61.023 1.00 52.41 O \nANISOU 1858 OG1 THR A 231 5143 5470 9300 -71 -120 -757 O \nATOM 1859 CG2 THR A 231 -2.141 17.208 -62.593 1.00 38.26 C \nANISOU 1859 CG2 THR A 231 3271 3748 7519 -45 -61 -817 C \nATOM 1860 N ILE A 232 -1.853 17.745 -58.977 1.00 41.75 N \nANISOU 1860 N ILE A 232 3765 4110 7988 -49 -166 -754 N \nATOM 1861 CA ILE A 232 -1.602 19.083 -58.367 1.00 38.35 C \nANISOU 1861 CA ILE A 232 3328 3656 7588 -7 -216 -776 C \nATOM 1862 C ILE A 232 -0.589 19.798 -59.237 1.00 39.17 C \nANISOU 1862 C ILE A 232 3443 3734 7704 34 -235 -811 C \nATOM 1863 O ILE A 232 0.438 19.212 -59.623 1.00 37.10 O \nANISOU 1863 O ILE A 232 3225 3442 7429 17 -238 -800 O \nATOM 1864 CB ILE A 232 -1.081 18.941 -56.950 1.00 32.72 C \nANISOU 1864 CB ILE A 232 2656 2900 6876 -20 -261 -738 C \nATOM 1865 CG1 ILE A 232 -2.082 18.131 -56.090 1.00 30.43 C \nANISOU 1865 CG1 ILE A 232 2360 2634 6568 -62 -238 -703 C \nATOM 1866 CG2 ILE A 232 -0.831 20.241 -56.322 1.00 30.69 C \nANISOU 1866 CG2 ILE A 232 2396 2620 6645 27 -311 -755 C \nATOM 1867 CD1 ILE A 232 -3.492 18.578 -56.129 1.00 30.00 C \nANISOU 1867 CD1 ILE A 232 2256 2628 6517 -63 -211 -722 C \nATOM 1868 N LEU A 233 -0.881 21.037 -59.589 1.00 41.02 N \nANISOU 1868 N LEU A 233 3640 3986 7960 85 -245 -854 N \nATOM 1869 CA LEU A 233 0.030 21.818 -60.404 1.00 46.24 C \nANISOU 1869 CA LEU A 233 4316 4621 8633 133 -263 -892 C \nATOM 1870 C LEU A 233 0.676 22.856 -59.568 1.00 47.91 C \nANISOU 1870 C LEU A 233 4555 4785 8863 185 -323 -898 C \nATOM 1871 O LEU A 233 0.005 23.782 -59.125 1.00 58.04 O \nANISOU 1871 O LEU A 233 5794 6099 10160 223 -338 -914 O \nATOM 1872 CB LEU A 233 -0.685 22.444 -61.548 1.00 51.00 C \nANISOU 1872 CB LEU A 233 4857 5282 9241 163 -229 -940 C \nATOM 1873 CG LEU A 233 0.179 23.152 -62.570 1.00 54.23 C \nANISOU 1873 CG LEU A 233 5279 5670 9656 213 -238 -984 C \nATOM 1874 CD1 LEU A 233 1.110 22.167 -63.262 1.00 58.68 C \nANISOU 1874 CD1 LEU A 233 5895 6200 10201 173 -223 -970 C \nATOM 1875 CD2 LEU A 233 -0.701 23.858 -63.592 1.00 52.06 C \nANISOU 1875 CD2 LEU A 233 4930 5466 9384 243 -204 -1033 C \nATOM 1876 N LYS A 234 1.981 22.697 -59.322 1.00 50.07 N \nANISOU 1876 N LYS A 234 4904 4988 9132 182 -359 -882 N \nATOM 1877 CA LYS A 234 2.738 23.602 -58.434 1.00 51.88 C \nANISOU 1877 CA LYS A 234 5181 5156 9374 228 -421 -880 C \nATOM 1878 C LYS A 234 2.818 25.021 -59.033 1.00 52.72 C \nANISOU 1878 C LYS A 234 5267 5265 9497 318 -437 -934 C \nATOM 1879 O LYS A 234 2.687 25.200 -60.256 1.00 41.80 O \nANISOU 1879 O LYS A 234 3855 3912 8114 337 -404 -974 O \nATOM 1880 CB LYS A 234 4.152 23.095 -58.268 1.00 56.93 C \nANISOU 1880 CB LYS A 234 5914 5719 9998 198 -449 -857 C \nATOM 1881 CG LYS A 234 4.327 21.687 -57.739 1.00 57.51 C \nANISOU 1881 CG LYS A 234 6012 5793 10047 113 -437 -805 C \nATOM 1882 CD LYS A 234 4.275 21.645 -56.225 1.00 64.40 C \nANISOU 1882 CD LYS A 234 6905 6644 10922 99 -475 -764 C \nATOM 1883 CE LYS A 234 4.725 20.275 -55.719 1.00 71.43 C \nANISOU 1883 CE LYS A 234 7831 7528 11781 18 -469 -715 C \nATOM 1884 NZ LYS A 234 4.372 20.055 -54.281 1.00 86.13 N \nANISOU 1884 NZ LYS A 234 9695 9389 13642 -4 -492 -675 N \nATOM 1885 N PRO A 235 3.020 26.047 -58.169 1.00 65.80 N \nANISOU 1885 N PRO A 235 6939 6894 11168 379 -488 -937 N \nATOM 1886 CA PRO A 235 3.064 27.462 -58.534 1.00 62.23 C \nANISOU 1886 CA PRO A 235 6467 6450 10728 479 -510 -985 C \nATOM 1887 C PRO A 235 3.596 27.760 -59.916 1.00 65.71 C \nANISOU 1887 C PRO A 235 6921 6879 11165 514 -491 -1032 C \nATOM 1888 O PRO A 235 2.784 28.046 -60.791 1.00 66.57 O \nANISOU 1888 O PRO A 235 6954 7064 11277 532 -452 -1068 O \nATOM 1889 CB PRO A 235 3.915 28.026 -57.451 1.00 66.64 C \nANISOU 1889 CB PRO A 235 7098 6932 11290 518 -575 -965 C \nATOM 1890 CG PRO A 235 3.410 27.283 -56.228 1.00 68.25 C \nANISOU 1890 CG PRO A 235 7292 7149 11492 450 -580 -912 C \nATOM 1891 CD PRO A 235 3.019 25.912 -56.697 1.00 68.27 C \nANISOU 1891 CD PRO A 235 7275 7182 11481 358 -526 -892 C \nATOM 1892 N ASN A 236 4.895 27.652 -60.178 1.00 66.24 N \nANISOU 1892 N ASN A 236 7085 6860 11223 515 -513 -1032 N \nATOM 1893 CA ASN A 236 5.370 28.031 -61.533 1.00 70.64 C \nANISOU 1893 CA ASN A 236 7656 7408 11775 553 -494 -1082 C \nATOM 1894 C ASN A 236 5.564 26.905 -62.536 1.00 66.68 C \nANISOU 1894 C ASN A 236 7162 6918 11258 474 -447 -1079 C \nATOM 1895 O ASN A 236 6.390 27.007 -63.450 1.00 81.00 O \nANISOU 1895 O ASN A 236 9025 8692 13059 484 -442 -1108 O \nATOM 1896 CB ASN A 236 6.627 28.924 -61.451 1.00 78.46 C \nANISOU 1896 CB ASN A 236 8748 8302 12762 624 -546 -1102 C \nATOM 1897 CG ASN A 236 6.273 30.375 -61.196 1.00 79.28 C \nANISOU 1897 CG ASN A 236 8817 8428 12880 743 -575 -1136 C \nATOM 1898 OD1 ASN A 236 6.673 30.949 -60.189 1.00 86.90 O \nANISOU 1898 OD1 ASN A 236 9830 9341 13846 789 -627 -1118 O \nATOM 1899 ND2 ASN A 236 5.467 30.956 -62.078 1.00 76.88 N \nANISOU 1899 ND2 ASN A 236 8422 8209 12581 793 -541 -1183 N \nATOM 1900 N ASP A 237 4.780 25.854 -62.409 1.00 61.70 N \nANISOU 1900 N ASP A 237 6480 6342 10622 398 -410 -1047 N \nATOM 1901 CA ASP A 237 4.855 24.734 -63.356 1.00 55.44 C \nANISOU 1901 CA ASP A 237 5684 5572 9810 328 -362 -1041 C \nATOM 1902 C ASP A 237 3.750 24.928 -64.375 1.00 55.60 C \nANISOU 1902 C ASP A 237 5612 5680 9835 344 -312 -1077 C \nATOM 1903 O ASP A 237 2.737 25.554 -64.094 1.00 68.74 O \nANISOU 1903 O ASP A 237 7206 7398 11513 379 -307 -1090 O \nATOM 1904 CB ASP A 237 4.702 23.418 -62.594 1.00 55.39 C \nANISOU 1904 CB ASP A 237 5685 5572 9788 242 -353 -982 C \nATOM 1905 CG ASP A 237 5.148 22.188 -63.398 1.00 53.65 C \nANISOU 1905 CG ASP A 237 5485 5361 9539 171 -317 -966 C \nATOM 1906 OD1 ASP A 237 5.273 22.232 -64.633 1.00 51.68 O \nANISOU 1906 OD1 ASP A 237 5223 5131 9283 178 -288 -1001 O \nATOM 1907 OD2 ASP A 237 5.267 21.114 -62.757 1.00 51.65 O \nANISOU 1907 OD2 ASP A 237 5250 5107 9267 107 -315 -918 O \nATOM 1908 N ALA A 238 3.948 24.392 -65.561 1.00 54.10 N \nANISOU 1908 N ALA A 238 5420 5506 9629 315 -273 -1094 N \nATOM 1909 CA ALA A 238 2.919 24.364 -66.601 1.00 49.75 C \nANISOU 1909 CA ALA A 238 4786 5039 9077 313 -220 -1122 C \nATOM 1910 C ALA A 238 2.432 22.938 -66.885 1.00 51.02 C \nANISOU 1910 C ALA A 238 4929 5240 9217 230 -174 -1085 C \nATOM 1911 O ALA A 238 3.204 21.962 -66.714 1.00 45.36 O \nANISOU 1911 O ALA A 238 4267 4487 8481 178 -178 -1050 O \nATOM 1912 CB ALA A 238 3.477 24.939 -67.864 1.00 51.14 C \nANISOU 1912 CB ALA A 238 4972 5211 9249 353 -209 -1175 C \nATOM 1913 N ILE A 239 1.150 22.811 -67.296 1.00 45.63 N \nANISOU 1913 N ILE A 239 4171 4634 8534 218 -130 -1093 N \nATOM 1914 CA ILE A 239 0.581 21.512 -67.641 1.00 39.85 C \nANISOU 1914 CA ILE A 239 3423 3939 7777 151 -84 -1060 C \nATOM 1915 C ILE A 239 0.255 21.503 -69.089 1.00 43.78 C \nANISOU 1915 C ILE A 239 3882 4488 8264 150 -39 -1096 C \nATOM 1916 O ILE A 239 -0.296 22.479 -69.550 1.00 46.63 O \nANISOU 1916 O ILE A 239 4193 4887 8637 192 -32 -1139 O \nATOM 1917 CB ILE A 239 -0.627 21.141 -66.795 1.00 43.12 C \nANISOU 1917 CB ILE A 239 3803 4389 8192 124 -70 -1029 C \nATOM 1918 CG1 ILE A 239 -1.249 19.809 -67.317 1.00 46.00 C \nANISOU 1918 CG1 ILE A 239 4158 4792 8527 65 -18 -999 C \nATOM 1919 CG2 ILE A 239 -1.660 22.221 -66.830 1.00 44.21 C \nANISOU 1919 CG2 ILE A 239 3874 4579 8344 160 -65 -1065 C \nATOM 1920 CD1 ILE A 239 -2.212 19.182 -66.367 1.00 44.54 C \nANISOU 1920 CD1 ILE A 239 3967 4622 8334 31 -6 -959 C \nATOM 1921 N ASN A 240 0.623 20.407 -69.819 1.00 45.25 N \nANISOU 1921 N ASN A 240 4089 4680 8424 103 -9 -1077 N \nATOM 1922 CA ASN A 240 0.414 20.325 -71.278 1.00 49.64 C \nANISOU 1922 CA ASN A 240 4613 5283 8966 99 34 -1109 C \nATOM 1923 C ASN A 240 -0.573 19.198 -71.643 1.00 48.70 C \nANISOU 1923 C ASN A 240 4465 5219 8821 48 85 -1078 C \nATOM 1924 O ASN A 240 -0.473 18.094 -71.161 1.00 50.16 O \nANISOU 1924 O ASN A 240 4678 5395 8987 10 90 -1030 O \nATOM 1925 CB ASN A 240 1.727 20.061 -72.008 1.00 58.76 C \nANISOU 1925 CB ASN A 240 5818 6404 10106 89 28 -1119 C \nATOM 1926 CG ASN A 240 2.837 21.042 -71.635 1.00 62.31 C \nANISOU 1926 CG ASN A 240 6319 6784 10573 134 -24 -1145 C \nATOM 1927 OD1 ASN A 240 3.036 22.071 -72.301 1.00 61.47 O \nANISOU 1927 OD1 ASN A 240 6204 6675 10477 186 -29 -1198 O \nATOM 1928 ND2 ASN A 240 3.557 20.724 -70.565 1.00 65.22 N \nANISOU 1928 ND2 ASN A 240 6746 7095 10941 117 -63 -1108 N \nATOM 1929 N PHE A 241 -1.544 19.492 -72.475 1.00 46.56 N \nANISOU 1929 N PHE A 241 4140 5006 8546 51 123 -1106 N \nATOM 1930 CA PHE A 241 -2.496 18.497 -72.916 1.00 38.07 C \nANISOU 1930 CA PHE A 241 3046 3977 7443 7 172 -1080 C \nATOM 1931 C PHE A 241 -2.332 18.332 -74.400 1.00 41.17 C \nANISOU 1931 C PHE A 241 3421 4405 7816 0 207 -1106 C \nATOM 1932 O PHE A 241 -2.202 19.336 -75.121 1.00 44.17 O \nANISOU 1932 O PHE A 241 3773 4801 8209 33 205 -1159 O \nATOM 1933 CB PHE A 241 -3.948 18.952 -72.633 1.00 37.59 C \nANISOU 1933 CB PHE A 241 2939 3959 7385 3 190 -1087 C \nATOM 1934 CG PHE A 241 -4.313 19.025 -71.167 1.00 37.37 C \nANISOU 1934 CG PHE A 241 2923 3905 7370 1 162 -1058 C \nATOM 1935 CD1 PHE A 241 -4.687 17.871 -70.493 1.00 36.71 C \nANISOU 1935 CD1 PHE A 241 2873 3808 7267 -37 174 -1005 C \nATOM 1936 CD2 PHE A 241 -4.305 20.194 -70.489 1.00 36.04 C \nANISOU 1936 CD2 PHE A 241 2735 3729 7229 39 125 -1083 C \nATOM 1937 CE1 PHE A 241 -4.948 17.891 -69.165 1.00 35.93 C \nANISOU 1937 CE1 PHE A 241 2789 3684 7178 -41 149 -978 C \nATOM 1938 CE2 PHE A 241 -4.652 20.246 -69.130 1.00 36.46 C \nANISOU 1938 CE2 PHE A 241 2799 3762 7293 33 99 -1055 C \nATOM 1939 CZ PHE A 241 -4.947 19.100 -68.465 1.00 36.15 C \nANISOU 1939 CZ PHE A 241 2794 3704 7235 -9 110 -1003 C \nATOM 1940 N GLU A 242 -2.453 17.090 -74.866 1.00 39.06 N \nANISOU 1940 N GLU A 242 3168 4158 7516 -38 240 -1071 N \nATOM 1941 CA GLU A 242 -2.498 16.819 -76.259 1.00 42.07 C \nANISOU 1941 CA GLU A 242 3529 4582 7873 -51 279 -1090 C \nATOM 1942 C GLU A 242 -3.423 15.624 -76.518 1.00 46.74 C \nANISOU 1942 C GLU A 242 4120 5210 8428 -87 323 -1048 C \nATOM 1943 O GLU A 242 -3.302 14.567 -75.908 1.00 59.79 O \nANISOU 1943 O GLU A 242 5806 6849 10062 -104 323 -998 O \nATOM 1944 CB GLU A 242 -1.067 16.522 -76.785 1.00 44.99 C \nANISOU 1944 CB GLU A 242 3932 4930 8232 -54 264 -1095 C \nATOM 1945 CG GLU A 242 -0.965 16.599 -78.316 1.00 46.39 C \nANISOU 1945 CG GLU A 242 4085 5151 8392 -59 298 -1130 C \nATOM 1946 CD GLU A 242 0.235 15.924 -78.911 1.00 49.27 C \nANISOU 1946 CD GLU A 242 4482 5509 8730 -82 296 -1122 C \nATOM 1947 OE1 GLU A 242 0.108 15.485 -80.046 1.00 49.46 O \nANISOU 1947 OE1 GLU A 242 4486 5580 8726 -100 332 -1128 O \nATOM 1948 OE2 GLU A 242 1.284 15.840 -78.247 1.00 61.52 O \nANISOU 1948 OE2 GLU A 242 6078 7013 10285 -85 259 -1108 O \nATOM 1949 N SER A 243 -4.305 15.753 -77.486 1.00 42.13 N \nANISOU 1949 N SER A 243 3502 4676 7830 -97 363 -1069 N \nATOM 1950 CA SER A 243 -5.198 14.668 -77.807 1.00 38.21 C \nANISOU 1950 CA SER A 243 3014 4209 7295 -127 406 -1031 C \nATOM 1951 C SER A 243 -5.862 14.884 -79.121 1.00 43.25 C \nANISOU 1951 C SER A 243 3617 4901 7915 -140 447 -1061 C \nATOM 1952 O SER A 243 -6.063 16.070 -79.571 1.00 51.24 O \nANISOU 1952 O SER A 243 4587 5936 8947 -127 444 -1115 O \nATOM 1953 CB SER A 243 -6.287 14.553 -76.769 1.00 35.93 C \nANISOU 1953 CB SER A 243 2737 3908 7007 -139 408 -1004 C \nATOM 1954 OG SER A 243 -7.230 13.521 -77.110 1.00 32.44 O \nANISOU 1954 OG SER A 243 2315 3488 6522 -165 452 -969 O \nATOM 1955 N ASN A 244 -6.251 13.739 -79.714 1.00 35.25 N \nANISOU 1955 N ASN A 244 2622 3911 6859 -162 484 -1026 N \nATOM 1956 CA ASN A 244 -6.942 13.749 -80.976 1.00 38.02 C \nANISOU 1956 CA ASN A 244 2949 4313 7184 -180 527 -1045 C \nATOM 1957 C ASN A 244 -8.190 12.966 -80.887 1.00 38.19 C \nANISOU 1957 C ASN A 244 2996 4344 7169 -206 562 -1006 C \nATOM 1958 O ASN A 244 -8.750 12.486 -81.879 1.00 35.10 O \nANISOU 1958 O ASN A 244 2605 3988 6741 -224 601 -1000 O \nATOM 1959 CB ASN A 244 -6.033 13.232 -82.064 1.00 38.34 C \nANISOU 1959 CB ASN A 244 2987 4378 7204 -180 538 -1048 C \nATOM 1960 CG ASN A 244 -5.775 11.796 -81.932 1.00 32.83 C \nANISOU 1960 CG ASN A 244 2327 3678 6468 -185 549 -989 C \nATOM 1961 OD1 ASN A 244 -5.753 11.246 -80.861 1.00 36.73 O \nANISOU 1961 OD1 ASN A 244 2853 4141 6962 -179 533 -949 O \nATOM 1962 ND2 ASN A 244 -5.616 11.159 -83.050 1.00 33.11 N \nANISOU 1962 ND2 ASN A 244 2357 3755 6467 -195 578 -982 N \nATOM 1963 N GLY A 245 -8.649 12.839 -79.660 1.00 41.56 N \nANISOU 1963 N GLY A 245 3451 4736 7605 -207 547 -980 N \nATOM 1964 CA GLY A 245 -9.885 12.129 -79.450 1.00 53.88 C \nANISOU 1964 CA GLY A 245 5049 6295 9129 -231 580 -943 C \nATOM 1965 C GLY A 245 -10.061 11.632 -78.032 1.00 53.82 C \nANISOU 1965 C GLY A 245 5086 6240 9124 -226 561 -902 C \nATOM 1966 O GLY A 245 -9.126 11.433 -77.245 1.00 65.22 O \nANISOU 1966 O GLY A 245 6539 7655 10588 -203 527 -886 O \nATOM 1967 N ASN A 246 -11.320 11.412 -77.752 1.00 50.95 N \nANISOU 1967 N ASN A 246 4754 5871 8735 -253 586 -886 N \nATOM 1968 CA ASN A 246 -11.826 10.986 -76.467 1.00 43.44 C \nANISOU 1968 CA ASN A 246 3850 4877 7777 -257 578 -850 C \nATOM 1969 C ASN A 246 -11.386 11.709 -75.260 1.00 38.67 C \nANISOU 1969 C ASN A 246 3229 4245 7218 -247 533 -861 C \nATOM 1970 O ASN A 246 -11.404 11.149 -74.186 1.00 42.74 O \nANISOU 1970 O ASN A 246 3785 4724 7730 -240 520 -825 O \nATOM 1971 CB ASN A 246 -11.660 9.478 -76.240 1.00 45.22 C \nANISOU 1971 CB ASN A 246 4136 5082 7964 -235 592 -792 C \nATOM 1972 CG ASN A 246 -11.839 8.693 -77.490 1.00 47.18 C \nANISOU 1972 CG ASN A 246 4397 5361 8167 -232 632 -778 C \nATOM 1973 OD1 ASN A 246 -11.453 9.147 -78.534 1.00 46.91 O \nANISOU 1973 OD1 ASN A 246 4319 5364 8141 -236 637 -809 O \nATOM 1974 ND2 ASN A 246 -12.534 7.570 -77.403 1.00 49.47 N \nANISOU 1974 ND2 ASN A 246 4753 5637 8407 -226 662 -732 N \nATOM 1975 N PHE A 247 -11.065 12.978 -75.399 1.00 42.85 N \nANISOU 1975 N PHE A 247 3701 4794 7787 -243 509 -910 N \nATOM 1976 CA PHE A 247 -10.553 13.799 -74.322 1.00 44.25 C \nANISOU 1976 CA PHE A 247 3858 4947 8007 -226 462 -924 C \nATOM 1977 C PHE A 247 -11.708 14.524 -73.626 1.00 49.11 C \nANISOU 1977 C PHE A 247 4464 5570 8624 -257 461 -937 C \nATOM 1978 O PHE A 247 -12.603 15.103 -74.269 1.00 59.38 O \nANISOU 1978 O PHE A 247 5737 6915 9911 -288 486 -966 O \nATOM 1979 CB PHE A 247 -9.657 14.844 -74.911 1.00 48.32 C \nANISOU 1979 CB PHE A 247 4320 5482 8558 -199 438 -974 C \nATOM 1980 CG PHE A 247 -8.992 15.740 -73.882 1.00 52.93 C \nANISOU 1980 CG PHE A 247 4887 6038 9185 -171 386 -990 C \nATOM 1981 CD1 PHE A 247 -8.736 15.291 -72.610 1.00 52.39 C \nANISOU 1981 CD1 PHE A 247 4857 5924 9126 -167 359 -952 C \nATOM 1982 CD2 PHE A 247 -8.613 17.023 -74.208 1.00 49.30 C \nANISOU 1982 CD2 PHE A 247 4376 5600 8756 -144 364 -1042 C \nATOM 1983 CE1 PHE A 247 -8.088 16.093 -71.705 1.00 53.39 C \nANISOU 1983 CE1 PHE A 247 4972 6024 9289 -140 311 -964 C \nATOM 1984 CE2 PHE A 247 -8.004 17.827 -73.288 1.00 49.55 C \nANISOU 1984 CE2 PHE A 247 4399 5603 8823 -112 316 -1055 C \nATOM 1985 CZ PHE A 247 -7.729 17.364 -72.039 1.00 50.46 C \nANISOU 1985 CZ PHE A 247 4555 5670 8947 -112 289 -1015 C \nATOM 1986 N ILE A 248 -11.701 14.468 -72.311 1.00 41.62 N \nANISOU 1986 N ILE A 248 3540 4585 7689 -254 434 -914 N \nATOM 1987 CA ILE A 248 -12.669 15.139 -71.522 1.00 39.00 C \nANISOU 1987 CA ILE A 248 3199 4261 7358 -285 429 -924 C \nATOM 1988 C ILE A 248 -11.843 16.244 -70.881 1.00 39.66 C \nANISOU 1988 C ILE A 248 3237 4343 7491 -249 377 -952 C \nATOM 1989 O ILE A 248 -11.279 16.078 -69.804 1.00 34.43 O \nANISOU 1989 O ILE A 248 2597 3638 6848 -231 343 -928 O \nATOM 1990 CB ILE A 248 -13.303 14.246 -70.457 1.00 41.97 C \nANISOU 1990 CB ILE A 248 3642 4595 7709 -308 436 -876 C \nATOM 1991 CG1 ILE A 248 -13.804 12.922 -71.016 1.00 48.08 C \nANISOU 1991 CG1 ILE A 248 4479 5355 8433 -321 482 -839 C \nATOM 1992 CG2 ILE A 248 -14.471 14.945 -69.852 1.00 42.16 C \nANISOU 1992 CG2 ILE A 248 3658 4638 7724 -355 439 -890 C \nATOM 1993 CD1 ILE A 248 -14.809 13.070 -72.144 1.00 52.08 C \nANISOU 1993 CD1 ILE A 248 4981 5901 8905 -361 525 -859 C \nATOM 1994 N ALA A 249 -11.829 17.425 -71.549 1.00 41.78 N \nANISOU 1994 N ALA A 249 3439 4660 7776 -238 371 -1004 N \nATOM 1995 CA ALA A 249 -10.979 18.543 -71.147 1.00 36.26 C \nANISOU 1995 CA ALA A 249 2697 3961 7120 -191 324 -1036 C \nATOM 1996 C ALA A 249 -11.505 19.304 -69.948 1.00 41.65 C \nANISOU 1996 C ALA A 249 3361 4652 7814 -197 295 -1039 C \nATOM 1997 O ALA A 249 -12.703 19.378 -69.725 1.00 42.35 O \nANISOU 1997 O ALA A 249 3444 4772 7875 -246 317 -1037 O \nATOM 1998 CB ALA A 249 -10.830 19.511 -72.300 1.00 42.13 C \nANISOU 1998 CB ALA A 249 3378 4758 7869 -169 330 -1091 C \nATOM 1999 N PRO A 250 -10.598 19.897 -69.174 1.00 39.14 N \nANISOU 1999 N PRO A 250 3035 4305 7532 -150 246 -1044 N \nATOM 2000 CA PRO A 250 -10.936 20.754 -68.080 1.00 42.07 C \nANISOU 2000 CA PRO A 250 3379 4688 7916 -145 213 -1051 C \nATOM 2001 C PRO A 250 -11.302 22.145 -68.522 1.00 49.15 C \nANISOU 2001 C PRO A 250 4197 5661 8818 -125 206 -1106 C \nATOM 2002 O PRO A 250 -10.939 22.554 -69.597 1.00 46.91 O \nANISOU 2002 O PRO A 250 3881 5405 8537 -97 216 -1142 O \nATOM 2003 CB PRO A 250 -9.646 20.817 -67.267 1.00 39.60 C \nANISOU 2003 CB PRO A 250 3095 4313 7639 -95 161 -1036 C \nATOM 2004 CG PRO A 250 -8.571 20.480 -68.180 1.00 36.69 C \nANISOU 2004 CG PRO A 250 2744 3918 7279 -65 164 -1043 C \nATOM 2005 CD PRO A 250 -9.156 19.698 -69.314 1.00 37.61 C \nANISOU 2005 CD PRO A 250 2865 4062 7364 -103 219 -1040 C \nATOM 2006 N GLU A 251 -12.137 22.814 -67.727 1.00 62.69 N \nANISOU 2006 N GLU A 251 5877 7418 10524 -146 195 -1112 N \nATOM 2007 CA GLU A 251 -12.462 24.221 -67.902 1.00 59.71 C \nANISOU 2007 CA GLU A 251 5415 7124 10148 -121 181 -1162 C \nATOM 2008 C GLU A 251 -12.102 24.886 -66.620 1.00 56.47 C \nANISOU 2008 C GLU A 251 4996 6700 9762 -82 129 -1155 C \nATOM 2009 O GLU A 251 -11.469 25.914 -66.627 1.00 60.79 O \nANISOU 2009 O GLU A 251 5500 7266 10330 -11 94 -1188 O \nATOM 2010 CB GLU A 251 -13.941 24.424 -68.173 1.00 68.00 C \nANISOU 2010 CB GLU A 251 6425 8258 11153 -195 220 -1175 C \nATOM 2011 CG GLU A 251 -14.304 25.894 -68.408 1.00 75.39 C \nANISOU 2011 CG GLU A 251 7261 9300 12082 -170 207 -1229 C \nATOM 2012 CD GLU A 251 -15.725 26.121 -68.894 1.00 68.45 C \nANISOU 2012 CD GLU A 251 6338 8518 11151 -252 249 -1248 C \nATOM 2013 OE1 GLU A 251 -16.487 25.145 -69.015 1.00 70.72 O \nANISOU 2013 OE1 GLU A 251 6682 8782 11408 -331 288 -1218 O \nATOM 2014 OE2 GLU A 251 -16.051 27.277 -69.189 1.00 68.94 O \nANISOU 2014 OE2 GLU A 251 6313 8682 11201 -236 243 -1293 O \nATOM 2015 N TYR A 252 -12.486 24.275 -65.508 1.00 51.10 N \nANISOU 2015 N TYR A 252 4358 5983 9074 -125 122 -1113 N \nATOM 2016 CA TYR A 252 -12.259 24.825 -64.193 1.00 57.67 C \nANISOU 2016 CA TYR A 252 5185 6803 9924 -99 74 -1101 C \nATOM 2017 C TYR A 252 -11.293 23.986 -63.343 1.00 59.95 C \nANISOU 2017 C TYR A 252 5551 6989 10237 -82 46 -1055 C \nATOM 2018 O TYR A 252 -11.317 22.764 -63.379 1.00 66.96 O \nANISOU 2018 O TYR A 252 6501 7828 11115 -121 72 -1019 O \nATOM 2019 CB TYR A 252 -13.582 24.913 -63.436 1.00 57.87 C \nANISOU 2019 CB TYR A 252 5191 6880 9916 -171 86 -1090 C \nATOM 2020 CG TYR A 252 -14.547 25.870 -63.997 1.00 57.88 C \nANISOU 2020 CG TYR A 252 5110 6994 9887 -195 105 -1134 C \nATOM 2021 CD1 TYR A 252 -14.350 27.258 -63.868 1.00 65.71 C \nANISOU 2021 CD1 TYR A 252 6020 8059 10890 -134 69 -1173 C \nATOM 2022 CD2 TYR A 252 -15.668 25.428 -64.666 1.00 60.00 C \nANISOU 2022 CD2 TYR A 252 5381 7305 10113 -277 157 -1137 C \nATOM 2023 CE1 TYR A 252 -15.249 28.164 -64.390 1.00 65.07 C \nANISOU 2023 CE1 TYR A 252 5851 8098 10774 -156 87 -1215 C \nATOM 2024 CE2 TYR A 252 -16.564 26.330 -65.191 1.00 65.66 C \nANISOU 2024 CE2 TYR A 252 6018 8135 10796 -308 175 -1178 C \nATOM 2025 CZ TYR A 252 -16.342 27.685 -65.051 1.00 68.28 C \nANISOU 2025 CZ TYR A 252 6259 8546 11137 -248 140 -1217 C \nATOM 2026 OH TYR A 252 -17.266 28.537 -65.592 1.00 90.51 O \nANISOU 2026 OH TYR A 252 8990 11487 13912 -283 160 -1257 O \nATOM 2027 N ALA A 253 -10.443 24.670 -62.595 1.00 58.13 N \nANISOU 2027 N ALA A 253 5317 6734 10037 -21 -7 -1056 N \nATOM 2028 CA ALA A 253 -9.498 24.020 -61.712 1.00 57.79 C \nANISOU 2028 CA ALA A 253 5342 6601 10014 -7 -40 -1015 C \nATOM 2029 C ALA A 253 -9.750 24.605 -60.361 1.00 52.62 C \nANISOU 2029 C ALA A 253 4673 5956 9364 -4 -79 -1002 C \nATOM 2030 O ALA A 253 -10.487 25.534 -60.256 1.00 56.22 O \nANISOU 2030 O ALA A 253 5065 6487 9809 -2 -83 -1029 O \nATOM 2031 CB ALA A 253 -8.066 24.280 -62.176 1.00 59.01 C \nANISOU 2031 CB ALA A 253 5519 6705 10197 63 -69 -1029 C \nATOM 2032 N TYR A 254 -9.092 24.093 -59.352 1.00 51.59 N \nANISOU 2032 N TYR A 254 4600 5755 9247 -2 -110 -963 N \nATOM 2033 CA TYR A 254 -9.304 24.507 -57.991 1.00 56.12 C \nANISOU 2033 CA TYR A 254 5169 6332 9823 -4 -148 -944 C \nATOM 2034 C TYR A 254 -7.999 24.953 -57.354 1.00 62.18 C \nANISOU 2034 C TYR A 254 5965 7039 10621 62 -207 -935 C \nATOM 2035 O TYR A 254 -7.076 24.164 -57.202 1.00 65.79 O \nANISOU 2035 O TYR A 254 6488 7421 11088 62 -217 -907 O \nATOM 2036 CB TYR A 254 -9.866 23.339 -57.199 1.00 59.43 C \nANISOU 2036 CB TYR A 254 5639 6719 10222 -77 -127 -898 C \nATOM 2037 CG TYR A 254 -11.253 22.945 -57.621 1.00 61.71 C \nANISOU 2037 CG TYR A 254 5912 7061 10474 -147 -73 -903 C \nATOM 2038 CD1 TYR A 254 -11.456 21.939 -58.558 1.00 63.42 C \nANISOU 2038 CD1 TYR A 254 6163 7261 10674 -178 -23 -896 C \nATOM 2039 CD2 TYR A 254 -12.366 23.575 -57.081 1.00 62.98 C \nANISOU 2039 CD2 TYR A 254 6029 7288 10613 -186 -71 -914 C \nATOM 2040 CE1 TYR A 254 -12.727 21.584 -58.964 1.00 65.59 C \nANISOU 2040 CE1 TYR A 254 6435 7576 10911 -242 26 -900 C \nATOM 2041 CE2 TYR A 254 -13.639 23.227 -57.466 1.00 63.16 C \nANISOU 2041 CE2 TYR A 254 6047 7354 10596 -259 -22 -918 C \nATOM 2042 CZ TYR A 254 -13.818 22.233 -58.403 1.00 65.72 C \nANISOU 2042 CZ TYR A 254 6413 7653 10904 -286 27 -911 C \nATOM 2043 OH TYR A 254 -15.074 21.865 -58.791 1.00 62.16 O \nANISOU 2043 OH TYR A 254 5971 7237 10410 -359 76 -914 O \nATOM 2044 N LYS A 255 -7.937 26.217 -56.961 1.00 67.86 N \nANISOU 2044 N LYS A 255 6637 7795 11350 118 -247 -959 N \nATOM 2045 CA LYS A 255 -6.793 26.758 -56.268 1.00 63.46 C \nANISOU 2045 CA LYS A 255 6113 7182 10818 184 -306 -950 C \nATOM 2046 C LYS A 255 -6.865 26.377 -54.836 1.00 57.48 C \nANISOU 2046 C LYS A 255 5388 6393 10058 149 -333 -905 C \nATOM 2047 O LYS A 255 -7.898 26.511 -54.240 1.00 61.55 O \nANISOU 2047 O LYS A 255 5866 6965 10557 109 -325 -900 O \nATOM 2048 CB LYS A 255 -6.890 28.256 -56.297 1.00 68.69 C \nANISOU 2048 CB LYS A 255 6707 7908 11484 259 -337 -990 C \nATOM 2049 CG LYS A 255 -5.739 28.943 -56.980 1.00 75.70 C \nANISOU 2049 CG LYS A 255 7613 8758 12392 351 -363 -1021 C \nATOM 2050 CD LYS A 255 -5.607 30.393 -56.528 1.00 73.06 C \nANISOU 2050 CD LYS A 255 7233 8466 12062 442 -411 -1046 C \nATOM 2051 CE LYS A 255 -6.443 31.343 -57.361 1.00 69.76 C \nANISOU 2051 CE LYS A 255 6715 8165 11627 473 -388 -1098 C \nATOM 2052 NZ LYS A 255 -6.382 32.712 -56.789 1.00 67.71 N \nANISOU 2052 NZ LYS A 255 6405 7957 11364 564 -436 -1118 N \nATOM 2053 N ILE A 256 -5.773 25.950 -54.247 1.00 57.07 N \nANISOU 2053 N ILE A 256 5407 6256 10021 162 -367 -874 N \nATOM 2054 CA ILE A 256 -5.872 25.605 -52.850 1.00 61.63 C \nANISOU 2054 CA ILE A 256 6013 6809 10594 127 -393 -832 C \nATOM 2055 C ILE A 256 -5.464 26.726 -51.872 1.00 71.73 C \nANISOU 2055 C ILE A 256 7282 8087 11886 187 -456 -831 C \nATOM 2056 O ILE A 256 -4.291 27.042 -51.678 1.00 77.82 O \nANISOU 2056 O ILE A 256 8101 8794 12674 240 -500 -825 O \nATOM 2057 CB ILE A 256 -5.251 24.241 -52.512 1.00 57.40 C \nANISOU 2057 CB ILE A 256 5556 6199 10056 79 -386 -787 C \nATOM 2058 CG1 ILE A 256 -4.230 24.349 -51.404 1.00 57.83 C \nANISOU 2058 CG1 ILE A 256 5664 6189 10121 99 -444 -756 C \nATOM 2059 CG2 ILE A 256 -4.720 23.567 -53.749 1.00 57.15 C \nANISOU 2059 CG2 ILE A 256 5549 6142 10023 76 -352 -798 C \nATOM 2060 CD1 ILE A 256 -4.853 24.244 -50.044 1.00 57.48 C \nANISOU 2060 CD1 ILE A 256 5615 6158 10066 61 -460 -725 C \nATOM 2061 N VAL A 257 -6.479 27.264 -51.222 1.00 80.33 N \nANISOU 2061 N VAL A 257 8314 9248 12962 171 -459 -834 N \nATOM 2062 CA VAL A 257 -6.302 28.207 -50.130 1.00 83.26 C \nANISOU 2062 CA VAL A 257 8669 9629 13337 215 -516 -826 C \nATOM 2063 C VAL A 257 -7.510 28.068 -49.221 1.00 88.38 C \nANISOU 2063 C VAL A 257 9280 10339 13961 146 -505 -808 C \nATOM 2064 O VAL A 257 -8.607 28.481 -49.603 1.00104.19 O \nANISOU 2064 O VAL A 257 11211 12433 15944 123 -475 -836 O \nATOM 2065 CB VAL A 257 -6.107 29.649 -50.648 1.00 80.34 C \nANISOU 2065 CB VAL A 257 8242 9310 12974 314 -543 -870 C \nATOM 2066 CG1 VAL A 257 -7.302 30.166 -51.477 1.00 68.45 C \nANISOU 2066 CG1 VAL A 257 6641 7921 11448 303 -501 -913 C \nATOM 2067 CG2 VAL A 257 -5.744 30.558 -49.477 1.00 79.74 C \nANISOU 2067 CG2 VAL A 257 8164 9233 12901 372 -607 -856 C \nATOM 2068 N LYS A 258 -7.356 27.479 -48.038 1.00 87.02 N \nANISOU 2068 N LYS A 258 9156 10120 13786 106 -525 -765 N \nATOM 2069 CA LYS A 258 -6.082 27.234 -47.395 1.00 86.21 C \nANISOU 2069 CA LYS A 258 9129 9925 13702 134 -571 -733 C \nATOM 2070 C LYS A 258 -5.873 25.770 -47.013 1.00 81.73 C \nANISOU 2070 C LYS A 258 8632 9294 13129 61 -549 -691 C \nATOM 2071 O LYS A 258 -6.767 24.933 -47.171 1.00 71.80 O \nANISOU 2071 O LYS A 258 7369 8061 11852 -7 -499 -686 O \nATOM 2072 CB LYS A 258 -6.020 28.058 -46.127 1.00103.83 C \nANISOU 2072 CB LYS A 258 11347 12170 15933 163 -628 -716 C \nATOM 2073 CG LYS A 258 -6.974 27.553 -45.058 1.00117.47 C \nANISOU 2073 CG LYS A 258 13065 13930 17638 81 -617 -687 C \nATOM 2074 CD LYS A 258 -7.148 28.536 -43.920 1.00130.63 C \nANISOU 2074 CD LYS A 258 14696 15638 19298 109 -668 -678 C \nATOM 2075 CE LYS A 258 -8.086 29.665 -44.323 1.00136.65 C \nANISOU 2075 CE LYS A 258 15358 16517 20046 137 -661 -719 C \nATOM 2076 NZ LYS A 258 -8.332 30.627 -43.210 1.00137.33 N \nANISOU 2076 NZ LYS A 258 15400 16660 20119 163 -710 -710 N \nATOM 2077 N LYS A 259 -4.666 25.475 -46.523 1.00 82.94 N \nANISOU 2077 N LYS A 259 8854 9366 13293 77 -588 -663 N \nATOM 2078 CA LYS A 259 -4.312 24.143 -45.998 1.00 79.36 C \nANISOU 2078 CA LYS A 259 8466 8858 12829 14 -576 -620 C \nATOM 2079 C LYS A 259 -4.318 24.093 -44.461 1.00 82.10 C \nANISOU 2079 C LYS A 259 8835 9193 13168 -13 -615 -582 C \nATOM 2080 O LYS A 259 -3.511 24.764 -43.822 1.00 74.71 O \nANISOU 2080 O LYS A 259 7922 8222 12243 29 -672 -571 O \nATOM 2081 CB LYS A 259 -2.947 23.682 -46.500 1.00 73.13 C \nANISOU 2081 CB LYS A 259 7743 7995 12049 31 -589 -611 C \nATOM 2082 CG LYS A 259 -2.950 23.089 -47.880 1.00 75.57 C \nANISOU 2082 CG LYS A 259 8048 8308 12355 23 -538 -633 C \nATOM 2083 CD LYS A 259 -1.979 21.925 -48.020 1.00 77.04 C \nANISOU 2083 CD LYS A 259 8302 8438 12532 -11 -531 -605 C \nATOM 2084 CE LYS A 259 -1.928 21.372 -49.428 1.00 79.83 C \nANISOU 2084 CE LYS A 259 8650 8800 12880 -14 -483 -626 C \nATOM 2085 NZ LYS A 259 -1.283 22.336 -50.377 1.00 89.80 N \nANISOU 2085 NZ LYS A 259 9907 10049 14162 49 -500 -665 N \nATOM 2086 N GLY A 260 -5.219 23.287 -43.884 1.00 78.45 N \nANISOU 2086 N GLY A 260 8369 8754 12684 -83 -583 -562 N \nATOM 2087 CA GLY A 260 -5.275 23.090 -42.431 1.00 78.02 C \nANISOU 2087 CA GLY A 260 8337 8688 12618 -117 -613 -525 C \nATOM 2088 C GLY A 260 -5.755 21.703 -42.049 1.00 84.27 C \nANISOU 2088 C GLY A 260 9163 9471 13384 -192 -571 -497 C \nATOM 2089 O GLY A 260 -5.423 20.727 -42.699 1.00 98.23 O \nANISOU 2089 O GLY A 260 10965 11213 15146 -207 -538 -491 O \nATOM 2090 N ASP A 261 -6.532 21.611 -40.985 1.00 79.78 N \nANISOU 2090 N ASP A 261 8588 8928 12797 -235 -573 -480 N \nATOM 2091 CA ASP A 261 -6.998 20.332 -40.519 1.00 79.06 C \nANISOU 2091 CA ASP A 261 8535 8827 12678 -299 -536 -454 C \nATOM 2092 C ASP A 261 -8.393 20.123 -41.068 1.00 76.98 C \nANISOU 2092 C ASP A 261 8244 8612 12394 -336 -478 -477 C \nATOM 2093 O ASP A 261 -9.148 21.075 -41.257 1.00 80.79 O \nANISOU 2093 O ASP A 261 8670 9148 12877 -331 -478 -505 O \nATOM 2094 CB ASP A 261 -6.995 20.262 -38.981 1.00 83.16 C \nANISOU 2094 CB ASP A 261 9075 9338 13184 -331 -571 -420 C \nATOM 2095 CG ASP A 261 -5.602 19.974 -38.382 1.00 87.72 C \nANISOU 2095 CG ASP A 261 9703 9857 13769 -318 -617 -387 C \nATOM 2096 OD1 ASP A 261 -4.791 19.245 -39.013 1.00100.06 O \nANISOU 2096 OD1 ASP A 261 11302 11384 15333 -311 -605 -380 O \nATOM 2097 OD2 ASP A 261 -5.323 20.454 -37.260 1.00 78.78 O \nANISOU 2097 OD2 ASP A 261 8578 8718 12638 -319 -666 -367 O \nATOM 2098 N SER A 262 -8.732 18.868 -41.315 1.00 78.08 N \nANISOU 2098 N SER A 262 8423 8735 12509 -372 -428 -465 N \nATOM 2099 CA SER A 262 -10.054 18.486 -41.746 1.00 76.25 C \nANISOU 2099 CA SER A 262 8186 8537 12250 -415 -370 -480 C \nATOM 2100 C SER A 262 -10.141 16.954 -41.717 1.00 86.09 C \nANISOU 2100 C SER A 262 9495 9749 13465 -443 -327 -455 C \nATOM 2101 O SER A 262 -9.137 16.253 -41.407 1.00 86.25 O \nANISOU 2101 O SER A 262 9551 9732 13487 -429 -343 -427 O \nATOM 2102 CB SER A 262 -10.292 18.996 -43.179 1.00 75.29 C \nANISOU 2102 CB SER A 262 8023 8444 12140 -388 -344 -519 C \nATOM 2103 OG SER A 262 -11.360 18.290 -43.798 1.00 92.70 O \nANISOU 2103 OG SER A 262 10244 10664 14314 -428 -281 -528 O \nATOM 2104 N ALA A 263 -11.332 16.432 -42.028 1.00 76.62 N \nANISOU 2104 N ALA A 263 8313 8566 12234 -482 -272 -464 N \nATOM 2105 CA ALA A 263 -11.451 15.046 -42.462 1.00 74.92 C \nANISOU 2105 CA ALA A 263 8152 8324 11990 -489 -222 -448 C \nATOM 2106 C ALA A 263 -12.719 14.909 -43.245 1.00 65.56 C \nANISOU 2106 C ALA A 263 6972 7160 10777 -519 -166 -471 C \nATOM 2107 O ALA A 263 -13.321 15.883 -43.614 1.00 57.73 O \nANISOU 2107 O ALA A 263 5934 6206 9793 -531 -167 -500 O \nATOM 2108 CB ALA A 263 -11.397 14.072 -41.283 1.00 83.95 C \nANISOU 2108 CB ALA A 263 9350 9442 13105 -513 -223 -412 C \nATOM 2109 N ILE A 264 -13.116 13.680 -43.512 1.00 70.16 N \nANISOU 2109 N ILE A 264 7613 7720 11325 -528 -117 -457 N \nATOM 2110 CA ILE A 264 -14.305 13.446 -44.271 1.00 60.51 C \nANISOU 2110 CA ILE A 264 6412 6508 10071 -558 -62 -475 C \nATOM 2111 C ILE A 264 -15.166 12.463 -43.475 1.00 63.34 C \nANISOU 2111 C ILE A 264 6847 6840 10379 -597 -28 -455 C \nATOM 2112 O ILE A 264 -14.915 11.260 -43.444 1.00 80.47 O \nANISOU 2112 O ILE A 264 9071 8979 12524 -575 -4 -430 O \nATOM 2113 CB ILE A 264 -13.967 12.922 -45.672 1.00 59.50 C \nANISOU 2113 CB ILE A 264 6286 6375 9946 -520 -29 -482 C \nATOM 2114 CG1 ILE A 264 -13.364 14.043 -46.500 1.00 60.08 C \nANISOU 2114 CG1 ILE A 264 6286 6477 10064 -489 -57 -511 C \nATOM 2115 CG2 ILE A 264 -15.218 12.362 -46.337 1.00 63.29 C \nANISOU 2115 CG2 ILE A 264 6812 6853 10381 -552 33 -491 C \nATOM 2116 CD1 ILE A 264 -12.756 13.596 -47.808 1.00 56.13 C \nANISOU 2116 CD1 ILE A 264 5782 5973 9573 -448 -36 -516 C \nATOM 2117 N VAL A 265 -16.194 13.008 -42.844 1.00 62.30 N \nANISOU 2117 N VAL A 265 6719 6726 10227 -655 -26 -466 N \nATOM 2118 CA VAL A 265 -17.105 12.257 -42.000 1.00 57.68 C \nANISOU 2118 CA VAL A 265 6210 6116 9591 -702 3 -451 C \nATOM 2119 C VAL A 265 -18.187 11.619 -42.842 1.00 55.21 C \nANISOU 2119 C VAL A 265 5959 5787 9232 -726 67 -461 C \nATOM 2120 O VAL A 265 -18.704 12.241 -43.751 1.00 61.26 O \nANISOU 2120 O VAL A 265 6695 6581 10001 -746 83 -488 O \nATOM 2121 CB VAL A 265 -17.724 13.184 -40.960 1.00 61.76 C \nANISOU 2121 CB VAL A 265 6703 6661 10102 -761 -25 -460 C \nATOM 2122 CG1 VAL A 265 -18.689 12.430 -40.049 1.00 78.71 C \nANISOU 2122 CG1 VAL A 265 8936 8779 12193 -815 6 -447 C \nATOM 2123 CG2 VAL A 265 -16.632 13.826 -40.128 1.00 46.03 C \nANISOU 2123 CG2 VAL A 265 4655 4682 8154 -732 -90 -448 C \nATOM 2124 N LYS A 266 -18.540 10.392 -42.501 1.00 58.51 N \nANISOU 2124 N LYS A 266 6466 6160 9605 -724 103 -440 N \nATOM 2125 CA LYS A 266 -19.594 9.636 -43.166 1.00 62.41 C \nANISOU 2125 CA LYS A 266 7041 6626 10046 -743 165 -444 C \nATOM 2126 C LYS A 266 -20.802 9.643 -42.282 1.00 67.29 C \nANISOU 2126 C LYS A 266 7725 7228 10615 -819 183 -447 C \nATOM 2127 O LYS A 266 -21.204 8.592 -41.777 1.00 80.18 O \nANISOU 2127 O LYS A 266 9451 8814 12200 -816 213 -429 O \nATOM 2128 CB LYS A 266 -19.165 8.170 -43.408 1.00 61.07 C \nANISOU 2128 CB LYS A 266 6937 6416 9851 -678 195 -416 C \nATOM 2129 CG LYS A 266 -17.882 7.995 -44.234 1.00 59.69 C \nANISOU 2129 CG LYS A 266 6703 6259 9717 -605 179 -409 C \nATOM 2130 CD LYS A 266 -18.010 8.646 -45.593 1.00 63.14 C \nANISOU 2130 CD LYS A 266 7094 6721 10176 -606 190 -435 C \nATOM 2131 CE LYS A 266 -17.348 7.847 -46.703 1.00 64.12 C \nANISOU 2131 CE LYS A 266 7219 6843 10301 -541 212 -425 C \nATOM 2132 NZ LYS A 266 -18.144 8.037 -47.983 1.00 72.18 N \nANISOU 2132 NZ LYS A 266 8249 7869 11306 -559 252 -448 N \nATOM 2133 N SER A 267 -21.415 10.819 -42.135 1.00 68.18 N \nANISOU 2133 N SER A 267 7790 7383 10733 -886 166 -472 N \nATOM 2134 CA SER A 267 -22.628 10.972 -41.307 1.00 70.62 C \nANISOU 2134 CA SER A 267 8156 7687 10990 -975 182 -480 C \nATOM 2135 C SER A 267 -23.887 11.037 -42.134 1.00 64.09 C \nANISOU 2135 C SER A 267 7379 6860 10114 -1040 231 -502 C \nATOM 2136 O SER A 267 -23.853 11.477 -43.259 1.00 62.87 O \nANISOU 2136 O SER A 267 7177 6735 9978 -1030 239 -519 O \nATOM 2137 CB SER A 267 -22.518 12.232 -40.446 1.00 77.06 C \nANISOU 2137 CB SER A 267 8886 8562 11833 -1017 129 -490 C \nATOM 2138 OG SER A 267 -23.693 12.410 -39.656 1.00 75.65 O \nANISOU 2138 OG SER A 267 8757 8387 11601 -1111 144 -498 O \nATOM 2139 N GLU A 268 -24.996 10.602 -41.554 1.00 76.69 N \nANISOU 2139 N GLU A 268 9075 8420 11645 -1108 264 -501 N \nATOM 2140 CA GLU A 268 -26.361 10.859 -42.102 1.00 78.90 C \nANISOU 2140 CA GLU A 268 9408 8704 11867 -1201 306 -524 C \nATOM 2141 C GLU A 268 -27.077 11.976 -41.313 1.00 65.46 C \nANISOU 2141 C GLU A 268 7663 7062 10146 -1306 283 -544 C \nATOM 2142 O GLU A 268 -28.100 12.480 -41.701 1.00 76.23 O \nANISOU 2142 O GLU A 268 9041 8457 11468 -1394 306 -567 O \nATOM 2143 CB GLU A 268 -27.196 9.569 -42.077 1.00 80.32 C \nANISOU 2143 CB GLU A 268 9747 8796 11974 -1213 364 -510 C \nATOM 2144 CG GLU A 268 -28.467 9.641 -42.923 1.00 93.52 C \nANISOU 2144 CG GLU A 268 11490 10458 13585 -1294 413 -530 C \nATOM 2145 CD GLU A 268 -29.474 8.523 -42.666 1.00104.33 C \nANISOU 2145 CD GLU A 268 13034 11736 14871 -1325 467 -519 C \nATOM 2146 OE1 GLU A 268 -29.392 7.484 -43.356 1.00115.65 O \nANISOU 2146 OE1 GLU A 268 14545 13110 16286 -1255 502 -503 O \nATOM 2147 OE2 GLU A 268 -30.383 8.687 -41.814 1.00101.80 O \nANISOU 2147 OE2 GLU A 268 12777 11403 14497 -1419 475 -526 O \nATOM 2148 N VAL A 269 -26.501 12.329 -40.188 1.00 58.68 N \nANISOU 2148 N VAL A 269 6754 6225 9317 -1295 237 -534 N \nATOM 2149 CA VAL A 269 -27.041 13.300 -39.267 1.00 52.79 C \nANISOU 2149 CA VAL A 269 5966 5539 8555 -1382 210 -547 C \nATOM 2150 C VAL A 269 -27.018 14.680 -39.906 1.00 58.31 C \nANISOU 2150 C VAL A 269 6536 6337 9282 -1404 183 -575 C \nATOM 2151 O VAL A 269 -26.140 15.026 -40.733 1.00 54.87 O \nANISOU 2151 O VAL A 269 6018 5926 8904 -1327 163 -579 O \nATOM 2152 CB VAL A 269 -26.193 13.324 -37.975 1.00 53.26 C \nANISOU 2152 CB VAL A 269 5991 5597 8648 -1344 161 -525 C \nATOM 2153 CG1 VAL A 269 -26.570 14.468 -37.069 1.00 53.55 C \nANISOU 2153 CG1 VAL A 269 5960 5710 8677 -1421 123 -537 C \nATOM 2154 CG2 VAL A 269 -26.325 11.985 -37.244 1.00 50.33 C \nANISOU 2154 CG2 VAL A 269 5747 5137 8238 -1330 189 -500 C \nATOM 2155 N GLU A 270 -28.001 15.484 -39.525 1.00 63.12 N \nANISOU 2155 N GLU A 270 7128 7010 9846 -1511 182 -595 N \nATOM 2156 CA GLU A 270 -28.142 16.819 -40.080 1.00 64.78 C \nANISOU 2156 CA GLU A 270 7215 7329 10069 -1541 160 -624 C \nATOM 2157 C GLU A 270 -27.397 17.871 -39.248 1.00 59.43 C \nANISOU 2157 C GLU A 270 6415 6726 9438 -1510 94 -623 C \nATOM 2158 O GLU A 270 -26.980 17.627 -38.147 1.00 52.61 O \nANISOU 2158 O GLU A 270 5568 5834 8586 -1492 66 -601 O \nATOM 2159 CB GLU A 270 -29.607 17.173 -40.197 1.00 78.85 C \nANISOU 2159 CB GLU A 270 9034 9155 11770 -1678 196 -648 C \nATOM 2160 CG GLU A 270 -30.376 17.093 -38.885 1.00 88.96 C \nANISOU 2160 CG GLU A 270 10377 10430 12993 -1774 196 -642 C \nATOM 2161 CD GLU A 270 -31.822 17.547 -39.032 1.00 96.21 C \nANISOU 2161 CD GLU A 270 11326 11404 13825 -1923 229 -668 C \nATOM 2162 OE1 GLU A 270 -32.181 18.039 -40.133 1.00 98.45 O \nANISOU 2162 OE1 GLU A 270 11566 11743 14097 -1950 246 -691 O \nATOM 2163 OE2 GLU A 270 -32.582 17.418 -38.043 1.00 97.59 O \nANISOU 2163 OE2 GLU A 270 11569 11570 13941 -2017 236 -665 O \nATOM 2164 N TYR A 271 -27.248 19.047 -39.823 1.00 59.73 N \nANISOU 2164 N TYR A 271 6332 6862 9500 -1501 68 -648 N \nATOM 2165 CA TYR A 271 -26.595 20.163 -39.163 1.00 64.96 C \nANISOU 2165 CA TYR A 271 6876 7605 10202 -1465 5 -650 C \nATOM 2166 C TYR A 271 -27.525 20.666 -38.077 1.00 69.85 C \nANISOU 2166 C TYR A 271 7492 8286 10764 -1573 -4 -654 C \nATOM 2167 O TYR A 271 -28.723 20.393 -38.108 1.00 84.65 O \nANISOU 2167 O TYR A 271 9436 10161 12566 -1684 40 -665 O \nATOM 2168 CB TYR A 271 -26.329 21.253 -40.201 1.00 66.52 C \nANISOU 2168 CB TYR A 271 6953 7894 10428 -1425 -12 -679 C \nATOM 2169 CG TYR A 271 -25.558 22.434 -39.708 1.00 68.43 C \nANISOU 2169 CG TYR A 271 7071 8216 10713 -1365 -77 -682 C \nATOM 2170 CD1 TYR A 271 -24.315 22.290 -39.168 1.00 66.17 C \nANISOU 2170 CD1 TYR A 271 6776 7878 10488 -1267 -121 -657 C \nATOM 2171 CD2 TYR A 271 -26.092 23.726 -39.801 1.00 81.40 C \nANISOU 2171 CD2 TYR A 271 8605 9993 12331 -1406 -95 -711 C \nATOM 2172 CE1 TYR A 271 -23.596 23.389 -38.731 1.00 72.58 C \nANISOU 2172 CE1 TYR A 271 7484 8757 11337 -1206 -183 -659 C \nATOM 2173 CE2 TYR A 271 -25.384 24.841 -39.353 1.00 81.95 C \nANISOU 2173 CE2 TYR A 271 8562 10140 12436 -1338 -157 -714 C \nATOM 2174 CZ TYR A 271 -24.132 24.668 -38.826 1.00 78.09 C \nANISOU 2174 CZ TYR A 271 8076 9585 12010 -1236 -201 -687 C \nATOM 2175 OH TYR A 271 -23.450 25.776 -38.384 1.00 79.93 O \nANISOU 2175 OH TYR A 271 8208 9887 12273 -1167 -262 -689 O \nATOM 2176 N GLY A 272 -26.988 21.392 -37.114 1.00 73.80 N \nANISOU 2176 N GLY A 272 7915 8836 11289 -1547 -61 -645 N \nATOM 2177 CA GLY A 272 -27.755 21.800 -35.928 1.00 69.27 C \nANISOU 2177 CA GLY A 272 7339 8318 10662 -1645 -74 -644 C \nATOM 2178 C GLY A 272 -27.463 23.192 -35.412 1.00 70.02 C \nANISOU 2178 C GLY A 272 7296 8536 10773 -1628 -134 -653 C \nATOM 2179 O GLY A 272 -27.846 23.523 -34.299 1.00 74.35 O \nANISOU 2179 O GLY A 272 7834 9129 11287 -1690 -156 -646 O \nATOM 2180 N ASN A 273 -26.733 23.988 -36.187 1.00 70.57 N \nANISOU 2180 N ASN A 273 7262 8659 10892 -1538 -163 -666 N \nATOM 2181 CA ASN A 273 -26.269 25.316 -35.748 1.00 75.95 C \nANISOU 2181 CA ASN A 273 7811 9451 11594 -1491 -225 -672 C \nATOM 2182 C ASN A 273 -25.618 25.363 -34.350 1.00 84.47 C \nANISOU 2182 C ASN A 273 8891 10509 12697 -1459 -277 -640 C \nATOM 2183 O ASN A 273 -25.945 26.225 -33.554 1.00 94.16 O \nANISOU 2183 O ASN A 273 10048 11833 13894 -1497 -311 -643 O \nATOM 2184 CB ASN A 273 -27.409 26.304 -35.818 1.00 65.80 C \nANISOU 2184 CB ASN A 273 6448 8312 10241 -1592 -218 -703 C \nATOM 2185 CG ASN A 273 -28.063 26.310 -37.182 1.00 69.52 C \nANISOU 2185 CG ASN A 273 6916 8814 10685 -1631 -168 -734 C \nATOM 2186 OD1 ASN A 273 -27.700 27.085 -38.055 1.00 63.25 O \nANISOU 2186 OD1 ASN A 273 6026 8089 9917 -1565 -181 -756 O \nATOM 2187 ND2 ASN A 273 -29.052 25.431 -37.373 1.00 73.34 N \nANISOU 2187 ND2 ASN A 273 7511 9243 11113 -1739 -109 -736 N \nATOM 2188 N CYS A 274 -24.670 24.464 -34.095 1.00 95.11 N \nANISOU 2188 N CYS A 274 10309 11736 14093 -1387 -285 -611 N \nATOM 2189 CA CYS A 274 -24.010 24.368 -32.787 1.00101.08 C \nANISOU 2189 CA CYS A 274 11078 12458 14869 -1360 -331 -578 C \nATOM 2190 C CYS A 274 -22.511 24.607 -32.936 1.00100.52 C \nANISOU 2190 C CYS A 274 10968 12349 14875 -1224 -381 -563 C \nATOM 2191 O CYS A 274 -22.052 24.953 -34.021 1.00 99.77 O \nANISOU 2191 O CYS A 274 10830 12264 14815 -1155 -380 -580 O \nATOM 2192 CB CYS A 274 -24.292 23.012 -32.135 1.00 97.78 C \nANISOU 2192 CB CYS A 274 10791 11934 14426 -1413 -296 -555 C \nATOM 2193 SG CYS A 274 -24.764 21.719 -33.293 1.00106.16 S \nANISOU 2193 SG CYS A 274 11964 12900 15472 -1433 -218 -564 S \nATOM 2194 N ASN A 275 -21.779 24.448 -31.835 1.00105.51 N \nANISOU 2194 N ASN A 275 11619 12940 15529 -1192 -423 -530 N \nATOM 2195 CA ASN A 275 -20.326 24.524 -31.834 1.00106.99 C \nANISOU 2195 CA ASN A 275 11794 13075 15782 -1076 -470 -510 C \nATOM 2196 C ASN A 275 -19.711 23.459 -30.963 1.00110.59 C \nANISOU 2196 C ASN A 275 12338 13429 16250 -1071 -476 -473 C \nATOM 2197 O ASN A 275 -20.318 23.042 -29.983 1.00115.54 O \nANISOU 2197 O ASN A 275 13011 14053 16838 -1147 -467 -460 O \nATOM 2198 CB ASN A 275 -19.892 25.882 -31.285 1.00106.75 C \nANISOU 2198 CB ASN A 275 11664 13131 15766 -1026 -538 -509 C \nATOM 2199 CG ASN A 275 -19.921 26.965 -32.332 1.00106.72 C \nANISOU 2199 CG ASN A 275 11563 13212 15773 -974 -545 -543 C \nATOM 2200 OD1 ASN A 275 -19.911 26.688 -33.517 1.00114.55 O \nANISOU 2200 OD1 ASN A 275 12565 14181 16779 -953 -509 -563 O \nATOM 2201 ND2 ASN A 275 -19.965 28.210 -31.895 1.00111.26 N \nANISOU 2201 ND2 ASN A 275 12044 13893 16337 -951 -592 -550 N \nATOM 2202 N THR A 276 -18.483 23.081 -31.301 1.00106.71 N \nANISOU 2202 N THR A 276 11869 12865 15812 -982 -495 -457 N \nATOM 2203 CA THR A 276 -17.726 22.088 -30.554 1.00110.92 C \nANISOU 2203 CA THR A 276 12477 13309 16358 -968 -504 -421 C \nATOM 2204 C THR A 276 -16.254 22.162 -30.965 1.00119.45 C \nANISOU 2204 C THR A 276 13549 14341 17497 -865 -542 -407 C \nATOM 2205 O THR A 276 -15.931 22.745 -31.991 1.00132.29 O \nANISOU 2205 O THR A 276 15128 15985 19151 -809 -546 -429 O \nATOM 2206 CB THR A 276 -18.279 20.672 -30.790 1.00118.49 C \nANISOU 2206 CB THR A 276 13533 14202 17288 -1017 -438 -418 C \nATOM 2207 OG1 THR A 276 -17.486 19.711 -30.086 1.00119.36 O \nANISOU 2207 OG1 THR A 276 13707 14237 17408 -996 -448 -384 O \nATOM 2208 CG2 THR A 276 -18.256 20.315 -32.239 1.00121.37 C \nANISOU 2208 CG2 THR A 276 13906 14542 17667 -984 -396 -438 C \nATOM 2209 N LYS A 277 -15.368 21.610 -30.146 1.00116.22 N \nANISOU 2209 N LYS A 277 13185 13872 17102 -846 -571 -373 N \nATOM 2210 CA LYS A 277 -13.989 21.373 -30.548 1.00120.38 C \nANISOU 2210 CA LYS A 277 13728 14337 17674 -767 -596 -357 C \nATOM 2211 C LYS A 277 -13.834 19.886 -30.814 1.00122.37 C \nANISOU 2211 C LYS A 277 14061 14518 17916 -780 -549 -344 C \nATOM 2212 O LYS A 277 -12.766 19.419 -31.269 1.00141.67 O \nANISOU 2212 O LYS A 277 16529 16911 20389 -728 -557 -332 O \nATOM 2213 CB LYS A 277 -13.011 21.826 -29.459 1.00131.30 C \nANISOU 2213 CB LYS A 277 15107 15708 19075 -735 -666 -326 C \nATOM 2214 CG LYS A 277 -11.544 21.841 -29.894 1.00136.08 C \nANISOU 2214 CG LYS A 277 15725 16255 19723 -655 -701 -313 C \nATOM 2215 CD LYS A 277 -10.540 22.323 -28.853 1.00134.46 C \nANISOU 2215 CD LYS A 277 15525 16032 19533 -625 -771 -281 C \nATOM 2216 CE LYS A 277 -9.113 22.206 -29.362 1.00132.75 C \nANISOU 2216 CE LYS A 277 15339 15749 19350 -559 -799 -269 C \nATOM 2217 NZ LYS A 277 -8.898 22.700 -30.756 1.00129.72 N \nANISOU 2217 NZ LYS A 277 14924 15369 18995 -499 -787 -301 N \nATOM 2218 N CYS A 278 -14.900 19.140 -30.526 1.00102.99 N \nANISOU 2218 N CYS A 278 11650 12063 15417 -851 -500 -347 N \nATOM 2219 CA CYS A 278 -14.902 17.727 -30.763 1.00110.57 C \nANISOU 2219 CA CYS A 278 12687 12965 16360 -859 -451 -336 C \nATOM 2220 C CYS A 278 -16.204 17.290 -31.419 1.00106.15 C \nANISOU 2220 C CYS A 278 12158 12414 15762 -909 -384 -361 C \nATOM 2221 O CYS A 278 -17.271 17.487 -30.845 1.00 96.51 O \nANISOU 2221 O CYS A 278 10943 11224 14501 -979 -370 -370 O \nATOM 2222 CB CYS A 278 -14.703 16.975 -29.451 1.00112.60 C \nANISOU 2222 CB CYS A 278 12996 13192 16593 -889 -462 -304 C \nATOM 2223 SG CYS A 278 -14.639 15.203 -29.757 1.00128.76 S \nANISOU 2223 SG CYS A 278 15133 15177 18613 -884 -403 -290 S \nATOM 2224 N GLN A 279 -16.084 16.647 -32.590 1.00 90.49 N \nANISOU 2224 N GLN A 279 10197 10399 13785 -877 -343 -370 N \nATOM 2225 CA GLN A 279 -17.234 16.178 -33.345 1.00 70.16 C \nANISOU 2225 CA GLN A 279 7660 7824 11173 -917 -279 -392 C \nATOM 2226 C GLN A 279 -17.090 14.712 -33.716 1.00 70.50 C \nANISOU 2226 C GLN A 279 7784 7805 11198 -896 -232 -377 C \nATOM 2227 O GLN A 279 -15.985 14.254 -34.005 1.00 70.87 O \nANISOU 2227 O GLN A 279 7831 7824 11274 -836 -246 -361 O \nATOM 2228 CB GLN A 279 -17.366 17.016 -34.588 1.00 61.06 C \nANISOU 2228 CB GLN A 279 6446 6712 10044 -895 -274 -423 C \nATOM 2229 CG GLN A 279 -18.466 16.566 -35.520 1.00 66.10 C \nANISOU 2229 CG GLN A 279 7122 7348 10645 -935 -208 -445 C \nATOM 2230 CD GLN A 279 -19.865 16.917 -35.020 1.00 67.46 C \nANISOU 2230 CD GLN A 279 7307 7559 10765 -1030 -187 -461 C \nATOM 2231 OE1 GLN A 279 -20.215 18.106 -34.897 1.00 57.52 O \nANISOU 2231 OE1 GLN A 279 5974 6374 9507 -1057 -214 -479 O \nATOM 2232 NE2 GLN A 279 -20.683 15.898 -34.774 1.00 63.36 N \nANISOU 2232 NE2 GLN A 279 6883 6997 10195 -1080 -138 -455 N \nATOM 2233 N THR A 280 -18.208 13.982 -33.708 1.00 67.94 N \nANISOU 2233 N THR A 280 7530 7461 10821 -947 -177 -384 N \nATOM 2234 CA THR A 280 -18.214 12.571 -34.148 1.00 66.21 C \nANISOU 2234 CA THR A 280 7393 7188 10576 -920 -127 -372 C \nATOM 2235 C THR A 280 -19.258 12.467 -35.223 1.00 65.95 C \nANISOU 2235 C THR A 280 7390 7153 10516 -946 -72 -397 C \nATOM 2236 O THR A 280 -20.032 13.410 -35.410 1.00 68.56 O \nANISOU 2236 O THR A 280 7684 7527 10840 -998 -72 -422 O \nATOM 2237 CB THR A 280 -18.466 11.562 -33.005 1.00 68.45 C \nANISOU 2237 CB THR A 280 7757 7435 10815 -942 -111 -349 C \nATOM 2238 OG1 THR A 280 -19.774 11.003 -33.103 1.00 78.64 O \nANISOU 2238 OG1 THR A 280 9130 8702 12047 -993 -54 -362 O \nATOM 2239 CG2 THR A 280 -18.305 12.206 -31.644 1.00 67.25 C \nANISOU 2239 CG2 THR A 280 7575 7308 10668 -978 -162 -338 C \nATOM 2240 N PRO A 281 -19.299 11.345 -35.946 1.00 67.43 N \nANISOU 2240 N PRO A 281 7641 7298 10682 -911 -24 -391 N \nATOM 2241 CA PRO A 281 -20.322 11.175 -36.982 1.00 76.31 C \nANISOU 2241 CA PRO A 281 8805 8413 11774 -937 30 -413 C \nATOM 2242 C PRO A 281 -21.772 11.186 -36.500 1.00 72.67 C \nANISOU 2242 C PRO A 281 8412 7946 11252 -1027 63 -426 C \nATOM 2243 O PRO A 281 -22.658 11.644 -37.230 1.00 77.93 O \nANISOU 2243 O PRO A 281 9080 8632 11899 -1076 90 -450 O \nATOM 2244 CB PRO A 281 -20.007 9.783 -37.555 1.00 79.36 C \nANISOU 2244 CB PRO A 281 9260 8750 12142 -875 71 -395 C \nATOM 2245 CG PRO A 281 -18.555 9.604 -37.314 1.00 75.33 C \nANISOU 2245 CG PRO A 281 8702 8246 11676 -807 29 -372 C \nATOM 2246 CD PRO A 281 -18.355 10.228 -35.953 1.00 72.37 C \nANISOU 2246 CD PRO A 281 8296 7888 11312 -843 -20 -364 C \nATOM 2247 N ILE A 282 -21.994 10.685 -35.290 1.00 62.42 N \nANISOU 2247 N ILE A 282 7172 6623 9922 -1053 62 -410 N \nATOM 2248 CA ILE A 282 -23.319 10.609 -34.740 1.00 59.39 C \nANISOU 2248 CA ILE A 282 6865 6225 9474 -1142 94 -421 C \nATOM 2249 C ILE A 282 -23.702 11.792 -33.816 1.00 66.02 C \nANISOU 2249 C ILE A 282 7647 7124 10315 -1221 54 -432 C \nATOM 2250 O ILE A 282 -24.832 11.847 -33.293 1.00 73.08 O \nANISOU 2250 O ILE A 282 8600 8016 11152 -1309 77 -443 O \nATOM 2251 CB ILE A 282 -23.525 9.291 -34.008 1.00 54.62 C \nANISOU 2251 CB ILE A 282 6375 5556 8821 -1129 126 -400 C \nATOM 2252 CG1 ILE A 282 -22.695 9.213 -32.753 1.00 58.19 C \nANISOU 2252 CG1 ILE A 282 6800 6016 9293 -1108 81 -378 C \nATOM 2253 CG2 ILE A 282 -23.205 8.150 -34.928 1.00 47.31 C \nANISOU 2253 CG2 ILE A 282 5503 4585 7888 -1048 165 -389 C \nATOM 2254 CD1 ILE A 282 -23.127 8.075 -31.842 1.00 59.57 C \nANISOU 2254 CD1 ILE A 282 7087 6138 9409 -1114 112 -363 C \nATOM 2255 N GLY A 283 -22.773 12.721 -33.615 1.00 59.19 N \nANISOU 2255 N GLY A 283 6671 6311 9508 -1189 -5 -429 N \nATOM 2256 CA GLY A 283 -23.064 13.924 -32.861 1.00 63.79 C \nANISOU 2256 CA GLY A 283 7184 6960 10093 -1250 -46 -439 C \nATOM 2257 C GLY A 283 -21.844 14.593 -32.271 1.00 60.97 C \nANISOU 2257 C GLY A 283 6737 6635 9795 -1197 -114 -423 C \nATOM 2258 O GLY A 283 -20.865 13.947 -31.994 1.00 58.10 O \nANISOU 2258 O GLY A 283 6387 6232 9456 -1134 -130 -398 O \nATOM 2259 N ALA A 284 -21.948 15.897 -32.044 1.00 58.75 N \nANISOU 2259 N ALA A 284 6367 6429 9528 -1225 -155 -437 N \nATOM 2260 CA ALA A 284 -20.937 16.655 -31.356 1.00 62.80 C \nANISOU 2260 CA ALA A 284 6801 6974 10087 -1183 -222 -421 C \nATOM 2261 C ALA A 284 -20.895 16.364 -29.840 1.00 68.65 C \nANISOU 2261 C ALA A 284 7576 7701 10806 -1216 -245 -397 C \nATOM 2262 O ALA A 284 -21.858 15.879 -29.249 1.00 75.20 O \nANISOU 2262 O ALA A 284 8475 8516 11579 -1290 -213 -399 O \nATOM 2263 CB ALA A 284 -21.168 18.131 -31.562 1.00 62.75 C \nANISOU 2263 CB ALA A 284 6691 7059 10094 -1199 -256 -444 C \nATOM 2264 N ILE A 285 -19.757 16.650 -29.224 1.00 68.08 N \nANISOU 2264 N ILE A 285 7461 7630 10776 -1163 -302 -374 N \nATOM 2265 CA ILE A 285 -19.668 16.626 -27.784 1.00 63.19 C \nANISOU 2265 CA ILE A 285 6856 7015 10141 -1196 -334 -352 C \nATOM 2266 C ILE A 285 -18.930 17.810 -27.195 1.00 70.26 C \nANISOU 2266 C ILE A 285 7661 7962 11073 -1169 -406 -342 C \nATOM 2267 O ILE A 285 -17.732 17.927 -27.334 1.00 75.74 O \nANISOU 2267 O ILE A 285 8327 8636 11813 -1095 -444 -326 O \nATOM 2268 CB ILE A 285 -19.142 15.265 -27.213 1.00 61.11 C \nANISOU 2268 CB ILE A 285 6675 6678 9865 -1173 -318 -324 C \nATOM 2269 CG1 ILE A 285 -19.066 15.357 -25.692 1.00 67.84 C \nANISOU 2269 CG1 ILE A 285 7533 7542 10700 -1212 -354 -303 C \nATOM 2270 CG2 ILE A 285 -17.818 14.806 -27.756 1.00 53.13 C \nANISOU 2270 CG2 ILE A 285 5655 5630 8901 -1084 -334 -307 C \nATOM 2271 CD1 ILE A 285 -20.396 15.751 -25.041 1.00 61.94 C \nANISOU 2271 CD1 ILE A 285 6802 6835 9899 -1311 -338 -320 C \nATOM 2272 N ASN A 286 -19.683 18.660 -26.491 1.00 86.29 N \nANISOU 2272 N ASN A 286 9654 10059 13075 -1234 -425 -351 N \nATOM 2273 CA ASN A 286 -19.152 19.741 -25.627 1.00 85.04 C \nANISOU 2273 CA ASN A 286 9420 9956 12936 -1219 -495 -337 C \nATOM 2274 C ASN A 286 -18.955 19.284 -24.176 1.00 87.73 C \nANISOU 2274 C ASN A 286 9803 10274 13256 -1251 -518 -307 C \nATOM 2275 O ASN A 286 -19.807 19.509 -23.334 1.00 85.43 O \nANISOU 2275 O ASN A 286 9515 10023 12920 -1330 -516 -310 O \nATOM 2276 CB ASN A 286 -20.098 20.941 -25.654 1.00 87.31 C \nANISOU 2276 CB ASN A 286 9632 10344 13197 -1272 -504 -363 C \nATOM 2277 CG ASN A 286 -19.634 22.079 -24.765 1.00 91.48 C \nANISOU 2277 CG ASN A 286 10082 10939 13739 -1253 -575 -349 C \nATOM 2278 OD1 ASN A 286 -18.478 22.135 -24.337 1.00 99.33 O \nANISOU 2278 OD1 ASN A 286 11069 11899 14772 -1185 -623 -322 O \nATOM 2279 ND2 ASN A 286 -20.546 22.992 -24.472 1.00 92.66 N \nANISOU 2279 ND2 ASN A 286 10171 11185 13849 -1314 -583 -366 N \nATOM 2280 N SER A 287 -17.824 18.637 -23.899 1.00 97.61 N \nANISOU 2280 N SER A 287 11085 11464 14537 -1195 -538 -279 N \nATOM 2281 CA SER A 287 -17.500 18.179 -22.542 1.00 98.51 C \nANISOU 2281 CA SER A 287 11237 11558 14633 -1219 -563 -249 C \nATOM 2282 C SER A 287 -16.071 18.469 -22.147 1.00 93.21 C \nANISOU 2282 C SER A 287 10537 10870 14007 -1152 -627 -218 C \nATOM 2283 O SER A 287 -15.354 19.172 -22.866 1.00 97.32 O \nANISOU 2283 O SER A 287 11007 11399 14573 -1086 -657 -222 O \nATOM 2284 CB SER A 287 -17.798 16.690 -22.395 1.00100.23 C \nANISOU 2284 CB SER A 287 11554 11712 14816 -1244 -506 -243 C \nATOM 2285 OG SER A 287 -19.201 16.465 -22.489 1.00102.60 O \nANISOU 2285 OG SER A 287 11895 12023 15064 -1320 -452 -268 O \nATOM 2286 N SER A 288 -15.688 17.979 -20.970 1.00 90.86 N \nANISOU 2286 N SER A 288 10276 10553 13694 -1173 -648 -189 N \nATOM 2287 CA SER A 288 -14.319 18.124 -20.477 1.00 90.14 C \nANISOU 2287 CA SER A 288 10173 10439 13636 -1121 -708 -157 C \nATOM 2288 C SER A 288 -13.966 16.965 -19.569 1.00 86.64 C \nANISOU 2288 C SER A 288 9798 9955 13168 -1146 -699 -130 C \nATOM 2289 O SER A 288 -14.183 17.044 -18.358 1.00 78.42 O \nANISOU 2289 O SER A 288 8765 8934 12099 -1194 -721 -114 O \nATOM 2290 CB SER A 288 -14.146 19.439 -19.730 1.00 86.88 C \nANISOU 2290 CB SER A 288 9696 10081 13234 -1120 -775 -146 C \nATOM 2291 OG SER A 288 -12.790 19.616 -19.380 1.00 90.75 O \nANISOU 2291 OG SER A 288 10185 10541 13756 -1066 -833 -115 O \nATOM 2292 N MET A 289 -13.427 15.906 -20.178 1.00 84.63 N \nANISOU 2292 N MET A 289 9587 9649 12918 -1111 -667 -125 N \nATOM 2293 CA MET A 289 -13.148 14.663 -19.488 1.00 92.29 C \nANISOU 2293 CA MET A 289 10621 10588 13857 -1127 -648 -105 C \nATOM 2294 C MET A 289 -12.107 13.835 -20.245 1.00 88.04 C \nANISOU 2294 C MET A 289 10103 10010 13338 -1069 -637 -94 C \nATOM 2295 O MET A 289 -12.076 13.814 -21.460 1.00 93.71 O \nANISOU 2295 O MET A 289 10810 10716 14078 -1029 -612 -111 O \nATOM 2296 CB MET A 289 -14.454 13.862 -19.323 1.00 97.16 C \nANISOU 2296 CB MET A 289 11295 11201 14421 -1181 -581 -124 C \nATOM 2297 CG MET A 289 -15.310 14.227 -18.111 1.00104.53 C \nANISOU 2297 CG MET A 289 12234 12167 15315 -1257 -591 -124 C \nATOM 2298 SD MET A 289 -16.631 13.023 -17.759 1.00118.37 S \nANISOU 2298 SD MET A 289 14083 13896 16996 -1317 -513 -141 S \nATOM 2299 CE MET A 289 -17.592 13.966 -16.592 1.00 84.04 C \nANISOU 2299 CE MET A 289 9715 9603 12615 -1410 -538 -147 C \nATOM 2300 N PRO A 290 -11.278 13.094 -19.531 1.00 99.58 N \nANISOU 2300 N PRO A 290 11593 11457 14785 -1068 -653 -64 N \nATOM 2301 CA PRO A 290 -10.197 12.360 -20.202 1.00101.79 C \nANISOU 2301 CA PRO A 290 11886 11712 15079 -1020 -648 -52 C \nATOM 2302 C PRO A 290 -10.665 11.222 -21.091 1.00 93.72 C \nANISOU 2302 C PRO A 290 10902 10675 14034 -999 -576 -69 C \nATOM 2303 O PRO A 290 -9.883 10.734 -21.936 1.00 90.07 O \nANISOU 2303 O PRO A 290 10439 10200 13585 -954 -567 -65 O \nATOM 2304 CB PRO A 290 -9.369 11.802 -19.036 1.00 97.35 C \nANISOU 2304 CB PRO A 290 11347 11151 14493 -1040 -680 -17 C \nATOM 2305 CG PRO A 290 -10.323 11.707 -17.914 1.00101.27 C \nANISOU 2305 CG PRO A 290 11864 11664 14949 -1097 -669 -18 C \nATOM 2306 CD PRO A 290 -11.303 12.841 -18.085 1.00105.64 C \nANISOU 2306 CD PRO A 290 12383 12236 15518 -1117 -673 -42 C \nATOM 2307 N PHE A 291 -11.912 10.796 -20.925 1.00 83.82 N \nANISOU 2307 N PHE A 291 9684 9422 12741 -1031 -525 -87 N \nATOM 2308 CA PHE A 291 -12.407 9.675 -21.727 1.00 92.82 C \nANISOU 2308 CA PHE A 291 10872 10543 13853 -1006 -456 -101 C \nATOM 2309 C PHE A 291 -13.847 9.825 -22.224 1.00 86.76 C \nANISOU 2309 C PHE A 291 10129 9770 13068 -1032 -406 -134 C \nATOM 2310 O PHE A 291 -14.619 10.637 -21.712 1.00 79.72 O \nANISOU 2310 O PHE A 291 9225 8895 12171 -1084 -418 -145 O \nATOM 2311 CB PHE A 291 -12.255 8.379 -20.945 1.00 95.55 C \nANISOU 2311 CB PHE A 291 11271 10886 14148 -1009 -432 -83 C \nATOM 2312 CG PHE A 291 -10.862 8.157 -20.410 1.00100.24 C \nANISOU 2312 CG PHE A 291 11844 11494 14750 -996 -479 -51 C \nATOM 2313 CD1 PHE A 291 -10.531 8.527 -19.120 1.00102.24 C \nANISOU 2313 CD1 PHE A 291 12088 11761 14996 -1037 -527 -30 C \nATOM 2314 CD2 PHE A 291 -9.888 7.601 -21.203 1.00 98.70 C \nANISOU 2314 CD2 PHE A 291 11638 11299 14564 -948 -476 -41 C \nATOM 2315 CE1 PHE A 291 -9.264 8.320 -18.611 1.00 99.30 C \nANISOU 2315 CE1 PHE A 291 11703 11401 14625 -1033 -571 1 C \nATOM 2316 CE2 PHE A 291 -8.614 7.389 -20.709 1.00104.21 C \nANISOU 2316 CE2 PHE A 291 12321 12013 15262 -947 -519 -11 C \nATOM 2317 CZ PHE A 291 -8.299 7.748 -19.411 1.00103.12 C \nANISOU 2317 CZ PHE A 291 12180 11886 15117 -991 -566 11 C \nATOM 2318 N HIS A 292 -14.165 9.056 -23.269 1.00 85.13 N \nANISOU 2318 N HIS A 292 9955 9541 12848 -997 -350 -148 N \nATOM 2319 CA HIS A 292 -15.523 8.935 -23.794 1.00 74.70 C \nANISOU 2319 CA HIS A 292 8679 8206 11499 -1021 -293 -176 C \nATOM 2320 C HIS A 292 -15.687 7.582 -24.458 1.00 74.99 C \nANISOU 2320 C HIS A 292 8779 8213 11499 -975 -232 -178 C \nATOM 2321 O HIS A 292 -14.699 6.894 -24.731 1.00 92.07 O \nANISOU 2321 O HIS A 292 10933 10379 13669 -921 -235 -160 O \nATOM 2322 CB HIS A 292 -15.857 10.079 -24.758 1.00 71.57 C \nANISOU 2322 CB HIS A 292 8227 7824 11141 -1026 -302 -200 C \nATOM 2323 CG HIS A 292 -15.292 9.912 -26.137 1.00 80.33 C \nANISOU 2323 CG HIS A 292 9315 8925 12283 -963 -288 -206 C \nATOM 2324 ND1 HIS A 292 -15.792 9.009 -27.049 1.00 88.30 N \nANISOU 2324 ND1 HIS A 292 10376 9908 13266 -937 -227 -217 N \nATOM 2325 CD2 HIS A 292 -14.303 10.574 -26.778 1.00 78.67 C \nANISOU 2325 CD2 HIS A 292 9040 8726 12126 -922 -328 -203 C \nATOM 2326 CE1 HIS A 292 -15.117 9.092 -28.178 1.00 86.13 C \nANISOU 2326 CE1 HIS A 292 10063 9634 13027 -886 -229 -220 C \nATOM 2327 NE2 HIS A 292 -14.205 10.035 -28.038 1.00 84.23 N \nANISOU 2327 NE2 HIS A 292 9753 9415 12835 -877 -289 -213 N \nATOM 2328 N ASN A 293 -16.932 7.217 -24.730 1.00 78.46 N \nANISOU 2328 N ASN A 293 9285 8629 11898 -999 -176 -199 N \nATOM 2329 CA ASN A 293 -17.267 5.963 -25.425 1.00 73.95 C \nANISOU 2329 CA ASN A 293 8786 8026 11287 -951 -113 -202 C \nATOM 2330 C ASN A 293 -18.319 6.150 -26.507 1.00 71.88 C \nANISOU 2330 C ASN A 293 8555 7741 11015 -963 -67 -230 C \nATOM 2331 O ASN A 293 -19.107 5.254 -26.781 1.00 76.37 O \nANISOU 2331 O ASN A 293 9211 8273 11532 -952 -10 -238 O \nATOM 2332 CB ASN A 293 -17.769 4.947 -24.431 1.00 78.74 C \nANISOU 2332 CB ASN A 293 9478 8613 11828 -961 -81 -196 C \nATOM 2333 CG ASN A 293 -19.031 5.397 -23.731 1.00 78.89 C \nANISOU 2333 CG ASN A 293 9546 8617 11812 -1043 -68 -214 C \nATOM 2334 OD1 ASN A 293 -19.349 6.592 -23.679 1.00 74.57 O \nANISOU 2334 OD1 ASN A 293 8950 8091 11293 -1101 -98 -226 O \nATOM 2335 ND2 ASN A 293 -19.752 4.435 -23.184 1.00 78.67 N \nANISOU 2335 ND2 ASN A 293 9617 8556 11718 -1049 -23 -217 N \nATOM 2336 N ILE A 294 -18.315 7.329 -27.115 1.00 66.79 N \nANISOU 2336 N ILE A 294 7841 7120 10418 -985 -94 -245 N \nATOM 2337 CA ILE A 294 -19.326 7.740 -28.065 1.00 67.29 C \nANISOU 2337 CA ILE A 294 7921 7174 10474 -1013 -59 -272 C \nATOM 2338 C ILE A 294 -19.180 7.023 -29.396 1.00 71.44 C \nANISOU 2338 C ILE A 294 8467 7678 11000 -948 -18 -275 C \nATOM 2339 O ILE A 294 -20.072 6.307 -29.835 1.00 75.26 O \nANISOU 2339 O ILE A 294 9034 8124 11436 -948 39 -285 O \nATOM 2340 CB ILE A 294 -19.245 9.251 -28.343 1.00 59.91 C \nANISOU 2340 CB ILE A 294 6890 6284 9589 -1045 -104 -287 C \nATOM 2341 CG1 ILE A 294 -19.257 10.076 -27.051 1.00 63.39 C \nANISOU 2341 CG1 ILE A 294 7295 6758 10034 -1102 -153 -281 C \nATOM 2342 CG2 ILE A 294 -20.405 9.657 -29.237 1.00 57.16 C \nANISOU 2342 CG2 ILE A 294 6560 5935 9222 -1088 -65 -317 C \nATOM 2343 CD1 ILE A 294 -20.506 9.909 -26.198 1.00 67.08 C \nANISOU 2343 CD1 ILE A 294 7835 7215 10439 -1183 -124 -291 C \nATOM 2344 N HIS A 295 -18.029 7.236 -30.023 1.00 75.43 N \nANISOU 2344 N HIS A 295 8899 8204 11557 -892 -49 -266 N \nATOM 2345 CA HIS A 295 -17.753 6.709 -31.358 1.00 75.63 C \nANISOU 2345 CA HIS A 295 8926 8219 11590 -832 -18 -269 C \nATOM 2346 C HIS A 295 -16.225 6.702 -31.618 1.00 65.51 C \nANISOU 2346 C HIS A 295 7573 6962 10355 -773 -59 -250 C \nATOM 2347 O HIS A 295 -15.536 7.620 -31.206 1.00 68.56 O \nANISOU 2347 O HIS A 295 7892 7372 10785 -787 -115 -245 O \nATOM 2348 CB HIS A 295 -18.480 7.581 -32.381 1.00 80.31 C \nANISOU 2348 CB HIS A 295 9495 8819 12200 -861 -4 -298 C \nATOM 2349 CG HIS A 295 -18.544 6.980 -33.753 1.00 81.22 C \nANISOU 2349 CG HIS A 295 9632 8917 12309 -812 40 -304 C \nATOM 2350 ND1 HIS A 295 -17.590 7.232 -34.715 1.00 79.21 N \nANISOU 2350 ND1 HIS A 295 9311 8684 12103 -761 21 -303 N \nATOM 2351 CD2 HIS A 295 -19.430 6.123 -34.310 1.00 83.84 C \nANISOU 2351 CD2 HIS A 295 10052 9212 12590 -804 101 -310 C \nATOM 2352 CE1 HIS A 295 -17.894 6.557 -35.808 1.00 85.33 C \nANISOU 2352 CE1 HIS A 295 10123 9440 12857 -726 69 -308 C \nATOM 2353 NE2 HIS A 295 -19.003 5.871 -35.588 1.00 83.03 N \nANISOU 2353 NE2 HIS A 295 9927 9113 12506 -749 118 -312 N \nATOM 2354 N PRO A 296 -15.704 5.658 -32.268 1.00 63.53 N \nANISOU 2354 N PRO A 296 7342 6706 10090 -710 -32 -237 N \nATOM 2355 CA PRO A 296 -14.265 5.563 -32.544 1.00 59.63 C \nANISOU 2355 CA PRO A 296 6789 6238 9631 -663 -67 -219 C \nATOM 2356 C PRO A 296 -13.783 6.667 -33.425 1.00 72.71 C \nANISOU 2356 C PRO A 296 8372 7907 11346 -661 -98 -234 C \nATOM 2357 O PRO A 296 -12.838 7.367 -33.079 1.00 63.59 O \nANISOU 2357 O PRO A 296 7161 6769 10232 -663 -153 -226 O \nATOM 2358 CB PRO A 296 -14.111 4.214 -33.263 1.00 59.87 C \nANISOU 2358 CB PRO A 296 6860 6267 9623 -600 -19 -209 C \nATOM 2359 CG PRO A 296 -15.500 3.759 -33.640 1.00 68.13 C \nANISOU 2359 CG PRO A 296 7985 7278 10623 -606 42 -225 C \nATOM 2360 CD PRO A 296 -16.439 4.424 -32.650 1.00 71.68 C \nANISOU 2360 CD PRO A 296 8462 7711 11064 -679 34 -237 C \nATOM 2361 N LEU A 297 -14.438 6.801 -34.577 1.00 93.56 N \nANISOU 2361 N LEU A 297 11019 10540 13989 -653 -62 -256 N \nATOM 2362 CA LEU A 297 -14.075 7.810 -35.584 1.00100.88 C \nANISOU 2362 CA LEU A 297 11880 11483 14969 -645 -83 -275 C \nATOM 2363 C LEU A 297 -14.407 9.204 -35.115 1.00 95.42 C \nANISOU 2363 C LEU A 297 11142 10806 14308 -693 -123 -292 C \nATOM 2364 O LEU A 297 -15.468 9.723 -35.391 1.00108.01 O \nANISOU 2364 O LEU A 297 12742 12404 15894 -730 -101 -315 O \nATOM 2365 CB LEU A 297 -14.776 7.543 -36.921 1.00106.16 C \nANISOU 2365 CB LEU A 297 12570 12143 15625 -629 -30 -294 C \nATOM 2366 CG LEU A 297 -14.523 6.173 -37.548 1.00104.81 C \nANISOU 2366 CG LEU A 297 12442 11962 15418 -573 12 -279 C \nATOM 2367 CD1 LEU A 297 -15.524 5.854 -38.656 1.00105.53 C \nANISOU 2367 CD1 LEU A 297 12577 12037 15484 -567 70 -297 C \nATOM 2368 CD2 LEU A 297 -13.102 6.115 -38.084 1.00105.71 C \nANISOU 2368 CD2 LEU A 297 12499 12100 15566 -527 -18 -267 C \nATOM 2369 N THR A 298 -13.490 9.815 -34.399 1.00 88.42 N \nANISOU 2369 N THR A 298 10211 9932 13454 -692 -181 -279 N \nATOM 2370 CA THR A 298 -13.733 11.120 -33.822 1.00 84.66 C \nANISOU 2370 CA THR A 298 9688 9476 13003 -729 -224 -291 C \nATOM 2371 C THR A 298 -12.841 12.098 -34.520 1.00 76.19 C \nANISOU 2371 C THR A 298 8547 8418 11984 -694 -265 -300 C \nATOM 2372 O THR A 298 -11.866 11.686 -35.129 1.00 92.79 O \nANISOU 2372 O THR A 298 10643 10509 14102 -649 -269 -291 O \nATOM 2373 CB THR A 298 -13.418 11.049 -32.320 1.00 94.88 C \nANISOU 2373 CB THR A 298 10995 10770 14286 -755 -261 -266 C \nATOM 2374 OG1 THR A 298 -14.122 9.924 -31.740 1.00 99.05 O \nANISOU 2374 OG1 THR A 298 11596 11280 14759 -776 -217 -256 O \nATOM 2375 CG2 THR A 298 -13.819 12.315 -31.603 1.00 92.25 C \nANISOU 2375 CG2 THR A 298 10620 10463 13968 -796 -301 -275 C \nATOM 2376 N ILE A 299 -13.160 13.386 -34.451 1.00 67.57 N \nANISOU 2376 N ILE A 299 7402 7354 10916 -711 -295 -319 N \nATOM 2377 CA ILE A 299 -12.372 14.412 -35.125 1.00 67.16 C \nANISOU 2377 CA ILE A 299 7288 7316 10913 -670 -334 -332 C \nATOM 2378 C ILE A 299 -12.250 15.673 -34.307 1.00 70.03 C \nANISOU 2378 C ILE A 299 7603 7708 11299 -679 -392 -334 C \nATOM 2379 O ILE A 299 -13.228 16.179 -33.790 1.00 86.74 O \nANISOU 2379 O ILE A 299 9707 9856 13396 -724 -389 -345 O \nATOM 2380 CB ILE A 299 -12.891 14.729 -36.571 1.00 79.67 C \nANISOU 2380 CB ILE A 299 8847 8918 12507 -655 -297 -366 C \nATOM 2381 CG1 ILE A 299 -13.791 16.009 -36.656 1.00 80.81 C \nANISOU 2381 CG1 ILE A 299 8936 9111 12655 -683 -306 -396 C \nATOM 2382 CG2 ILE A 299 -13.577 13.502 -37.209 1.00 80.12 C \nANISOU 2382 CG2 ILE A 299 8963 8954 12526 -665 -229 -367 C \nATOM 2383 CD1 ILE A 299 -13.105 17.199 -37.288 1.00 79.81 C \nANISOU 2383 CD1 ILE A 299 8739 9011 12575 -634 -346 -415 C \nATOM 2384 N GLY A 300 -11.043 16.194 -34.195 1.00 92.30 N \nANISOU 2384 N GLY A 300 10399 10518 14155 -636 -446 -322 N \nATOM 2385 CA GLY A 300 -10.757 17.405 -33.409 1.00109.03 C \nANISOU 2385 CA GLY A 300 12474 12658 16293 -630 -508 -320 C \nATOM 2386 C GLY A 300 -9.831 17.080 -32.240 1.00120.05 C \nANISOU 2386 C GLY A 300 13901 14024 17687 -634 -552 -282 C \nATOM 2387 O GLY A 300 -8.964 16.205 -32.362 1.00112.54 O \nANISOU 2387 O GLY A 300 12986 13037 16735 -619 -548 -262 O \nATOM 2388 N GLU A 301 -10.005 17.799 -31.126 1.00128.77 N \nANISOU 2388 N GLU A 301 14987 15151 18788 -655 -594 -272 N \nATOM 2389 CA GLU A 301 -9.343 17.455 -29.854 1.00132.29 C \nANISOU 2389 CA GLU A 301 15466 15575 19224 -673 -632 -235 C \nATOM 2390 C GLU A 301 -10.402 16.881 -28.911 1.00125.49 C \nANISOU 2390 C GLU A 301 14630 14731 18320 -739 -603 -229 C \nATOM 2391 O GLU A 301 -11.243 17.583 -28.325 1.00 86.51 O \nANISOU 2391 O GLU A 301 9666 9834 13371 -773 -612 -237 O \nATOM 2392 CB GLU A 301 -8.569 18.611 -29.202 1.00138.67 C \nANISOU 2392 CB GLU A 301 16245 16387 20057 -644 -706 -222 C \nATOM 2393 CG GLU A 301 -7.056 18.538 -29.384 1.00129.17 C \nANISOU 2393 CG GLU A 301 15067 15135 18878 -601 -746 -202 C \nATOM 2394 CD GLU A 301 -6.313 19.666 -28.681 1.00128.17 C \nANISOU 2394 CD GLU A 301 14926 15002 18770 -571 -821 -187 C \nATOM 2395 OE1 GLU A 301 -6.954 20.528 -28.055 1.00126.39 O \nANISOU 2395 OE1 GLU A 301 14663 14818 18541 -578 -844 -192 O \nATOM 2396 OE2 GLU A 301 -5.072 19.701 -28.755 1.00129.33 O \nANISOU 2396 OE2 GLU A 301 15104 15105 18932 -541 -858 -170 O \nATOM 2397 N CYS A 302 -10.322 15.570 -28.783 1.00131.49 N \nANISOU 2397 N CYS A 302 15445 15463 19053 -755 -567 -213 N \nATOM 2398 CA CYS A 302 -11.350 14.783 -28.159 1.00128.08 C \nANISOU 2398 CA CYS A 302 15053 15036 18575 -808 -524 -211 C \nATOM 2399 C CYS A 302 -10.749 13.814 -27.158 1.00126.63 C \nANISOU 2399 C CYS A 302 14916 14832 18367 -822 -533 -178 C \nATOM 2400 O CYS A 302 -9.683 13.226 -27.387 1.00138.89 O \nANISOU 2400 O CYS A 302 16483 16364 19927 -791 -542 -160 O \nATOM 2401 CB CYS A 302 -12.086 13.982 -29.229 1.00123.06 C \nANISOU 2401 CB CYS A 302 14446 14391 17920 -805 -454 -232 C \nATOM 2402 SG CYS A 302 -12.750 15.052 -30.492 1.00111.20 S \nANISOU 2402 SG CYS A 302 12889 12919 16444 -792 -440 -272 S \nATOM 2403 N PRO A 303 -11.442 13.631 -26.041 1.00111.50 N \nANISOU 2403 N PRO A 303 13022 12926 16415 -873 -529 -170 N \nATOM 2404 CA PRO A 303 -11.116 12.579 -25.102 1.00103.03 C \nANISOU 2404 CA PRO A 303 11997 11840 15308 -892 -525 -143 C \nATOM 2405 C PRO A 303 -10.779 11.248 -25.754 1.00 91.01 C \nANISOU 2405 C PRO A 303 10515 10298 13766 -861 -479 -138 C \nATOM 2406 O PRO A 303 -11.247 10.938 -26.846 1.00100.17 O \nANISOU 2406 O PRO A 303 11683 11451 14925 -839 -432 -158 O \nATOM 2407 CB PRO A 303 -12.416 12.441 -24.280 1.00107.86 C \nANISOU 2407 CB PRO A 303 12639 12465 15877 -952 -497 -152 C \nATOM 2408 CG PRO A 303 -13.327 13.552 -24.705 1.00101.31 C \nANISOU 2408 CG PRO A 303 11770 11663 15061 -972 -496 -180 C \nATOM 2409 CD PRO A 303 -12.529 14.490 -25.548 1.00102.14 C \nANISOU 2409 CD PRO A 303 11815 11775 15220 -920 -534 -187 C \nATOM 2410 N LYS A 304 -10.014 10.441 -25.055 1.00 95.49 N \nANISOU 2410 N LYS A 304 11108 10863 14312 -861 -491 -110 N \nATOM 2411 CA LYS A 304 -9.680 9.134 -25.572 1.00101.37 C \nANISOU 2411 CA LYS A 304 11884 11602 15029 -830 -448 -102 C \nATOM 2412 C LYS A 304 -10.925 8.284 -25.657 1.00 92.08 C \nANISOU 2412 C LYS A 304 10759 10420 13807 -838 -380 -118 C \nATOM 2413 O LYS A 304 -11.524 7.950 -24.651 1.00 98.42 O \nANISOU 2413 O LYS A 304 11597 11224 14573 -873 -370 -113 O \nATOM 2414 CB LYS A 304 -8.675 8.437 -24.655 1.00112.03 C \nANISOU 2414 CB LYS A 304 13247 12963 16355 -838 -475 -69 C \nATOM 2415 CG LYS A 304 -7.321 9.110 -24.547 1.00119.17 C \nANISOU 2415 CG LYS A 304 14119 13867 17295 -833 -541 -49 C \nATOM 2416 CD LYS A 304 -6.267 8.089 -24.157 1.00111.34 C \nANISOU 2416 CD LYS A 304 13142 12891 16269 -834 -548 -20 C \nATOM 2417 CE LYS A 304 -6.067 7.065 -25.242 1.00108.28 C \nANISOU 2417 CE LYS A 304 12762 12515 15863 -793 -499 -26 C \nATOM 2418 NZ LYS A 304 -5.994 7.608 -26.631 1.00103.98 N \nANISOU 2418 NZ LYS A 304 12193 11954 15361 -758 -492 -47 N \nATOM 2419 N TYR A 305 -11.303 7.926 -26.865 1.00 89.80 N \nANISOU 2419 N TYR A 305 10480 10122 13519 -805 -334 -136 N \nATOM 2420 CA TYR A 305 -12.325 6.925 -27.036 1.00 90.75 C \nANISOU 2420 CA TYR A 305 10662 10229 13588 -801 -268 -146 C \nATOM 2421 C TYR A 305 -11.919 5.624 -26.317 1.00 88.28 C \nANISOU 2421 C TYR A 305 10391 9927 13226 -784 -252 -123 C \nATOM 2422 O TYR A 305 -10.815 5.090 -26.508 1.00 70.95 O \nANISOU 2422 O TYR A 305 8175 7751 11032 -751 -265 -103 O \nATOM 2423 CB TYR A 305 -12.594 6.651 -28.514 1.00 83.42 C \nANISOU 2423 CB TYR A 305 9739 9291 12667 -759 -224 -165 C \nATOM 2424 CG TYR A 305 -13.640 5.573 -28.743 1.00 94.26 C \nANISOU 2424 CG TYR A 305 11188 10644 13983 -747 -154 -173 C \nATOM 2425 CD1 TYR A 305 -14.972 5.793 -28.461 1.00 94.59 C \nANISOU 2425 CD1 TYR A 305 11276 10665 13999 -793 -125 -193 C \nATOM 2426 CD2 TYR A 305 -13.289 4.319 -29.221 1.00 93.00 C \nANISOU 2426 CD2 TYR A 305 11057 10488 13790 -691 -117 -162 C \nATOM 2427 CE1 TYR A 305 -15.917 4.803 -28.657 1.00 95.03 C \nANISOU 2427 CE1 TYR A 305 11416 10693 13998 -780 -62 -200 C \nATOM 2428 CE2 TYR A 305 -14.242 3.338 -29.424 1.00 93.58 C \nANISOU 2428 CE2 TYR A 305 11208 10540 13808 -670 -55 -169 C \nATOM 2429 CZ TYR A 305 -15.556 3.588 -29.135 1.00 91.25 C \nANISOU 2429 CZ TYR A 305 10969 10213 13489 -715 -27 -188 C \nATOM 2430 OH TYR A 305 -16.507 2.613 -29.328 1.00 98.63 O \nANISOU 2430 OH TYR A 305 11994 11116 14364 -693 35 -195 O \nATOM 2431 N VAL A 306 -12.829 5.111 -25.502 1.00 83.77 N \nANISOU 2431 N VAL A 306 9876 9344 12606 -809 -222 -125 N \nATOM 2432 CA VAL A 306 -12.610 3.819 -24.832 1.00 86.02 C \nANISOU 2432 CA VAL A 306 10205 9642 12835 -787 -199 -107 C \nATOM 2433 C VAL A 306 -13.875 3.014 -24.898 1.00 78.09 C \nANISOU 2433 C VAL A 306 9284 8610 11776 -778 -132 -123 C \nATOM 2434 O VAL A 306 -14.913 3.600 -25.029 1.00 70.10 O \nANISOU 2434 O VAL A 306 8298 7571 10767 -816 -117 -145 O \nATOM 2435 CB VAL A 306 -12.192 4.014 -23.373 1.00 82.01 C \nANISOU 2435 CB VAL A 306 9688 9153 12319 -831 -244 -87 C \nATOM 2436 CG1 VAL A 306 -10.682 3.918 -23.287 1.00 82.21 C \nANISOU 2436 CG1 VAL A 306 9661 9211 12362 -814 -290 -60 C \nATOM 2437 CG2 VAL A 306 -12.682 5.359 -22.857 1.00 74.92 C \nANISOU 2437 CG2 VAL A 306 8766 8244 11455 -893 -282 -98 C \nATOM 2438 N LYS A 307 -13.780 1.687 -24.826 1.00 85.48 N \nANISOU 2438 N LYS A 307 10265 9556 12658 -728 -94 -113 N \nATOM 2439 CA LYS A 307 -14.978 0.846 -24.882 1.00109.72 C \nANISOU 2439 CA LYS A 307 13429 12591 15668 -709 -28 -127 C \nATOM 2440 C LYS A 307 -15.486 0.333 -23.524 1.00115.46 C \nANISOU 2440 C LYS A 307 14217 13312 16339 -734 -17 -124 C \nATOM 2441 O LYS A 307 -16.131 -0.712 -23.450 1.00128.40 O \nANISOU 2441 O LYS A 307 15938 14932 17916 -696 36 -129 O \nATOM 2442 CB LYS A 307 -14.790 -0.290 -25.878 1.00119.75 C \nANISOU 2442 CB LYS A 307 14723 13870 16907 -624 18 -123 C \nATOM 2443 CG LYS A 307 -13.811 -1.384 -25.491 1.00125.41 C \nANISOU 2443 CG LYS A 307 15424 14641 17587 -570 17 -98 C \nATOM 2444 CD LYS A 307 -13.746 -2.434 -26.613 1.00128.83 C \nANISOU 2444 CD LYS A 307 15875 15087 17986 -483 65 -96 C \nATOM 2445 CE LYS A 307 -14.096 -1.858 -27.993 1.00128.34 C \nANISOU 2445 CE LYS A 307 15804 14994 17966 -477 79 -113 C \nATOM 2446 NZ LYS A 307 -14.029 -2.845 -29.097 1.00133.54 N \nANISOU 2446 NZ LYS A 307 16480 15667 18592 -393 124 -109 N \nATOM 2447 N SER A 308 -15.211 1.091 -22.466 1.00119.82 N \nANISOU 2447 N SER A 308 14733 13879 16913 -797 -68 -117 N \nATOM 2448 CA SER A 308 -15.764 0.822 -21.134 1.00118.98 C \nANISOU 2448 CA SER A 308 14681 13766 16760 -837 -63 -117 C \nATOM 2449 C SER A 308 -17.128 1.476 -21.012 1.00114.54 C \nANISOU 2449 C SER A 308 14173 13159 16190 -901 -43 -143 C \nATOM 2450 O SER A 308 -17.402 2.457 -21.699 1.00102.28 O \nANISOU 2450 O SER A 308 12584 11596 14681 -932 -56 -156 O \nATOM 2451 CB SER A 308 -14.866 1.406 -20.032 1.00116.36 C \nANISOU 2451 CB SER A 308 14284 13473 16453 -883 -129 -95 C \nATOM 2452 OG SER A 308 -13.575 0.814 -19.989 1.00113.72 O \nANISOU 2452 OG SER A 308 13905 13186 16119 -840 -151 -70 O \nATOM 2453 N ASN A 309 -17.967 0.934 -20.132 1.00111.05 N \nANISOU 2453 N ASN A 309 13815 12693 15686 -925 -12 -151 N \nATOM 2454 CA ASN A 309 -19.252 1.550 -19.804 1.00108.84 C \nANISOU 2454 CA ASN A 309 13591 12375 15387 -1004 4 -175 C \nATOM 2455 C ASN A 309 -19.166 2.482 -18.609 1.00106.84 C \nANISOU 2455 C ASN A 309 13293 12149 15152 -1086 -50 -169 C \nATOM 2456 O ASN A 309 -20.010 3.351 -18.442 1.00102.13 O \nANISOU 2456 O ASN A 309 12704 11542 14557 -1162 -55 -187 O \nATOM 2457 CB ASN A 309 -20.310 0.485 -19.538 1.00112.47 C \nANISOU 2457 CB ASN A 309 14182 12786 15766 -990 70 -189 C \nATOM 2458 CG ASN A 309 -20.745 -0.220 -20.808 1.00117.97 C \nANISOU 2458 CG ASN A 309 14937 13444 16441 -922 126 -200 C \nATOM 2459 OD1 ASN A 309 -20.850 0.399 -21.868 1.00114.97 O \nANISOU 2459 OD1 ASN A 309 14524 13059 16103 -928 125 -209 O \nATOM 2460 ND2 ASN A 309 -20.997 -1.517 -20.708 1.00119.27 N \nANISOU 2460 ND2 ASN A 309 15193 13585 16539 -854 176 -199 N \nATOM 2461 N LYS A 310 -18.131 2.297 -17.792 1.00106.86 N \nANISOU 2461 N LYS A 310 13248 12192 15163 -1073 -90 -144 N \nATOM 2462 CA LYS A 310 -18.000 3.011 -16.533 1.00 96.59 C \nANISOU 2462 CA LYS A 310 11914 10918 13868 -1144 -139 -135 C \nATOM 2463 C LYS A 310 -16.533 3.302 -16.201 1.00 92.84 C \nANISOU 2463 C LYS A 310 11347 10491 13438 -1127 -203 -104 C \nATOM 2464 O LYS A 310 -15.702 2.388 -16.123 1.00 99.10 O \nANISOU 2464 O LYS A 310 12136 11304 14214 -1073 -199 -86 O \nATOM 2465 CB LYS A 310 -18.637 2.169 -15.425 1.00 92.66 C \nANISOU 2465 CB LYS A 310 11506 10406 13297 -1164 -107 -139 C \nATOM 2466 CG LYS A 310 -18.678 2.844 -14.065 1.00 92.37 C \nANISOU 2466 CG LYS A 310 11447 10393 13255 -1246 -151 -132 C \nATOM 2467 CD LYS A 310 -18.948 1.837 -12.964 1.00 90.73 C \nANISOU 2467 CD LYS A 310 11315 10180 12976 -1247 -123 -132 C \nATOM 2468 CE LYS A 310 -18.919 2.504 -11.599 1.00 92.94 C \nANISOU 2468 CE LYS A 310 11569 10490 13252 -1330 -170 -122 C \nATOM 2469 NZ LYS A 310 -19.565 1.637 -10.577 1.00 99.72 N \nANISOU 2469 NZ LYS A 310 12521 11333 14033 -1347 -132 -132 N \nATOM 2470 N LEU A 311 -16.222 4.579 -16.008 1.00 82.10 N \nANISOU 2470 N LEU A 311 9914 9150 12129 -1174 -262 -98 N \nATOM 2471 CA LEU A 311 -14.952 4.974 -15.394 1.00 89.21 C \nANISOU 2471 CA LEU A 311 10745 10089 13063 -1176 -328 -68 C \nATOM 2472 C LEU A 311 -15.223 6.004 -14.318 1.00 83.57 C \nANISOU 2472 C LEU A 311 10006 9392 12356 -1253 -375 -64 C \nATOM 2473 O LEU A 311 -15.348 7.205 -14.621 1.00 80.67 O \nANISOU 2473 O LEU A 311 9586 9031 12032 -1278 -408 -70 O \nATOM 2474 CB LEU A 311 -13.956 5.557 -16.420 1.00 91.12 C \nANISOU 2474 CB LEU A 311 10913 10339 13369 -1134 -363 -58 C \nATOM 2475 CG LEU A 311 -13.430 4.580 -17.487 1.00 97.61 C \nANISOU 2475 CG LEU A 311 11744 11157 14188 -1058 -327 -56 C \nATOM 2476 CD1 LEU A 311 -12.520 5.302 -18.476 1.00 95.96 C \nANISOU 2476 CD1 LEU A 311 11466 10954 14043 -1029 -364 -50 C \nATOM 2477 CD2 LEU A 311 -12.708 3.380 -16.883 1.00 98.30 C \nANISOU 2477 CD2 LEU A 311 11849 11271 14229 -1029 -319 -35 C \nATOM 2478 N VAL A 312 -15.264 5.537 -13.066 1.00 77.68 N \nANISOU 2478 N VAL A 312 9291 8659 11565 -1286 -379 -53 N \nATOM 2479 CA VAL A 312 -15.532 6.421 -11.906 1.00 74.76 C \nANISOU 2479 CA VAL A 312 8902 8310 11193 -1362 -423 -47 C \nATOM 2480 C VAL A 312 -14.457 6.346 -10.799 1.00 73.97 C \nANISOU 2480 C VAL A 312 8771 8243 11090 -1374 -476 -13 C \nATOM 2481 O VAL A 312 -14.202 5.293 -10.218 1.00 75.48 O \nANISOU 2481 O VAL A 312 9000 8443 11237 -1361 -455 -4 O \nATOM 2482 CB VAL A 312 -16.910 6.123 -11.296 1.00 64.21 C \nANISOU 2482 CB VAL A 312 7644 6957 9796 -1418 -376 -71 C \nATOM 2483 CG1 VAL A 312 -17.184 7.045 -10.130 1.00 58.70 C \nANISOU 2483 CG1 VAL A 312 6920 6289 9094 -1500 -422 -65 C \nATOM 2484 CG2 VAL A 312 -17.985 6.295 -12.355 1.00 58.96 C \nANISOU 2484 CG2 VAL A 312 7013 6260 9130 -1420 -328 -104 C \nATOM 2485 N LEU A 313 -13.857 7.484 -10.505 1.00 69.16 N \nANISOU 2485 N LEU A 313 8095 7657 10526 -1397 -544 6 N \nATOM 2486 CA LEU A 313 -12.799 7.534 -9.512 1.00 75.20 C \nANISOU 2486 CA LEU A 313 8833 8450 11291 -1412 -600 40 C \nATOM 2487 C LEU A 313 -13.397 7.865 -8.155 1.00 82.79 C \nANISOU 2487 C LEU A 313 9808 9431 12217 -1486 -617 43 C \nATOM 2488 O LEU A 313 -14.075 8.888 -7.992 1.00 82.38 O \nANISOU 2488 O LEU A 313 9734 9387 12178 -1530 -636 33 O \nATOM 2489 CB LEU A 313 -11.746 8.603 -9.866 1.00 67.87 C \nANISOU 2489 CB LEU A 313 7833 7527 10425 -1394 -669 62 C \nATOM 2490 CG LEU A 313 -10.903 8.340 -11.108 1.00 68.02 C \nANISOU 2490 CG LEU A 313 7833 7530 10480 -1327 -664 65 C \nATOM 2491 CD1 LEU A 313 -10.317 9.649 -11.626 1.00 61.81 C \nANISOU 2491 CD1 LEU A 313 6988 6740 9756 -1311 -722 72 C \nATOM 2492 CD2 LEU A 313 -9.813 7.302 -10.811 1.00 69.84 C \nANISOU 2492 CD2 LEU A 313 8075 7775 10684 -1307 -667 90 C \nATOM 2493 N ALA A 314 -13.124 7.024 -7.167 1.00 79.97 N \nANISOU 2493 N ALA A 314 9482 9088 11812 -1503 -613 57 N \nATOM 2494 CA ALA A 314 -13.484 7.360 -5.805 1.00 80.29 C \nANISOU 2494 CA ALA A 314 9530 9153 11822 -1574 -639 65 C \nATOM 2495 C ALA A 314 -12.607 8.516 -5.364 1.00 73.20 C \nANISOU 2495 C ALA A 314 8565 8280 10968 -1594 -722 97 C \nATOM 2496 O ALA A 314 -11.400 8.493 -5.557 1.00 78.31 O \nANISOU 2496 O ALA A 314 9183 8930 11642 -1560 -760 123 O \nATOM 2497 CB ALA A 314 -13.267 6.171 -4.898 1.00 87.59 C \nANISOU 2497 CB ALA A 314 10501 10093 12687 -1580 -616 74 C \nATOM 2498 N THR A 315 -13.222 9.522 -4.767 1.00 65.04 N \nANISOU 2498 N THR A 315 7511 7266 9937 -1649 -752 94 N \nATOM 2499 CA THR A 315 -12.499 10.629 -4.143 1.00 66.47 C \nANISOU 2499 CA THR A 315 7634 7473 10148 -1669 -833 126 C \nATOM 2500 C THR A 315 -12.721 10.656 -2.617 1.00 75.21 C \nANISOU 2500 C THR A 315 8754 8613 11208 -1741 -857 141 C \nATOM 2501 O THR A 315 -11.812 10.934 -1.844 1.00 81.53 O \nANISOU 2501 O THR A 315 9532 9432 12013 -1754 -915 176 O \nATOM 2502 CB THR A 315 -12.944 11.977 -4.749 1.00 66.01 C \nANISOU 2502 CB THR A 315 7523 7424 10133 -1666 -859 114 C \nATOM 2503 OG1 THR A 315 -14.378 12.174 -4.607 1.00 58.20 O \nANISOU 2503 OG1 THR A 315 6553 6449 9111 -1720 -819 82 O \nATOM 2504 CG2 THR A 315 -12.560 12.014 -6.233 1.00 62.63 C \nANISOU 2504 CG2 THR A 315 7078 6965 9753 -1593 -844 103 C \nATOM 2505 N GLY A 316 -13.941 10.371 -2.195 1.00 76.41 N \nANISOU 2505 N GLY A 316 8947 8770 11313 -1792 -810 114 N \nATOM 2506 CA GLY A 316 -14.278 10.369 -0.792 1.00 75.02 C \nANISOU 2506 CA GLY A 316 8789 8626 11090 -1864 -826 123 C \nATOM 2507 C GLY A 316 -14.116 9.004 -0.148 1.00 76.34 C \nANISOU 2507 C GLY A 316 9017 8788 11203 -1868 -788 124 C \nATOM 2508 O GLY A 316 -13.344 8.164 -0.639 1.00 72.64 O \nANISOU 2508 O GLY A 316 8557 8302 10738 -1810 -772 132 O \nATOM 2509 N LEU A 317 -14.910 8.779 0.909 1.00 71.69 N \nANISOU 2509 N LEU A 317 8467 8215 10556 -1935 -770 113 N \nATOM 2510 CA LEU A 317 -14.769 7.642 1.809 1.00 77.13 C \nANISOU 2510 CA LEU A 317 9208 8912 11186 -1949 -745 117 C \nATOM 2511 C LEU A 317 -15.818 6.552 1.629 1.00 73.94 C \nANISOU 2511 C LEU A 317 8891 8476 10726 -1943 -659 77 C \nATOM 2512 O LEU A 317 -16.913 6.819 1.209 1.00 84.65 O \nANISOU 2512 O LEU A 317 10277 9810 12074 -1966 -623 47 O \nATOM 2513 CB LEU A 317 -14.843 8.131 3.252 1.00 79.26 C \nANISOU 2513 CB LEU A 317 9466 9224 11425 -2030 -789 135 C \nATOM 2514 CG LEU A 317 -13.984 9.360 3.554 1.00 86.56 C \nANISOU 2514 CG LEU A 317 10313 10180 12398 -2042 -878 175 C \nATOM 2515 CD1 LEU A 317 -14.821 10.638 3.610 1.00 83.12 C \nANISOU 2515 CD1 LEU A 317 9841 9765 11976 -2089 -903 165 C \nATOM 2516 CD2 LEU A 317 -13.219 9.160 4.853 1.00 87.19 C \nANISOU 2516 CD2 LEU A 317 10387 10294 12446 -2080 -922 209 C \nATOM 2517 N ARG A 318 -15.472 5.327 1.986 1.00 69.22 N \nANISOU 2517 N ARG A 318 8335 7881 10084 -1914 -627 78 N \nATOM 2518 CA ARG A 318 -16.450 4.258 2.092 1.00 72.83 C \nANISOU 2518 CA ARG A 318 8886 8310 10475 -1909 -549 43 C \nATOM 2519 C ARG A 318 -17.648 4.748 2.889 1.00 81.37 C \nANISOU 2519 C ARG A 318 10009 9391 11518 -2000 -540 22 C \nATOM 2520 O ARG A 318 -17.493 5.205 4.013 1.00 79.30 O \nANISOU 2520 O ARG A 318 9722 9168 11240 -2065 -584 40 O \nATOM 2521 CB ARG A 318 -15.856 3.031 2.787 1.00 65.19 C \nANISOU 2521 CB ARG A 318 7947 7369 9455 -1881 -531 52 C \nATOM 2522 CG ARG A 318 -14.926 2.213 1.915 1.00 62.76 C \nANISOU 2522 CG ARG A 318 7621 7064 9162 -1788 -516 63 C \nATOM 2523 CD ARG A 318 -14.389 1.019 2.686 1.00 69.89 C \nANISOU 2523 CD ARG A 318 8544 8007 10002 -1766 -498 71 C \nATOM 2524 NE ARG A 318 -13.280 0.340 2.031 1.00 74.20 N \nANISOU 2524 NE ARG A 318 9053 8581 10560 -1693 -499 89 N \nATOM 2525 CZ ARG A 318 -13.395 -0.684 1.199 1.00 78.41 C \nANISOU 2525 CZ ARG A 318 9620 9102 11069 -1610 -440 71 C \nATOM 2526 NH1 ARG A 318 -14.575 -1.195 0.909 1.00 86.92 N \nANISOU 2526 NH1 ARG A 318 10781 10134 12111 -1583 -372 34 N \nATOM 2527 NH2 ARG A 318 -12.316 -1.218 0.670 1.00 84.42 N \nANISOU 2527 NH2 ARG A 318 10336 9901 11838 -1554 -448 91 N \nATOM 2528 N ASN A 319 -18.844 4.634 2.319 1.00 92.31 N \nANISOU 2528 N ASN A 319 11460 10732 12881 -2009 -482 -16 N \nATOM 2529 CA ASN A 319 -20.056 5.167 2.963 1.00 94.55 C \nANISOU 2529 CA ASN A 319 11785 11015 13124 -2106 -471 -39 C \nATOM 2530 C ASN A 319 -21.201 4.165 2.984 1.00 97.22 C \nANISOU 2530 C ASN A 319 12251 11301 13388 -2112 -388 -79 C \nATOM 2531 O ASN A 319 -22.102 4.204 2.152 1.00 92.62 O \nANISOU 2531 O ASN A 319 11720 10673 12799 -2114 -344 -108 O \nATOM 2532 CB ASN A 319 -20.482 6.440 2.248 1.00 92.53 C \nANISOU 2532 CB ASN A 319 11476 10765 12917 -2139 -497 -43 C \nATOM 2533 CG ASN A 319 -21.762 7.011 2.794 1.00 85.87 C \nANISOU 2533 CG ASN A 319 10671 9930 12027 -2245 -484 -68 C \nATOM 2534 OD1 ASN A 319 -22.029 6.939 3.987 1.00 96.72 O \nANISOU 2534 OD1 ASN A 319 12071 11328 13352 -2312 -491 -67 O \nATOM 2535 ND2 ASN A 319 -22.579 7.563 1.910 1.00 80.13 N \nANISOU 2535 ND2 ASN A 319 9949 9185 11311 -2266 -462 -92 N \nATOM 2536 N SER A 320 -21.121 3.223 3.914 1.00111.03 N \nANISOU 2536 N SER A 320 14055 13055 15077 -2109 -367 -81 N \nATOM 2537 CA SER A 320 -22.247 2.332 4.189 1.00120.46 C \nANISOU 2537 CA SER A 320 15380 14200 16190 -2123 -292 -120 C \nATOM 2538 C SER A 320 -22.992 2.825 5.439 1.00121.97 C \nANISOU 2538 C SER A 320 15600 14413 16331 -2242 -305 -130 C \nATOM 2539 O SER A 320 -22.351 3.272 6.405 1.00113.15 O \nANISOU 2539 O SER A 320 14414 13355 15222 -2284 -362 -102 O \nATOM 2540 CB SER A 320 -21.778 0.885 4.371 1.00119.85 C \nANISOU 2540 CB SER A 320 15355 14115 16067 -2034 -251 -122 C \nATOM 2541 OG SER A 320 -22.811 0.090 4.931 1.00122.59 O \nANISOU 2541 OG SER A 320 15831 14421 16328 -2055 -188 -158 O \nATOM 2542 N PRO A 321 -24.342 2.787 5.405 1.00123.58 N \nANISOU 2542 N PRO A 321 15906 14569 16480 -2302 -253 -168 N \nATOM 2543 CA PRO A 321 -25.162 2.980 6.617 1.00129.03 C \nANISOU 2543 CA PRO A 321 16652 15272 17103 -2414 -249 -184 C \nATOM 2544 C PRO A 321 -25.296 1.679 7.424 1.00120.80 C \nANISOU 2544 C PRO A 321 15713 14204 15981 -2386 -200 -201 C \nATOM 2545 O PRO A 321 -26.394 1.296 7.823 1.00121.71 O \nANISOU 2545 O PRO A 321 15948 14274 16020 -2439 -149 -237 O \nATOM 2546 CB PRO A 321 -26.523 3.465 6.065 1.00127.10 C \nANISOU 2546 CB PRO A 321 16476 14983 16831 -2489 -211 -220 C \nATOM 2547 CG PRO A 321 -26.294 3.745 4.611 1.00132.97 C \nANISOU 2547 CG PRO A 321 17175 15706 17642 -2421 -210 -216 C \nATOM 2548 CD PRO A 321 -25.169 2.844 4.191 1.00127.32 C \nANISOU 2548 CD PRO A 321 16434 14983 16960 -2289 -207 -196 C \nTER 2549 PRO A 321 \nATOM 2550 N ILE B 10 -14.693 3.451 12.775 1.00 98.50 N \nANISOU 2550 N ILE B 10 12185 11944 13298 -1318 -779 -14 N \nATOM 2551 CA ILE B 10 -14.439 1.974 12.661 1.00 96.54 C \nANISOU 2551 CA ILE B 10 11963 11743 12975 -1172 -805 -52 C \nATOM 2552 C ILE B 10 -15.745 1.157 12.671 1.00109.89 C \nANISOU 2552 C ILE B 10 13864 13327 14561 -1085 -863 -78 C \nATOM 2553 O ILE B 10 -15.880 0.170 11.945 1.00131.03 O \nANISOU 2553 O ILE B 10 16628 15995 17163 -964 -896 -111 O \nATOM 2554 CB ILE B 10 -13.431 1.452 13.718 1.00 86.39 C \nANISOU 2554 CB ILE B 10 10547 10605 11672 -1118 -796 -66 C \nATOM 2555 CG1 ILE B 10 -13.873 0.097 14.305 1.00 81.91 C \nANISOU 2555 CG1 ILE B 10 10043 10096 10984 -945 -840 -116 C \nATOM 2556 CG2 ILE B 10 -13.224 2.483 14.809 1.00 85.96 C \nANISOU 2556 CG2 ILE B 10 10433 10548 11681 -1221 -777 -37 C \nATOM 2557 CD1 ILE B 10 -12.797 -0.649 15.069 1.00 79.19 C \nANISOU 2557 CD1 ILE B 10 9534 9975 10580 -884 -831 -139 C \nATOM 2558 N GLU B 11 -16.709 1.578 13.476 1.00107.55 N \nANISOU 2558 N GLU B 11 13676 12945 14246 -1145 -886 -66 N \nATOM 2559 CA GLU B 11 -18.035 0.967 13.460 1.00105.55 C \nANISOU 2559 CA GLU B 11 13687 12545 13872 -1103 -959 -81 C \nATOM 2560 C GLU B 11 -18.867 1.492 12.287 1.00101.41 C \nANISOU 2560 C GLU B 11 13298 11908 13326 -1248 -973 -50 C \nATOM 2561 O GLU B 11 -20.010 1.066 12.091 1.00110.87 O \nANISOU 2561 O GLU B 11 14765 12958 14403 -1261 -1046 -53 O \nATOM 2562 CB GLU B 11 -18.741 1.232 14.793 1.00112.40 C \nANISOU 2562 CB GLU B 11 14632 13365 14709 -1143 -984 -74 C \nATOM 2563 CG GLU B 11 -18.014 0.694 16.020 1.00119.89 C \nANISOU 2563 CG GLU B 11 15457 14435 15661 -1007 -975 -105 C \nATOM 2564 CD GLU B 11 -17.750 -0.807 15.979 1.00121.49 C \nANISOU 2564 CD GLU B 11 15705 14707 15749 -756 -1022 -170 C \nATOM 2565 OE1 GLU B 11 -18.664 -1.581 16.363 1.00120.68 O \nANISOU 2565 OE1 GLU B 11 15834 14507 15512 -621 -1103 -207 O \nATOM 2566 OE2 GLU B 11 -16.623 -1.218 15.595 1.00120.50 O \nANISOU 2566 OE2 GLU B 11 15391 14749 15644 -689 -985 -187 O \nATOM 2567 N GLY B 12 -18.281 2.398 11.500 1.00 97.18 N \nANISOU 2567 N GLY B 12 12595 11444 12886 -1357 -912 -23 N \nATOM 2568 CA GLY B 12 -18.970 3.093 10.420 1.00 99.41 C \nANISOU 2568 CA GLY B 12 12943 11679 13147 -1518 -912 9 C \nATOM 2569 C GLY B 12 -18.678 4.584 10.483 1.00103.90 C \nANISOU 2569 C GLY B 12 13316 12364 13799 -1663 -851 39 C \nATOM 2570 O GLY B 12 -18.029 5.058 11.421 1.00 99.47 O \nANISOU 2570 O GLY B 12 12609 11878 13306 -1637 -820 38 O \nATOM 2571 N GLY B 13 -19.163 5.319 9.483 1.00102.21 N \nANISOU 2571 N GLY B 13 13101 12177 13557 -1803 -842 62 N \nATOM 2572 CA GLY B 13 -18.952 6.772 9.397 1.00100.43 C \nANISOU 2572 CA GLY B 13 12684 12103 13371 -1906 -793 78 C \nATOM 2573 C GLY B 13 -19.957 7.608 10.187 1.00 94.76 C \nANISOU 2573 C GLY B 13 11978 11448 12580 -2069 -802 100 C \nATOM 2574 O GLY B 13 -21.015 7.124 10.572 1.00 90.46 O \nANISOU 2574 O GLY B 13 11632 10804 11936 -2161 -852 116 O \nATOM 2575 N TRP B 14 -19.607 8.868 10.437 1.00 97.22 N \nANISOU 2575 N TRP B 14 12091 11928 12921 -2096 -762 99 N \nATOM 2576 CA TRP B 14 -20.455 9.790 11.225 1.00 87.73 C \nANISOU 2576 CA TRP B 14 10848 10846 11641 -2243 -763 115 C \nATOM 2577 C TRP B 14 -21.377 10.557 10.289 1.00 87.49 C \nANISOU 2577 C TRP B 14 10791 10971 11479 -2447 -763 135 C \nATOM 2578 O TRP B 14 -20.989 11.603 9.735 1.00 80.42 O \nANISOU 2578 O TRP B 14 9697 10281 10577 -2430 -728 118 O \nATOM 2579 CB TRP B 14 -19.649 10.864 11.988 1.00 81.86 C \nANISOU 2579 CB TRP B 14 9895 10246 10961 -2150 -727 93 C \nATOM 2580 CG TRP B 14 -18.673 10.518 13.070 1.00 79.70 C \nANISOU 2580 CG TRP B 14 9600 9887 10794 -1993 -724 78 C \nATOM 2581 CD1 TRP B 14 -17.569 11.286 13.474 1.00 78.23 C \nANISOU 2581 CD1 TRP B 14 9278 9772 10674 -1870 -706 56 C \nATOM 2582 CD2 TRP B 14 -18.688 9.373 13.919 1.00 81.77 C \nANISOU 2582 CD2 TRP B 14 9989 9994 11085 -1943 -746 81 C \nATOM 2583 NE1 TRP B 14 -16.923 10.664 14.511 1.00 80.69 N \nANISOU 2583 NE1 TRP B 14 9625 9981 11055 -1787 -713 54 N \nATOM 2584 CE2 TRP B 14 -17.569 9.484 14.792 1.00 85.22 C \nANISOU 2584 CE2 TRP B 14 10334 10436 11608 -1820 -732 66 C \nATOM 2585 CE3 TRP B 14 -19.509 8.239 14.010 1.00 79.31 C \nANISOU 2585 CE3 TRP B 14 9877 9541 10714 -1975 -787 89 C \nATOM 2586 CZ2 TRP B 14 -17.266 8.506 15.739 1.00 83.85 C \nANISOU 2586 CZ2 TRP B 14 10221 10173 11464 -1746 -746 61 C \nATOM 2587 CZ3 TRP B 14 -19.201 7.271 14.949 1.00 81.65 C \nANISOU 2587 CZ3 TRP B 14 10241 9743 11038 -1857 -807 75 C \nATOM 2588 CH2 TRP B 14 -18.098 7.409 15.809 1.00 82.52 C \nANISOU 2588 CH2 TRP B 14 10216 9902 11237 -1753 -781 62 C \nATOM 2589 N GLN B 15 -22.604 10.070 10.134 1.00 88.03 N \nANISOU 2589 N GLN B 15 11071 10959 11417 -2642 -811 168 N \nATOM 2590 CA GLN B 15 -23.610 10.806 9.387 1.00 90.13 C \nANISOU 2590 CA GLN B 15 11323 11404 11517 -2903 -818 197 C \nATOM 2591 C GLN B 15 -23.663 12.271 9.849 1.00 89.56 C \nANISOU 2591 C GLN B 15 10983 11654 11393 -2968 -777 187 C \nATOM 2592 O GLN B 15 -24.011 13.173 9.069 1.00 83.33 O \nANISOU 2592 O GLN B 15 10044 11131 10485 -3100 -758 189 O \nATOM 2593 CB GLN B 15 -24.971 10.148 9.556 1.00 98.24 C \nANISOU 2593 CB GLN B 15 12663 12281 12381 -3140 -894 242 C \nATOM 2594 CG GLN B 15 -26.043 10.707 8.617 1.00101.74 C \nANISOU 2594 CG GLN B 15 13147 12892 12620 -3465 -915 284 C \nATOM 2595 CD GLN B 15 -25.784 10.475 7.119 1.00108.69 C \nANISOU 2595 CD GLN B 15 14031 13764 13501 -3450 -908 281 C \nATOM 2596 OE1 GLN B 15 -25.041 9.572 6.701 1.00100.38 O \nANISOU 2596 OE1 GLN B 15 13057 12505 12577 -3225 -910 256 O \nATOM 2597 NE2 GLN B 15 -26.402 11.316 6.298 1.00115.48 N \nANISOU 2597 NE2 GLN B 15 14788 14886 14201 -3699 -898 305 N \nATOM 2598 N GLY B 16 -23.307 12.489 11.118 1.00 86.77 N \nANISOU 2598 N GLY B 16 10563 11294 11110 -2860 -766 172 N \nATOM 2599 CA GLY B 16 -23.379 13.786 11.746 1.00 85.33 C \nANISOU 2599 CA GLY B 16 10153 11398 10869 -2889 -737 155 C \nATOM 2600 C GLY B 16 -22.191 14.702 11.534 1.00 93.01 C \nANISOU 2600 C GLY B 16 10879 12538 11923 -2648 -696 102 C \nATOM 2601 O GLY B 16 -22.260 15.863 11.924 1.00 94.95 O \nANISOU 2601 O GLY B 16 10929 13059 12089 -2638 -681 76 O \nATOM 2602 N MET B 17 -21.101 14.221 10.931 1.00 96.92 N \nANISOU 2602 N MET B 17 11393 12880 12553 -2447 -688 81 N \nATOM 2603 CA MET B 17 -19.946 15.087 10.731 1.00 91.64 C \nANISOU 2603 CA MET B 17 10551 12332 11938 -2218 -669 30 C \nATOM 2604 C MET B 17 -19.953 15.711 9.353 1.00 89.71 C \nANISOU 2604 C MET B 17 10190 12290 11608 -2222 -657 10 C \nATOM 2605 O MET B 17 -19.530 15.107 8.374 1.00 95.64 O \nANISOU 2605 O MET B 17 11010 12910 12418 -2179 -656 14 O \nATOM 2606 CB MET B 17 -18.619 14.383 10.959 1.00 94.86 C \nANISOU 2606 CB MET B 17 11038 12489 12515 -2008 -673 18 C \nATOM 2607 CG MET B 17 -17.464 15.380 10.827 1.00 94.43 C \nANISOU 2607 CG MET B 17 10862 12537 12479 -1789 -676 -31 C \nATOM 2608 SD MET B 17 -15.932 14.854 11.545 1.00 83.59 S \nANISOU 2608 SD MET B 17 9588 10917 11254 -1601 -696 -39 S \nATOM 2609 CE MET B 17 -15.721 13.332 10.611 1.00 93.12 C \nANISOU 2609 CE MET B 17 10926 11911 12545 -1650 -688 -7 C \nATOM 2610 N VAL B 18 -20.422 16.940 9.302 1.00 97.10 N \nANISOU 2610 N VAL B 18 10932 13572 12390 -2262 -649 -16 N \nATOM 2611 CA VAL B 18 -20.580 17.692 8.063 1.00106.11 C \nANISOU 2611 CA VAL B 18 11920 14997 13402 -2276 -639 -43 C \nATOM 2612 C VAL B 18 -19.382 18.623 7.841 1.00111.64 C \nANISOU 2612 C VAL B 18 12485 15813 14118 -1952 -645 -117 C \nATOM 2613 O VAL B 18 -19.214 19.183 6.761 1.00127.41 O \nANISOU 2613 O VAL B 18 14372 18007 16033 -1879 -643 -152 O \nATOM 2614 CB VAL B 18 -21.891 18.535 8.102 1.00108.80 C \nANISOU 2614 CB VAL B 18 12103 15731 13505 -2530 -632 -34 C \nATOM 2615 CG1 VAL B 18 -23.084 17.647 8.462 1.00106.16 C \nANISOU 2615 CG1 VAL B 18 11966 15242 13126 -2865 -647 43 C \nATOM 2616 CG2 VAL B 18 -21.787 19.703 9.085 1.00105.72 C \nANISOU 2616 CG2 VAL B 18 11517 15620 13030 -2402 -632 -85 C \nATOM 2617 N ASP B 19 -18.565 18.784 8.874 1.00110.47 N \nANISOU 2617 N ASP B 19 12373 15538 14062 -1757 -663 -141 N \nATOM 2618 CA ASP B 19 -17.473 19.763 8.898 1.00114.42 C \nANISOU 2618 CA ASP B 19 12803 16131 14542 -1443 -693 -215 C \nATOM 2619 C ASP B 19 -16.223 19.344 8.078 1.00119.32 C \nANISOU 2619 C ASP B 19 13552 16509 15276 -1263 -715 -227 C \nATOM 2620 O ASP B 19 -15.383 20.181 7.719 1.00110.14 O \nANISOU 2620 O ASP B 19 12363 15431 14057 -1011 -754 -290 O \nATOM 2621 CB ASP B 19 -17.050 20.006 10.361 1.00121.88 C \nANISOU 2621 CB ASP B 19 13789 16984 15534 -1331 -716 -227 C \nATOM 2622 CG ASP B 19 -18.175 20.586 11.213 1.00123.38 C \nANISOU 2622 CG ASP B 19 13839 17442 15596 -1476 -700 -225 C \nATOM 2623 OD1 ASP B 19 -19.182 21.057 10.636 1.00130.80 O \nANISOU 2623 OD1 ASP B 19 14620 18708 16371 -1638 -679 -226 O \nATOM 2624 OD2 ASP B 19 -18.039 20.571 12.458 1.00120.99 O \nANISOU 2624 OD2 ASP B 19 13585 17038 15346 -1445 -711 -220 O \nATOM 2625 N GLY B 20 -16.085 18.048 7.799 1.00112.74 N \nANISOU 2625 N GLY B 20 12872 15379 14584 -1381 -699 -171 N \nATOM 2626 CA GLY B 20 -14.885 17.539 7.132 1.00101.22 C \nANISOU 2626 CA GLY B 20 11538 13690 13230 -1246 -719 -174 C \nATOM 2627 C GLY B 20 -14.919 16.054 6.824 1.00 94.23 C \nANISOU 2627 C GLY B 20 10789 12545 12471 -1390 -697 -116 C \nATOM 2628 O GLY B 20 -15.965 15.409 6.932 1.00 93.10 O \nANISOU 2628 O GLY B 20 10665 12389 12322 -1586 -673 -75 O \nATOM 2629 N TRP B 21 -13.758 15.510 6.469 1.00 85.18 N \nANISOU 2629 N TRP B 21 9754 11194 11418 -1287 -716 -114 N \nATOM 2630 CA TRP B 21 -13.651 14.084 6.121 1.00 88.66 C \nANISOU 2630 CA TRP B 21 10304 11423 11959 -1383 -700 -70 C \nATOM 2631 C TRP B 21 -13.315 13.217 7.309 1.00 77.47 C \nANISOU 2631 C TRP B 21 8977 9832 10625 -1408 -704 -44 C \nATOM 2632 O TRP B 21 -13.862 12.135 7.458 1.00 69.48 O \nANISOU 2632 O TRP B 21 8023 8728 9648 -1510 -689 -14 O \nATOM 2633 CB TRP B 21 -12.603 13.867 5.027 1.00100.63 C \nANISOU 2633 CB TRP B 21 11875 12850 13511 -1288 -714 -80 C \nATOM 2634 CG TRP B 21 -13.110 14.108 3.627 1.00111.53 C \nANISOU 2634 CG TRP B 21 13189 14353 14832 -1316 -698 -90 C \nATOM 2635 CD1 TRP B 21 -14.348 14.539 3.259 1.00116.05 C \nANISOU 2635 CD1 TRP B 21 13660 15126 15309 -1432 -674 -90 C \nATOM 2636 CD2 TRP B 21 -12.367 13.956 2.421 1.00114.58 C \nANISOU 2636 CD2 TRP B 21 13612 14687 15237 -1244 -707 -100 C \nATOM 2637 NE1 TRP B 21 -14.428 14.644 1.902 1.00118.04 N \nANISOU 2637 NE1 TRP B 21 13874 15456 15519 -1436 -666 -99 N \nATOM 2638 CE2 TRP B 21 -13.220 14.298 1.361 1.00114.79 C \nANISOU 2638 CE2 TRP B 21 13546 14885 15185 -1307 -685 -108 C \nATOM 2639 CE3 TRP B 21 -11.055 13.560 2.132 1.00119.86 C \nANISOU 2639 CE3 TRP B 21 14388 15188 15967 -1153 -735 -99 C \nATOM 2640 CZ2 TRP B 21 -12.809 14.260 0.029 1.00123.21 C \nANISOU 2640 CZ2 TRP B 21 14616 15951 16247 -1257 -686 -119 C \nATOM 2641 CZ3 TRP B 21 -10.645 13.518 0.801 1.00123.94 C \nANISOU 2641 CZ3 TRP B 21 14918 15698 16476 -1110 -739 -109 C \nATOM 2642 CH2 TRP B 21 -11.523 13.864 -0.232 1.00120.36 C \nANISOU 2642 CH2 TRP B 21 14364 15408 15959 -1149 -713 -121 C \nATOM 2643 N TYR B 22 -12.394 13.696 8.133 1.00 75.47 N \nANISOU 2643 N TYR B 22 8751 9539 10385 -1302 -735 -59 N \nATOM 2644 CA TYR B 22 -12.060 13.013 9.368 1.00 74.67 C \nANISOU 2644 CA TYR B 22 8714 9315 10341 -1333 -740 -36 C \nATOM 2645 C TYR B 22 -12.213 13.956 10.537 1.00 73.58 C \nANISOU 2645 C TYR B 22 8540 9254 10165 -1290 -757 -53 C \nATOM 2646 O TYR B 22 -12.095 15.178 10.380 1.00 77.57 O \nANISOU 2646 O TYR B 22 8996 9882 10595 -1179 -781 -92 O \nATOM 2647 CB TYR B 22 -10.625 12.525 9.346 1.00 80.65 C \nANISOU 2647 CB TYR B 22 9571 9932 11140 -1286 -771 -27 C \nATOM 2648 CG TYR B 22 -10.120 12.101 7.993 1.00 78.65 C \nANISOU 2648 CG TYR B 22 9348 9639 10897 -1276 -770 -25 C \nATOM 2649 CD1 TYR B 22 -9.127 12.822 7.348 1.00 72.31 C \nANISOU 2649 CD1 TYR B 22 8605 8812 10056 -1176 -814 -45 C \nATOM 2650 CD2 TYR B 22 -10.617 10.951 7.378 1.00 72.99 C \nANISOU 2650 CD2 TYR B 22 8623 8896 10215 -1354 -736 -5 C \nATOM 2651 CE1 TYR B 22 -8.644 12.419 6.122 1.00 71.02 C \nANISOU 2651 CE1 TYR B 22 8475 8607 9902 -1174 -815 -42 C \nATOM 2652 CE2 TYR B 22 -10.130 10.532 6.157 1.00 69.17 C \nANISOU 2652 CE2 TYR B 22 8163 8378 9740 -1343 -736 -4 C \nATOM 2653 CZ TYR B 22 -9.149 11.274 5.526 1.00 68.58 C \nANISOU 2653 CZ TYR B 22 8129 8288 9639 -1263 -770 -20 C \nATOM 2654 OH TYR B 22 -8.699 10.871 4.287 1.00 58.31 O \nANISOU 2654 OH TYR B 22 6854 6956 8346 -1259 -770 -18 O \nATOM 2655 N GLY B 23 -12.469 13.386 11.710 1.00 67.41 N \nANISOU 2655 N GLY B 23 7780 8411 9421 -1357 -749 -30 N \nATOM 2656 CA GLY B 23 -12.593 14.190 12.916 1.00 67.35 C \nANISOU 2656 CA GLY B 23 7745 8463 9383 -1322 -764 -43 C \nATOM 2657 C GLY B 23 -12.979 13.432 14.149 1.00 65.58 C \nANISOU 2657 C GLY B 23 7545 8172 9202 -1407 -751 -16 C \nATOM 2658 O GLY B 23 -12.780 12.216 14.238 1.00 57.40 O \nANISOU 2658 O GLY B 23 6565 7026 8217 -1456 -742 8 O \nATOM 2659 N TYR B 24 -13.579 14.144 15.095 1.00 72.70 N \nANISOU 2659 N TYR B 24 8394 9163 10065 -1413 -751 -25 N \nATOM 2660 CA TYR B 24 -13.827 13.585 16.436 1.00 73.56 C \nANISOU 2660 CA TYR B 24 8533 9208 10209 -1471 -747 -5 C \nATOM 2661 C TYR B 24 -15.279 13.669 16.846 1.00 71.66 C \nANISOU 2661 C TYR B 24 8249 9057 9923 -1583 -726 5 C \nATOM 2662 O TYR B 24 -16.073 14.385 16.234 1.00 85.61 O \nANISOU 2662 O TYR B 24 9940 10976 11612 -1631 -717 -6 O \nATOM 2663 CB TYR B 24 -12.998 14.331 17.464 1.00 73.51 C \nANISOU 2663 CB TYR B 24 8543 9190 10196 -1381 -781 -19 C \nATOM 2664 CG TYR B 24 -11.543 14.517 17.077 1.00 78.55 C \nANISOU 2664 CG TYR B 24 9273 9737 10835 -1286 -825 -28 C \nATOM 2665 CD1 TYR B 24 -11.132 15.637 16.349 1.00 77.93 C \nANISOU 2665 CD1 TYR B 24 9201 9721 10689 -1155 -860 -66 C \nATOM 2666 CD2 TYR B 24 -10.576 13.576 17.443 1.00 78.26 C \nANISOU 2666 CD2 TYR B 24 9326 9569 10840 -1333 -839 1 C \nATOM 2667 CE1 TYR B 24 -9.798 15.827 16.014 1.00 75.74 C \nANISOU 2667 CE1 TYR B 24 9061 9327 10389 -1072 -919 -73 C \nATOM 2668 CE2 TYR B 24 -9.245 13.752 17.113 1.00 80.81 C \nANISOU 2668 CE2 TYR B 24 9765 9802 11136 -1292 -890 2 C \nATOM 2669 CZ TYR B 24 -8.860 14.886 16.397 1.00 84.60 C \nANISOU 2669 CZ TYR B 24 10295 10298 11553 -1161 -935 -34 C \nATOM 2670 OH TYR B 24 -7.545 15.092 16.046 1.00 95.24 O \nANISOU 2670 OH TYR B 24 11810 11527 12851 -1121 -1004 -33 O \nATOM 2671 N HIS B 25 -15.623 12.909 17.870 1.00 64.47 N \nANISOU 2671 N HIS B 25 7391 8063 9041 -1638 -725 25 N \nATOM 2672 CA HIS B 25 -16.871 13.060 18.552 1.00 62.42 C \nANISOU 2672 CA HIS B 25 7125 7863 8727 -1747 -720 36 C \nATOM 2673 C HIS B 25 -16.634 12.862 20.019 1.00 64.92 C \nANISOU 2673 C HIS B 25 7464 8121 9081 -1722 -728 40 C \nATOM 2674 O HIS B 25 -16.244 11.772 20.446 1.00 67.87 O \nANISOU 2674 O HIS B 25 7910 8374 9504 -1700 -734 51 O \nATOM 2675 CB HIS B 25 -17.927 12.067 18.103 1.00 66.88 C \nANISOU 2675 CB HIS B 25 7797 8357 9259 -1867 -722 60 C \nATOM 2676 CG HIS B 25 -19.219 12.218 18.854 1.00 79.24 C \nANISOU 2676 CG HIS B 25 9403 9961 10744 -2008 -732 77 C \nATOM 2677 ND1 HIS B 25 -19.958 13.384 18.851 1.00 89.42 N \nANISOU 2677 ND1 HIS B 25 10590 11448 11935 -2114 -724 76 N \nATOM 2678 CD2 HIS B 25 -19.878 11.359 19.667 1.00 82.86 C \nANISOU 2678 CD2 HIS B 25 9997 10300 11186 -2060 -755 93 C \nATOM 2679 CE1 HIS B 25 -21.030 13.226 19.605 1.00 93.90 C \nANISOU 2679 CE1 HIS B 25 11237 12008 12433 -2259 -741 100 C \nATOM 2680 NE2 HIS B 25 -21.007 12.001 20.106 1.00 91.00 N \nANISOU 2680 NE2 HIS B 25 11031 11428 12116 -2220 -763 110 N \nATOM 2681 N HIS B 26 -16.885 13.908 20.799 1.00 65.45 N \nANISOU 2681 N HIS B 26 7457 8302 9108 -1721 -731 29 N \nATOM 2682 CA HIS B 26 -16.762 13.824 22.247 1.00 67.88 C \nANISOU 2682 CA HIS B 26 7783 8565 9444 -1708 -739 34 C \nATOM 2683 C HIS B 26 -18.127 13.751 22.938 1.00 71.61 C \nANISOU 2683 C HIS B 26 8273 9077 9860 -1841 -736 51 C \nATOM 2684 O HIS B 26 -19.148 14.185 22.421 1.00 72.38 O \nANISOU 2684 O HIS B 26 8344 9289 9869 -1957 -731 56 O \nATOM 2685 CB HIS B 26 -15.947 15.016 22.777 1.00 71.12 C \nANISOU 2685 CB HIS B 26 8130 9049 9843 -1591 -757 6 C \nATOM 2686 CG HIS B 26 -16.709 16.301 22.834 1.00 77.58 C \nANISOU 2686 CG HIS B 26 8833 10081 10562 -1597 -755 -19 C \nATOM 2687 ND1 HIS B 26 -16.903 17.098 21.730 1.00 78.30 N \nANISOU 2687 ND1 HIS B 26 8836 10342 10574 -1567 -752 -45 N \nATOM 2688 CD2 HIS B 26 -17.328 16.931 23.865 1.00 82.42 C \nANISOU 2688 CD2 HIS B 26 9386 10805 11124 -1628 -755 -24 C \nATOM 2689 CE1 HIS B 26 -17.620 18.158 22.071 1.00 85.02 C \nANISOU 2689 CE1 HIS B 26 9563 11427 11315 -1581 -750 -69 C \nATOM 2690 NE2 HIS B 26 -17.883 18.086 23.364 1.00 80.88 N \nANISOU 2690 NE2 HIS B 26 9056 10867 10809 -1621 -752 -56 N \nATOM 2691 N SER B 27 -18.121 13.196 24.127 1.00 73.46 N \nANISOU 2691 N SER B 27 8561 9222 10128 -1837 -743 60 N \nATOM 2692 CA SER B 27 -19.262 13.283 24.991 1.00 74.30 C \nANISOU 2692 CA SER B 27 8696 9359 10176 -1949 -749 74 C \nATOM 2693 C SER B 27 -18.746 13.419 26.426 1.00 71.58 C \nANISOU 2693 C SER B 27 8329 8990 9878 -1882 -754 69 C \nATOM 2694 O SER B 27 -17.864 12.674 26.849 1.00 68.20 O \nANISOU 2694 O SER B 27 7938 8458 9517 -1799 -759 68 O \nATOM 2695 CB SER B 27 -20.182 12.074 24.815 1.00 71.04 C \nANISOU 2695 CB SER B 27 8449 8816 9727 -2036 -770 95 C \nATOM 2696 OG SER B 27 -19.594 10.905 25.348 1.00 78.57 O \nANISOU 2696 OG SER B 27 9479 9633 10740 -1929 -782 89 O \nATOM 2697 N ASN B 28 -19.291 14.394 27.151 1.00 70.71 N \nANISOU 2697 N ASN B 28 8148 9004 9715 -1928 -752 65 N \nATOM 2698 CA ASN B 28 -18.909 14.648 28.539 1.00 69.33 C \nANISOU 2698 CA ASN B 28 7953 8817 9573 -1874 -759 60 C \nATOM 2699 C ASN B 28 -20.059 15.292 29.317 1.00 67.05 C \nANISOU 2699 C ASN B 28 7628 8647 9202 -1989 -759 66 C \nATOM 2700 O ASN B 28 -21.157 15.395 28.795 1.00 68.41 O \nANISOU 2700 O ASN B 28 7811 8898 9282 -2137 -758 81 O \nATOM 2701 CB ASN B 28 -17.640 15.510 28.601 1.00 71.75 C \nANISOU 2701 CB ASN B 28 8192 9161 9907 -1726 -768 33 C \nATOM 2702 CG ASN B 28 -17.825 16.879 27.966 1.00 72.41 C \nANISOU 2702 CG ASN B 28 8162 9447 9905 -1684 -770 1 C \nATOM 2703 OD1 ASN B 28 -18.878 17.187 27.414 1.00 72.76 O \nANISOU 2703 OD1 ASN B 28 8144 9635 9865 -1794 -754 4 O \nATOM 2704 ND2 ASN B 28 -16.788 17.702 28.028 1.00 67.60 N \nANISOU 2704 ND2 ASN B 28 7535 8860 9288 -1524 -797 -32 N \nATOM 2705 N GLU B 29 -19.808 15.682 30.570 1.00 62.94 N \nANISOU 2705 N GLU B 29 7075 8139 8701 -1941 -764 59 N \nATOM 2706 CA GLU B 29 -20.812 16.336 31.435 1.00 69.03 C \nANISOU 2706 CA GLU B 29 7800 9037 9392 -2046 -764 64 C \nATOM 2707 C GLU B 29 -21.392 17.637 30.793 1.00 69.58 C \nANISOU 2707 C GLU B 29 7718 9385 9333 -2101 -755 44 C \nATOM 2708 O GLU B 29 -22.570 17.910 30.936 1.00 70.89 O \nANISOU 2708 O GLU B 29 7863 9683 9388 -2281 -754 61 O \nATOM 2709 CB GLU B 29 -20.251 16.586 32.862 1.00 67.89 C \nANISOU 2709 CB GLU B 29 7639 8861 9296 -1956 -772 54 C \nATOM 2710 CG GLU B 29 -18.945 17.408 32.875 1.00 80.65 C \nANISOU 2710 CG GLU B 29 9193 10510 10942 -1773 -784 20 C \nATOM 2711 CD GLU B 29 -17.614 16.615 32.601 1.00 84.08 C \nANISOU 2711 CD GLU B 29 9717 10759 11470 -1679 -796 25 C \nATOM 2712 OE1 GLU B 29 -17.512 15.371 32.757 1.00 70.69 O \nANISOU 2712 OE1 GLU B 29 8101 8927 9831 -1720 -791 49 O \nATOM 2713 OE2 GLU B 29 -16.619 17.260 32.220 1.00 90.59 O \nANISOU 2713 OE2 GLU B 29 10539 11592 12288 -1558 -819 2 O \nATOM 2714 N GLN B 30 -20.572 18.361 30.030 1.00 70.60 N \nANISOU 2714 N GLN B 30 7755 9612 9459 -1954 -755 8 N \nATOM 2715 CA GLN B 30 -20.998 19.556 29.304 1.00 71.80 C \nANISOU 2715 CA GLN B 30 7742 10069 9470 -1960 -749 -25 C \nATOM 2716 C GLN B 30 -21.800 19.219 28.023 1.00 82.63 C \nANISOU 2716 C GLN B 30 9119 11506 10772 -2133 -736 -1 C \nATOM 2717 O GLN B 30 -22.223 20.135 27.290 1.00 79.12 O \nANISOU 2717 O GLN B 30 8522 11352 10189 -2168 -728 -25 O \nATOM 2718 CB GLN B 30 -19.804 20.460 28.952 1.00 74.22 C \nANISOU 2718 CB GLN B 30 7979 10448 9773 -1699 -770 -82 C \nATOM 2719 CG GLN B 30 -19.085 21.059 30.154 1.00 88.27 C \nANISOU 2719 CG GLN B 30 9765 12205 11570 -1530 -800 -112 C \nATOM 2720 CD GLN B 30 -17.965 20.178 30.704 1.00101.23 C \nANISOU 2720 CD GLN B 30 11579 13524 13360 -1460 -819 -90 C \nATOM 2721 OE1 GLN B 30 -17.818 19.008 30.329 1.00113.12 O \nANISOU 2721 OE1 GLN B 30 13183 14838 14959 -1543 -804 -51 O \nATOM 2722 NE2 GLN B 30 -17.167 20.739 31.599 1.00106.08 N \nANISOU 2722 NE2 GLN B 30 12232 14098 13974 -1310 -857 -115 N \nATOM 2723 N GLY B 31 -22.070 17.932 27.774 1.00 88.84 N \nANISOU 2723 N GLY B 31 10080 12048 11627 -2241 -738 43 N \nATOM 2724 CA GLY B 31 -22.785 17.500 26.557 1.00 88.40 C \nANISOU 2724 CA GLY B 31 10080 12004 11504 -2403 -737 68 C \nATOM 2725 C GLY B 31 -21.863 16.836 25.534 1.00 85.79 C \nANISOU 2725 C GLY B 31 9810 11508 11278 -2272 -733 61 C \nATOM 2726 O GLY B 31 -20.919 16.162 25.891 1.00 87.55 O \nANISOU 2726 O GLY B 31 10107 11527 11629 -2129 -738 57 O \nATOM 2727 N SER B 32 -22.165 17.031 24.255 1.00 84.37 N \nANISOU 2727 N SER B 32 9591 11441 11026 -2342 -727 61 N \nATOM 2728 CA SER B 32 -21.536 16.300 23.181 1.00 75.56 C \nANISOU 2728 CA SER B 32 8550 10170 9989 -2266 -725 62 C \nATOM 2729 C SER B 32 -21.352 17.169 21.943 1.00 79.42 C \nANISOU 2729 C SER B 32 8895 10876 10404 -2228 -712 33 C \nATOM 2730 O SER B 32 -21.825 18.307 21.893 1.00 73.28 O \nANISOU 2730 O SER B 32 7951 10400 9492 -2271 -706 11 O \nATOM 2731 CB SER B 32 -22.366 15.067 22.833 1.00 70.82 C \nANISOU 2731 CB SER B 32 8154 9381 9372 -2427 -744 105 C \nATOM 2732 OG SER B 32 -23.477 15.386 22.062 1.00 71.92 O \nANISOU 2732 OG SER B 32 8297 9670 9359 -2650 -751 127 O \nATOM 2733 N GLY B 33 -20.623 16.638 20.962 1.00 81.60 N \nANISOU 2733 N GLY B 33 9224 11023 10759 -2134 -710 29 N \nATOM 2734 CA GLY B 33 -20.382 17.361 19.716 1.00 82.94 C \nANISOU 2734 CA GLY B 33 9275 11376 10865 -2079 -702 -1 C \nATOM 2735 C GLY B 33 -19.398 16.717 18.750 1.00 81.83 C \nANISOU 2735 C GLY B 33 9208 11055 10828 -1955 -703 -5 C \nATOM 2736 O GLY B 33 -18.559 15.923 19.150 1.00 82.18 O \nANISOU 2736 O GLY B 33 9359 10869 10997 -1860 -711 2 O \nATOM 2737 N TYR B 34 -19.523 17.061 17.468 1.00 83.49 N \nANISOU 2737 N TYR B 34 9352 11400 10971 -1972 -695 -17 N \nATOM 2738 CA TYR B 34 -18.569 16.652 16.433 1.00 82.30 C \nANISOU 2738 CA TYR B 34 9248 11121 10900 -1847 -697 -28 C \nATOM 2739 C TYR B 34 -17.540 17.746 16.168 1.00 82.13 C \nANISOU 2739 C TYR B 34 9130 11222 10855 -1617 -715 -85 C \nATOM 2740 O TYR B 34 -17.763 18.908 16.462 1.00 80.65 O \nANISOU 2740 O TYR B 34 8806 11283 10553 -1552 -723 -125 O \nATOM 2741 CB TYR B 34 -19.277 16.331 15.125 1.00 80.80 C \nANISOU 2741 CB TYR B 34 9068 10984 10647 -1992 -685 -8 C \nATOM 2742 CG TYR B 34 -20.266 15.181 15.189 1.00 80.54 C \nANISOU 2742 CG TYR B 34 9202 10790 10611 -2200 -691 44 C \nATOM 2743 CD1 TYR B 34 -21.630 15.416 15.395 1.00 71.48 C \nANISOU 2743 CD1 TYR B 34 8061 9777 9319 -2441 -697 73 C \nATOM 2744 CD2 TYR B 34 -19.848 13.855 15.025 1.00 74.21 C \nANISOU 2744 CD2 TYR B 34 8567 9710 9918 -2155 -701 62 C \nATOM 2745 CE1 TYR B 34 -22.533 14.366 15.465 1.00 71.56 C \nANISOU 2745 CE1 TYR B 34 8289 9602 9300 -2621 -725 119 C \nATOM 2746 CE2 TYR B 34 -20.757 12.806 15.090 1.00 73.18 C \nANISOU 2746 CE2 TYR B 34 8624 9426 9756 -2297 -724 98 C \nATOM 2747 CZ TYR B 34 -22.091 13.067 15.315 1.00 74.34 C \nANISOU 2747 CZ TYR B 34 8821 9662 9762 -2525 -742 126 C \nATOM 2748 OH TYR B 34 -22.977 12.025 15.374 1.00 80.30 O \nANISOU 2748 OH TYR B 34 9823 10227 10461 -2654 -786 160 O \nATOM 2749 N ALA B 35 -16.402 17.349 15.619 1.00 86.51 N \nANISOU 2749 N ALA B 35 9772 11600 11498 -1485 -730 -92 N \nATOM 2750 CA ALA B 35 -15.310 18.273 15.350 1.00 91.39 C \nANISOU 2750 CA ALA B 35 10376 12266 12084 -1253 -768 -145 C \nATOM 2751 C ALA B 35 -14.340 17.650 14.355 1.00 90.70 C \nANISOU 2751 C ALA B 35 10397 11995 12070 -1193 -781 -138 C \nATOM 2752 O ALA B 35 -13.709 16.653 14.651 1.00 88.12 O \nANISOU 2752 O ALA B 35 10194 11438 11850 -1226 -783 -104 O \nATOM 2753 CB ALA B 35 -14.590 18.623 16.643 1.00 93.20 C \nANISOU 2753 CB ALA B 35 10669 12408 12336 -1134 -805 -159 C \nATOM 2754 N ALA B 36 -14.252 18.229 13.166 1.00100.81 N \nANISOU 2754 N ALA B 36 11617 13408 13277 -1112 -787 -171 N \nATOM 2755 CA ALA B 36 -13.396 17.689 12.109 1.00104.68 C \nANISOU 2755 CA ALA B 36 12204 13743 13825 -1064 -799 -165 C \nATOM 2756 C ALA B 36 -11.953 18.142 12.271 1.00104.40 C \nANISOU 2756 C ALA B 36 12305 13577 13787 -863 -867 -196 C \nATOM 2757 O ALA B 36 -11.697 19.236 12.773 1.00106.63 O \nANISOU 2757 O ALA B 36 12581 13959 13973 -695 -914 -245 O \nATOM 2758 CB ALA B 36 -13.925 18.101 10.744 1.00109.00 C \nANISOU 2758 CB ALA B 36 12640 14486 14288 -1069 -781 -187 C \nATOM 2759 N ASP B 37 -11.014 17.300 11.850 1.00101.55 N \nANISOU 2759 N ASP B 37 12085 12995 13506 -884 -881 -167 N \nATOM 2760 CA ASP B 37 -9.613 17.681 11.858 1.00105.12 C \nANISOU 2760 CA ASP B 37 12714 13300 13925 -736 -960 -186 C \nATOM 2761 C ASP B 37 -9.310 18.487 10.594 1.00111.68 C \nANISOU 2761 C ASP B 37 13549 14222 14663 -567 -997 -238 C \nATOM 2762 O ASP B 37 -9.511 18.010 9.479 1.00120.49 O \nANISOU 2762 O ASP B 37 14617 15354 15809 -629 -961 -225 O \nATOM 2763 CB ASP B 37 -8.730 16.451 11.942 1.00104.54 C \nANISOU 2763 CB ASP B 37 12779 12995 13945 -863 -964 -130 C \nATOM 2764 CG ASP B 37 -7.324 16.777 12.347 1.00107.99 C \nANISOU 2764 CG ASP B 37 13439 13262 14330 -786 -1056 -134 C \nATOM 2765 OD1 ASP B 37 -6.843 17.892 12.056 1.00113.31 O \nANISOU 2765 OD1 ASP B 37 14211 13949 14894 -590 -1131 -186 O \nATOM 2766 OD2 ASP B 37 -6.691 15.904 12.959 1.00114.80 O \nANISOU 2766 OD2 ASP B 37 14393 13988 15238 -922 -1061 -86 O \nATOM 2767 N LYS B 38 -8.812 19.704 10.779 1.00104.59 N \nANISOU 2767 N LYS B 38 12720 13381 13637 -335 -1076 -302 N \nATOM 2768 CA LYS B 38 -8.579 20.617 9.671 1.00102.36 C \nANISOU 2768 CA LYS B 38 12436 13227 13230 -119 -1123 -369 C \nATOM 2769 C LYS B 38 -7.423 20.171 8.811 1.00100.41 C \nANISOU 2769 C LYS B 38 12400 12746 13003 -100 -1174 -352 C \nATOM 2770 O LYS B 38 -7.525 20.148 7.585 1.00 92.28 O \nANISOU 2770 O LYS B 38 11315 11788 11960 -74 -1157 -366 O \nATOM 2771 CB LYS B 38 -8.285 22.017 10.204 1.00108.44 C \nANISOU 2771 CB LYS B 38 13260 14113 13829 172 -1214 -453 C \nATOM 2772 CG LYS B 38 -8.071 23.074 9.133 1.00112.09 C \nANISOU 2772 CG LYS B 38 13716 14754 14121 457 -1277 -542 C \nATOM 2773 CD LYS B 38 -7.996 24.467 9.711 1.00110.79 C \nANISOU 2773 CD LYS B 38 13564 14775 13757 778 -1364 -640 C \nATOM 2774 CE LYS B 38 -8.152 25.504 8.629 1.00112.25 C \nANISOU 2774 CE LYS B 38 13636 15264 13748 1061 -1403 -740 C \nATOM 2775 NZ LYS B 38 -7.988 26.890 9.134 1.00115.45 N \nANISOU 2775 NZ LYS B 38 14070 15874 13922 1440 -1506 -853 N \nATOM 2776 N GLU B 39 -6.316 19.838 9.470 1.00100.43 N \nANISOU 2776 N GLU B 39 12654 12482 13025 -131 -1241 -321 N \nATOM 2777 CA GLU B 39 -5.095 19.455 8.775 1.00 97.99 C \nANISOU 2777 CA GLU B 39 12586 11941 12703 -142 -1308 -299 C \nATOM 2778 C GLU B 39 -5.318 18.158 8.009 1.00 98.02 C \nANISOU 2778 C GLU B 39 12485 11915 12843 -371 -1218 -237 C \nATOM 2779 O GLU B 39 -5.045 18.081 6.815 1.00 96.72 O \nANISOU 2779 O GLU B 39 12346 11738 12664 -337 -1225 -246 O \nATOM 2780 CB GLU B 39 -3.921 19.300 9.755 1.00 96.52 C \nANISOU 2780 CB GLU B 39 12692 11497 12484 -197 -1399 -266 C \nATOM 2781 CG GLU B 39 -2.618 18.886 9.079 1.00103.45 C \nANISOU 2781 CG GLU B 39 13848 12140 13319 -261 -1479 -234 C \nATOM 2782 CD GLU B 39 -1.403 18.906 9.993 1.00105.10 C \nANISOU 2782 CD GLU B 39 14394 12102 13438 -330 -1595 -202 C \nATOM 2783 OE1 GLU B 39 -1.484 19.480 11.099 1.00112.11 O \nANISOU 2783 OE1 GLU B 39 15335 12984 14276 -254 -1634 -221 O \nATOM 2784 OE2 GLU B 39 -0.353 18.338 9.602 1.00101.29 O \nANISOU 2784 OE2 GLU B 39 14132 11435 12919 -481 -1651 -153 O \nATOM 2785 N SER B 40 -5.840 17.154 8.706 1.00 96.83 N \nANISOU 2785 N SER B 40 12220 11760 12810 -583 -1139 -181 N \nATOM 2786 CA SER B 40 -6.004 15.822 8.148 1.00 93.02 C \nANISOU 2786 CA SER B 40 11664 11243 12438 -777 -1066 -127 C \nATOM 2787 C SER B 40 -6.943 15.832 6.932 1.00 87.78 C \nANISOU 2787 C SER B 40 10828 10733 11793 -758 -1004 -147 C \nATOM 2788 O SER B 40 -6.626 15.268 5.884 1.00 97.28 O \nANISOU 2788 O SER B 40 12054 11887 13022 -800 -993 -132 O \nATOM 2789 CB SER B 40 -6.529 14.867 9.230 1.00 91.12 C \nANISOU 2789 CB SER B 40 11333 11002 12285 -949 -1005 -82 C \nATOM 2790 OG SER B 40 -5.768 13.673 9.249 1.00 90.50 O \nANISOU 2790 OG SER B 40 11327 10810 12248 -1102 -1002 -32 O \nATOM 2791 N THR B 41 -8.093 16.471 7.075 1.00 90.53 N \nANISOU 2791 N THR B 41 11006 11280 12112 -714 -966 -177 N \nATOM 2792 CA THR B 41 -9.063 16.597 5.980 1.00 87.82 C \nANISOU 2792 CA THR B 41 10499 11118 11751 -727 -913 -194 C \nATOM 2793 C THR B 41 -8.419 17.308 4.785 1.00 93.01 C \nANISOU 2793 C THR B 41 11210 11804 12324 -555 -963 -240 C \nATOM 2794 O THR B 41 -8.598 16.899 3.640 1.00102.18 O \nANISOU 2794 O THR B 41 12327 12988 13509 -602 -931 -231 O \nATOM 2795 CB THR B 41 -10.326 17.354 6.444 1.00 86.57 C \nANISOU 2795 CB THR B 41 10157 11211 11526 -728 -879 -220 C \nATOM 2796 OG1 THR B 41 -10.999 16.596 7.459 1.00 85.62 O \nANISOU 2796 OG1 THR B 41 10007 11043 11481 -900 -835 -174 O \nATOM 2797 CG2 THR B 41 -11.291 17.571 5.286 1.00 92.59 C \nANISOU 2797 CG2 THR B 41 10760 12191 12231 -774 -835 -234 C \nATOM 2798 N GLN B 42 -7.660 18.365 5.053 1.00 93.97 N \nANISOU 2798 N GLN B 42 11450 11917 12337 -340 -1050 -293 N \nATOM 2799 CA GLN B 42 -6.974 19.111 3.997 1.00 89.64 C \nANISOU 2799 CA GLN B 42 10996 11384 11681 -131 -1120 -348 C \nATOM 2800 C GLN B 42 -5.982 18.255 3.227 1.00 86.90 C \nANISOU 2800 C GLN B 42 10825 10798 11396 -213 -1141 -306 C \nATOM 2801 O GLN B 42 -6.030 18.190 2.001 1.00 92.46 O \nANISOU 2801 O GLN B 42 11486 11551 12092 -189 -1126 -317 O \nATOM 2802 CB GLN B 42 -6.251 20.334 4.571 1.00 85.13 C \nANISOU 2802 CB GLN B 42 10590 10799 10958 141 -1235 -416 C \nATOM 2803 CG GLN B 42 -5.791 21.318 3.515 1.00 86.34 C \nANISOU 2803 CG GLN B 42 10816 11036 10954 423 -1315 -496 C \nATOM 2804 CD GLN B 42 -6.934 21.737 2.597 1.00 87.32 C \nANISOU 2804 CD GLN B 42 10634 11520 11025 460 -1242 -538 C \nATOM 2805 OE1 GLN B 42 -8.038 22.041 3.058 1.00 88.50 O \nANISOU 2805 OE1 GLN B 42 10540 11936 11150 408 -1179 -549 O \nATOM 2806 NE2 GLN B 42 -6.671 21.764 1.292 1.00 88.52 N \nANISOU 2806 NE2 GLN B 42 10799 11691 11142 531 -1253 -559 N \nATOM 2807 N LYS B 43 -5.078 17.616 3.965 1.00 86.52 N \nANISOU 2807 N LYS B 43 10966 10513 11393 -322 -1178 -257 N \nATOM 2808 CA LYS B 43 -4.061 16.716 3.393 1.00 81.92 C \nANISOU 2808 CA LYS B 43 10550 9725 10850 -448 -1202 -208 C \nATOM 2809 C LYS B 43 -4.683 15.663 2.456 1.00 84.55 C \nANISOU 2809 C LYS B 43 10710 10121 11293 -601 -1103 -173 C \nATOM 2810 O LYS B 43 -4.129 15.333 1.417 1.00 89.98 O \nANISOU 2810 O LYS B 43 11468 10741 11979 -614 -1117 -165 O \nATOM 2811 CB LYS B 43 -3.294 16.021 4.510 1.00 85.23 C \nANISOU 2811 CB LYS B 43 11118 9970 11295 -615 -1230 -151 C \nATOM 2812 CG LYS B 43 -2.073 16.759 5.015 1.00102.70 C \nANISOU 2812 CG LYS B 43 13648 12000 13372 -521 -1366 -164 C \nATOM 2813 CD LYS B 43 -2.386 18.182 5.468 1.00114.88 C \nANISOU 2813 CD LYS B 43 15218 13626 14804 -248 -1428 -242 C \nATOM 2814 CE LYS B 43 -1.127 18.968 5.838 1.00124.34 C \nANISOU 2814 CE LYS B 43 16802 14608 15835 -112 -1591 -265 C \nATOM 2815 NZ LYS B 43 -1.341 20.355 6.355 1.00129.14 N \nANISOU 2815 NZ LYS B 43 17466 15298 16305 197 -1669 -351 N \nATOM 2816 N ALA B 44 -5.854 15.168 2.825 1.00 85.66 N \nANISOU 2816 N ALA B 44 10646 10385 11514 -709 -1012 -155 N \nATOM 2817 CA ALA B 44 -6.544 14.166 2.039 1.00 82.73 C \nANISOU 2817 CA ALA B 44 10148 10059 11228 -841 -932 -125 C \nATOM 2818 C ALA B 44 -7.089 14.721 0.746 1.00 82.88 C \nANISOU 2818 C ALA B 44 10070 10217 11204 -756 -915 -162 C \nATOM 2819 O ALA B 44 -7.104 14.035 -0.261 1.00 92.30 O \nANISOU 2819 O ALA B 44 11247 11385 12438 -821 -886 -143 O \nATOM 2820 CB ALA B 44 -7.654 13.525 2.852 1.00 75.78 C \nANISOU 2820 CB ALA B 44 9137 9243 10413 -970 -864 -99 C \nATOM 2821 N ILE B 45 -7.549 15.956 0.777 1.00 86.15 N \nANISOU 2821 N ILE B 45 10407 10805 11520 -608 -934 -216 N \nATOM 2822 CA ILE B 45 -8.121 16.603 -0.402 1.00 86.75 C \nANISOU 2822 CA ILE B 45 10359 11082 11522 -525 -919 -258 C \nATOM 2823 C ILE B 45 -7.005 16.991 -1.359 1.00 81.51 C \nANISOU 2823 C ILE B 45 9842 10328 10799 -362 -989 -290 C \nATOM 2824 O ILE B 45 -7.119 16.777 -2.558 1.00 83.89 O \nANISOU 2824 O ILE B 45 10098 10670 11105 -375 -966 -292 O \nATOM 2825 CB ILE B 45 -8.920 17.880 -0.001 1.00 92.42 C \nANISOU 2825 CB ILE B 45 10922 12084 12111 -402 -924 -317 C \nATOM 2826 CG1 ILE B 45 -10.109 17.542 0.898 1.00 93.92 C \nANISOU 2826 CG1 ILE B 45 10975 12371 12338 -589 -859 -282 C \nATOM 2827 CG2 ILE B 45 -9.417 18.641 -1.221 1.00 94.88 C \nANISOU 2827 CG2 ILE B 45 11085 12660 12303 -304 -916 -369 C \nATOM 2828 CD1 ILE B 45 -10.574 18.719 1.738 1.00100.16 C \nANISOU 2828 CD1 ILE B 45 11656 13393 13007 -474 -879 -333 C \nATOM 2829 N ASP B 46 -5.954 17.602 -0.828 1.00 84.25 N \nANISOU 2829 N ASP B 46 10387 10549 11075 -206 -1084 -318 N \nATOM 2830 CA ASP B 46 -4.752 17.904 -1.608 1.00 84.76 C \nANISOU 2830 CA ASP B 46 10672 10464 11067 -65 -1175 -342 C \nATOM 2831 C ASP B 46 -4.228 16.658 -2.308 1.00 90.05 C \nANISOU 2831 C ASP B 46 11414 10959 11844 -257 -1146 -277 C \nATOM 2832 O ASP B 46 -3.942 16.689 -3.510 1.00 95.59 O \nANISOU 2832 O ASP B 46 12144 11657 12520 -201 -1159 -292 O \nATOM 2833 CB ASP B 46 -3.676 18.517 -0.719 1.00 85.98 C \nANISOU 2833 CB ASP B 46 11100 10441 11125 69 -1295 -362 C \nATOM 2834 CG ASP B 46 -3.965 19.983 -0.394 1.00101.62 C \nANISOU 2834 CG ASP B 46 13054 12611 12944 367 -1357 -455 C \nATOM 2835 OD1 ASP B 46 -4.865 20.576 -1.033 1.00108.06 O \nANISOU 2835 OD1 ASP B 46 13634 13722 13701 477 -1312 -508 O \nATOM 2836 OD2 ASP B 46 -3.321 20.548 0.520 1.00108.95 O \nANISOU 2836 OD2 ASP B 46 14190 13421 13784 489 -1453 -477 O \nATOM 2837 N GLY B 47 -4.150 15.550 -1.572 1.00 85.08 N \nANISOU 2837 N GLY B 47 10791 10216 11321 -475 -1104 -210 N \nATOM 2838 CA GLY B 47 -3.688 14.300 -2.135 1.00 78.88 C \nANISOU 2838 CA GLY B 47 10040 9314 10615 -653 -1074 -155 C \nATOM 2839 C GLY B 47 -4.637 13.752 -3.186 1.00 80.48 C \nANISOU 2839 C GLY B 47 10052 9640 10887 -710 -987 -150 C \nATOM 2840 O GLY B 47 -4.241 13.462 -4.331 1.00 86.49 O \nANISOU 2840 O GLY B 47 10850 10362 11649 -711 -991 -147 O \nATOM 2841 N VAL B 48 -5.895 13.591 -2.810 1.00 77.15 N \nANISOU 2841 N VAL B 48 9448 9354 10510 -772 -915 -146 N \nATOM 2842 CA VAL B 48 -6.872 12.931 -3.695 1.00 83.17 C \nANISOU 2842 CA VAL B 48 10073 10204 11323 -867 -841 -132 C \nATOM 2843 C VAL B 48 -7.122 13.726 -4.973 1.00 86.50 C \nANISOU 2843 C VAL B 48 10433 10757 11676 -757 -845 -174 C \nATOM 2844 O VAL B 48 -7.292 13.153 -6.046 1.00 95.56 O \nANISOU 2844 O VAL B 48 11553 11902 12854 -814 -815 -160 O \nATOM 2845 CB VAL B 48 -8.195 12.626 -2.947 1.00 80.95 C \nANISOU 2845 CB VAL B 48 9665 10019 11073 -977 -783 -115 C \nATOM 2846 CG1 VAL B 48 -9.401 12.743 -3.860 1.00 81.04 C \nANISOU 2846 CG1 VAL B 48 9551 10188 11054 -1030 -737 -122 C \nATOM 2847 CG2 VAL B 48 -8.129 11.231 -2.308 1.00 76.62 C \nANISOU 2847 CG2 VAL B 48 9157 9346 10608 -1109 -758 -69 C \nATOM 2848 N THR B 49 -7.129 15.045 -4.871 1.00 91.80 N \nANISOU 2848 N THR B 49 11080 11560 12239 -585 -888 -230 N \nATOM 2849 CA THR B 49 -7.455 15.873 -6.035 1.00 91.64 C \nANISOU 2849 CA THR B 49 10965 11731 12122 -463 -891 -280 C \nATOM 2850 C THR B 49 -6.352 15.817 -7.087 1.00 96.99 C \nANISOU 2850 C THR B 49 11791 12273 12787 -366 -942 -291 C \nATOM 2851 O THR B 49 -6.638 15.702 -8.274 1.00105.14 O \nANISOU 2851 O THR B 49 12752 13384 13813 -377 -914 -297 O \nATOM 2852 CB THR B 49 -7.715 17.344 -5.678 1.00 91.32 C \nANISOU 2852 CB THR B 49 10843 11924 11930 -258 -932 -354 C \nATOM 2853 OG1 THR B 49 -6.820 17.725 -4.637 1.00 99.60 O \nANISOU 2853 OG1 THR B 49 12064 12823 12955 -138 -1007 -368 O \nATOM 2854 CG2 THR B 49 -9.154 17.555 -5.205 1.00 94.73 C \nANISOU 2854 CG2 THR B 49 11051 12611 12329 -382 -866 -350 C \nATOM 2855 N ASN B 50 -5.093 15.880 -6.665 1.00 88.19 N \nANISOU 2855 N ASN B 50 10902 10950 11657 -291 -1023 -290 N \nATOM 2856 CA ASN B 50 -3.983 15.837 -7.620 1.00 84.54 C \nANISOU 2856 CA ASN B 50 10622 10337 11161 -220 -1086 -296 C \nATOM 2857 C ASN B 50 -3.819 14.452 -8.224 1.00 79.00 C \nANISOU 2857 C ASN B 50 9919 9519 10578 -431 -1031 -232 C \nATOM 2858 O ASN B 50 -3.333 14.312 -9.347 1.00 83.21 O \nANISOU 2858 O ASN B 50 10514 10005 11099 -405 -1048 -235 O \nATOM 2859 CB ASN B 50 -2.680 16.242 -6.936 1.00 87.27 C \nANISOU 2859 CB ASN B 50 11258 10472 11428 -128 -1203 -303 C \nATOM 2860 CG ASN B 50 -2.823 17.483 -6.082 1.00 90.02 C \nANISOU 2860 CG ASN B 50 11632 10915 11658 85 -1265 -366 C \nATOM 2861 OD1 ASN B 50 -3.854 18.157 -6.103 1.00 91.61 O \nANISOU 2861 OD1 ASN B 50 11610 11379 11817 185 -1221 -413 O \nATOM 2862 ND2 ASN B 50 -1.783 17.791 -5.317 1.00 89.21 N \nANISOU 2862 ND2 ASN B 50 11808 10608 11480 145 -1372 -367 N \nATOM 2863 N LYS B 51 -4.237 13.440 -7.482 1.00 72.37 N \nANISOU 2863 N LYS B 51 9008 8649 9839 -619 -970 -179 N \nATOM 2864 CA LYS B 51 -4.353 12.111 -8.035 1.00 71.25 C \nANISOU 2864 CA LYS B 51 8820 8461 9791 -786 -910 -132 C \nATOM 2865 C LYS B 51 -5.269 12.112 -9.236 1.00 80.68 C \nANISOU 2865 C LYS B 51 9874 9786 10995 -777 -857 -147 C \nATOM 2866 O LYS B 51 -4.891 11.654 -10.323 1.00 89.43 O \nANISOU 2866 O LYS B 51 11013 10848 12118 -794 -854 -139 O \nATOM 2867 CB LYS B 51 -4.917 11.166 -7.009 1.00 70.19 C \nANISOU 2867 CB LYS B 51 8612 8325 9732 -932 -858 -93 C \nATOM 2868 CG LYS B 51 -4.999 9.736 -7.486 1.00 69.38 C \nANISOU 2868 CG LYS B 51 8475 8189 9697 -1062 -810 -56 C \nATOM 2869 CD LYS B 51 -5.774 8.852 -6.523 1.00 67.45 C \nANISOU 2869 CD LYS B 51 8156 7970 9502 -1157 -764 -33 C \nATOM 2870 CE LYS B 51 -4.821 8.046 -5.684 1.00 68.71 C \nANISOU 2870 CE LYS B 51 8380 8066 9663 -1236 -785 -5 C \nATOM 2871 NZ LYS B 51 -5.417 7.218 -4.619 1.00 76.38 N \nANISOU 2871 NZ LYS B 51 9288 9071 10660 -1296 -753 9 N \nATOM 2872 N VAL B 52 -6.465 12.652 -9.047 1.00 83.77 N \nANISOU 2872 N VAL B 52 10116 10352 11361 -768 -818 -168 N \nATOM 2873 CA VAL B 52 -7.403 12.826 -10.148 1.00 83.34 C \nANISOU 2873 CA VAL B 52 9932 10458 11277 -785 -776 -182 C \nATOM 2874 C VAL B 52 -6.778 13.617 -11.319 1.00 82.64 C \nANISOU 2874 C VAL B 52 9871 10418 11111 -623 -818 -227 C \nATOM 2875 O VAL B 52 -6.919 13.237 -12.485 1.00 93.75 O \nANISOU 2875 O VAL B 52 11250 11840 12532 -661 -793 -220 O \nATOM 2876 CB VAL B 52 -8.694 13.541 -9.670 1.00 81.08 C \nANISOU 2876 CB VAL B 52 9487 10397 10922 -816 -745 -199 C \nATOM 2877 CG1 VAL B 52 -9.528 14.027 -10.852 1.00 74.10 C \nANISOU 2877 CG1 VAL B 52 8467 9736 9953 -831 -718 -222 C \nATOM 2878 CG2 VAL B 52 -9.518 12.602 -8.801 1.00 82.69 C \nANISOU 2878 CG2 VAL B 52 9680 10542 11195 -999 -702 -151 C \nATOM 2879 N ASN B 53 -6.140 14.741 -11.019 1.00 70.87 N \nANISOU 2879 N ASN B 53 8447 8958 9523 -426 -889 -278 N \nATOM 2880 CA ASN B 53 -5.607 15.586 -12.078 1.00 74.63 C \nANISOU 2880 CA ASN B 53 8964 9497 9895 -228 -943 -335 C \nATOM 2881 C ASN B 53 -4.461 14.874 -12.785 1.00 83.81 C \nANISOU 2881 C ASN B 53 10316 10420 11109 -253 -978 -306 C \nATOM 2882 O ASN B 53 -4.366 14.883 -14.008 1.00 85.93 O \nANISOU 2882 O ASN B 53 10571 10721 11357 -212 -976 -320 O \nATOM 2883 CB ASN B 53 -5.163 16.959 -11.548 1.00 75.56 C \nANISOU 2883 CB ASN B 53 9149 9695 9865 36 -1031 -408 C \nATOM 2884 CG ASN B 53 -6.291 17.717 -10.862 1.00 82.70 C \nANISOU 2884 CG ASN B 53 9840 10888 10695 63 -996 -442 C \nATOM 2885 OD1 ASN B 53 -7.465 17.566 -11.209 1.00 82.39 O \nANISOU 2885 OD1 ASN B 53 9585 11062 10659 -79 -916 -428 O \nATOM 2886 ND2 ASN B 53 -5.938 18.525 -9.869 1.00 84.10 N \nANISOU 2886 ND2 ASN B 53 10093 11074 10789 229 -1062 -484 N \nATOM 2887 N SER B 54 -3.577 14.256 -12.014 1.00 89.55 N \nANISOU 2887 N SER B 54 11215 10924 11887 -337 -1012 -264 N \nATOM 2888 CA SER B 54 -2.454 13.546 -12.609 1.00 89.20 C \nANISOU 2888 CA SER B 54 11347 10678 11865 -404 -1049 -230 C \nATOM 2889 C SER B 54 -2.944 12.526 -13.632 1.00 91.64 C \nANISOU 2889 C SER B 54 11531 11023 12265 -540 -968 -198 C \nATOM 2890 O SER B 54 -2.408 12.434 -14.731 1.00 99.67 O \nANISOU 2890 O SER B 54 12614 11991 13264 -510 -990 -203 O \nATOM 2891 CB SER B 54 -1.621 12.871 -11.524 1.00 93.46 C \nANISOU 2891 CB SER B 54 12038 11039 12433 -545 -1081 -179 C \nATOM 2892 OG SER B 54 -0.935 13.849 -10.742 1.00 86.50 O \nANISOU 2892 OG SER B 54 11349 10075 11443 -412 -1182 -209 O \nATOM 2893 N ILE B 55 -3.980 11.769 -13.277 1.00 92.37 N \nANISOU 2893 N ILE B 55 11463 11192 12442 -680 -885 -168 N \nATOM 2894 CA ILE B 55 -4.601 10.820 -14.212 1.00 86.80 C \nANISOU 2894 CA ILE B 55 10659 10518 11802 -789 -818 -143 C \nATOM 2895 C ILE B 55 -5.118 11.535 -15.451 1.00 95.11 C \nANISOU 2895 C ILE B 55 11627 11712 12800 -699 -808 -181 C \nATOM 2896 O ILE B 55 -4.868 11.096 -16.565 1.00108.47 O \nANISOU 2896 O ILE B 55 13336 13368 14509 -716 -799 -174 O \nATOM 2897 CB ILE B 55 -5.779 10.068 -13.538 1.00 82.84 C \nANISOU 2897 CB ILE B 55 10045 10070 11360 -922 -752 -115 C \nATOM 2898 CG1 ILE B 55 -5.254 9.054 -12.511 1.00 82.60 C \nANISOU 2898 CG1 ILE B 55 10078 9923 11383 -1015 -754 -78 C \nATOM 2899 CG2 ILE B 55 -6.693 9.365 -14.538 1.00 80.28 C \nANISOU 2899 CG2 ILE B 55 9646 9794 11062 -1006 -699 -102 C \nATOM 2900 CD1 ILE B 55 -6.278 8.631 -11.481 1.00 75.84 C \nANISOU 2900 CD1 ILE B 55 9151 9108 10556 -1090 -716 -64 C \nATOM 2901 N ILE B 56 -5.834 12.637 -15.234 1.00100.49 N \nANISOU 2901 N ILE B 56 12202 12579 13400 -608 -808 -223 N \nATOM 2902 CA ILE B 56 -6.401 13.438 -16.321 1.00 99.19 C \nANISOU 2902 CA ILE B 56 11917 12624 13145 -524 -799 -266 C \nATOM 2903 C ILE B 56 -5.337 14.164 -17.151 1.00 97.85 C \nANISOU 2903 C ILE B 56 11857 12424 12896 -316 -871 -315 C \nATOM 2904 O ILE B 56 -5.413 14.157 -18.376 1.00102.20 O \nANISOU 2904 O ILE B 56 12368 13037 13427 -296 -859 -327 O \nATOM 2905 CB ILE B 56 -7.412 14.490 -15.791 1.00100.04 C \nANISOU 2905 CB ILE B 56 11858 13007 13146 -481 -786 -305 C \nATOM 2906 CG1 ILE B 56 -8.645 13.797 -15.221 1.00 98.42 C \nANISOU 2906 CG1 ILE B 56 11559 12845 12992 -713 -719 -255 C \nATOM 2907 CG2 ILE B 56 -7.846 15.456 -16.897 1.00 95.87 C \nANISOU 2907 CG2 ILE B 56 11186 12759 12479 -371 -787 -361 C \nATOM 2908 CD1 ILE B 56 -9.552 14.701 -14.419 1.00 99.84 C \nANISOU 2908 CD1 ILE B 56 11595 13270 13069 -718 -710 -280 C \nATOM 2909 N ASP B 57 -4.393 14.822 -16.488 1.00 98.22 N \nANISOU 2909 N ASP B 57 12062 12375 12883 -157 -955 -345 N \nATOM 2910 CA ASP B 57 -3.396 15.674 -17.170 1.00106.07 C \nANISOU 2910 CA ASP B 57 13215 13327 13759 81 -1051 -402 C \nATOM 2911 C ASP B 57 -2.348 14.890 -17.970 1.00101.96 C \nANISOU 2911 C ASP B 57 12882 12568 13291 15 -1081 -365 C \nATOM 2912 O ASP B 57 -1.995 15.280 -19.081 1.00104.31 O \nANISOU 2912 O ASP B 57 13225 12887 13520 144 -1117 -402 O \nATOM 2913 CB ASP B 57 -2.683 16.598 -16.170 1.00113.19 C \nANISOU 2913 CB ASP B 57 14293 14160 14553 275 -1154 -446 C \nATOM 2914 CG ASP B 57 -3.629 17.542 -15.466 1.00114.08 C \nANISOU 2914 CG ASP B 57 14216 14548 14579 386 -1136 -498 C \nATOM 2915 OD1 ASP B 57 -4.630 17.956 -16.088 1.00119.04 O \nANISOU 2915 OD1 ASP B 57 14601 15477 15152 408 -1080 -531 O \nATOM 2916 OD2 ASP B 57 -3.373 17.844 -14.282 1.00113.72 O \nANISOU 2916 OD2 ASP B 57 14264 14432 14511 430 -1180 -503 O \nATOM 2917 N LYS B 58 -1.850 13.795 -17.407 1.00100.64 N \nANISOU 2917 N LYS B 58 12812 12201 13227 -185 -1067 -296 N \nATOM 2918 CA LYS B 58 -0.920 12.909 -18.135 1.00102.71 C \nANISOU 2918 CA LYS B 58 13216 12282 13529 -296 -1085 -254 C \nATOM 2919 C LYS B 58 -1.470 12.441 -19.474 1.00111.24 C \nANISOU 2919 C LYS B 58 14153 13455 14659 -336 -1017 -251 C \nATOM 2920 O LYS B 58 -0.715 12.109 -20.387 1.00115.64 O \nANISOU 2920 O LYS B 58 14821 13908 15209 -348 -1046 -240 O \nATOM 2921 CB LYS B 58 -0.558 11.691 -17.295 1.00 99.74 C \nANISOU 2921 CB LYS B 58 12878 11779 13240 -527 -1058 -183 C \nATOM 2922 CG LYS B 58 0.339 12.029 -16.121 1.00102.72 C \nANISOU 2922 CG LYS B 58 13462 12017 13550 -528 -1144 -174 C \nATOM 2923 CD LYS B 58 1.800 12.128 -16.559 1.00108.12 C \nANISOU 2923 CD LYS B 58 14448 12501 14132 -532 -1256 -163 C \nATOM 2924 CE LYS B 58 2.609 13.060 -15.663 1.00104.24 C \nANISOU 2924 CE LYS B 58 14232 11867 13505 -429 -1383 -183 C \nATOM 2925 NZ LYS B 58 2.516 14.481 -16.112 1.00102.02 N \nANISOU 2925 NZ LYS B 58 14033 11625 13102 -106 -1459 -270 N \nATOM 2926 N MET B 59 -2.789 12.464 -19.600 1.00111.88 N \nANISOU 2926 N MET B 59 14005 13733 14773 -367 -936 -259 N \nATOM 2927 CA MET B 59 -3.429 12.096 -20.836 1.00117.65 C \nANISOU 2927 CA MET B 59 14610 14561 15532 -417 -877 -256 C \nATOM 2928 C MET B 59 -3.178 13.099 -21.971 1.00119.25 C \nANISOU 2928 C MET B 59 14821 14864 15624 -220 -922 -316 C \nATOM 2929 O MET B 59 -3.586 12.835 -23.095 1.00118.27 O \nANISOU 2929 O MET B 59 14608 14816 15513 -257 -881 -315 O \nATOM 2930 CB MET B 59 -4.936 11.901 -20.622 1.00126.47 C \nANISOU 2930 CB MET B 59 15522 15853 16676 -535 -795 -243 C \nATOM 2931 CG MET B 59 -5.544 10.887 -21.571 1.00134.19 C \nANISOU 2931 CG MET B 59 16440 16828 17718 -682 -734 -208 C \nATOM 2932 SD MET B 59 -4.851 9.237 -21.303 1.00148.53 S \nANISOU 2932 SD MET B 59 18371 18410 19652 -818 -723 -149 S \nATOM 2933 CE MET B 59 -3.681 9.176 -22.668 1.00152.07 C \nANISOU 2933 CE MET B 59 18924 18770 20087 -749 -761 -158 C \nATOM 2934 N ASN B 60 -2.484 14.208 -21.695 1.00124.29 N \nANISOU 2934 N ASN B 60 15585 15498 16142 1 -1014 -373 N \nATOM 2935 CA ASN B 60 -2.141 15.248 -22.708 1.00137.08 C \nANISOU 2935 CA ASN B 60 17243 17219 17622 250 -1078 -447 C \nATOM 2936 C ASN B 60 -1.743 14.768 -24.131 1.00141.67 C \nANISOU 2936 C ASN B 60 17867 17732 18227 226 -1073 -435 C \nATOM 2937 O ASN B 60 -1.522 15.594 -25.040 1.00133.99 O \nANISOU 2937 O ASN B 60 16914 16860 17135 438 -1124 -499 O \nATOM 2938 CB ASN B 60 -0.981 16.115 -22.162 1.00144.94 C \nANISOU 2938 CB ASN B 60 18516 18064 18490 478 -1214 -494 C \nATOM 2939 CG ASN B 60 -1.449 17.371 -21.449 1.00148.59 C \nANISOU 2939 CG ASN B 60 18898 18746 18814 708 -1252 -571 C \nATOM 2940 OD1 ASN B 60 -2.468 17.975 -21.802 1.00151.06 O \nANISOU 2940 OD1 ASN B 60 18948 19390 19058 784 -1200 -618 O \nATOM 2941 ND2 ASN B 60 -0.676 17.799 -20.456 1.00150.01 N \nANISOU 2941 ND2 ASN B 60 19312 18759 18927 817 -1349 -586 N \nATOM 2942 N THR B 61 -1.660 13.447 -24.312 1.00142.65 N \nANISOU 2942 N THR B 61 18000 17707 18492 -13 -1016 -361 N \nATOM 2943 CA THR B 61 -1.134 12.830 -25.537 1.00149.85 C \nANISOU 2943 CA THR B 61 18979 18520 19439 -60 -1015 -341 C \nATOM 2944 C THR B 61 -1.885 13.155 -26.842 1.00162.71 C \nANISOU 2944 C THR B 61 20436 20355 21032 1 -971 -375 C \nATOM 2945 O THR B 61 -1.274 13.654 -27.791 1.00175.62 O \nANISOU 2945 O THR B 61 22161 21978 22586 156 -1028 -415 O \nATOM 2946 CB THR B 61 -1.031 11.298 -25.384 1.00141.18 C \nANISOU 2946 CB THR B 61 17883 17281 18480 -317 -957 -262 C \nATOM 2947 OG1 THR B 61 -2.318 10.748 -25.083 1.00134.67 O \nANISOU 2947 OG1 THR B 61 16854 16582 17732 -448 -863 -238 O \nATOM 2948 CG2 THR B 61 -0.059 10.930 -24.282 1.00132.67 C \nANISOU 2948 CG2 THR B 61 16986 16015 17406 -396 -1010 -226 C \nATOM 2949 N GLN B 62 -3.184 12.844 -26.893 1.00166.71 N \nANISOU 2949 N GLN B 62 20718 21040 21583 -134 -879 -357 N \nATOM 2950 CA GLN B 62 -4.017 13.052 -28.101 1.00160.50 C \nANISOU 2950 CA GLN B 62 19762 20467 20752 -140 -832 -377 C \nATOM 2951 C GLN B 62 -4.049 14.508 -28.637 1.00149.69 C \nANISOU 2951 C GLN B 62 18317 19354 19205 116 -880 -465 C \nATOM 2952 O GLN B 62 -4.127 15.469 -27.859 1.00143.95 O \nANISOU 2952 O GLN B 62 17558 18762 18373 267 -919 -515 O \nATOM 2953 CB GLN B 62 -5.454 12.511 -27.900 1.00162.16 C \nANISOU 2953 CB GLN B 62 19794 20814 21005 -364 -743 -336 C \nATOM 2954 CG GLN B 62 -6.371 13.312 -26.981 1.00164.99 C \nANISOU 2954 CG GLN B 62 20009 21401 21277 -366 -729 -358 C \nATOM 2955 CD GLN B 62 -5.955 13.256 -25.523 1.00176.48 C \nANISOU 2955 CD GLN B 62 21559 22712 22781 -349 -756 -346 C \nATOM 2956 OE1 GLN B 62 -5.000 12.571 -25.163 1.00176.66 O \nANISOU 2956 OE1 GLN B 62 21753 22472 22896 -359 -784 -316 O \nATOM 2957 NE2 GLN B 62 -6.665 13.986 -24.674 1.00195.70 N \nANISOU 2957 NE2 GLN B 62 23876 25342 25138 -335 -750 -369 N \nATOM 2958 N PHE B 63 -3.934 14.646 -29.963 1.00141.25 N \nANISOU 2958 N PHE B 63 17223 18357 18090 183 -883 -489 N \nATOM 2959 CA PHE B 63 -4.171 15.919 -30.672 1.00148.24 C \nANISOU 2959 CA PHE B 63 17979 19559 18786 415 -915 -578 C \nATOM 2960 C PHE B 63 -4.933 15.750 -32.008 1.00140.16 C \nANISOU 2960 C PHE B 63 16778 18739 17736 311 -852 -573 C \nATOM 2961 O PHE B 63 -6.013 16.309 -32.201 1.00126.47 O \nANISOU 2961 O PHE B 63 14805 17363 15886 264 -808 -597 O \nATOM 2962 CB PHE B 63 -2.851 16.641 -30.986 1.00153.49 C \nANISOU 2962 CB PHE B 63 18871 20098 19349 728 -1034 -645 C \nATOM 2963 CG PHE B 63 -1.944 16.854 -29.800 1.00156.68 C \nANISOU 2963 CG PHE B 63 19517 20267 19748 835 -1121 -650 C \nATOM 2964 CD1 PHE B 63 -2.144 17.924 -28.925 1.00151.18 C \nANISOU 2964 CD1 PHE B 63 18777 19751 18912 1038 -1169 -717 C \nATOM 2965 CD2 PHE B 63 -0.861 16.013 -29.586 1.00156.27 C \nANISOU 2965 CD2 PHE B 63 19738 19833 19803 731 -1163 -591 C \nATOM 2966 CE1 PHE B 63 -1.301 18.132 -27.843 1.00147.02 C \nANISOU 2966 CE1 PHE B 63 18500 18992 18368 1135 -1258 -722 C \nATOM 2967 CE2 PHE B 63 -0.015 16.215 -28.503 1.00159.63 C \nANISOU 2967 CE2 PHE B 63 20406 20047 20200 795 -1250 -590 C \nATOM 2968 CZ PHE B 63 -0.236 17.275 -27.631 1.00151.50 C \nANISOU 2968 CZ PHE B 63 19355 19163 19043 1001 -1300 -655 C \nATOM 2969 N GLU B 64 -4.348 14.971 -32.921 1.00141.10 N \nANISOU 2969 N GLU B 64 17020 18642 17951 258 -851 -539 N \nATOM 2970 CA GLU B 64 -4.880 14.786 -34.281 1.00136.96 C \nANISOU 2970 CA GLU B 64 16371 18266 17403 180 -804 -536 C \nATOM 2971 C GLU B 64 -5.935 13.701 -34.256 1.00130.56 C \nANISOU 2971 C GLU B 64 15477 17428 16701 -151 -714 -454 C \nATOM 2972 O GLU B 64 -5.942 12.898 -33.334 1.00145.37 O \nANISOU 2972 O GLU B 64 17441 19097 18698 -287 -697 -400 O \nATOM 2973 CB GLU B 64 -3.778 14.341 -35.257 1.00136.37 C \nANISOU 2973 CB GLU B 64 16482 17947 17385 259 -845 -532 C \nATOM 2974 CG GLU B 64 -2.783 15.426 -35.659 1.00142.33 C \nANISOU 2974 CG GLU B 64 17358 18728 17993 600 -949 -619 C \nATOM 2975 CD GLU B 64 -3.377 16.517 -36.560 1.00143.58 C \nANISOU 2975 CD GLU B 64 17303 19295 17957 779 -951 -703 C \nATOM 2976 OE1 GLU B 64 -3.657 16.275 -37.765 1.00138.82 O \nANISOU 2976 OE1 GLU B 64 16611 18783 17350 715 -913 -696 O \nATOM 2977 OE2 GLU B 64 -3.557 17.649 -36.057 1.00146.01 O \nANISOU 2977 OE2 GLU B 64 17521 19860 18095 996 -994 -780 O \nATOM 2978 N ALA B 65 -6.784 13.643 -35.282 1.00112.18 N \nANISOU 2978 N ALA B 65 13009 15297 14317 -275 -667 -446 N \nATOM 2979 CA ALA B 65 -7.778 12.574 -35.393 1.00102.36 C \nANISOU 2979 CA ALA B 65 11751 13991 13151 -583 -603 -369 C \nATOM 2980 C ALA B 65 -8.048 12.241 -36.860 1.00 99.78 C \nANISOU 2980 C ALA B 65 11393 13716 12803 -664 -579 -358 C \nATOM 2981 O ALA B 65 -7.967 13.131 -37.712 1.00105.79 O \nANISOU 2981 O ALA B 65 12038 14721 13434 -530 -593 -414 O \nATOM 2982 CB ALA B 65 -9.058 12.963 -34.666 1.00 93.85 C \nANISOU 2982 CB ALA B 65 10526 13163 11972 -754 -572 -357 C \nATOM 2983 N VAL B 66 -8.309 10.963 -37.172 1.00 91.56 N \nANISOU 2983 N VAL B 66 10462 12448 11878 -855 -550 -293 N \nATOM 2984 CA VAL B 66 -8.546 10.541 -38.579 1.00 92.46 C \nANISOU 2984 CA VAL B 66 10573 12577 11980 -937 -531 -278 C \nATOM 2985 C VAL B 66 -9.243 9.167 -38.626 1.00 90.61 C \nANISOU 2985 C VAL B 66 10464 12136 11828 -1174 -505 -207 C \nATOM 2986 O VAL B 66 -9.124 8.388 -37.681 1.00 87.82 O \nANISOU 2986 O VAL B 66 10224 11567 11575 -1206 -509 -177 O \nATOM 2987 CB VAL B 66 -7.240 10.632 -39.478 1.00 85.72 C \nANISOU 2987 CB VAL B 66 9787 11611 11171 -716 -563 -315 C \nATOM 2988 CG1 VAL B 66 -5.947 10.637 -38.635 1.00 81.17 C \nANISOU 2988 CG1 VAL B 66 9351 10812 10680 -536 -612 -331 C \nATOM 2989 CG2 VAL B 66 -7.189 9.503 -40.508 1.00 82.59 C \nANISOU 2989 CG2 VAL B 66 9485 11032 10863 -824 -543 -273 C \nATOM 2990 N GLY B 67 -10.024 8.934 -39.693 1.00 93.25 N \nANISOU 2990 N GLY B 67 10781 12558 12093 -1332 -487 -185 N \nATOM 2991 CA GLY B 67 -10.537 7.603 -40.065 1.00 89.04 C \nANISOU 2991 CA GLY B 67 10414 11802 11617 -1503 -482 -129 C \nATOM 2992 C GLY B 67 -9.585 6.938 -41.042 1.00 85.97 C \nANISOU 2992 C GLY B 67 10102 11234 11330 -1382 -486 -135 C \nATOM 2993 O GLY B 67 -8.499 6.570 -40.627 1.00 85.11 O \nANISOU 2993 O GLY B 67 10053 10948 11337 -1231 -498 -146 O \nATOM 2994 N ARG B 68 -10.013 6.785 -42.314 1.00 83.64 N \nANISOU 2994 N ARG B 68 9805 10997 10976 -1472 -478 -125 N \nATOM 2995 CA ARG B 68 -9.166 6.457 -43.526 1.00 71.04 C \nANISOU 2995 CA ARG B 68 8236 9314 9441 -1357 -479 -140 C \nATOM 2996 C ARG B 68 -9.917 5.600 -44.556 1.00 70.84 C \nANISOU 2996 C ARG B 68 8313 9219 9385 -1522 -475 -103 C \nATOM 2997 O ARG B 68 -10.783 4.799 -44.195 1.00 80.30 O \nANISOU 2997 O ARG B 68 9648 10298 10562 -1681 -487 -63 O \nATOM 2998 CB ARG B 68 -7.853 5.800 -43.183 1.00 73.05 C \nANISOU 2998 CB ARG B 68 8584 9329 9844 -1189 -493 -147 C \nATOM 2999 CG ARG B 68 -6.791 5.871 -44.284 1.00 77.98 C \nANISOU 2999 CG ARG B 68 9208 9917 10504 -1047 -501 -173 C \nATOM 3000 CD ARG B 68 -5.432 6.347 -43.754 1.00 74.19 C \nANISOU 3000 CD ARG B 68 8749 9371 10071 -856 -533 -204 C \nATOM 3001 NE ARG B 68 -5.195 5.827 -42.416 1.00 80.30 N \nANISOU 3001 NE ARG B 68 9589 10008 10913 -873 -541 -184 N \nATOM 3002 CZ ARG B 68 -4.742 6.548 -41.392 1.00 93.23 C \nANISOU 3002 CZ ARG B 68 11218 11666 12538 -784 -566 -205 C \nATOM 3003 NH1 ARG B 68 -4.446 7.833 -41.562 1.00102.62 N \nANISOU 3003 NH1 ARG B 68 12347 13004 13640 -640 -594 -253 N \nATOM 3004 NH2 ARG B 68 -4.593 5.978 -40.207 1.00 84.68 N \nANISOU 3004 NH2 ARG B 68 10193 10466 11516 -823 -568 -182 N \nATOM 3005 N GLU B 69 -9.592 5.774 -45.840 1.00 64.11 N \nANISOU 3005 N GLU B 69 7415 8430 8514 -1477 -469 -118 N \nATOM 3006 CA GLU B 69 -10.420 5.254 -46.928 1.00 63.27 C \nANISOU 3006 CA GLU B 69 7382 8321 8337 -1652 -468 -87 C \nATOM 3007 C GLU B 69 -9.640 4.418 -47.935 1.00 59.87 C \nANISOU 3007 C GLU B 69 7038 7706 8004 -1547 -471 -90 C \nATOM 3008 O GLU B 69 -8.593 4.830 -48.397 1.00 62.48 O \nANISOU 3008 O GLU B 69 7290 8064 8387 -1372 -466 -125 O \nATOM 3009 CB GLU B 69 -11.094 6.422 -47.633 1.00 72.77 C \nANISOU 3009 CB GLU B 69 8410 9874 9366 -1759 -455 -100 C \nATOM 3010 CG GLU B 69 -12.386 6.097 -48.385 1.00 79.80 C \nANISOU 3010 CG GLU B 69 9382 10826 10113 -2054 -463 -52 C \nATOM 3011 CD GLU B 69 -13.467 7.180 -48.241 1.00 85.01 C \nANISOU 3011 CD GLU B 69 9883 11863 10553 -2275 -456 -45 C \nATOM 3012 OE1 GLU B 69 -13.237 8.209 -47.546 1.00 80.19 O \nANISOU 3012 OE1 GLU B 69 9078 11487 9902 -2168 -442 -86 O \nATOM 3013 OE2 GLU B 69 -14.559 7.011 -48.842 1.00 93.98 O \nANISOU 3013 OE2 GLU B 69 11094 13080 11533 -2566 -470 2 O \nATOM 3014 N PHE B 70 -10.194 3.268 -48.324 1.00 59.85 N \nANISOU 3014 N PHE B 70 7213 7524 8003 -1655 -487 -55 N \nATOM 3015 CA PHE B 70 -9.505 2.266 -49.151 1.00 53.11 C \nANISOU 3015 CA PHE B 70 6455 6486 7237 -1553 -493 -58 C \nATOM 3016 C PHE B 70 -10.420 1.656 -50.168 1.00 50.44 C \nANISOU 3016 C PHE B 70 6256 6098 6812 -1706 -512 -30 C \nATOM 3017 O PHE B 70 -11.579 1.520 -49.911 1.00 64.43 O \nANISOU 3017 O PHE B 70 8144 7864 8473 -1894 -537 2 O \nATOM 3018 CB PHE B 70 -8.978 1.138 -48.279 1.00 53.80 C \nANISOU 3018 CB PHE B 70 6659 6355 7427 -1447 -509 -58 C \nATOM 3019 CG PHE B 70 -7.982 1.587 -47.229 1.00 50.17 C \nANISOU 3019 CG PHE B 70 6099 5911 7051 -1314 -498 -79 C \nATOM 3020 CD1 PHE B 70 -8.362 1.714 -45.945 1.00 46.68 C \nANISOU 3020 CD1 PHE B 70 5665 5469 6602 -1348 -504 -72 C \nATOM 3021 CD2 PHE B 70 -6.692 1.933 -47.589 1.00 45.99 C \nANISOU 3021 CD2 PHE B 70 5492 5394 6590 -1170 -492 -105 C \nATOM 3022 CE1 PHE B 70 -7.463 2.136 -44.999 1.00 46.28 C \nANISOU 3022 CE1 PHE B 70 5540 5427 6616 -1237 -501 -90 C \nATOM 3023 CE2 PHE B 70 -5.799 2.401 -46.685 1.00 43.67 C \nANISOU 3023 CE2 PHE B 70 5150 5101 6343 -1071 -498 -121 C \nATOM 3024 CZ PHE B 70 -6.181 2.496 -45.363 1.00 45.50 C \nANISOU 3024 CZ PHE B 70 5384 5332 6573 -1103 -501 -113 C \nATOM 3025 N ASN B 71 -9.892 1.246 -51.311 1.00 47.65 N \nANISOU 3025 N ASN B 71 5917 5690 6498 -1633 -507 -39 N \nATOM 3026 CA ASN B 71 -10.702 0.676 -52.354 1.00 48.28 C \nANISOU 3026 CA ASN B 71 6142 5713 6489 -1769 -531 -14 C \nATOM 3027 C ASN B 71 -10.863 -0.852 -52.200 1.00 47.27 C \nANISOU 3027 C ASN B 71 6262 5316 6384 -1719 -576 -5 C \nATOM 3028 O ASN B 71 -10.656 -1.391 -51.144 1.00 54.32 O \nANISOU 3028 O ASN B 71 7207 6105 7327 -1628 -589 -13 O \nATOM 3029 CB ASN B 71 -10.178 1.087 -53.745 1.00 49.15 C \nANISOU 3029 CB ASN B 71 6141 5929 6605 -1724 -506 -30 C \nATOM 3030 CG ASN B 71 -8.988 0.303 -54.186 1.00 50.04 C \nANISOU 3030 CG ASN B 71 6274 5890 6851 -1523 -502 -53 C \nATOM 3031 OD1 ASN B 71 -8.591 -0.672 -53.557 1.00 66.48 O \nANISOU 3031 OD1 ASN B 71 8452 7804 9005 -1425 -518 -57 O \nATOM 3032 ND2 ASN B 71 -8.386 0.732 -55.242 1.00 52.51 N \nANISOU 3032 ND2 ASN B 71 6486 6286 7180 -1461 -482 -71 N \nATOM 3033 N ASN B 72 -11.316 -1.520 -53.227 1.00 48.16 N \nANISOU 3033 N ASN B 72 6532 5334 6433 -1774 -606 7 N \nATOM 3034 CA ASN B 72 -11.666 -2.905 -53.126 1.00 51.60 C \nANISOU 3034 CA ASN B 72 7232 5536 6838 -1715 -667 7 C \nATOM 3035 C ASN B 72 -10.439 -3.815 -53.267 1.00 51.80 C \nANISOU 3035 C ASN B 72 7211 5482 6987 -1457 -655 -33 C \nATOM 3036 O ASN B 72 -10.471 -4.934 -52.785 1.00 53.02 O \nANISOU 3036 O ASN B 72 7518 5499 7127 -1334 -698 -51 O \nATOM 3037 CB ASN B 72 -12.668 -3.247 -54.210 1.00 55.67 C \nANISOU 3037 CB ASN B 72 7968 5975 7208 -1879 -718 35 C \nATOM 3038 CG ASN B 72 -13.437 -4.495 -53.909 1.00 60.21 C \nANISOU 3038 CG ASN B 72 8897 6302 7679 -1856 -811 37 C \nATOM 3039 OD1 ASN B 72 -13.757 -4.776 -52.742 1.00 68.46 O \nANISOU 3039 OD1 ASN B 72 10042 7269 8702 -1829 -844 35 O \nATOM 3040 ND2 ASN B 72 -13.808 -5.231 -54.955 1.00 59.49 N \nANISOU 3040 ND2 ASN B 72 9023 6079 7503 -1862 -865 40 N \nATOM 3041 N LEU B 73 -9.399 -3.355 -53.975 1.00 49.39 N \nANISOU 3041 N LEU B 73 6709 5280 6776 -1380 -604 -48 N \nATOM 3042 CA LEU B 73 -8.155 -4.059 -54.084 1.00 44.71 C \nANISOU 3042 CA LEU B 73 6048 4656 6285 -1185 -589 -79 C \nATOM 3043 C LEU B 73 -7.111 -3.600 -53.093 1.00 42.70 C \nANISOU 3043 C LEU B 73 5623 4475 6127 -1102 -556 -92 C \nATOM 3044 O LEU B 73 -5.928 -3.837 -53.313 1.00 47.11 O \nANISOU 3044 O LEU B 73 6092 5053 6756 -995 -539 -108 O \nATOM 3045 CB LEU B 73 -7.622 -3.987 -55.499 1.00 42.88 C \nANISOU 3045 CB LEU B 73 5758 4457 6076 -1162 -570 -84 C \nATOM 3046 CG LEU B 73 -8.495 -4.724 -56.448 1.00 44.95 C \nANISOU 3046 CG LEU B 73 6219 4617 6243 -1213 -612 -75 C \nATOM 3047 CD1 LEU B 73 -7.936 -4.612 -57.862 1.00 43.26 C \nANISOU 3047 CD1 LEU B 73 5933 4446 6060 -1190 -588 -81 C \nATOM 3048 CD2 LEU B 73 -8.699 -6.206 -56.020 1.00 47.87 C \nANISOU 3048 CD2 LEU B 73 6786 4836 6566 -1077 -670 -98 C \nATOM 3049 N GLU B 74 -7.577 -3.013 -51.994 1.00 45.15 N \nANISOU 3049 N GLU B 74 5914 4818 6422 -1167 -556 -81 N \nATOM 3050 CA GLU B 74 -6.709 -2.615 -50.862 1.00 42.72 C \nANISOU 3050 CA GLU B 74 5483 4558 6190 -1097 -536 -91 C \nATOM 3051 C GLU B 74 -7.275 -3.134 -49.555 1.00 43.41 C \nANISOU 3051 C GLU B 74 5657 4586 6250 -1099 -560 -89 C \nATOM 3052 O GLU B 74 -7.225 -2.460 -48.550 1.00 42.94 O \nANISOU 3052 O GLU B 74 5526 4577 6212 -1123 -549 -85 O \nATOM 3053 CB GLU B 74 -6.575 -1.095 -50.800 1.00 42.75 C \nANISOU 3053 CB GLU B 74 5344 4698 6200 -1147 -510 -90 C \nATOM 3054 CG GLU B 74 -5.948 -0.477 -52.071 1.00 42.78 C \nANISOU 3054 CG GLU B 74 5263 4776 6217 -1112 -493 -102 C \nATOM 3055 CD GLU B 74 -5.895 1.043 -51.982 1.00 44.59 C \nANISOU 3055 CD GLU B 74 5358 5172 6414 -1115 -480 -115 C \nATOM 3056 OE1 GLU B 74 -6.951 1.640 -51.688 1.00 46.47 O \nANISOU 3056 OE1 GLU B 74 5568 5520 6569 -1230 -477 -106 O \nATOM 3057 OE2 GLU B 74 -4.810 1.636 -52.241 1.00 40.17 O \nANISOU 3057 OE2 GLU B 74 4732 4643 5887 -999 -482 -139 O \nATOM 3058 N ARG B 75 -7.719 -4.387 -49.546 1.00 43.13 N \nANISOU 3058 N ARG B 75 5782 4443 6162 -1041 -601 -98 N \nATOM 3059 CA ARG B 75 -8.254 -5.006 -48.346 1.00 42.90 C \nANISOU 3059 CA ARG B 75 5862 4349 6088 -1007 -636 -105 C \nATOM 3060 C ARG B 75 -7.175 -5.373 -47.301 1.00 40.36 C \nANISOU 3060 C ARG B 75 5416 4086 5831 -884 -620 -126 C \nATOM 3061 O ARG B 75 -7.433 -5.380 -46.104 1.00 39.02 O \nANISOU 3061 O ARG B 75 5262 3912 5653 -881 -630 -127 O \nATOM 3062 CB ARG B 75 -9.082 -6.231 -48.737 1.00 46.85 C \nANISOU 3062 CB ARG B 75 6609 4715 6475 -946 -703 -119 C \nATOM 3063 CG ARG B 75 -10.251 -5.917 -49.654 1.00 48.10 C \nANISOU 3063 CG ARG B 75 6942 4798 6537 -1112 -735 -89 C \nATOM 3064 CD ARG B 75 -11.072 -4.833 -49.016 1.00 56.81 C \nANISOU 3064 CD ARG B 75 8037 5944 7604 -1315 -728 -52 C \nATOM 3065 NE ARG B 75 -12.348 -4.603 -49.664 1.00 69.04 N \nANISOU 3065 NE ARG B 75 9783 7437 9011 -1527 -773 -16 N \nATOM 3066 CZ ARG B 75 -13.132 -3.548 -49.394 1.00 80.78 C \nANISOU 3066 CZ ARG B 75 11241 9022 10431 -1760 -764 22 C \nATOM 3067 NH1 ARG B 75 -12.741 -2.630 -48.508 1.00 85.19 N \nANISOU 3067 NH1 ARG B 75 11578 9728 11063 -1769 -711 21 N \nATOM 3068 NH2 ARG B 75 -14.301 -3.393 -50.020 1.00 77.42 N \nANISOU 3068 NH2 ARG B 75 11008 8565 9843 -1996 -811 62 N \nATOM 3069 N ARG B 76 -5.963 -5.661 -47.748 1.00 40.97 N \nANISOU 3069 N ARG B 76 5375 4230 5961 -805 -597 -141 N \nATOM 3070 CA ARG B 76 -4.865 -5.962 -46.749 1.00 40.00 C \nANISOU 3070 CA ARG B 76 5132 4193 5873 -739 -585 -153 C \nATOM 3071 C ARG B 76 -4.506 -4.760 -45.962 1.00 36.20 C \nANISOU 3071 C ARG B 76 4558 3744 5454 -821 -560 -132 C \nATOM 3072 O ARG B 76 -4.582 -4.752 -44.737 1.00 32.64 O \nANISOU 3072 O ARG B 76 4094 3305 5001 -819 -565 -132 O \nATOM 3073 CB ARG B 76 -3.641 -6.475 -47.470 1.00 37.81 C \nANISOU 3073 CB ARG B 76 4763 3995 5609 -688 -572 -164 C \nATOM 3074 CG ARG B 76 -3.837 -7.827 -48.148 1.00 37.48 C \nANISOU 3074 CG ARG B 76 4791 3964 5488 -565 -600 -198 C \nATOM 3075 CD ARG B 76 -2.670 -8.152 -49.032 1.00 36.11 C \nANISOU 3075 CD ARG B 76 4514 3883 5324 -550 -583 -203 C \nATOM 3076 NE ARG B 76 -2.598 -7.170 -50.094 1.00 38.47 N \nANISOU 3076 NE ARG B 76 4813 4117 5687 -639 -562 -177 N \nATOM 3077 CZ ARG B 76 -1.481 -6.892 -50.737 1.00 42.96 C \nANISOU 3077 CZ ARG B 76 5298 4735 6288 -676 -545 -167 C \nATOM 3078 NH1 ARG B 76 -0.326 -7.499 -50.397 1.00 47.66 N \nANISOU 3078 NH1 ARG B 76 5805 5452 6853 -673 -546 -173 N \nATOM 3079 NH2 ARG B 76 -1.494 -6.042 -51.708 1.00 43.40 N \nANISOU 3079 NH2 ARG B 76 5365 4737 6386 -725 -533 -153 N \nATOM 3080 N ILE B 77 -4.277 -3.661 -46.689 1.00 37.08 N \nANISOU 3080 N ILE B 77 4618 3868 5604 -882 -540 -118 N \nATOM 3081 CA ILE B 77 -4.028 -2.361 -46.031 1.00 39.07 C \nANISOU 3081 CA ILE B 77 4798 4157 5890 -928 -529 -108 C \nATOM 3082 C ILE B 77 -5.172 -1.939 -45.154 1.00 37.94 C \nANISOU 3082 C ILE B 77 4686 4010 5718 -987 -532 -100 C \nATOM 3083 O ILE B 77 -4.976 -1.417 -44.042 1.00 47.77 O \nANISOU 3083 O ILE B 77 5888 5281 6981 -992 -530 -98 O \nATOM 3084 CB ILE B 77 -3.795 -1.269 -47.104 1.00 46.75 C \nANISOU 3084 CB ILE B 77 5725 5167 6870 -943 -518 -109 C \nATOM 3085 CG1 ILE B 77 -2.557 -1.553 -47.921 1.00 47.63 C \nANISOU 3085 CG1 ILE B 77 5822 5269 7006 -895 -522 -114 C \nATOM 3086 CG2 ILE B 77 -3.555 0.084 -46.440 1.00 56.98 C \nANISOU 3086 CG2 ILE B 77 6959 6522 8171 -940 -519 -113 C \nATOM 3087 CD1 ILE B 77 -1.331 -1.804 -47.054 1.00 48.16 C \nANISOU 3087 CD1 ILE B 77 5875 5334 7087 -882 -537 -110 C \nATOM 3088 N GLU B 78 -6.391 -2.113 -45.624 1.00 38.79 N \nANISOU 3088 N GLU B 78 4886 4087 5766 -1051 -542 -92 N \nATOM 3089 CA GLU B 78 -7.562 -1.670 -44.846 1.00 43.94 C \nANISOU 3089 CA GLU B 78 5588 4742 6363 -1151 -552 -77 C \nATOM 3090 C GLU B 78 -7.680 -2.420 -43.557 1.00 42.56 C \nANISOU 3090 C GLU B 78 5476 4508 6186 -1103 -573 -82 C \nATOM 3091 O GLU B 78 -7.961 -1.864 -42.521 1.00 55.79 O \nANISOU 3091 O GLU B 78 7123 6212 7862 -1146 -570 -75 O \nATOM 3092 CB GLU B 78 -8.807 -1.868 -45.714 1.00 53.36 C \nANISOU 3092 CB GLU B 78 6919 5895 7461 -1263 -575 -61 C \nATOM 3093 CG GLU B 78 -10.112 -1.439 -45.054 1.00 65.60 C \nANISOU 3093 CG GLU B 78 8554 7453 8916 -1422 -596 -36 C \nATOM 3094 CD GLU B 78 -11.309 -1.694 -45.952 1.00 76.54 C \nANISOU 3094 CD GLU B 78 10121 8785 10175 -1574 -634 -12 C \nATOM 3095 OE1 GLU B 78 -12.113 -0.760 -46.167 1.00 96.28 O \nANISOU 3095 OE1 GLU B 78 12591 11406 12586 -1766 -628 14 O \nATOM 3096 OE2 GLU B 78 -11.452 -2.828 -46.467 1.00 79.47 O \nANISOU 3096 OE2 GLU B 78 10670 9009 10514 -1507 -675 -20 O \nATOM 3097 N ASN B 79 -7.416 -3.702 -43.620 1.00 46.13 N \nANISOU 3097 N ASN B 79 6000 4900 6625 -996 -595 -101 N \nATOM 3098 CA ASN B 79 -7.499 -4.570 -42.458 1.00 52.11 C \nANISOU 3098 CA ASN B 79 6813 5630 7355 -914 -621 -117 C \nATOM 3099 C ASN B 79 -6.377 -4.184 -41.515 1.00 48.89 C \nANISOU 3099 C ASN B 79 6246 5310 7020 -890 -592 -118 C \nATOM 3100 O ASN B 79 -6.558 -4.196 -40.292 1.00 41.92 O \nANISOU 3100 O ASN B 79 5364 4432 6132 -886 -599 -119 O \nATOM 3101 CB ASN B 79 -7.356 -6.044 -42.876 1.00 55.19 C \nANISOU 3101 CB ASN B 79 7289 5994 7685 -764 -655 -151 C \nATOM 3102 CG ASN B 79 -7.710 -6.993 -41.764 1.00 62.44 C \nANISOU 3102 CG ASN B 79 8297 6897 8531 -649 -698 -179 C \nATOM 3103 OD1 ASN B 79 -6.868 -7.711 -41.292 1.00 63.10 O \nANISOU 3103 OD1 ASN B 79 8280 7086 8607 -532 -694 -208 O \nATOM 3104 ND2 ASN B 79 -8.977 -6.993 -41.339 1.00 70.89 N \nANISOU 3104 ND2 ASN B 79 9562 7847 9525 -691 -744 -172 N \nATOM 3105 N LEU B 80 -5.206 -3.897 -42.099 1.00 44.48 N \nANISOU 3105 N LEU B 80 5576 4809 6514 -881 -568 -117 N \nATOM 3106 CA LEU B 80 -4.052 -3.416 -41.322 1.00 44.89 C \nANISOU 3106 CA LEU B 80 5521 4922 6613 -890 -555 -112 C \nATOM 3107 C LEU B 80 -4.405 -2.147 -40.576 1.00 42.77 C \nANISOU 3107 C LEU B 80 5230 4652 6369 -951 -548 -98 C \nATOM 3108 O LEU B 80 -4.171 -2.024 -39.370 1.00 40.42 O \nANISOU 3108 O LEU B 80 4907 4371 6081 -954 -552 -96 O \nATOM 3109 CB LEU B 80 -2.857 -3.180 -42.271 1.00 46.13 C \nANISOU 3109 CB LEU B 80 5624 5107 6795 -894 -548 -108 C \nATOM 3110 CG LEU B 80 -1.601 -2.549 -41.713 1.00 48.20 C \nANISOU 3110 CG LEU B 80 5841 5395 7077 -928 -555 -97 C \nATOM 3111 CD1 LEU B 80 -1.220 -3.128 -40.383 1.00 56.08 C \nANISOU 3111 CD1 LEU B 80 6811 6445 8052 -939 -564 -95 C \nATOM 3112 CD2 LEU B 80 -0.459 -2.743 -42.631 1.00 49.46 C \nANISOU 3112 CD2 LEU B 80 5995 5571 7227 -940 -564 -93 C \nATOM 3113 N ASN B 81 -4.986 -1.181 -41.297 1.00 44.52 N \nANISOU 3113 N ASN B 81 5449 4881 6587 -998 -539 -93 N \nATOM 3114 CA ASN B 81 -5.519 0.021 -40.636 1.00 50.36 C \nANISOU 3114 CA ASN B 81 6149 5669 7317 -1048 -534 -88 C \nATOM 3115 C ASN B 81 -6.542 -0.327 -39.534 1.00 53.38 C \nANISOU 3115 C ASN B 81 6589 6024 7668 -1095 -543 -79 C \nATOM 3116 O ASN B 81 -6.475 0.190 -38.435 1.00 51.79 O \nANISOU 3116 O ASN B 81 6349 5850 7479 -1101 -542 -78 O \nATOM 3117 CB ASN B 81 -6.235 0.903 -41.651 1.00 55.20 C \nANISOU 3117 CB ASN B 81 6736 6352 7886 -1105 -524 -87 C \nATOM 3118 CG ASN B 81 -6.507 2.293 -41.124 1.00 59.04 C \nANISOU 3118 CG ASN B 81 7134 6960 8340 -1126 -518 -95 C \nATOM 3119 OD1 ASN B 81 -5.599 3.109 -41.027 1.00 61.43 O \nANISOU 3119 OD1 ASN B 81 7377 7305 8657 -1039 -525 -114 O \nATOM 3120 ND2 ASN B 81 -7.729 2.545 -40.729 1.00 58.60 N \nANISOU 3120 ND2 ASN B 81 7085 6961 8218 -1237 -515 -82 N \nATOM 3121 N LYS B 82 -7.515 -1.175 -39.849 1.00 51.21 N \nANISOU 3121 N LYS B 82 6433 5684 7339 -1125 -561 -75 N \nATOM 3122 CA LYS B 82 -8.506 -1.535 -38.851 1.00 64.17 C \nANISOU 3122 CA LYS B 82 8177 7275 8929 -1166 -585 -68 C \nATOM 3123 C LYS B 82 -7.861 -2.123 -37.591 1.00 72.57 C \nANISOU 3123 C LYS B 82 9213 8332 10027 -1073 -590 -81 C \nATOM 3124 O LYS B 82 -8.259 -1.795 -36.474 1.00 73.38 O \nANISOU 3124 O LYS B 82 9318 8438 10123 -1107 -594 -75 O \nATOM 3125 CB LYS B 82 -9.474 -2.531 -39.431 1.00 75.20 C \nANISOU 3125 CB LYS B 82 9767 8566 10240 -1177 -626 -68 C \nATOM 3126 CG LYS B 82 -10.489 -3.060 -38.445 1.00 81.84 C \nANISOU 3126 CG LYS B 82 10777 9318 11001 -1198 -673 -65 C \nATOM 3127 CD LYS B 82 -11.508 -1.995 -38.076 1.00 93.67 C \nANISOU 3127 CD LYS B 82 12293 10853 12444 -1390 -673 -32 C \nATOM 3128 CE LYS B 82 -12.711 -2.618 -37.380 1.00100.12 C \nANISOU 3128 CE LYS B 82 13357 11539 13145 -1446 -739 -22 C \nATOM 3129 NZ LYS B 82 -12.374 -3.528 -36.240 1.00101.87 N \nANISOU 3129 NZ LYS B 82 13621 11699 13384 -1274 -763 -52 N \nATOM 3130 N LYS B 83 -6.872 -3.006 -37.756 1.00 76.67 N \nANISOU 3130 N LYS B 83 9697 8865 10568 -968 -590 -99 N \nATOM 3131 CA LYS B 83 -6.254 -3.682 -36.602 1.00 71.27 C \nANISOU 3131 CA LYS B 83 8973 8222 9886 -896 -597 -113 C \nATOM 3132 C LYS B 83 -5.373 -2.786 -35.767 1.00 60.54 C \nANISOU 3132 C LYS B 83 7501 6918 8584 -939 -577 -100 C \nATOM 3133 O LYS B 83 -5.309 -2.927 -34.526 1.00 57.23 O \nANISOU 3133 O LYS B 83 7064 6520 8160 -930 -582 -101 O \nATOM 3134 CB LYS B 83 -5.446 -4.883 -37.034 1.00 82.26 C \nANISOU 3134 CB LYS B 83 10335 9675 11246 -794 -604 -138 C \nATOM 3135 CG LYS B 83 -6.302 -6.044 -37.564 1.00 94.74 C \nANISOU 3135 CG LYS B 83 12057 11204 12737 -688 -643 -167 C \nATOM 3136 CD LYS B 83 -7.778 -6.001 -37.114 1.00 97.08 C \nANISOU 3136 CD LYS B 83 12536 11374 12974 -709 -682 -163 C \nATOM 3137 CE LYS B 83 -8.612 -7.219 -37.518 1.00 95.45 C \nANISOU 3137 CE LYS B 83 12540 11083 12645 -579 -747 -198 C \nATOM 3138 NZ LYS B 83 -10.031 -6.870 -37.811 1.00 91.38 N \nANISOU 3138 NZ LYS B 83 12253 10403 12064 -688 -791 -174 N \nATOM 3139 N MET B 84 -4.730 -1.835 -36.416 1.00 53.44 N \nANISOU 3139 N MET B 84 6547 6033 7726 -976 -562 -90 N \nATOM 3140 CA MET B 84 -4.069 -0.750 -35.680 1.00 50.19 C \nANISOU 3140 CA MET B 84 6081 5642 7345 -1004 -562 -81 C \nATOM 3141 C MET B 84 -5.007 -0.020 -34.747 1.00 51.61 C \nANISOU 3141 C MET B 84 6263 5825 7521 -1038 -559 -77 C \nATOM 3142 O MET B 84 -4.675 0.238 -33.579 1.00 55.99 O \nANISOU 3142 O MET B 84 6797 6391 8087 -1040 -565 -74 O \nATOM 3143 CB MET B 84 -3.462 0.279 -36.618 1.00 52.10 C \nANISOU 3143 CB MET B 84 6305 5890 7602 -1000 -563 -82 C \nATOM 3144 CG MET B 84 -2.501 1.189 -35.880 1.00 54.89 C \nANISOU 3144 CG MET B 84 6656 6242 7959 -992 -586 -80 C \nATOM 3145 SD MET B 84 -1.807 2.393 -36.917 1.00 68.56 S \nANISOU 3145 SD MET B 84 8410 7968 9673 -936 -610 -95 S \nATOM 3146 CE MET B 84 -3.224 3.510 -37.023 1.00 49.19 C \nANISOU 3146 CE MET B 84 5884 5615 7192 -917 -588 -114 C \nATOM 3147 N GLU B 85 -6.197 0.325 -35.229 1.00 56.11 N \nANISOU 3147 N GLU B 85 6862 6397 8059 -1085 -553 -74 N \nATOM 3148 CA GLU B 85 -7.192 1.029 -34.358 1.00 58.78 C \nANISOU 3148 CA GLU B 85 7199 6767 8368 -1151 -553 -67 C \nATOM 3149 C GLU B 85 -7.752 0.175 -33.264 1.00 56.66 C \nANISOU 3149 C GLU B 85 7006 6442 8082 -1155 -568 -63 C \nATOM 3150 O GLU B 85 -7.780 0.595 -32.118 1.00 65.16 O \nANISOU 3150 O GLU B 85 8051 7539 9168 -1166 -568 -61 O \nATOM 3151 CB GLU B 85 -8.332 1.629 -35.166 1.00 71.20 C \nANISOU 3151 CB GLU B 85 8784 8393 9874 -1250 -548 -59 C \nATOM 3152 CG GLU B 85 -7.906 2.572 -36.297 1.00 78.95 C \nANISOU 3152 CG GLU B 85 9675 9471 10849 -1231 -534 -70 C \nATOM 3153 CD GLU B 85 -6.982 3.707 -35.856 1.00 86.77 C \nANISOU 3153 CD GLU B 85 10568 10539 11860 -1143 -535 -92 C \nATOM 3154 OE1 GLU B 85 -6.787 3.942 -34.635 1.00 91.61 O \nANISOU 3154 OE1 GLU B 85 11171 11146 12490 -1123 -543 -93 O \nATOM 3155 OE2 GLU B 85 -6.451 4.388 -36.763 1.00 96.31 O \nANISOU 3155 OE2 GLU B 85 11728 11810 13054 -1080 -537 -111 O \nATOM 3156 N ASP B 86 -8.173 -1.030 -33.577 1.00 63.95 N \nANISOU 3156 N ASP B 86 8036 7293 8967 -1123 -589 -69 N \nATOM 3157 CA ASP B 86 -8.579 -1.984 -32.517 1.00 69.94 C \nANISOU 3157 CA ASP B 86 8882 8004 9690 -1073 -616 -78 C \nATOM 3158 C ASP B 86 -7.415 -2.230 -31.568 1.00 73.52 C \nANISOU 3158 C ASP B 86 9228 8519 10188 -1003 -605 -89 C \nATOM 3159 O ASP B 86 -7.612 -2.334 -30.373 1.00 80.98 O \nANISOU 3159 O ASP B 86 10178 9467 11123 -994 -614 -90 O \nATOM 3160 CB ASP B 86 -9.015 -3.334 -33.104 1.00 78.80 C \nANISOU 3160 CB ASP B 86 10148 9053 10738 -986 -655 -99 C \nATOM 3161 CG ASP B 86 -10.231 -3.218 -34.002 1.00 91.79 C \nANISOU 3161 CG ASP B 86 11955 10611 12310 -1080 -682 -83 C \nATOM 3162 OD1 ASP B 86 -10.999 -2.241 -33.853 1.00105.51 O \nANISOU 3162 OD1 ASP B 86 13704 12359 14026 -1232 -677 -55 O \nATOM 3163 OD2 ASP B 86 -10.432 -4.104 -34.867 1.00 99.79 O \nANISOU 3163 OD2 ASP B 86 13089 11560 13267 -1013 -714 -99 O \nATOM 3164 N GLY B 87 -6.209 -2.339 -32.120 1.00 71.49 N \nANISOU 3164 N GLY B 87 8885 8313 9964 -973 -591 -92 N \nATOM 3165 CA GLY B 87 -5.011 -2.571 -31.319 1.00 70.78 C \nANISOU 3165 CA GLY B 87 8708 8298 9888 -956 -588 -94 C \nATOM 3166 C GLY B 87 -4.830 -1.528 -30.229 1.00 64.61 C \nANISOU 3166 C GLY B 87 7890 7516 9141 -1011 -584 -78 C \nATOM 3167 O GLY B 87 -4.748 -1.889 -29.055 1.00 74.70 O \nANISOU 3167 O GLY B 87 9152 8827 10405 -1002 -591 -80 O \nATOM 3168 N PHE B 88 -4.773 -0.252 -30.607 1.00 46.50 N \nANISOU 3168 N PHE B 88 5584 5204 6880 -1050 -578 -68 N \nATOM 3169 CA PHE B 88 -4.585 0.823 -29.638 1.00 49.54 C \nANISOU 3169 CA PHE B 88 5943 5597 7281 -1072 -583 -62 C \nATOM 3170 C PHE B 88 -5.761 1.057 -28.733 1.00 55.89 C \nANISOU 3170 C PHE B 88 6759 6403 8074 -1098 -578 -61 C \nATOM 3171 O PHE B 88 -5.609 1.433 -27.555 1.00 60.19 O \nANISOU 3171 O PHE B 88 7284 6958 8626 -1105 -583 -58 O \nATOM 3172 CB PHE B 88 -4.244 2.134 -30.334 1.00 47.37 C \nANISOU 3172 CB PHE B 88 5655 5332 7010 -1058 -588 -68 C \nATOM 3173 CG PHE B 88 -2.858 2.181 -30.876 1.00 40.60 C \nANISOU 3173 CG PHE B 88 4826 4450 6152 -1041 -612 -66 C \nATOM 3174 CD1 PHE B 88 -1.760 2.016 -30.037 1.00 43.85 C \nANISOU 3174 CD1 PHE B 88 5270 4841 6549 -1071 -640 -53 C \nATOM 3175 CD2 PHE B 88 -2.650 2.424 -32.161 1.00 40.44 C \nANISOU 3175 CD2 PHE B 88 4815 4425 6127 -1015 -613 -73 C \nATOM 3176 CE1 PHE B 88 -0.449 2.078 -30.513 1.00 44.49 C \nANISOU 3176 CE1 PHE B 88 5418 4887 6600 -1095 -676 -44 C \nATOM 3177 CE2 PHE B 88 -1.336 2.499 -32.660 1.00 44.54 C \nANISOU 3177 CE2 PHE B 88 5392 4903 6629 -1010 -646 -69 C \nATOM 3178 CZ PHE B 88 -0.247 2.296 -31.843 1.00 42.13 C \nANISOU 3178 CZ PHE B 88 5142 4568 6298 -1061 -680 -52 C \nATOM 3179 N LEU B 89 -6.939 0.752 -29.245 1.00 68.36 N \nANISOU 3179 N LEU B 89 8390 7962 9621 -1125 -575 -61 N \nATOM 3180 CA LEU B 89 -8.166 0.870 -28.456 1.00 76.68 C \nANISOU 3180 CA LEU B 89 9493 9004 10638 -1182 -581 -54 C \nATOM 3181 C LEU B 89 -8.157 -0.126 -27.308 1.00 77.95 C \nANISOU 3181 C LEU B 89 9697 9130 10790 -1133 -598 -60 C \nATOM 3182 O LEU B 89 -8.477 0.223 -26.171 1.00 88.60 O \nANISOU 3182 O LEU B 89 11040 10487 12139 -1159 -600 -55 O \nATOM 3183 CB LEU B 89 -9.365 0.624 -29.360 1.00 89.00 C \nANISOU 3183 CB LEU B 89 11154 10529 12133 -1250 -592 -46 C \nATOM 3184 CG LEU B 89 -10.751 0.586 -28.717 1.00 99.12 C \nANISOU 3184 CG LEU B 89 12550 11773 13338 -1347 -616 -32 C \nATOM 3185 CD1 LEU B 89 -11.839 0.991 -29.697 1.00 93.64 C \nANISOU 3185 CD1 LEU B 89 11928 11096 12557 -1491 -626 -12 C \nATOM 3186 CD2 LEU B 89 -11.018 -0.823 -28.218 1.00104.81 C \nANISOU 3186 CD2 LEU B 89 13420 12382 14022 -1263 -656 -45 C \nATOM 3187 N ASP B 90 -7.796 -1.372 -27.615 1.00 78.85 N \nANISOU 3187 N ASP B 90 9845 9230 10884 -1051 -610 -76 N \nATOM 3188 CA ASP B 90 -7.688 -2.432 -26.607 1.00 83.84 C \nANISOU 3188 CA ASP B 90 10495 9882 11479 -969 -629 -95 C \nATOM 3189 C ASP B 90 -6.729 -1.999 -25.500 1.00 79.05 C \nANISOU 3189 C ASP B 90 9777 9346 10913 -992 -615 -86 C \nATOM 3190 O ASP B 90 -7.071 -2.048 -24.332 1.00 85.98 O \nANISOU 3190 O ASP B 90 10664 10226 11777 -987 -623 -88 O \nATOM 3191 CB ASP B 90 -7.217 -3.745 -27.234 1.00 95.93 C \nANISOU 3191 CB ASP B 90 12030 11458 12959 -858 -644 -123 C \nATOM 3192 CG ASP B 90 -8.322 -4.464 -28.014 1.00111.70 C \nANISOU 3192 CG ASP B 90 14198 13363 14882 -796 -681 -141 C \nATOM 3193 OD1 ASP B 90 -9.411 -3.875 -28.258 1.00115.01 O \nANISOU 3193 OD1 ASP B 90 14736 13676 15287 -886 -694 -121 O \nATOM 3194 OD2 ASP B 90 -8.082 -5.640 -28.390 1.00135.78 O \nANISOU 3194 OD2 ASP B 90 17269 16458 17862 -662 -704 -176 O \nATOM 3195 N VAL B 91 -5.540 -1.551 -25.888 1.00 71.83 N \nANISOU 3195 N VAL B 91 8784 8474 10035 -1024 -602 -76 N \nATOM 3196 CA VAL B 91 -4.496 -1.139 -24.957 1.00 64.95 C \nANISOU 3196 CA VAL B 91 7852 7649 9178 -1067 -604 -63 C \nATOM 3197 C VAL B 91 -4.974 0.007 -24.099 1.00 69.51 C \nANISOU 3197 C VAL B 91 8439 8186 9788 -1102 -603 -53 C \nATOM 3198 O VAL B 91 -4.911 -0.065 -22.873 1.00 74.62 O \nANISOU 3198 O VAL B 91 9070 8855 10428 -1111 -609 -50 O \nATOM 3199 CB VAL B 91 -3.261 -0.698 -25.715 1.00 62.75 C \nANISOU 3199 CB VAL B 91 7557 7376 8909 -1110 -609 -50 C \nATOM 3200 CG1 VAL B 91 -2.246 -0.061 -24.783 1.00 67.71 C \nANISOU 3200 CG1 VAL B 91 8188 8009 9531 -1175 -631 -31 C \nATOM 3201 CG2 VAL B 91 -2.637 -1.890 -26.414 1.00 64.07 C \nANISOU 3201 CG2 VAL B 91 7692 7624 9028 -1096 -610 -58 C \nATOM 3202 N TRP B 92 -5.500 1.052 -24.732 1.00 69.44 N \nANISOU 3202 N TRP B 92 8442 8144 9798 -1117 -596 -51 N \nATOM 3203 CA TRP B 92 -6.020 2.229 -23.978 1.00 69.01 C \nANISOU 3203 CA TRP B 92 8372 8098 9750 -1141 -596 -48 C \nATOM 3204 C TRP B 92 -7.232 1.974 -23.109 1.00 74.33 C \nANISOU 3204 C TRP B 92 9074 8765 10404 -1170 -593 -46 C \nATOM 3205 O TRP B 92 -7.358 2.534 -22.022 1.00 85.43 O \nANISOU 3205 O TRP B 92 10459 10188 11814 -1186 -596 -43 O \nATOM 3206 CB TRP B 92 -6.330 3.400 -24.918 1.00 64.65 C \nANISOU 3206 CB TRP B 92 7795 7581 9186 -1141 -591 -56 C \nATOM 3207 CG TRP B 92 -5.073 4.078 -25.370 1.00 60.85 C \nANISOU 3207 CG TRP B 92 7314 7095 8710 -1087 -612 -64 C \nATOM 3208 CD1 TRP B 92 -4.575 4.150 -26.638 1.00 58.73 C \nANISOU 3208 CD1 TRP B 92 7058 6819 8438 -1058 -616 -70 C \nATOM 3209 CD2 TRP B 92 -4.128 4.739 -24.531 1.00 53.48 C \nANISOU 3209 CD2 TRP B 92 6409 6142 7770 -1056 -644 -66 C \nATOM 3210 NE1 TRP B 92 -3.380 4.843 -26.638 1.00 58.47 N \nANISOU 3210 NE1 TRP B 92 7074 6755 8388 -1008 -656 -77 N \nATOM 3211 CE2 TRP B 92 -3.085 5.209 -25.352 1.00 57.97 C \nANISOU 3211 CE2 TRP B 92 7034 6676 8317 -1008 -678 -74 C \nATOM 3212 CE3 TRP B 92 -4.071 4.990 -23.173 1.00 58.23 C \nANISOU 3212 CE3 TRP B 92 7016 6739 8371 -1066 -656 -62 C \nATOM 3213 CZ2 TRP B 92 -1.988 5.925 -24.850 1.00 64.52 C \nANISOU 3213 CZ2 TRP B 92 7959 7447 9107 -969 -735 -78 C \nATOM 3214 CZ3 TRP B 92 -2.962 5.692 -22.651 1.00 66.74 C \nANISOU 3214 CZ3 TRP B 92 8167 7771 9420 -1031 -706 -64 C \nATOM 3215 CH2 TRP B 92 -1.943 6.157 -23.496 1.00 66.79 C \nANISOU 3215 CH2 TRP B 92 8262 7725 9389 -984 -750 -73 C \nATOM 3216 N THR B 93 -8.116 1.104 -23.562 1.00 80.46 N \nANISOU 3216 N THR B 93 9922 9504 11145 -1174 -598 -48 N \nATOM 3217 CA THR B 93 -9.243 0.661 -22.720 1.00 78.03 C \nANISOU 3217 CA THR B 93 9699 9156 10791 -1197 -615 -46 C \nATOM 3218 C THR B 93 -8.670 -0.047 -21.496 1.00 72.93 C \nANISOU 3218 C THR B 93 9032 8524 10153 -1131 -623 -56 C \nATOM 3219 O THR B 93 -8.964 0.307 -20.368 1.00 74.98 O \nANISOU 3219 O THR B 93 9285 8788 10414 -1156 -625 -51 O \nATOM 3220 CB THR B 93 -10.207 -0.281 -23.498 1.00 83.06 C \nANISOU 3220 CB THR B 93 10484 9716 11359 -1192 -642 -51 C \nATOM 3221 OG1 THR B 93 -10.984 0.476 -24.428 1.00 76.17 O \nANISOU 3221 OG1 THR B 93 9641 8847 10455 -1303 -638 -34 O \nATOM 3222 CG2 THR B 93 -11.145 -1.039 -22.554 1.00 82.89 C \nANISOU 3222 CG2 THR B 93 10605 9623 11267 -1170 -682 -58 C \nATOM 3223 N TYR B 94 -7.849 -1.058 -21.740 1.00 73.71 N \nANISOU 3223 N TYR B 94 9107 8657 10241 -1054 -627 -72 N \nATOM 3224 CA TYR B 94 -7.203 -1.818 -20.679 1.00 72.02 C \nANISOU 3224 CA TYR B 94 8842 8517 10004 -1001 -634 -84 C \nATOM 3225 C TYR B 94 -6.519 -0.945 -19.640 1.00 68.40 C \nANISOU 3225 C TYR B 94 8310 8090 9588 -1067 -624 -65 C \nATOM 3226 O TYR B 94 -6.655 -1.192 -18.445 1.00 58.01 O \nANISOU 3226 O TYR B 94 6986 6802 8254 -1055 -631 -69 O \nATOM 3227 CB TYR B 94 -6.169 -2.755 -21.274 1.00 75.37 C \nANISOU 3227 CB TYR B 94 9202 9040 10394 -951 -634 -99 C \nATOM 3228 CG TYR B 94 -5.385 -3.517 -20.243 1.00 82.19 C \nANISOU 3228 CG TYR B 94 9978 10048 11203 -925 -639 -111 C \nATOM 3229 CD1 TYR B 94 -5.789 -4.787 -19.843 1.00 80.71 C \nANISOU 3229 CD1 TYR B 94 9799 9950 10919 -790 -662 -153 C \nATOM 3230 CD2 TYR B 94 -4.236 -2.962 -19.674 1.00 76.99 C \nANISOU 3230 CD2 TYR B 94 9240 9448 10563 -1033 -632 -84 C \nATOM 3231 CE1 TYR B 94 -5.067 -5.478 -18.912 1.00 86.45 C \nANISOU 3231 CE1 TYR B 94 10414 10863 11571 -768 -665 -168 C \nATOM 3232 CE2 TYR B 94 -3.513 -3.649 -18.750 1.00 84.83 C \nANISOU 3232 CE2 TYR B 94 10147 10602 11483 -1048 -638 -90 C \nATOM 3233 CZ TYR B 94 -3.936 -4.903 -18.381 1.00 90.36 C \nANISOU 3233 CZ TYR B 94 10812 11430 12089 -917 -649 -133 C \nATOM 3234 OH TYR B 94 -3.193 -5.595 -17.463 1.00132.97 O \nANISOU 3234 OH TYR B 94 16091 17043 17389 -934 -654 -143 O \nATOM 3235 N ASN B 95 -5.751 0.042 -20.089 1.00 66.19 N \nANISOU 3235 N ASN B 95 7997 7802 9352 -1122 -616 -48 N \nATOM 3236 CA ASN B 95 -5.029 0.888 -19.151 1.00 63.99 C \nANISOU 3236 CA ASN B 95 7692 7530 9091 -1168 -624 -34 C \nATOM 3237 C ASN B 95 -5.998 1.644 -18.268 1.00 69.69 C \nANISOU 3237 C ASN B 95 8426 8224 9829 -1176 -620 -33 C \nATOM 3238 O ASN B 95 -5.953 1.528 -17.022 1.00 74.23 O \nANISOU 3238 O ASN B 95 8988 8817 10398 -1185 -626 -30 O \nATOM 3239 CB ASN B 95 -4.112 1.880 -19.872 1.00 65.51 C \nANISOU 3239 CB ASN B 95 7900 7691 9298 -1190 -637 -25 C \nATOM 3240 CG ASN B 95 -2.877 1.212 -20.481 1.00 66.87 C \nANISOU 3240 CG ASN B 95 8076 7895 9439 -1224 -650 -16 C \nATOM 3241 OD1 ASN B 95 -2.396 0.157 -20.019 1.00 73.12 O \nANISOU 3241 OD1 ASN B 95 8825 8772 10184 -1255 -651 -13 O \nATOM 3242 ND2 ASN B 95 -2.357 1.826 -21.511 1.00 67.53 N \nANISOU 3242 ND2 ASN B 95 8199 7932 9526 -1222 -663 -14 N \nATOM 3243 N ALA B 96 -6.896 2.392 -18.890 1.00 64.41 N \nANISOU 3243 N ALA B 96 7771 7536 9165 -1187 -612 -35 N \nATOM 3244 CA ALA B 96 -7.819 3.230 -18.119 1.00 75.22 C \nANISOU 3244 CA ALA B 96 9134 8918 10526 -1221 -609 -33 C \nATOM 3245 C ALA B 96 -8.593 2.440 -17.036 1.00 84.92 C \nANISOU 3245 C ALA B 96 10407 10123 11734 -1230 -615 -32 C \nATOM 3246 O ALA B 96 -8.728 2.886 -15.893 1.00 82.79 O \nANISOU 3246 O ALA B 96 10120 9867 11470 -1247 -617 -28 O \nATOM 3247 CB ALA B 96 -8.786 3.908 -19.057 1.00 79.77 C \nANISOU 3247 CB ALA B 96 9710 9528 11073 -1264 -599 -34 C \nATOM 3248 N GLU B 97 -9.065 1.244 -17.385 1.00 92.75 N \nANISOU 3248 N GLU B 97 11472 11077 12691 -1198 -626 -40 N \nATOM 3249 CA GLU B 97 -9.800 0.411 -16.430 1.00 92.19 C \nANISOU 3249 CA GLU B 97 11479 10974 12574 -1168 -648 -48 C \nATOM 3250 C GLU B 97 -8.937 -0.084 -15.275 1.00 88.97 C \nANISOU 3250 C GLU B 97 11003 10626 12174 -1115 -649 -57 C \nATOM 3251 O GLU B 97 -9.380 -0.079 -14.136 1.00 79.21 O \nANISOU 3251 O GLU B 97 9787 9385 10924 -1117 -658 -58 O \nATOM 3252 CB GLU B 97 -10.442 -0.776 -17.123 1.00 97.24 C \nANISOU 3252 CB GLU B 97 12246 11556 13144 -1102 -678 -67 C \nATOM 3253 CG GLU B 97 -11.406 -0.382 -18.227 1.00 98.95 C \nANISOU 3253 CG GLU B 97 12562 11706 13327 -1186 -687 -52 C \nATOM 3254 CD GLU B 97 -12.685 -1.177 -18.180 1.00 98.95 C \nANISOU 3254 CD GLU B 97 12785 11592 13220 -1179 -743 -59 C \nATOM 3255 OE1 GLU B 97 -13.175 -1.446 -17.070 1.00107.38 O \nANISOU 3255 OE1 GLU B 97 13927 12625 14247 -1158 -771 -64 O \nATOM 3256 OE2 GLU B 97 -13.210 -1.506 -19.246 1.00 97.81 O \nANISOU 3256 OE2 GLU B 97 12763 11381 13020 -1196 -768 -58 O \nATOM 3257 N LEU B 98 -7.717 -0.532 -15.562 1.00 85.26 N \nANISOU 3257 N LEU B 98 10457 10229 11709 -1087 -642 -62 N \nATOM 3258 CA LEU B 98 -6.816 -0.985 -14.475 1.00 80.87 C \nANISOU 3258 CA LEU B 98 9825 9771 11132 -1080 -645 -64 C \nATOM 3259 C LEU B 98 -6.193 0.154 -13.721 1.00 66.03 C \nANISOU 3259 C LEU B 98 7908 7881 9299 -1164 -640 -39 C \nATOM 3260 O LEU B 98 -5.899 0.029 -12.541 1.00 62.69 O \nANISOU 3260 O LEU B 98 7454 7506 8859 -1180 -646 -36 O \nATOM 3261 CB LEU B 98 -5.720 -1.918 -14.974 1.00 89.12 C \nANISOU 3261 CB LEU B 98 10798 10937 12126 -1060 -646 -74 C \nATOM 3262 CG LEU B 98 -6.194 -3.328 -15.377 1.00 96.70 C \nANISOU 3262 CG LEU B 98 11776 11964 13000 -923 -661 -115 C \nATOM 3263 CD1 LEU B 98 -4.994 -4.255 -15.399 1.00104.89 C \nANISOU 3263 CD1 LEU B 98 12687 13211 13954 -917 -661 -128 C \nATOM 3264 CD2 LEU B 98 -7.241 -3.921 -14.451 1.00 97.24 C \nANISOU 3264 CD2 LEU B 98 11918 12017 13013 -816 -687 -145 C \nATOM 3265 N LEU B 99 -6.086 1.289 -14.367 1.00 63.60 N \nANISOU 3265 N LEU B 99 7617 7515 9035 -1202 -636 -27 N \nATOM 3266 CA LEU B 99 -5.684 2.475 -13.640 1.00 65.42 C \nANISOU 3266 CA LEU B 99 7845 7724 9288 -1239 -646 -14 C \nATOM 3267 C LEU B 99 -6.701 2.829 -12.573 1.00 74.28 C \nANISOU 3267 C LEU B 99 8968 8837 10417 -1240 -641 -16 C \nATOM 3268 O LEU B 99 -6.333 3.146 -11.459 1.00 91.07 O \nANISOU 3268 O LEU B 99 11084 10974 12545 -1258 -651 -10 O \nATOM 3269 CB LEU B 99 -5.516 3.657 -14.578 1.00 62.35 C \nANISOU 3269 CB LEU B 99 7474 7301 8916 -1229 -652 -16 C \nATOM 3270 CG LEU B 99 -5.071 4.941 -13.870 1.00 70.61 C \nANISOU 3270 CG LEU B 99 8541 8331 9958 -1219 -678 -16 C \nATOM 3271 CD1 LEU B 99 -3.777 4.719 -13.105 1.00 65.83 C \nANISOU 3271 CD1 LEU B 99 7984 7704 9326 -1266 -712 1 C \nATOM 3272 CD2 LEU B 99 -4.891 6.094 -14.860 1.00 75.56 C \nANISOU 3272 CD2 LEU B 99 9187 8953 10569 -1159 -694 -33 C \nATOM 3273 N VAL B 100 -7.986 2.780 -12.916 1.00 81.29 N \nANISOU 3273 N VAL B 100 9887 9704 11297 -1237 -631 -22 N \nATOM 3274 CA VAL B 100 -9.056 3.160 -11.980 1.00 71.14 C \nANISOU 3274 CA VAL B 100 8620 8410 9998 -1268 -632 -20 C \nATOM 3275 C VAL B 100 -9.169 2.185 -10.817 1.00 71.93 C \nANISOU 3275 C VAL B 100 8744 8509 10079 -1238 -643 -25 C \nATOM 3276 O VAL B 100 -9.167 2.599 -9.663 1.00 84.90 O \nANISOU 3276 O VAL B 100 10363 10164 11730 -1256 -645 -20 O \nATOM 3277 CB VAL B 100 -10.400 3.279 -12.702 1.00 67.44 C \nANISOU 3277 CB VAL B 100 8213 7921 9490 -1319 -631 -17 C \nATOM 3278 CG1 VAL B 100 -11.559 3.245 -11.731 1.00 67.42 C \nANISOU 3278 CG1 VAL B 100 8277 7896 9445 -1372 -645 -11 C \nATOM 3279 CG2 VAL B 100 -10.441 4.581 -13.493 1.00 70.56 C \nANISOU 3279 CG2 VAL B 100 8544 8383 9884 -1358 -618 -16 C \nATOM 3280 N LEU B 101 -9.264 0.901 -11.117 1.00 68.89 N \nANISOU 3280 N LEU B 101 8400 8122 9652 -1174 -655 -41 N \nATOM 3281 CA LEU B 101 -9.376 -0.132 -10.067 1.00 73.38 C \nANISOU 3281 CA LEU B 101 8986 8726 10171 -1103 -673 -60 C \nATOM 3282 C LEU B 101 -8.239 -0.026 -9.069 1.00 75.13 C \nANISOU 3282 C LEU B 101 9100 9038 10407 -1125 -664 -53 C \nATOM 3283 O LEU B 101 -8.463 0.052 -7.880 1.00 77.99 O \nANISOU 3283 O LEU B 101 9458 9412 10764 -1129 -670 -52 O \nATOM 3284 CB LEU B 101 -9.396 -1.559 -10.670 1.00 73.24 C \nANISOU 3284 CB LEU B 101 9007 8742 10077 -983 -695 -93 C \nATOM 3285 CG LEU B 101 -10.547 -1.901 -11.640 1.00 75.17 C \nANISOU 3285 CG LEU B 101 9413 8874 10275 -949 -723 -104 C \nATOM 3286 CD1 LEU B 101 -10.420 -3.301 -12.210 1.00 70.03 C \nANISOU 3286 CD1 LEU B 101 8804 8270 9535 -792 -752 -146 C \nATOM 3287 CD2 LEU B 101 -11.885 -1.740 -10.943 1.00 80.59 C \nANISOU 3287 CD2 LEU B 101 10252 9451 10916 -976 -756 -100 C \nATOM 3288 N MET B 102 -7.013 -0.012 -9.574 1.00 78.16 N \nANISOU 3288 N MET B 102 9417 9482 10798 -1159 -657 -43 N \nATOM 3289 CA MET B 102 -5.831 0.027 -8.720 1.00 75.38 C \nANISOU 3289 CA MET B 102 8997 9218 10428 -1223 -662 -29 C \nATOM 3290 C MET B 102 -5.862 1.268 -7.864 1.00 79.94 C \nANISOU 3290 C MET B 102 9597 9723 11054 -1280 -665 -9 C \nATOM 3291 O MET B 102 -5.663 1.206 -6.659 1.00 77.43 O \nANISOU 3291 O MET B 102 9255 9448 10718 -1305 -672 -4 O \nATOM 3292 CB MET B 102 -4.561 0.005 -9.577 1.00 73.44 C \nANISOU 3292 CB MET B 102 8725 9016 10163 -1290 -666 -13 C \nATOM 3293 CG MET B 102 -4.181 -1.390 -10.079 1.00 76.01 C \nANISOU 3293 CG MET B 102 8982 9494 10404 -1249 -665 -34 C \nATOM 3294 SD MET B 102 -2.943 -1.359 -11.373 1.00 79.55 S \nANISOU 3294 SD MET B 102 9423 9971 10830 -1339 -670 -14 S \nATOM 3295 CE MET B 102 -1.951 0.047 -10.917 1.00 72.27 C \nANISOU 3295 CE MET B 102 8586 8939 9934 -1484 -699 30 C \nATOM 3296 N GLU B 103 -6.150 2.400 -8.497 1.00 81.30 N \nANISOU 3296 N GLU B 103 9808 9807 11274 -1289 -663 -3 N \nATOM 3297 CA GLU B 103 -6.031 3.690 -7.838 1.00 71.14 C \nANISOU 3297 CA GLU B 103 8539 8479 10011 -1312 -675 7 C \nATOM 3298 C GLU B 103 -7.192 3.962 -6.905 1.00 66.51 C \nANISOU 3298 C GLU B 103 7947 7887 9436 -1302 -665 1 C \nATOM 3299 O GLU B 103 -7.050 4.669 -5.896 1.00 60.55 O \nANISOU 3299 O GLU B 103 7191 7130 8687 -1317 -675 6 O \nATOM 3300 CB GLU B 103 -5.920 4.796 -8.887 1.00 69.09 C \nANISOU 3300 CB GLU B 103 8306 8180 9767 -1290 -682 2 C \nATOM 3301 CG GLU B 103 -4.876 5.838 -8.534 1.00 81.75 C \nANISOU 3301 CG GLU B 103 9966 9744 11349 -1289 -723 6 C \nATOM 3302 CD GLU B 103 -3.459 5.288 -8.449 1.00 87.92 C \nANISOU 3302 CD GLU B 103 10807 10511 12089 -1362 -756 29 C \nATOM 3303 OE1 GLU B 103 -2.596 5.991 -7.887 1.00 89.68 O \nANISOU 3303 OE1 GLU B 103 11125 10678 12270 -1386 -806 38 O \nATOM 3304 OE2 GLU B 103 -3.207 4.160 -8.916 1.00 99.70 O \nANISOU 3304 OE2 GLU B 103 12260 12056 13567 -1404 -740 36 O \nATOM 3305 N ASN B 104 -8.360 3.428 -7.243 1.00 66.22 N \nANISOU 3305 N ASN B 104 7932 7839 9390 -1284 -653 -8 N \nATOM 3306 CA ASN B 104 -9.505 3.561 -6.357 1.00 70.64 C \nANISOU 3306 CA ASN B 104 8519 8385 9938 -1300 -653 -9 C \nATOM 3307 C ASN B 104 -9.234 2.810 -5.068 1.00 73.75 C \nANISOU 3307 C ASN B 104 8903 8804 10316 -1276 -662 -12 C \nATOM 3308 O ASN B 104 -9.507 3.322 -3.982 1.00 84.87 O \nANISOU 3308 O ASN B 104 10304 10212 11732 -1299 -664 -7 O \nATOM 3309 CB ASN B 104 -10.764 2.996 -7.006 1.00 75.47 C \nANISOU 3309 CB ASN B 104 9217 8950 10507 -1304 -659 -14 C \nATOM 3310 CG ASN B 104 -11.494 4.015 -7.853 1.00 66.80 C \nANISOU 3310 CG ASN B 104 8122 7861 9398 -1379 -650 -5 C \nATOM 3311 OD1 ASN B 104 -11.177 5.213 -7.842 1.00 68.59 O \nANISOU 3311 OD1 ASN B 104 8269 8149 9643 -1397 -639 -4 O \nATOM 3312 ND2 ASN B 104 -12.522 3.552 -8.534 1.00 59.22 N \nANISOU 3312 ND2 ASN B 104 7264 6853 8383 -1419 -664 -2 N \nATOM 3313 N GLU B 105 -8.697 1.599 -5.167 1.00 70.10 N \nANISOU 3313 N GLU B 105 8425 8393 9816 -1225 -668 -25 N \nATOM 3314 CA GLU B 105 -8.266 0.886 -3.976 1.00 76.73 C \nANISOU 3314 CA GLU B 105 9220 9316 10616 -1202 -676 -33 C \nATOM 3315 C GLU B 105 -7.278 1.684 -3.101 1.00 82.84 C \nANISOU 3315 C GLU B 105 9945 10115 11414 -1286 -677 -9 C \nATOM 3316 O GLU B 105 -7.443 1.782 -1.881 1.00 82.66 O \nANISOU 3316 O GLU B 105 9912 10108 11386 -1295 -681 -7 O \nATOM 3317 CB GLU B 105 -7.612 -0.427 -4.329 1.00 77.80 C \nANISOU 3317 CB GLU B 105 9304 9576 10680 -1142 -682 -54 C \nATOM 3318 CG GLU B 105 -7.441 -1.279 -3.085 1.00 94.57 C \nANISOU 3318 CG GLU B 105 11370 11833 12729 -1095 -693 -74 C \nATOM 3319 CD GLU B 105 -6.240 -2.179 -3.143 1.00108.23 C \nANISOU 3319 CD GLU B 105 12979 13773 14370 -1109 -693 -82 C \nATOM 3320 OE1 GLU B 105 -6.468 -3.396 -3.056 1.00115.97 O \nANISOU 3320 OE1 GLU B 105 13920 14896 15247 -975 -706 -127 O \nATOM 3321 OE2 GLU B 105 -5.072 -1.705 -3.277 1.00115.31 O \nANISOU 3321 OE2 GLU B 105 13830 14708 15272 -1251 -688 -47 O \nATOM 3322 N ARG B 106 -6.267 2.277 -3.722 1.00 79.35 N \nANISOU 3322 N ARG B 106 9502 9661 10987 -1344 -682 9 N \nATOM 3323 CA ARG B 106 -5.277 3.019 -2.956 1.00 75.48 C \nANISOU 3323 CA ARG B 106 9026 9163 10490 -1422 -704 32 C \nATOM 3324 C ARG B 106 -5.966 4.183 -2.287 1.00 75.50 C \nANISOU 3324 C ARG B 106 9059 9092 10536 -1401 -706 30 C \nATOM 3325 O ARG B 106 -5.697 4.501 -1.125 1.00 82.26 O \nANISOU 3325 O ARG B 106 9922 9952 11383 -1433 -721 40 O \nATOM 3326 CB ARG B 106 -4.128 3.485 -3.846 1.00 77.60 C \nANISOU 3326 CB ARG B 106 9348 9396 10742 -1477 -729 48 C \nATOM 3327 CG ARG B 106 -3.276 2.316 -4.393 1.00 83.28 C \nANISOU 3327 CG ARG B 106 10024 10226 11393 -1535 -730 55 C \nATOM 3328 CD ARG B 106 -2.336 2.744 -5.507 1.00101.31 C \nANISOU 3328 CD ARG B 106 12383 12452 13660 -1587 -756 71 C \nATOM 3329 NE ARG B 106 -1.472 3.823 -5.041 1.00120.35 N \nANISOU 3329 NE ARG B 106 14923 14762 16042 -1657 -810 94 N \nATOM 3330 CZ ARG B 106 -1.757 5.129 -5.097 1.00133.79 C \nANISOU 3330 CZ ARG B 106 16711 16339 17784 -1574 -832 82 C \nATOM 3331 NH1 ARG B 106 -2.901 5.572 -5.612 1.00128.56 N \nANISOU 3331 NH1 ARG B 106 15996 15661 17192 -1454 -797 53 N \nATOM 3332 NH2 ARG B 106 -0.880 6.001 -4.630 1.00139.22 N \nANISOU 3332 NH2 ARG B 106 17549 16932 18415 -1614 -898 96 N \nATOM 3333 N THR B 107 -6.891 4.817 -2.997 1.00 77.05 N \nANISOU 3333 N THR B 107 9264 9245 10765 -1357 -693 19 N \nATOM 3334 CA THR B 107 -7.636 5.960 -2.418 1.00 71.91 C \nANISOU 3334 CA THR B 107 8613 8580 10130 -1344 -692 13 C \nATOM 3335 C THR B 107 -8.380 5.535 -1.156 1.00 69.47 C \nANISOU 3335 C THR B 107 8290 8286 9819 -1358 -684 14 C \nATOM 3336 O THR B 107 -8.376 6.235 -0.147 1.00 69.33 O \nANISOU 3336 O THR B 107 8268 8270 9804 -1365 -693 17 O \nATOM 3337 CB THR B 107 -8.629 6.541 -3.423 1.00 73.80 C \nANISOU 3337 CB THR B 107 8839 8832 10370 -1329 -676 1 C \nATOM 3338 OG1 THR B 107 -7.924 7.123 -4.523 1.00 74.69 O \nANISOU 3338 OG1 THR B 107 8962 8940 10478 -1295 -688 -6 O \nATOM 3339 CG2 THR B 107 -9.496 7.606 -2.785 1.00 77.42 C \nANISOU 3339 CG2 THR B 107 9266 9338 10812 -1336 -673 -6 C \nATOM 3340 N LEU B 108 -9.026 4.377 -1.208 1.00 67.63 N \nANISOU 3340 N LEU B 108 8067 8060 9569 -1343 -675 8 N \nATOM 3341 CA LEU B 108 -9.863 3.933 -0.088 1.00 66.39 C \nANISOU 3341 CA LEU B 108 7929 7904 9393 -1335 -678 3 C \nATOM 3342 C LEU B 108 -9.053 3.603 1.152 1.00 69.65 C \nANISOU 3342 C LEU B 108 8301 8368 9796 -1339 -685 7 C \nATOM 3343 O LEU B 108 -9.411 4.026 2.254 1.00 86.09 O \nANISOU 3343 O LEU B 108 10383 10444 11885 -1354 -688 10 O \nATOM 3344 CB LEU B 108 -10.761 2.757 -0.483 1.00 62.18 C \nANISOU 3344 CB LEU B 108 7467 7347 8812 -1283 -687 -14 C \nATOM 3345 CG LEU B 108 -11.871 3.070 -1.519 1.00 62.88 C \nANISOU 3345 CG LEU B 108 7637 7371 8885 -1319 -690 -11 C \nATOM 3346 CD1 LEU B 108 -12.846 1.884 -1.646 1.00 61.34 C \nANISOU 3346 CD1 LEU B 108 7583 7111 8612 -1262 -724 -28 C \nATOM 3347 CD2 LEU B 108 -12.641 4.346 -1.193 1.00 57.55 C \nANISOU 3347 CD2 LEU B 108 6954 6698 8214 -1413 -682 5 C \nATOM 3348 N ASP B 109 -7.958 2.869 1.017 1.00 65.40 N \nANISOU 3348 N ASP B 109 7723 7900 9226 -1344 -690 8 N \nATOM 3349 CA ASP B 109 -7.165 2.634 2.208 1.00 72.19 C \nANISOU 3349 CA ASP B 109 8540 8837 10052 -1388 -701 17 C \nATOM 3350 C ASP B 109 -6.162 3.763 2.533 1.00 64.65 C \nANISOU 3350 C ASP B 109 7617 7837 9111 -1474 -721 44 C \nATOM 3351 O ASP B 109 -5.592 3.796 3.606 1.00 68.75 O \nANISOU 3351 O ASP B 109 8130 8393 9599 -1533 -737 58 O \nATOM 3352 CB ASP B 109 -6.592 1.218 2.241 1.00 80.62 C \nANISOU 3352 CB ASP B 109 9536 10062 11033 -1369 -702 3 C \nATOM 3353 CG ASP B 109 -5.707 0.938 1.137 1.00 84.28 C \nANISOU 3353 CG ASP B 109 9980 10572 11470 -1410 -704 10 C \nATOM 3354 OD1 ASP B 109 -5.086 1.907 0.651 1.00 99.27 O \nANISOU 3354 OD1 ASP B 109 11933 12379 13405 -1485 -714 36 O \nATOM 3355 OD2 ASP B 109 -5.623 -0.263 0.773 1.00 84.63 O \nANISOU 3355 OD2 ASP B 109 9962 10754 11440 -1351 -701 -15 O \nATOM 3356 N PHE B 110 -6.021 4.728 1.649 1.00 60.01 N \nANISOU 3356 N PHE B 110 7081 7165 8555 -1468 -730 48 N \nATOM 3357 CA PHE B 110 -5.439 6.003 2.018 1.00 62.32 C \nANISOU 3357 CA PHE B 110 7445 7388 8848 -1485 -765 58 C \nATOM 3358 C PHE B 110 -6.284 6.613 3.159 1.00 67.56 C \nANISOU 3358 C PHE B 110 8091 8044 9535 -1455 -758 50 C \nATOM 3359 O PHE B 110 -5.744 7.003 4.184 1.00 81.07 O \nANISOU 3359 O PHE B 110 9839 9740 11224 -1488 -785 61 O \nATOM 3360 CB PHE B 110 -5.437 6.947 0.828 1.00 61.36 C \nANISOU 3360 CB PHE B 110 7369 7206 8739 -1427 -776 45 C \nATOM 3361 CG PHE B 110 -4.922 8.328 1.130 1.00 58.97 C \nANISOU 3361 CG PHE B 110 7159 6839 8408 -1383 -826 38 C \nATOM 3362 CD1 PHE B 110 -3.665 8.505 1.687 1.00 60.32 C \nANISOU 3362 CD1 PHE B 110 7455 6948 8518 -1444 -886 59 C \nATOM 3363 CD2 PHE B 110 -5.657 9.451 0.795 1.00 57.98 C \nANISOU 3363 CD2 PHE B 110 7013 6731 8288 -1278 -824 8 C \nATOM 3364 CE1 PHE B 110 -3.135 9.778 1.916 1.00 60.95 C \nANISOU 3364 CE1 PHE B 110 7674 6941 8544 -1372 -953 45 C \nATOM 3365 CE2 PHE B 110 -5.149 10.744 1.036 1.00 61.27 C \nANISOU 3365 CE2 PHE B 110 7521 7110 8648 -1185 -883 -14 C \nATOM 3366 CZ PHE B 110 -3.879 10.910 1.583 1.00 61.46 C \nANISOU 3366 CZ PHE B 110 7708 7030 8614 -1215 -953 2 C \nATOM 3367 N HIS B 111 -7.596 6.663 2.977 1.00 57.29 N \nANISOU 3367 N HIS B 111 6747 6754 8265 -1411 -727 34 N \nATOM 3368 CA HIS B 111 -8.521 7.164 4.001 1.00 57.57 C \nANISOU 3368 CA HIS B 111 6764 6799 8311 -1404 -719 29 C \nATOM 3369 C HIS B 111 -8.465 6.366 5.297 1.00 59.52 C \nANISOU 3369 C HIS B 111 6997 7070 8548 -1431 -719 37 C \nATOM 3370 O HIS B 111 -8.404 6.936 6.408 1.00 56.98 O \nANISOU 3370 O HIS B 111 6678 6745 8226 -1443 -731 41 O \nATOM 3371 CB HIS B 111 -9.974 7.120 3.496 1.00 54.22 C \nANISOU 3371 CB HIS B 111 6325 6388 7888 -1403 -694 20 C \nATOM 3372 CG HIS B 111 -10.265 8.081 2.394 1.00 51.68 C \nANISOU 3372 CG HIS B 111 5986 6093 7556 -1390 -690 10 C \nATOM 3373 ND1 HIS B 111 -9.882 9.403 2.448 1.00 57.23 N \nANISOU 3373 ND1 HIS B 111 6668 6836 8240 -1342 -708 -5 N \nATOM 3374 CD2 HIS B 111 -10.898 7.927 1.212 1.00 54.50 C \nANISOU 3374 CD2 HIS B 111 6344 6463 7900 -1406 -676 7 C \nATOM 3375 CE1 HIS B 111 -10.280 10.030 1.360 1.00 55.74 C \nANISOU 3375 CE1 HIS B 111 6445 6711 8024 -1323 -701 -20 C \nATOM 3376 NE2 HIS B 111 -10.893 9.154 0.586 1.00 57.25 N \nANISOU 3376 NE2 HIS B 111 6646 6883 8222 -1379 -679 -8 N \nATOM 3377 N ASP B 112 -8.457 5.041 5.169 1.00 58.12 N \nANISOU 3377 N ASP B 112 6801 6935 8348 -1425 -710 33 N \nATOM 3378 CA ASP B 112 -8.285 4.183 6.367 1.00 58.01 C \nANISOU 3378 CA ASP B 112 6754 6992 8297 -1430 -714 32 C \nATOM 3379 C ASP B 112 -6.986 4.495 7.104 1.00 60.11 C \nANISOU 3379 C ASP B 112 7015 7290 8536 -1513 -736 54 C \nATOM 3380 O ASP B 112 -6.961 4.581 8.333 1.00 65.11 O \nANISOU 3380 O ASP B 112 7638 7946 9157 -1538 -742 60 O \nATOM 3381 CB ASP B 112 -8.357 2.701 6.016 1.00 56.16 C \nANISOU 3381 CB ASP B 112 6487 6846 8005 -1373 -709 11 C \nATOM 3382 CG ASP B 112 -9.758 2.273 5.535 1.00 61.08 C \nANISOU 3382 CG ASP B 112 7177 7406 8623 -1286 -709 -13 C \nATOM 3383 OD1 ASP B 112 -10.675 3.117 5.592 1.00 67.04 O \nANISOU 3383 OD1 ASP B 112 7987 8069 9415 -1312 -707 -5 O \nATOM 3384 OD2 ASP B 112 -9.935 1.118 5.049 1.00 66.53 O \nANISOU 3384 OD2 ASP B 112 7878 8146 9254 -1199 -718 -40 O \nATOM 3385 N SER B 113 -5.915 4.692 6.353 1.00 63.23 N \nANISOU 3385 N SER B 113 7441 7674 8908 -1569 -754 70 N \nATOM 3386 CA SER B 113 -4.612 4.987 6.964 1.00 69.33 C \nANISOU 3386 CA SER B 113 8267 8453 9622 -1684 -795 99 C \nATOM 3387 C SER B 113 -4.667 6.338 7.691 1.00 66.29 C \nANISOU 3387 C SER B 113 7970 7955 9263 -1667 -824 103 C \nATOM 3388 O SER B 113 -4.156 6.481 8.793 1.00 70.94 O \nANISOU 3388 O SER B 113 8593 8550 9811 -1737 -851 120 O \nATOM 3389 CB SER B 113 -3.482 4.980 5.922 1.00 73.91 C \nANISOU 3389 CB SER B 113 8913 9017 10153 -1761 -824 118 C \nATOM 3390 OG SER B 113 -2.862 6.261 5.878 1.00 87.60 O \nANISOU 3390 OG SER B 113 10801 10608 11877 -1775 -878 130 O \nATOM 3391 N ASN B 114 -5.273 7.331 7.071 1.00 60.31 N \nANISOU 3391 N ASN B 114 7242 7119 8554 -1572 -822 83 N \nATOM 3392 CA ASN B 114 -5.358 8.663 7.691 1.00 60.84 C \nANISOU 3392 CA ASN B 114 7376 7120 8621 -1517 -855 74 C \nATOM 3393 C ASN B 114 -6.213 8.670 8.945 1.00 61.02 C \nANISOU 3393 C ASN B 114 7332 7181 8670 -1508 -831 69 C \nATOM 3394 O ASN B 114 -5.896 9.337 9.917 1.00 61.43 O \nANISOU 3394 O ASN B 114 7441 7201 8700 -1511 -864 73 O \nATOM 3395 CB ASN B 114 -5.935 9.679 6.693 1.00 67.65 C \nANISOU 3395 CB ASN B 114 8239 7965 9502 -1402 -853 44 C \nATOM 3396 CG ASN B 114 -4.937 10.099 5.623 1.00 67.86 C \nANISOU 3396 CG ASN B 114 8377 7925 9484 -1377 -900 41 C \nATOM 3397 OD1 ASN B 114 -3.738 10.128 5.845 1.00 69.81 O \nANISOU 3397 OD1 ASN B 114 8761 8097 9669 -1438 -959 62 O \nATOM 3398 ND2 ASN B 114 -5.443 10.400 4.449 1.00 74.13 N \nANISOU 3398 ND2 ASN B 114 9127 8745 10295 -1303 -880 19 N \nATOM 3399 N VAL B 115 -7.324 7.933 8.920 1.00 63.50 N \nANISOU 3399 N VAL B 115 7553 7551 9022 -1494 -782 60 N \nATOM 3400 CA VAL B 115 -8.170 7.793 10.116 1.00 57.32 C \nANISOU 3400 CA VAL B 115 6728 6797 8253 -1493 -765 57 C \nATOM 3401 C VAL B 115 -7.349 7.160 11.232 1.00 58.84 C \nANISOU 3401 C VAL B 115 6921 7025 8409 -1560 -781 75 C \nATOM 3402 O VAL B 115 -7.327 7.663 12.350 1.00 58.17 O \nANISOU 3402 O VAL B 115 6852 6929 8321 -1573 -795 80 O \nATOM 3403 CB VAL B 115 -9.436 6.933 9.839 1.00 52.25 C \nANISOU 3403 CB VAL B 115 6047 6181 7625 -1470 -730 45 C \nATOM 3404 CG1 VAL B 115 -10.096 6.457 11.127 1.00 53.75 C \nANISOU 3404 CG1 VAL B 115 6224 6393 7806 -1470 -726 43 C \nATOM 3405 CG2 VAL B 115 -10.446 7.723 9.047 1.00 44.97 C \nANISOU 3405 CG2 VAL B 115 5126 5246 6716 -1452 -718 35 C \nATOM 3406 N LYS B 116 -6.693 6.040 10.927 1.00 63.28 N \nANISOU 3406 N LYS B 116 7455 7660 8929 -1607 -778 83 N \nATOM 3407 CA LYS B 116 -5.790 5.372 11.897 1.00 69.04 C \nANISOU 3407 CA LYS B 116 8161 8485 9587 -1703 -795 102 C \nATOM 3408 C LYS B 116 -4.749 6.321 12.504 1.00 66.59 C \nANISOU 3408 C LYS B 116 7962 8101 9239 -1797 -846 131 C \nATOM 3409 O LYS B 116 -4.378 6.180 13.658 1.00 70.46 O \nANISOU 3409 O LYS B 116 8450 8639 9684 -1873 -862 146 O \nATOM 3410 CB LYS B 116 -5.039 4.197 11.246 1.00 78.25 C \nANISOU 3410 CB LYS B 116 9268 9784 10677 -1760 -791 106 C \nATOM 3411 CG LYS B 116 -5.687 2.834 11.386 1.00 85.08 C \nANISOU 3411 CG LYS B 116 10016 10805 11505 -1676 -761 75 C \nATOM 3412 CD LYS B 116 -5.531 2.356 12.809 1.00102.49 C \nANISOU 3412 CD LYS B 116 12156 13142 13645 -1712 -765 75 C \nATOM 3413 CE LYS B 116 -6.263 1.055 13.037 1.00114.46 C \nANISOU 3413 CE LYS B 116 13574 14813 15101 -1573 -749 28 C \nATOM 3414 NZ LYS B 116 -6.252 0.723 14.488 1.00122.45 N \nANISOU 3414 NZ LYS B 116 14524 15948 16054 -1584 -754 23 N \nATOM 3415 N ASN B 117 -4.261 7.273 11.721 1.00 60.76 N \nANISOU 3415 N ASN B 117 7340 7244 8501 -1785 -883 135 N \nATOM 3416 CA ASN B 117 -3.290 8.235 12.229 1.00 71.08 C \nANISOU 3416 CA ASN B 117 8816 8444 9747 -1842 -955 154 C \nATOM 3417 C ASN B 117 -3.864 9.167 13.268 1.00 80.89 C \nANISOU 3417 C ASN B 117 10080 9634 11020 -1763 -965 139 C \nATOM 3418 O ASN B 117 -3.206 9.471 14.273 1.00 98.56 O \nANISOU 3418 O ASN B 117 12418 11833 13197 -1837 -1014 159 O \nATOM 3419 CB ASN B 117 -2.662 9.038 11.096 1.00 76.93 C \nANISOU 3419 CB ASN B 117 9706 9065 10459 -1803 -1007 151 C \nATOM 3420 CG ASN B 117 -1.444 8.337 10.511 1.00 84.33 C \nANISOU 3420 CG ASN B 117 10719 10018 11303 -1967 -1041 186 C \nATOM 3421 OD1 ASN B 117 -0.627 7.794 11.255 1.00 93.67 O \nANISOU 3421 OD1 ASN B 117 11937 11259 12393 -2145 -1070 224 O \nATOM 3422 ND2 ASN B 117 -1.308 8.358 9.190 1.00 84.57 N \nANISOU 3422 ND2 ASN B 117 10774 10016 11343 -1925 -1042 178 N \nATOM 3423 N LEU B 118 -5.092 9.615 13.048 1.00 75.45 N \nANISOU 3423 N LEU B 118 9303 8956 10409 -1630 -922 106 N \nATOM 3424 CA LEU B 118 -5.796 10.369 14.070 1.00 66.83 C \nANISOU 3424 CA LEU B 118 8192 7861 9340 -1565 -920 90 C \nATOM 3425 C LEU B 118 -5.963 9.581 15.355 1.00 67.58 C \nANISOU 3425 C LEU B 118 8222 8018 9438 -1645 -898 108 C \nATOM 3426 O LEU B 118 -5.656 10.080 16.460 1.00 64.79 O \nANISOU 3426 O LEU B 118 7928 7634 9056 -1667 -932 116 O \nATOM 3427 CB LEU B 118 -7.135 10.812 13.564 1.00 71.52 C \nANISOU 3427 CB LEU B 118 8684 8500 9988 -1463 -875 59 C \nATOM 3428 CG LEU B 118 -7.231 12.294 13.227 1.00 72.78 C \nANISOU 3428 CG LEU B 118 8889 8649 10116 -1337 -910 26 C \nATOM 3429 CD1 LEU B 118 -6.024 12.720 12.419 1.00 75.40 C \nANISOU 3429 CD1 LEU B 118 9370 8891 10387 -1300 -975 23 C \nATOM 3430 CD2 LEU B 118 -8.526 12.574 12.475 1.00 69.08 C \nANISOU 3430 CD2 LEU B 118 8295 8280 9672 -1287 -860 1 C \nATOM 3431 N TYR B 119 -6.441 8.344 15.218 1.00 66.47 N \nANISOU 3431 N TYR B 119 7970 7970 9317 -1670 -850 108 N \nATOM 3432 CA TYR B 119 -6.616 7.436 16.390 1.00 65.15 C \nANISOU 3432 CA TYR B 119 7728 7895 9130 -1717 -832 115 C \nATOM 3433 C TYR B 119 -5.348 7.263 17.172 1.00 70.15 C \nANISOU 3433 C TYR B 119 8413 8563 9680 -1851 -873 146 C \nATOM 3434 O TYR B 119 -5.397 7.226 18.390 1.00 77.26 O \nANISOU 3434 O TYR B 119 9295 9498 10563 -1884 -877 152 O \nATOM 3435 CB TYR B 119 -7.144 6.080 15.944 1.00 59.13 C \nANISOU 3435 CB TYR B 119 6867 7238 8361 -1684 -793 99 C \nATOM 3436 CG TYR B 119 -7.501 5.144 17.072 1.00 64.54 C \nANISOU 3436 CG TYR B 119 7476 8037 9010 -1674 -780 89 C \nATOM 3437 CD1 TYR B 119 -8.771 5.175 17.671 1.00 64.31 C \nANISOU 3437 CD1 TYR B 119 7442 7975 9020 -1590 -764 68 C \nATOM 3438 CD2 TYR B 119 -6.577 4.200 17.537 1.00 70.52 C \nANISOU 3438 CD2 TYR B 119 8166 8958 9669 -1754 -788 98 C \nATOM 3439 CE1 TYR B 119 -9.101 4.301 18.703 1.00 69.64 C \nANISOU 3439 CE1 TYR B 119 8065 8747 9647 -1554 -761 53 C \nATOM 3440 CE2 TYR B 119 -6.891 3.324 18.572 1.00 68.71 C \nANISOU 3440 CE2 TYR B 119 7850 8871 9384 -1719 -779 79 C \nATOM 3441 CZ TYR B 119 -8.140 3.373 19.154 1.00 72.32 C \nANISOU 3441 CZ TYR B 119 8321 9266 9891 -1604 -768 54 C \nATOM 3442 OH TYR B 119 -8.425 2.502 20.174 1.00 70.44 O \nANISOU 3442 OH TYR B 119 8015 9164 9584 -1547 -768 30 O \nATOM 3443 N ASP B 120 -4.211 7.184 16.469 1.00 79.40 N \nANISOU 3443 N ASP B 120 9661 9724 10785 -1948 -908 169 N \nATOM 3444 CA ASP B 120 -2.895 6.975 17.119 1.00 86.98 C \nANISOU 3444 CA ASP B 120 10699 10725 11623 -2138 -961 210 C \nATOM 3445 C ASP B 120 -2.334 8.262 17.779 1.00 87.02 C \nANISOU 3445 C ASP B 120 10909 10559 11595 -2165 -1035 227 C \nATOM 3446 O ASP B 120 -1.842 8.210 18.884 1.00 84.60 O \nANISOU 3446 O ASP B 120 10645 10279 11219 -2282 -1065 252 O \nATOM 3447 CB ASP B 120 -1.878 6.403 16.131 1.00 95.83 C \nANISOU 3447 CB ASP B 120 11854 11902 12655 -2266 -983 234 C \nATOM 3448 CG ASP B 120 -1.987 4.890 15.971 1.00111.09 C \nANISOU 3448 CG ASP B 120 13583 14085 14541 -2298 -930 224 C \nATOM 3449 OD1 ASP B 120 -2.948 4.274 16.497 1.00115.31 O \nANISOU 3449 OD1 ASP B 120 13970 14724 15117 -2183 -880 192 O \nATOM 3450 OD2 ASP B 120 -1.101 4.307 15.294 1.00125.79 O \nANISOU 3450 OD2 ASP B 120 15441 16049 16305 -2430 -946 246 O \nATOM 3451 N LYS B 121 -2.414 9.406 17.104 1.00 83.10 N \nANISOU 3451 N LYS B 121 10543 9901 11131 -2041 -1070 207 N \nATOM 3452 CA LYS B 121 -2.099 10.692 17.732 1.00 89.35 C \nANISOU 3452 CA LYS B 121 11527 10539 11883 -1987 -1146 202 C \nATOM 3453 C LYS B 121 -2.767 10.864 19.113 1.00 90.23 C \nANISOU 3453 C LYS B 121 11561 10689 12032 -1955 -1122 194 C \nATOM 3454 O LYS B 121 -2.160 11.384 20.047 1.00 91.10 O \nANISOU 3454 O LYS B 121 11823 10722 12069 -2012 -1188 211 O \nATOM 3455 CB LYS B 121 -2.550 11.840 16.846 1.00 96.92 C \nANISOU 3455 CB LYS B 121 12543 11401 12879 -1776 -1163 157 C \nATOM 3456 CG LYS B 121 -1.695 12.124 15.619 1.00107.82 C \nANISOU 3456 CG LYS B 121 14091 12682 14193 -1772 -1224 159 C \nATOM 3457 CD LYS B 121 -2.310 13.240 14.761 1.00110.20 C \nANISOU 3457 CD LYS B 121 14399 12948 14525 -1530 -1231 102 C \nATOM 3458 CE LYS B 121 -2.607 14.517 15.559 1.00108.61 C \nANISOU 3458 CE LYS B 121 14273 12704 14288 -1359 -1280 61 C \nATOM 3459 NZ LYS B 121 -1.460 15.442 15.624 1.00116.69 N \nANISOU 3459 NZ LYS B 121 15627 13548 15164 -1299 -1418 53 N \nATOM 3460 N VAL B 122 -4.022 10.443 19.224 1.00 90.68 N \nANISOU 3460 N VAL B 122 11410 10851 12194 -1869 -1037 169 N \nATOM 3461 CA VAL B 122 -4.763 10.516 20.482 1.00 90.34 C \nANISOU 3461 CA VAL B 122 11285 10851 12188 -1841 -1010 162 C \nATOM 3462 C VAL B 122 -4.277 9.472 21.473 1.00 89.26 C \nANISOU 3462 C VAL B 122 11097 10821 11996 -1999 -1004 193 C \nATOM 3463 O VAL B 122 -3.913 9.813 22.596 1.00 86.62 O \nANISOU 3463 O VAL B 122 10834 10461 11618 -2059 -1040 210 O \nATOM 3464 CB VAL B 122 -6.275 10.337 20.267 1.00 91.94 C \nANISOU 3464 CB VAL B 122 11322 11121 12491 -1725 -935 129 C \nATOM 3465 CG1 VAL B 122 -7.032 10.419 21.576 1.00 96.34 C \nANISOU 3465 CG1 VAL B 122 11817 11714 13076 -1708 -915 124 C \nATOM 3466 CG2 VAL B 122 -6.792 11.413 19.334 1.00 93.18 C \nANISOU 3466 CG2 VAL B 122 11499 11229 12676 -1592 -939 98 C \nATOM 3467 N ARG B 123 -4.217 8.216 21.037 1.00 87.28 N \nANISOU 3467 N ARG B 123 10723 10710 11727 -2061 -964 199 N \nATOM 3468 CA ARG B 123 -3.783 7.106 21.901 1.00 84.14 C \nANISOU 3468 CA ARG B 123 10230 10493 11245 -2195 -953 219 C \nATOM 3469 C ARG B 123 -2.447 7.344 22.563 1.00 82.14 C \nANISOU 3469 C ARG B 123 10120 10228 10863 -2402 -1024 266 C \nATOM 3470 O ARG B 123 -2.247 6.901 23.685 1.00 92.49 O \nANISOU 3470 O ARG B 123 11374 11658 12109 -2502 -1025 282 O \nATOM 3471 CB ARG B 123 -3.686 5.799 21.132 1.00 80.85 C \nANISOU 3471 CB ARG B 123 9676 10260 10785 -2217 -917 211 C \nATOM 3472 CG ARG B 123 -3.332 4.611 21.995 1.00 81.75 C \nANISOU 3472 CG ARG B 123 9647 10631 10783 -2318 -903 216 C \nATOM 3473 CD ARG B 123 -3.500 3.321 21.208 1.00 93.44 C \nANISOU 3473 CD ARG B 123 10969 12320 12216 -2260 -865 187 C \nATOM 3474 NE ARG B 123 -3.045 2.142 21.963 1.00108.57 N \nANISOU 3474 NE ARG B 123 12720 14554 13977 -2344 -858 182 N \nATOM 3475 CZ ARG B 123 -2.524 1.042 21.412 1.00118.48 C \nANISOU 3475 CZ ARG B 123 13839 16076 15101 -2391 -848 171 C \nATOM 3476 NH1 ARG B 123 -2.368 0.941 20.092 1.00113.29 N \nANISOU 3476 NH1 ARG B 123 13206 15378 14463 -2371 -845 168 N \nATOM 3477 NH2 ARG B 123 -2.152 0.029 22.189 1.00120.83 N \nANISOU 3477 NH2 ARG B 123 13962 16715 15232 -2454 -843 159 N \nATOM 3478 N LEU B 124 -1.536 8.033 21.885 1.00 81.03 N \nANISOU 3478 N LEU B 124 10181 9941 10665 -2474 -1093 290 N \nATOM 3479 CA LEU B 124 -0.224 8.326 22.475 1.00 90.37 C \nANISOU 3479 CA LEU B 124 11574 11069 11692 -2699 -1185 342 C \nATOM 3480 C LEU B 124 -0.290 9.370 23.573 1.00 88.70 C \nANISOU 3480 C LEU B 124 11514 10704 11484 -2654 -1236 342 C \nATOM 3481 O LEU B 124 0.464 9.282 24.546 1.00 83.10 O \nANISOU 3481 O LEU B 124 10903 10018 10654 -2848 -1288 382 O \nATOM 3482 CB LEU B 124 0.785 8.779 21.426 1.00 91.49 C \nANISOU 3482 CB LEU B 124 11951 11065 11747 -2784 -1264 366 C \nATOM 3483 CG LEU B 124 1.345 7.637 20.589 1.00100.15 C \nANISOU 3483 CG LEU B 124 12940 12347 12763 -2946 -1240 389 C \nATOM 3484 CD1 LEU B 124 2.532 8.122 19.759 1.00100.47 C \nANISOU 3484 CD1 LEU B 124 13270 12225 12678 -3090 -1341 427 C \nATOM 3485 CD2 LEU B 124 1.719 6.429 21.446 1.00 98.01 C \nANISOU 3485 CD2 LEU B 124 12492 12377 12372 -3163 -1212 418 C \nATOM 3486 N GLN B 125 -1.214 10.322 23.439 1.00 89.81 N \nANISOU 3486 N GLN B 125 11660 10718 11747 -2409 -1221 295 N \nATOM 3487 CA GLN B 125 -1.346 11.395 24.424 1.00 93.02 C \nANISOU 3487 CA GLN B 125 12198 10995 12152 -2327 -1270 284 C \nATOM 3488 C GLN B 125 -1.971 10.996 25.754 1.00 85.48 C \nANISOU 3488 C GLN B 125 11083 10157 11237 -2345 -1219 284 C \nATOM 3489 O GLN B 125 -1.752 11.681 26.733 1.00 98.96 O \nANISOU 3489 O GLN B 125 12921 11776 12903 -2353 -1272 291 O \nATOM 3490 CB GLN B 125 -2.116 12.584 23.869 1.00 92.08 C \nANISOU 3490 CB GLN B 125 12109 10762 12115 -2059 -1274 229 C \nATOM 3491 CG GLN B 125 -1.325 13.427 22.887 1.00 89.94 C \nANISOU 3491 CG GLN B 125 12090 10323 11760 -1996 -1367 220 C \nATOM 3492 CD GLN B 125 -2.129 14.599 22.406 1.00 91.42 C \nANISOU 3492 CD GLN B 125 12265 10470 12002 -1713 -1368 154 C \nATOM 3493 OE1 GLN B 125 -1.825 15.738 22.720 1.00 94.66 O \nANISOU 3493 OE1 GLN B 125 12876 10758 12330 -1579 -1458 126 O \nATOM 3494 NE2 GLN B 125 -3.194 14.320 21.672 1.00 97.00 N \nANISOU 3494 NE2 GLN B 125 12732 11300 12825 -1619 -1271 127 N \nATOM 3495 N LEU B 126 -2.671 9.873 25.833 1.00 86.21 N \nANISOU 3495 N LEU B 126 10923 10442 11391 -2350 -1128 275 N \nATOM 3496 CA LEU B 126 -3.405 9.570 27.059 1.00 85.13 C \nANISOU 3496 CA LEU B 126 10648 10401 11296 -2323 -1084 265 C \nATOM 3497 C LEU B 126 -3.357 8.115 27.506 1.00 83.40 C \nANISOU 3497 C LEU B 126 10239 10426 11022 -2433 -1036 276 C \nATOM 3498 O LEU B 126 -4.273 7.610 28.125 1.00 93.36 O \nANISOU 3498 O LEU B 126 11347 11789 12338 -2342 -983 249 O \nATOM 3499 CB LEU B 126 -4.842 10.084 26.914 1.00 87.49 C \nANISOU 3499 CB LEU B 126 10850 10657 11734 -2101 -1030 218 C \nATOM 3500 CG LEU B 126 -5.585 9.890 25.596 1.00 80.90 C \nANISOU 3500 CG LEU B 126 9929 9832 10976 -1985 -982 189 C \nATOM 3501 CD1 LEU B 126 -6.099 8.470 25.464 1.00 85.92 C \nANISOU 3501 CD1 LEU B 126 10392 10631 11622 -1991 -921 181 C \nATOM 3502 CD2 LEU B 126 -6.723 10.863 25.491 1.00 74.43 C \nANISOU 3502 CD2 LEU B 126 9089 8949 10241 -1821 -962 154 C \nATOM 3503 N ARG B 127 -2.231 7.482 27.250 1.00 93.37 N \nANISOU 3503 N ARG B 127 11528 11798 12151 -2635 -1067 312 N \nATOM 3504 CA ARG B 127 -1.972 6.046 27.537 1.00 96.98 C \nANISOU 3504 CA ARG B 127 11783 12562 12501 -2752 -1030 317 C \nATOM 3505 C ARG B 127 -2.936 5.394 28.534 1.00 95.72 C \nANISOU 3505 C ARG B 127 11431 12559 12380 -2631 -974 281 C \nATOM 3506 O ARG B 127 -3.835 4.642 28.141 1.00 95.85 O \nANISOU 3506 O ARG B 127 11294 12675 12449 -2460 -919 235 O \nATOM 3507 CB ARG B 127 -0.501 5.803 27.982 1.00 97.52 C \nANISOU 3507 CB ARG B 127 11944 12744 12365 -3073 -1096 379 C \nATOM 3508 CG ARG B 127 0.509 6.843 27.487 1.00 99.35 C \nANISOU 3508 CG ARG B 127 12493 12720 12535 -3209 -1193 424 C \nATOM 3509 CD ARG B 127 0.968 7.753 28.628 1.00103.58 C \nANISOU 3509 CD ARG B 127 13252 13092 13012 -3308 -1271 456 C \nATOM 3510 NE ARG B 127 1.151 9.135 28.223 1.00109.25 N \nANISOU 3510 NE ARG B 127 14272 13473 13765 -3204 -1352 453 N \nATOM 3511 CZ ARG B 127 2.169 9.608 27.517 1.00117.68 C \nANISOU 3511 CZ ARG B 127 15619 14377 14716 -3327 -1448 487 C \nATOM 3512 NH1 ARG B 127 3.121 8.794 27.088 1.00127.54 N \nANISOU 3512 NH1 ARG B 127 16879 15771 15808 -3602 -1472 535 N \nATOM 3513 NH2 ARG B 127 2.224 10.902 27.219 1.00120.91 N \nANISOU 3513 NH2 ARG B 127 16301 14491 15147 -3164 -1527 466 N \nATOM 3514 N ASP B 128 -2.723 5.668 29.814 1.00 96.99 N \nANISOU 3514 N ASP B 128 11625 12730 12497 -2720 -997 301 N \nATOM 3515 CA ASP B 128 -3.506 5.047 30.881 1.00101.05 C \nANISOU 3515 CA ASP B 128 11972 13400 13021 -2624 -954 270 C \nATOM 3516 C ASP B 128 -4.525 6.027 31.498 1.00 99.41 C \nANISOU 3516 C ASP B 128 11837 12972 12962 -2464 -947 250 C \nATOM 3517 O ASP B 128 -5.257 5.666 32.417 1.00105.10 O \nANISOU 3517 O ASP B 128 12457 13773 13702 -2377 -918 225 O \nATOM 3518 CB ASP B 128 -2.602 4.420 31.958 1.00100.40 C \nANISOU 3518 CB ASP B 128 11819 13569 12758 -2847 -977 301 C \nATOM 3519 CG ASP B 128 -1.504 5.372 32.460 1.00104.97 C \nANISOU 3519 CG ASP B 128 12630 13994 13258 -3091 -1056 367 C \nATOM 3520 OD1 ASP B 128 -1.515 6.573 32.120 1.00 97.53 O \nANISOU 3520 OD1 ASP B 128 11907 12743 12407 -3036 -1097 376 O \nATOM 3521 OD2 ASP B 128 -0.613 4.888 33.189 1.00108.64 O \nANISOU 3521 OD2 ASP B 128 13067 14667 13544 -3337 -1085 405 O \nATOM 3522 N ASN B 129 -4.583 7.240 30.960 1.00 85.98 N \nANISOU 3522 N ASN B 129 10302 11019 11347 -2415 -975 257 N \nATOM 3523 CA ASN B 129 -5.634 8.160 31.299 1.00 85.19 C \nANISOU 3523 CA ASN B 129 10237 10760 11372 -2252 -962 231 C \nATOM 3524 C ASN B 129 -6.998 7.808 30.657 1.00 85.14 C \nANISOU 3524 C ASN B 129 10122 10760 11468 -2067 -903 187 C \nATOM 3525 O ASN B 129 -8.015 8.364 31.056 1.00 76.91 O \nANISOU 3525 O ASN B 129 9079 9639 10505 -1961 -886 167 O \nATOM 3526 CB ASN B 129 -5.211 9.573 30.919 1.00 87.76 C \nANISOU 3526 CB ASN B 129 10763 10867 11715 -2238 -1019 242 C \nATOM 3527 CG ASN B 129 -4.219 10.152 31.917 1.00 96.60 C \nANISOU 3527 CG ASN B 129 12047 11918 12737 -2377 -1093 278 C \nATOM 3528 OD1 ASN B 129 -3.665 9.423 32.750 1.00101.98 O \nANISOU 3528 OD1 ASN B 129 12687 12737 13326 -2540 -1099 307 O \nATOM 3529 ND2 ASN B 129 -4.014 11.466 31.864 1.00 92.63 N \nANISOU 3529 ND2 ASN B 129 11739 11219 12236 -2304 -1156 273 N \nATOM 3530 N ALA B 130 -7.007 6.888 29.686 1.00 78.13 N \nANISOU 3530 N ALA B 130 9160 9968 10560 -2044 -879 174 N \nATOM 3531 CA ALA B 130 -8.228 6.391 29.052 1.00 73.69 C \nANISOU 3531 CA ALA B 130 8534 9407 10060 -1887 -838 135 C \nATOM 3532 C ALA B 130 -8.206 4.899 28.715 1.00 74.59 C \nANISOU 3532 C ALA B 130 8532 9717 10091 -1846 -820 110 C \nATOM 3533 O ALA B 130 -7.136 4.312 28.531 1.00 73.33 O \nANISOU 3533 O ALA B 130 8320 9711 9831 -1956 -830 125 O \nATOM 3534 CB ALA B 130 -8.507 7.182 27.772 1.00 76.88 C \nANISOU 3534 CB ALA B 130 9011 9664 10537 -1837 -837 132 C \nATOM 3535 N LYS B 131 -9.409 4.326 28.577 1.00 77.01 N \nANISOU 3535 N LYS B 131 8818 10020 10421 -1687 -802 69 N \nATOM 3536 CA LYS B 131 -9.622 2.920 28.175 1.00 82.90 C \nANISOU 3536 CA LYS B 131 9486 10936 11077 -1573 -796 27 C \nATOM 3537 C LYS B 131 -9.884 2.876 26.670 1.00 85.56 C \nANISOU 3537 C LYS B 131 9870 11186 11453 -1520 -790 18 C \nATOM 3538 O LYS B 131 -10.773 3.549 26.193 1.00 67.77 O \nANISOU 3538 O LYS B 131 7713 8747 9288 -1479 -787 19 O \nATOM 3539 CB LYS B 131 -10.853 2.272 28.845 1.00 91.50 C \nANISOU 3539 CB LYS B 131 10594 12033 12141 -1400 -804 -20 C \nATOM 3540 CG LYS B 131 -10.665 1.678 30.234 1.00102.40 C \nANISOU 3540 CG LYS B 131 11885 13595 13429 -1380 -812 -37 C \nATOM 3541 CD LYS B 131 -11.924 0.945 30.735 1.00103.18 C \nANISOU 3541 CD LYS B 131 12042 13683 13479 -1169 -834 -93 C \nATOM 3542 CE LYS B 131 -11.851 0.521 32.232 1.00104.49 C \nANISOU 3542 CE LYS B 131 12130 14010 13561 -1136 -844 -112 C \nATOM 3543 NZ LYS B 131 -10.491 0.086 32.681 1.00103.77 N \nANISOU 3543 NZ LYS B 131 11853 14215 13361 -1257 -832 -99 N \nATOM 3544 N GLU B 132 -9.108 2.071 25.935 1.00 96.43 N \nANISOU 3544 N GLU B 132 11169 12723 12746 -1534 -789 11 N \nATOM 3545 CA GLU B 132 -9.410 1.770 24.534 1.00 93.28 C \nANISOU 3545 CA GLU B 132 10804 12273 12365 -1456 -784 -7 C \nATOM 3546 C GLU B 132 -10.577 0.796 24.462 1.00 93.86 C \nANISOU 3546 C GLU B 132 10910 12364 12387 -1243 -797 -65 C \nATOM 3547 O GLU B 132 -10.419 -0.391 24.765 1.00 96.34 O \nANISOU 3547 O GLU B 132 11134 12902 12568 -1131 -810 -110 O \nATOM 3548 CB GLU B 132 -8.203 1.158 23.829 1.00 93.00 C \nANISOU 3548 CB GLU B 132 10673 12426 12238 -1539 -783 1 C \nATOM 3549 CG GLU B 132 -6.999 2.071 23.720 1.00 93.84 C \nANISOU 3549 CG GLU B 132 10811 12480 12363 -1759 -791 60 C \nATOM 3550 CD GLU B 132 -5.879 1.452 22.904 1.00 96.89 C \nANISOU 3550 CD GLU B 132 11129 13041 12644 -1867 -796 73 C \nATOM 3551 OE1 GLU B 132 -6.027 1.324 21.678 1.00 91.07 O \nANISOU 3551 OE1 GLU B 132 10414 12250 11938 -1807 -789 62 O \nATOM 3552 OE2 GLU B 132 -4.842 1.090 23.495 1.00102.08 O \nANISOU 3552 OE2 GLU B 132 11710 13904 13173 -2032 -810 97 O \nATOM 3553 N LEU B 133 -11.736 1.299 24.055 1.00 88.37 N \nANISOU 3553 N LEU B 133 10358 11448 11772 -1187 -804 -68 N \nATOM 3554 CA LEU B 133 -12.961 0.490 24.013 1.00 90.50 C \nANISOU 3554 CA LEU B 133 10741 11667 11977 -1002 -838 -117 C \nATOM 3555 C LEU B 133 -12.907 -0.554 22.902 1.00 93.14 C \nANISOU 3555 C LEU B 133 11081 12083 12225 -869 -855 -158 C \nATOM 3556 O LEU B 133 -13.724 -1.508 22.889 1.00 88.93 O \nANISOU 3556 O LEU B 133 10653 11552 11586 -669 -902 -214 O \nATOM 3557 CB LEU B 133 -14.211 1.362 23.851 1.00 82.07 C \nANISOU 3557 CB LEU B 133 9846 10348 10989 -1038 -848 -97 C \nATOM 3558 CG LEU B 133 -14.782 2.093 25.036 1.00 79.92 C \nANISOU 3558 CG LEU B 133 9614 9996 10758 -1099 -850 -79 C \nATOM 3559 CD1 LEU B 133 -13.730 2.286 26.083 1.00 81.43 C \nANISOU 3559 CD1 LEU B 133 9655 10327 10959 -1165 -828 -63 C \nATOM 3560 CD2 LEU B 133 -15.379 3.420 24.600 1.00 81.16 C \nANISOU 3560 CD2 LEU B 133 9838 9990 11010 -1234 -835 -38 C \nATOM 3561 N GLY B 134 -11.948 -0.378 21.987 1.00 82.52 N \nANISOU 3561 N GLY B 134 9645 10799 10910 -968 -827 -133 N \nATOM 3562 CA GLY B 134 -11.780 -1.286 20.854 1.00 81.29 C \nANISOU 3562 CA GLY B 134 9474 10734 10678 -860 -837 -168 C \nATOM 3563 C GLY B 134 -12.805 -1.027 19.785 1.00 82.46 C \nANISOU 3563 C GLY B 134 9803 10648 10880 -816 -854 -169 C \nATOM 3564 O GLY B 134 -13.219 -1.943 19.077 1.00 90.47 O \nANISOU 3564 O GLY B 134 10890 11679 11805 -655 -887 -214 O \nATOM 3565 N ASN B 135 -13.204 0.237 19.667 1.00 86.16 N \nANISOU 3565 N ASN B 135 10345 10919 11475 -961 -835 -120 N \nATOM 3566 CA ASN B 135 -14.346 0.634 18.829 1.00 84.07 C \nANISOU 3566 CA ASN B 135 10255 10445 11242 -968 -853 -113 C \nATOM 3567 C ASN B 135 -14.100 1.974 18.109 1.00 82.76 C \nANISOU 3567 C ASN B 135 10059 10191 11196 -1139 -815 -62 C \nATOM 3568 O ASN B 135 -14.957 2.458 17.368 1.00 76.32 O \nANISOU 3568 O ASN B 135 9352 9246 10399 -1184 -822 -50 O \nATOM 3569 CB ASN B 135 -15.622 0.711 19.670 1.00 83.17 C \nANISOU 3569 CB ASN B 135 10304 10202 11093 -939 -892 -120 C \nATOM 3570 CG ASN B 135 -15.663 1.936 20.531 1.00 85.67 C \nANISOU 3570 CG ASN B 135 10572 10477 11501 -1091 -863 -77 C \nATOM 3571 OD1 ASN B 135 -14.614 2.474 20.931 1.00 95.67 O \nANISOU 3571 OD1 ASN B 135 11683 11837 12830 -1167 -825 -55 O \nATOM 3572 ND2 ASN B 135 -16.871 2.410 20.807 1.00 78.52 N \nANISOU 3572 ND2 ASN B 135 9816 9432 10586 -1146 -888 -65 N \nATOM 3573 N GLY B 136 -12.932 2.571 18.332 1.00 77.23 N \nANISOU 3573 N GLY B 136 9224 9569 10550 -1231 -783 -36 N \nATOM 3574 CA GLY B 136 -12.623 3.850 17.749 1.00 67.41 C \nANISOU 3574 CA GLY B 136 7966 8255 9394 -1345 -761 -1 C \nATOM 3575 C GLY B 136 -12.634 4.910 18.800 1.00 68.87 C \nANISOU 3575 C GLY B 136 8132 8413 9623 -1417 -756 20 C \nATOM 3576 O GLY B 136 -12.129 6.008 18.570 1.00 58.83 O \nANISOU 3576 O GLY B 136 6838 7116 8399 -1480 -748 40 O \nATOM 3577 N CYS B 137 -13.197 4.568 19.961 1.00 78.61 N \nANISOU 3577 N CYS B 137 9386 9656 10827 -1385 -767 9 N \nATOM 3578 CA CYS B 137 -13.404 5.520 21.046 1.00 79.96 C \nANISOU 3578 CA CYS B 137 9548 9800 11033 -1444 -764 26 C \nATOM 3579 C CYS B 137 -12.583 5.183 22.240 1.00 78.43 C \nANISOU 3579 C CYS B 137 9287 9697 10818 -1447 -768 27 C \nATOM 3580 O CYS B 137 -12.315 4.016 22.494 1.00 83.35 O \nANISOU 3580 O CYS B 137 9874 10423 11372 -1383 -775 6 O \nATOM 3581 CB CYS B 137 -14.855 5.497 21.497 1.00 73.98 C \nANISOU 3581 CB CYS B 137 8889 8971 10250 -1434 -780 18 C \nATOM 3582 SG CYS B 137 -16.003 5.783 20.168 1.00 81.40 S \nANISOU 3582 SG CYS B 137 9938 9819 11171 -1478 -788 23 S \nATOM 3583 N PHE B 138 -12.216 6.213 22.989 1.00 74.17 N \nANISOU 3583 N PHE B 138 8728 9138 10316 -1515 -766 48 N \nATOM 3584 CA PHE B 138 -11.575 6.028 24.257 1.00 73.67 C \nANISOU 3584 CA PHE B 138 8620 9146 10226 -1543 -773 55 C \nATOM 3585 C PHE B 138 -12.548 6.468 25.358 1.00 75.73 C \nANISOU 3585 C PHE B 138 8909 9361 10505 -1532 -775 52 C \nATOM 3586 O PHE B 138 -13.118 7.557 25.295 1.00 64.93 O \nANISOU 3586 O PHE B 138 7570 7921 9179 -1558 -772 60 O \nATOM 3587 CB PHE B 138 -10.307 6.874 24.359 1.00 83.44 C \nANISOU 3587 CB PHE B 138 9857 10376 11472 -1635 -787 83 C \nATOM 3588 CG PHE B 138 -9.302 6.647 23.256 1.00 81.92 C \nANISOU 3588 CG PHE B 138 9667 10205 11254 -1677 -794 94 C \nATOM 3589 CD1 PHE B 138 -8.347 5.659 23.367 1.00 78.11 C \nANISOU 3589 CD1 PHE B 138 9129 9860 10689 -1738 -800 101 C \nATOM 3590 CD2 PHE B 138 -9.292 7.466 22.132 1.00 80.21 C \nANISOU 3590 CD2 PHE B 138 9501 9896 11078 -1663 -797 96 C \nATOM 3591 CE1 PHE B 138 -7.415 5.471 22.375 1.00 83.79 C \nANISOU 3591 CE1 PHE B 138 9858 10608 11372 -1801 -810 115 C \nATOM 3592 CE2 PHE B 138 -8.364 7.283 21.134 1.00 78.56 C \nANISOU 3592 CE2 PHE B 138 9312 9696 10843 -1703 -809 106 C \nATOM 3593 CZ PHE B 138 -7.422 6.286 21.258 1.00 86.03 C \nANISOU 3593 CZ PHE B 138 10216 10760 11710 -1781 -816 118 C \nATOM 3594 N GLU B 139 -12.735 5.620 26.368 1.00 75.49 N \nANISOU 3594 N GLU B 139 8859 9398 10425 -1489 -783 37 N \nATOM 3595 CA GLU B 139 -13.402 6.038 27.590 1.00 78.03 C \nANISOU 3595 CA GLU B 139 9202 9686 10758 -1495 -787 39 C \nATOM 3596 C GLU B 139 -12.337 6.590 28.510 1.00 76.81 C \nANISOU 3596 C GLU B 139 8993 9578 10612 -1572 -789 61 C \nATOM 3597 O GLU B 139 -11.500 5.846 29.046 1.00 64.44 O \nANISOU 3597 O GLU B 139 7365 8133 8986 -1591 -794 61 O \nATOM 3598 CB GLU B 139 -14.162 4.890 28.275 1.00 86.26 C \nANISOU 3598 CB GLU B 139 10278 10767 11730 -1393 -806 7 C \nATOM 3599 CG GLU B 139 -14.898 5.337 29.533 1.00 86.14 C \nANISOU 3599 CG GLU B 139 10300 10706 11724 -1407 -814 10 C \nATOM 3600 CD GLU B 139 -15.947 4.359 30.042 1.00 89.00 C \nANISOU 3600 CD GLU B 139 10763 11048 12005 -1292 -848 -24 C \nATOM 3601 OE1 GLU B 139 -16.353 3.422 29.327 1.00 89.94 O \nANISOU 3601 OE1 GLU B 139 10961 11157 12055 -1186 -874 -55 O \nATOM 3602 OE2 GLU B 139 -16.393 4.546 31.186 1.00 96.17 O \nANISOU 3602 OE2 GLU B 139 11694 11940 12907 -1297 -858 -23 O \nATOM 3603 N PHE B 140 -12.380 7.906 28.702 1.00 81.16 N \nANISOU 3603 N PHE B 140 9571 10051 11214 -1617 -791 78 N \nATOM 3604 CA PHE B 140 -11.442 8.585 29.566 1.00 77.99 C \nANISOU 3604 CA PHE B 140 9169 9653 10809 -1679 -809 98 C \nATOM 3605 C PHE B 140 -11.623 8.008 30.940 1.00 85.81 C \nANISOU 3605 C PHE B 140 10125 10708 11770 -1681 -809 95 C \nATOM 3606 O PHE B 140 -12.729 7.669 31.370 1.00 91.72 O \nANISOU 3606 O PHE B 140 10878 11449 12522 -1623 -801 77 O \nATOM 3607 CB PHE B 140 -11.743 10.061 29.680 1.00 74.18 C \nANISOU 3607 CB PHE B 140 8725 9095 10365 -1670 -819 99 C \nATOM 3608 CG PHE B 140 -11.331 10.849 28.502 1.00 80.26 C \nANISOU 3608 CG PHE B 140 9531 9823 11142 -1652 -830 97 C \nATOM 3609 CD1 PHE B 140 -12.093 10.848 27.347 1.00 74.42 C \nANISOU 3609 CD1 PHE B 140 8774 9082 10421 -1619 -809 84 C \nATOM 3610 CD2 PHE B 140 -10.184 11.620 28.551 1.00 79.78 C \nANISOU 3610 CD2 PHE B 140 9545 9715 11051 -1665 -874 107 C \nATOM 3611 CE1 PHE B 140 -11.692 11.578 26.257 1.00 80.62 C \nANISOU 3611 CE1 PHE B 140 9582 9847 11203 -1590 -821 78 C \nATOM 3612 CE2 PHE B 140 -9.793 12.370 27.460 1.00 81.52 C \nANISOU 3612 CE2 PHE B 140 9820 9893 11262 -1617 -896 97 C \nATOM 3613 CZ PHE B 140 -10.544 12.346 26.307 1.00 78.03 C \nANISOU 3613 CZ PHE B 140 9325 9475 10846 -1575 -865 81 C \nATOM 3614 N TYR B 141 -10.532 7.886 31.660 1.00 96.01 N \nANISOU 3614 N TYR B 141 11401 12063 13016 -1759 -826 114 N \nATOM 3615 CA TYR B 141 -10.669 7.488 33.032 1.00 97.97 C \nANISOU 3615 CA TYR B 141 11608 12384 13231 -1766 -827 111 C \nATOM 3616 C TYR B 141 -11.234 8.734 33.670 1.00106.16 C \nANISOU 3616 C TYR B 141 12699 13307 14330 -1757 -833 116 C \nATOM 3617 O TYR B 141 -12.382 8.749 34.134 1.00124.83 O \nANISOU 3617 O TYR B 141 15060 15649 16720 -1700 -820 100 O \nATOM 3618 CB TYR B 141 -9.338 7.022 33.619 1.00 93.55 C \nANISOU 3618 CB TYR B 141 11013 11953 12580 -1888 -847 135 C \nATOM 3619 CG TYR B 141 -9.063 5.575 33.276 1.00 86.89 C \nANISOU 3619 CG TYR B 141 10061 11310 11643 -1871 -834 116 C \nATOM 3620 CD1 TYR B 141 -10.018 4.605 33.543 1.00 82.08 C \nANISOU 3620 CD1 TYR B 141 9391 10789 11008 -1725 -819 72 C \nATOM 3621 CD2 TYR B 141 -7.871 5.173 32.681 1.00 92.74 C \nANISOU 3621 CD2 TYR B 141 10774 12163 12299 -1991 -847 137 C \nATOM 3622 CE1 TYR B 141 -9.805 3.291 33.224 1.00 82.56 C \nANISOU 3622 CE1 TYR B 141 9350 11059 10958 -1660 -817 40 C \nATOM 3623 CE2 TYR B 141 -7.638 3.842 32.373 1.00 91.87 C \nANISOU 3623 CE2 TYR B 141 10536 12290 12080 -1964 -835 112 C \nATOM 3624 CZ TYR B 141 -8.616 2.914 32.652 1.00 92.52 C \nANISOU 3624 CZ TYR B 141 10545 12473 12137 -1779 -819 59 C \nATOM 3625 OH TYR B 141 -8.411 1.585 32.363 1.00115.92 O \nANISOU 3625 OH TYR B 141 13378 15700 14966 -1703 -816 19 O \nATOM 3626 N HIS B 142 -10.478 9.817 33.565 1.00 96.95 N \nANISOU 3626 N HIS B 142 11600 12066 13170 -1803 -861 134 N \nATOM 3627 CA HIS B 142 -10.898 11.092 34.153 1.00 89.34 C \nANISOU 3627 CA HIS B 142 10678 11028 12239 -1769 -874 130 C \nATOM 3628 C HIS B 142 -12.066 11.860 33.515 1.00 90.55 C \nANISOU 3628 C HIS B 142 10815 11152 12436 -1692 -855 108 C \nATOM 3629 O HIS B 142 -12.642 11.495 32.486 1.00 99.44 O \nANISOU 3629 O HIS B 142 11920 12286 13577 -1671 -832 98 O \nATOM 3630 CB HIS B 142 -9.692 12.021 34.343 1.00 83.69 C \nANISOU 3630 CB HIS B 142 10077 10242 11481 -1808 -931 147 C \nATOM 3631 CG HIS B 142 -8.984 12.404 33.095 1.00 80.13 C \nANISOU 3631 CG HIS B 142 9706 9733 11009 -1798 -959 148 C \nATOM 3632 ND1 HIS B 142 -8.000 11.608 32.545 1.00 89.83 N \nANISOU 3632 ND1 HIS B 142 10962 10983 12186 -1897 -972 171 N \nATOM 3633 CD2 HIS B 142 -9.031 13.527 32.344 1.00 75.66 C \nANISOU 3633 CD2 HIS B 142 9202 9102 10443 -1701 -984 126 C \nATOM 3634 CE1 HIS B 142 -7.506 12.205 31.476 1.00 92.07 C \nANISOU 3634 CE1 HIS B 142 11341 11188 12454 -1865 -1005 168 C \nATOM 3635 NE2 HIS B 142 -8.119 13.368 31.329 1.00 88.59 N \nANISOU 3635 NE2 HIS B 142 10921 10695 12043 -1733 -1013 137 N \nATOM 3636 N LYS B 143 -12.432 12.911 34.227 1.00 88.60 N \nANISOU 3636 N LYS B 143 10576 10897 12193 -1664 -866 100 N \nATOM 3637 CA LYS B 143 -13.335 13.923 33.752 1.00 86.41 C \nANISOU 3637 CA LYS B 143 10266 10648 11917 -1611 -857 78 C \nATOM 3638 C LYS B 143 -12.565 14.784 32.791 1.00 85.78 C \nANISOU 3638 C LYS B 143 10233 10550 11809 -1546 -889 64 C \nATOM 3639 O LYS B 143 -11.486 15.287 33.136 1.00 89.76 O \nANISOU 3639 O LYS B 143 10832 10994 12278 -1519 -940 66 O \nATOM 3640 CB LYS B 143 -13.773 14.784 34.926 1.00 88.04 C \nANISOU 3640 CB LYS B 143 10454 10886 12109 -1592 -867 69 C \nATOM 3641 CG LYS B 143 -14.639 15.976 34.552 1.00 96.26 C \nANISOU 3641 CG LYS B 143 11433 12025 13115 -1542 -862 41 C \nATOM 3642 CD LYS B 143 -14.769 16.953 35.708 1.00104.21 C \nANISOU 3642 CD LYS B 143 12423 13083 14088 -1498 -882 26 C \nATOM 3643 CE LYS B 143 -15.477 16.306 36.893 1.00106.43 C \nANISOU 3643 CE LYS B 143 12685 13354 14398 -1582 -859 46 C \nATOM 3644 NZ LYS B 143 -15.710 17.263 37.999 1.00102.39 N \nANISOU 3644 NZ LYS B 143 12145 12905 13853 -1546 -875 31 N \nATOM 3645 N CYS B 144 -13.135 14.979 31.608 1.00 82.12 N \nANISOU 3645 N CYS B 144 9726 10132 11345 -1521 -869 50 N \nATOM 3646 CA CYS B 144 -12.478 15.724 30.554 1.00 74.82 C \nANISOU 3646 CA CYS B 144 8841 9202 10386 -1440 -899 30 C \nATOM 3647 C CYS B 144 -13.405 16.804 30.040 1.00 76.00 C \nANISOU 3647 C CYS B 144 8900 9489 10489 -1372 -889 -5 C \nATOM 3648 O CYS B 144 -14.205 16.578 29.122 1.00 65.00 O \nANISOU 3648 O CYS B 144 7438 8162 9096 -1416 -853 -5 O \nATOM 3649 CB CYS B 144 -12.044 14.797 29.421 1.00 70.38 C \nANISOU 3649 CB CYS B 144 8302 8591 9848 -1481 -886 46 C \nATOM 3650 SG CYS B 144 -10.796 15.439 28.253 1.00 77.47 S \nANISOU 3650 SG CYS B 144 9308 9427 10698 -1399 -941 32 S \nATOM 3651 N ASP B 145 -13.287 17.991 30.641 1.00 87.83 N \nANISOU 3651 N ASP B 145 10398 11050 11924 -1266 -925 -37 N \nATOM 3652 CA ASP B 145 -14.093 19.158 30.226 1.00 91.70 C \nANISOU 3652 CA ASP B 145 10768 11744 12328 -1182 -921 -81 C \nATOM 3653 C ASP B 145 -13.811 19.540 28.774 1.00 87.20 C \nANISOU 3653 C ASP B 145 10192 11228 11713 -1096 -934 -109 C \nATOM 3654 O ASP B 145 -12.884 19.038 28.155 1.00 88.85 O \nANISOU 3654 O ASP B 145 10512 11290 11956 -1084 -955 -95 O \nATOM 3655 CB ASP B 145 -13.908 20.368 31.178 1.00 99.75 C \nANISOU 3655 CB ASP B 145 11791 12845 13265 -1040 -969 -123 C \nATOM 3656 CG ASP B 145 -12.444 20.792 31.354 1.00102.08 C \nANISOU 3656 CG ASP B 145 12282 12982 13522 -893 -1055 -140 C \nATOM 3657 OD1 ASP B 145 -11.633 20.633 30.432 1.00107.40 O \nANISOU 3657 OD1 ASP B 145 13062 13555 14189 -853 -1087 -140 O \nATOM 3658 OD2 ASP B 145 -12.103 21.317 32.433 1.00106.54 O \nANISOU 3658 OD2 ASP B 145 12919 13513 14047 -822 -1101 -154 O \nATOM 3659 N ASN B 146 -14.629 20.423 28.230 1.00 90.67 N \nANISOU 3659 N ASN B 146 10489 11902 12059 -1047 -920 -147 N \nATOM 3660 CA ASN B 146 -14.476 20.843 26.847 1.00 89.98 C \nANISOU 3660 CA ASN B 146 10369 11908 11912 -959 -929 -179 C \nATOM 3661 C ASN B 146 -13.055 21.270 26.500 1.00 89.65 C \nANISOU 3661 C ASN B 146 10495 11730 11839 -762 -1007 -210 C \nATOM 3662 O ASN B 146 -12.569 20.954 25.425 1.00 87.69 O \nANISOU 3662 O ASN B 146 10303 11408 11606 -749 -1014 -206 O \nATOM 3663 CB ASN B 146 -15.466 21.965 26.516 1.00 90.44 C \nANISOU 3663 CB ASN B 146 10229 12310 11826 -909 -916 -229 C \nATOM 3664 CG ASN B 146 -16.898 21.505 26.583 1.00 98.98 C \nANISOU 3664 CG ASN B 146 11182 13519 12907 -1156 -850 -189 C \nATOM 3665 OD1 ASN B 146 -17.750 22.178 27.161 1.00116.04 O \nANISOU 3665 OD1 ASN B 146 13209 15911 14970 -1198 -839 -205 O \nATOM 3666 ND2 ASN B 146 -17.173 20.336 26.019 1.00105.22 N \nANISOU 3666 ND2 ASN B 146 12033 14157 13790 -1325 -815 -136 N \nATOM 3667 N GLU B 147 -12.397 21.987 27.405 1.00 96.57 N \nANISOU 3667 N GLU B 147 11477 12560 12656 -615 -1075 -240 N \nATOM 3668 CA GLU B 147 -11.029 22.442 27.157 1.00102.26 C \nANISOU 3668 CA GLU B 147 12426 13116 13311 -433 -1174 -269 C \nATOM 3669 C GLU B 147 -10.042 21.285 27.183 1.00100.66 C \nANISOU 3669 C GLU B 147 12411 12627 13210 -588 -1186 -202 C \nATOM 3670 O GLU B 147 -9.075 21.288 26.430 1.00102.73 O \nANISOU 3670 O GLU B 147 12841 12758 13435 -529 -1245 -206 O \nATOM 3671 CB GLU B 147 -10.617 23.558 28.126 1.00106.22 C \nANISOU 3671 CB GLU B 147 13031 13636 13692 -223 -1261 -323 C \nATOM 3672 CG GLU B 147 -11.339 24.866 27.846 1.00115.37 C \nANISOU 3672 CG GLU B 147 14012 15129 14693 0 -1273 -411 C \nATOM 3673 CD GLU B 147 -10.834 26.026 28.687 1.00126.22 C \nANISOU 3673 CD GLU B 147 15514 16528 15916 273 -1378 -481 C \nATOM 3674 OE1 GLU B 147 -11.400 26.251 29.778 1.00128.24 O \nANISOU 3674 OE1 GLU B 147 15672 16883 16169 241 -1356 -482 O \nATOM 3675 OE2 GLU B 147 -9.869 26.709 28.272 1.00134.93 O \nANISOU 3675 OE2 GLU B 147 16838 17539 16891 527 -1492 -538 O \nATOM 3676 N CYS B 148 -10.284 20.302 28.047 1.00 98.79 N \nANISOU 3676 N CYS B 148 12141 12316 13077 -786 -1134 -144 N \nATOM 3677 CA CYS B 148 -9.489 19.073 28.066 1.00 91.41 C \nANISOU 3677 CA CYS B 148 11320 11193 12218 -955 -1130 -83 C \nATOM 3678 C CYS B 148 -9.659 18.326 26.743 1.00 96.00 C \nANISOU 3678 C CYS B 148 11834 11788 12852 -1025 -1082 -67 C \nATOM 3679 O CYS B 148 -8.707 17.768 26.210 1.00107.10 O \nANISOU 3679 O CYS B 148 13365 13068 14261 -1079 -1110 -41 O \nATOM 3680 CB CYS B 148 -9.901 18.173 29.250 1.00 93.48 C \nANISOU 3680 CB CYS B 148 11516 11441 12563 -1120 -1080 -38 C \nATOM 3681 SG CYS B 148 -9.331 16.452 29.285 1.00 96.93 S \nANISOU 3681 SG CYS B 148 11980 11774 13074 -1332 -1046 27 S \nATOM 3682 N MET B 149 -10.869 18.351 26.199 1.00 90.10 N \nANISOU 3682 N MET B 149 10903 11201 12129 -1036 -1015 -81 N \nATOM 3683 CA MET B 149 -11.150 17.728 24.928 1.00 83.48 C \nANISOU 3683 CA MET B 149 10007 10383 11329 -1094 -973 -69 C \nATOM 3684 C MET B 149 -10.494 18.496 23.792 1.00 82.94 C \nANISOU 3684 C MET B 149 10006 10320 11186 -945 -1023 -108 C \nATOM 3685 O MET B 149 -9.872 17.894 22.907 1.00 84.45 O \nANISOU 3685 O MET B 149 10270 10414 11403 -984 -1028 -89 O \nATOM 3686 CB MET B 149 -12.663 17.640 24.684 1.00 87.12 C \nANISOU 3686 CB MET B 149 10290 11010 11802 -1170 -903 -71 C \nATOM 3687 CG MET B 149 -13.183 16.228 24.520 1.00 87.79 C \nANISOU 3687 CG MET B 149 10358 11028 11969 -1331 -851 -26 C \nATOM 3688 SD MET B 149 -13.631 15.548 26.100 1.00104.44 S \nANISOU 3688 SD MET B 149 12469 13090 14122 -1426 -833 2 S \nATOM 3689 CE MET B 149 -14.088 13.874 25.699 1.00 76.04 C \nANISOU 3689 CE MET B 149 8891 9420 10582 -1538 -795 35 C \nATOM 3690 N GLU B 150 -10.647 19.817 23.772 1.00 85.41 N \nANISOU 3690 N GLU B 150 10294 10768 11391 -761 -1064 -168 N \nATOM 3691 CA GLU B 150 -9.986 20.612 22.731 1.00 93.42 C \nANISOU 3691 CA GLU B 150 11393 11794 12308 -572 -1128 -217 C \nATOM 3692 C GLU B 150 -8.501 20.280 22.745 1.00 92.55 C \nANISOU 3692 C GLU B 150 11556 11418 12191 -571 -1208 -193 C \nATOM 3693 O GLU B 150 -7.874 20.204 21.680 1.00 99.66 O \nANISOU 3693 O GLU B 150 12554 12246 13067 -533 -1239 -197 O \nATOM 3694 CB GLU B 150 -10.217 22.114 22.903 1.00 99.77 C \nANISOU 3694 CB GLU B 150 12152 12798 12959 -323 -1181 -299 C \nATOM 3695 CG GLU B 150 -9.611 22.997 21.805 1.00109.41 C \nANISOU 3695 CG GLU B 150 13458 14065 14047 -77 -1256 -367 C \nATOM 3696 CD GLU B 150 -10.173 22.714 20.412 1.00116.33 C \nANISOU 3696 CD GLU B 150 14177 15078 14945 -133 -1193 -366 C \nATOM 3697 OE1 GLU B 150 -11.418 22.712 20.257 1.00128.78 O \nANISOU 3697 OE1 GLU B 150 15505 16900 16527 -237 -1111 -364 O \nATOM 3698 OE2 GLU B 150 -9.383 22.504 19.469 1.00109.97 O \nANISOU 3698 OE2 GLU B 150 13509 14137 14138 -90 -1230 -365 O \nATOM 3699 N SER B 151 -7.972 20.068 23.953 1.00 88.47 N \nANISOU 3699 N SER B 151 11165 10766 11683 -638 -1243 -163 N \nATOM 3700 CA SER B 151 -6.542 19.873 24.162 1.00 91.95 C \nANISOU 3700 CA SER B 151 11895 10968 12074 -675 -1336 -135 C \nATOM 3701 C SER B 151 -6.058 18.581 23.526 1.00 95.03 C \nANISOU 3701 C SER B 151 12303 11264 12539 -886 -1299 -73 C \nATOM 3702 O SER B 151 -4.968 18.555 22.950 1.00106.14 O \nANISOU 3702 O SER B 151 13924 12526 13878 -896 -1374 -62 O \nATOM 3703 CB SER B 151 -6.147 19.899 25.649 1.00 93.74 C \nANISOU 3703 CB SER B 151 12240 11097 12279 -735 -1378 -112 C \nATOM 3704 OG SER B 151 -6.240 18.626 26.241 1.00100.11 O \nANISOU 3704 OG SER B 151 12962 11884 13193 -983 -1308 -44 O \nATOM 3705 N VAL B 152 -6.866 17.527 23.607 1.00 90.07 N \nANISOU 3705 N VAL B 152 11465 10725 12031 -1044 -1194 -38 N \nATOM 3706 CA VAL B 152 -6.485 16.252 22.990 1.00 93.14 C \nANISOU 3706 CA VAL B 152 11841 11072 12476 -1215 -1156 10 C \nATOM 3707 C VAL B 152 -6.594 16.283 21.458 1.00 93.11 C \nANISOU 3707 C VAL B 152 11801 11098 12478 -1153 -1141 -9 C \nATOM 3708 O VAL B 152 -5.939 15.504 20.773 1.00104.73 O \nANISOU 3708 O VAL B 152 13327 12508 13956 -1254 -1142 22 O \nATOM 3709 CB VAL B 152 -7.275 15.035 23.537 1.00 94.23 C \nANISOU 3709 CB VAL B 152 11798 11293 12713 -1362 -1065 44 C \nATOM 3710 CG1 VAL B 152 -7.206 14.974 25.048 1.00 93.55 C \nANISOU 3710 CG1 VAL B 152 11731 11193 12620 -1421 -1076 61 C \nATOM 3711 CG2 VAL B 152 -8.715 15.039 23.077 1.00 97.72 C \nANISOU 3711 CG2 VAL B 152 12048 11865 13216 -1317 -989 21 C \nATOM 3712 N ARG B 153 -7.418 17.182 20.932 1.00 91.08 N \nANISOU 3712 N ARG B 153 11441 10961 12203 -996 -1125 -60 N \nATOM 3713 CA ARG B 153 -7.578 17.319 19.484 1.00 90.87 C \nANISOU 3713 CA ARG B 153 11369 10988 12169 -929 -1112 -83 C \nATOM 3714 C ARG B 153 -6.400 18.020 18.838 1.00 98.16 C \nANISOU 3714 C ARG B 153 12517 11794 12987 -797 -1214 -108 C \nATOM 3715 O ARG B 153 -5.955 17.616 17.775 1.00 89.39 O \nANISOU 3715 O ARG B 153 11452 10631 11881 -828 -1217 -97 O \nATOM 3716 CB ARG B 153 -8.856 18.095 19.133 1.00 85.91 C \nANISOU 3716 CB ARG B 153 10542 10578 11521 -825 -1066 -130 C \nATOM 3717 CG ARG B 153 -10.151 17.382 19.506 1.00 78.37 C \nANISOU 3717 CG ARG B 153 9401 9727 10649 -977 -974 -102 C \nATOM 3718 CD ARG B 153 -11.333 18.013 18.802 1.00 79.98 C \nANISOU 3718 CD ARG B 153 9430 10154 10805 -941 -933 -135 C \nATOM 3719 NE ARG B 153 -12.520 18.124 19.647 1.00 83.23 N \nANISOU 3719 NE ARG B 153 9710 10699 11213 -1025 -890 -130 N \nATOM 3720 CZ ARG B 153 -12.951 19.254 20.207 1.00 89.55 C \nANISOU 3720 CZ ARG B 153 10427 11678 11919 -928 -907 -172 C \nATOM 3721 NH1 ARG B 153 -12.318 20.404 20.003 1.00 90.36 N \nANISOU 3721 NH1 ARG B 153 10563 11855 11914 -707 -971 -232 N \nATOM 3722 NH2 ARG B 153 -14.039 19.244 20.959 1.00 95.05 N \nANISOU 3722 NH2 ARG B 153 11013 12491 12610 -1043 -867 -159 N \nATOM 3723 N ASN B 154 -5.911 19.080 19.480 1.00111.76 N \nANISOU 3723 N ASN B 154 14397 13467 14598 -639 -1306 -146 N \nATOM 3724 CA ASN B 154 -4.820 19.904 18.920 1.00116.70 C \nANISOU 3724 CA ASN B 154 15297 13960 15083 -465 -1432 -184 C \nATOM 3725 C ASN B 154 -3.424 19.468 19.371 1.00111.68 C \nANISOU 3725 C ASN B 154 14977 13065 14390 -607 -1526 -131 C \nATOM 3726 O ASN B 154 -2.459 20.192 19.152 1.00113.71 O \nANISOU 3726 O ASN B 154 15538 13164 14500 -476 -1657 -157 O \nATOM 3727 CB ASN B 154 -5.037 21.387 19.264 1.00123.89 C \nANISOU 3727 CB ASN B 154 16247 14970 15857 -164 -1505 -270 C \nATOM 3728 CG ASN B 154 -5.278 21.609 20.742 1.00131.45 C \nANISOU 3728 CG ASN B 154 17196 15935 16814 -181 -1510 -265 C \nATOM 3729 OD1 ASN B 154 -5.199 20.661 21.515 1.00131.56 O \nANISOU 3729 OD1 ASN B 154 17196 15863 16926 -419 -1465 -196 O \nATOM 3730 ND2 ASN B 154 -5.619 22.842 21.150 1.00146.28 N \nANISOU 3730 ND2 ASN B 154 19058 17947 18574 78 -1561 -342 N \nATOM 3731 N GLY B 155 -3.327 18.309 20.025 1.00107.30 N \nANISOU 3731 N GLY B 155 14364 12480 13924 -874 -1468 -59 N \nATOM 3732 CA GLY B 155 -2.047 17.794 20.500 1.00102.99 C \nANISOU 3732 CA GLY B 155 14081 11747 13304 -1072 -1548 1 C \nATOM 3733 C GLY B 155 -1.567 18.419 21.804 1.00107.43 C \nANISOU 3733 C GLY B 155 14855 12197 13766 -1052 -1641 1 C \nATOM 3734 O GLY B 155 -0.710 17.866 22.491 1.00110.30 O \nANISOU 3734 O GLY B 155 15385 12450 14074 -1277 -1687 62 O \nATOM 3735 N THR B 156 -2.128 19.563 22.167 1.00106.71 N \nANISOU 3735 N THR B 156 14749 12158 13637 -792 -1669 -67 N \nATOM 3736 CA THR B 156 -1.684 20.299 23.326 1.00113.84 C \nANISOU 3736 CA THR B 156 15878 12948 14429 -720 -1771 -81 C \nATOM 3737 C THR B 156 -2.372 19.818 24.591 1.00104.06 C \nANISOU 3737 C THR B 156 14428 11815 13296 -853 -1683 -50 C \nATOM 3738 O THR B 156 -2.926 20.617 25.329 1.00 99.47 O \nANISOU 3738 O THR B 156 13797 11303 12694 -685 -1692 -96 O \nATOM 3739 CB THR B 156 -1.986 21.790 23.142 1.00125.14 C \nANISOU 3739 CB THR B 156 17375 14428 15744 -338 -1848 -182 C \nATOM 3740 OG1 THR B 156 -3.402 21.983 23.126 1.00126.62 O \nANISOU 3740 OG1 THR B 156 17173 14898 16038 -235 -1723 -223 O \nATOM 3741 CG2 THR B 156 -1.393 22.306 21.840 1.00125.91 C \nANISOU 3741 CG2 THR B 156 17669 14444 15727 -161 -1936 -225 C \nATOM 3742 N TYR B 157 -2.303 18.515 24.850 1.00105.53 N \nANISOU 3742 N TYR B 157 14494 12027 13574 -1142 -1605 23 N \nATOM 3743 CA TYR B 157 -2.951 17.908 26.017 1.00103.47 C \nANISOU 3743 CA TYR B 157 14032 11874 13409 -1270 -1520 52 C \nATOM 3744 C TYR B 157 -1.931 17.580 27.081 1.00109.24 C \nANISOU 3744 C TYR B 157 14981 12478 14048 -1475 -1595 108 C \nATOM 3745 O TYR B 157 -0.937 16.910 26.805 1.00126.83 O \nANISOU 3745 O TYR B 157 17357 14629 16205 -1689 -1636 163 O \nATOM 3746 CB TYR B 157 -3.693 16.630 25.614 1.00102.57 C \nANISOU 3746 CB TYR B 157 13617 11918 13439 -1416 -1385 82 C \nATOM 3747 CG TYR B 157 -4.063 15.689 26.766 1.00 93.08 C \nANISOU 3747 CG TYR B 157 12259 10804 12302 -1585 -1316 121 C \nATOM 3748 CD1 TYR B 157 -5.182 15.923 27.571 1.00 94.40 C \nANISOU 3748 CD1 TYR B 157 12252 11072 12545 -1504 -1256 97 C \nATOM 3749 CD2 TYR B 157 -3.308 14.562 27.030 1.00 87.90 C \nANISOU 3749 CD2 TYR B 157 11622 10160 11614 -1824 -1313 179 C \nATOM 3750 CE1 TYR B 157 -5.530 15.062 28.605 1.00 89.91 C \nANISOU 3750 CE1 TYR B 157 11556 10579 12026 -1636 -1201 127 C \nATOM 3751 CE2 TYR B 157 -3.642 13.691 28.063 1.00 88.90 C \nANISOU 3751 CE2 TYR B 157 11595 10402 11780 -1949 -1254 205 C \nATOM 3752 CZ TYR B 157 -4.758 13.947 28.848 1.00 92.77 C \nANISOU 3752 CZ TYR B 157 11935 10958 12354 -1843 -1200 177 C \nATOM 3753 OH TYR B 157 -5.082 13.090 29.868 1.00 82.10 O \nANISOU 3753 OH TYR B 157 10451 9715 11031 -1947 -1150 198 O \nATOM 3754 N ASP B 158 -2.187 18.034 28.305 1.00115.78 N \nANISOU 3754 N ASP B 158 15822 13305 14866 -1433 -1611 99 N \nATOM 3755 CA ASP B 158 -1.284 17.798 29.440 1.00117.31 C \nANISOU 3755 CA ASP B 158 16223 13389 14960 -1635 -1684 152 C \nATOM 3756 C ASP B 158 -1.642 16.503 30.170 1.00111.28 C \nANISOU 3756 C ASP B 158 15201 12788 14291 -1872 -1575 204 C \nATOM 3757 O ASP B 158 -2.622 16.446 30.904 1.00104.85 O \nANISOU 3757 O ASP B 158 14168 12092 13578 -1809 -1496 186 O \nATOM 3758 CB ASP B 158 -1.333 18.975 30.425 1.00120.05 C \nANISOU 3758 CB ASP B 158 16735 13647 15231 -1452 -1768 111 C \nATOM 3759 CG ASP B 158 -0.347 18.823 31.563 1.00121.57 C \nANISOU 3759 CG ASP B 158 17192 13702 15298 -1667 -1862 168 C \nATOM 3760 OD1 ASP B 158 0.861 18.681 31.271 1.00131.89 O \nANISOU 3760 OD1 ASP B 158 18813 14844 16456 -1837 -1970 213 O \nATOM 3761 OD2 ASP B 158 -0.781 18.847 32.733 1.00104.31 O \nANISOU 3761 OD2 ASP B 158 14909 11574 13151 -1682 -1830 171 O \nATOM 3762 N TYR B 159 -0.829 15.471 29.970 1.00115.67 N \nANISOU 3762 N TYR B 159 15790 13368 14791 -2138 -1577 265 N \nATOM 3763 CA TYR B 159 -1.030 14.175 30.631 1.00110.72 C \nANISOU 3763 CA TYR B 159 14923 12937 14210 -2348 -1487 306 C \nATOM 3764 C TYR B 159 -0.916 14.227 32.153 1.00114.36 C \nANISOU 3764 C TYR B 159 15421 13406 14626 -2445 -1510 329 C \nATOM 3765 O TYR B 159 -1.782 13.683 32.841 1.00109.13 O \nANISOU 3765 O TYR B 159 14501 12900 14062 -2427 -1416 319 O \nATOM 3766 CB TYR B 159 -0.059 13.117 30.061 1.00107.82 C \nANISOU 3766 CB TYR B 159 14581 12642 13743 -2618 -1497 362 C \nATOM 3767 CG TYR B 159 -0.101 11.783 30.795 1.00102.70 C \nANISOU 3767 CG TYR B 159 13693 12244 13084 -2826 -1422 397 C \nATOM 3768 CD1 TYR B 159 -1.009 10.781 30.413 1.00104.73 C \nANISOU 3768 CD1 TYR B 159 13623 12713 13458 -2755 -1302 371 C \nATOM 3769 CD2 TYR B 159 0.742 11.530 31.868 1.00 99.74 C \nANISOU 3769 CD2 TYR B 159 13429 11905 12562 -3078 -1479 449 C \nATOM 3770 CE1 TYR B 159 -1.067 9.565 31.075 1.00100.82 C \nANISOU 3770 CE1 TYR B 159 12909 12471 12927 -2891 -1243 387 C \nATOM 3771 CE2 TYR B 159 0.698 10.322 32.541 1.00100.39 C \nANISOU 3771 CE2 TYR B 159 13267 12267 12611 -3247 -1412 472 C \nATOM 3772 CZ TYR B 159 -0.207 9.344 32.145 1.00108.22 C \nANISOU 3772 CZ TYR B 159 13926 13478 13714 -3133 -1295 436 C \nATOM 3773 OH TYR B 159 -0.266 8.152 32.828 1.00102.80 O \nANISOU 3773 OH TYR B 159 13000 13090 12969 -3249 -1238 443 O \nATOM 3774 N PRO B 160 0.160 14.857 32.687 1.00125.57 N \nANISOU 3774 N PRO B 160 17185 14646 15880 -2551 -1643 359 N \nATOM 3775 CA PRO B 160 0.393 14.751 34.137 1.00123.16 C \nANISOU 3775 CA PRO B 160 16920 14362 15511 -2699 -1667 392 C \nATOM 3776 C PRO B 160 -0.665 15.368 35.031 1.00114.62 C \nANISOU 3776 C PRO B 160 15708 13296 14545 -2479 -1622 344 C \nATOM 3777 O PRO B 160 -0.774 14.966 36.192 1.00124.45 O \nANISOU 3777 O PRO B 160 16865 14631 15788 -2595 -1596 367 O \nATOM 3778 CB PRO B 160 1.746 15.451 34.345 1.00135.26 C \nANISOU 3778 CB PRO B 160 18920 15650 16824 -2838 -1841 430 C \nATOM 3779 CG PRO B 160 1.960 16.280 33.128 1.00135.33 C \nANISOU 3779 CG PRO B 160 19140 15474 16804 -2637 -1914 391 C \nATOM 3780 CD PRO B 160 1.269 15.558 32.010 1.00126.46 C \nANISOU 3780 CD PRO B 160 17689 14527 15832 -2575 -1786 371 C \nATOM 3781 N GLN B 161 -1.449 16.307 34.511 1.00108.02 N \nANISOU 3781 N GLN B 161 14843 12405 13795 -2179 -1611 278 N \nATOM 3782 CA GLN B 161 -2.532 16.908 35.312 1.00100.95 C \nANISOU 3782 CA GLN B 161 13797 11563 12995 -1983 -1564 231 C \nATOM 3783 C GLN B 161 -3.463 15.851 35.854 1.00 88.80 C \nANISOU 3783 C GLN B 161 11922 10232 11586 -2064 -1432 243 C \nATOM 3784 O GLN B 161 -3.802 15.868 37.017 1.00 81.01 O \nANISOU 3784 O GLN B 161 10877 9284 10617 -2080 -1416 246 O \nATOM 3785 CB GLN B 161 -3.358 17.902 34.490 1.00103.56 C \nANISOU 3785 CB GLN B 161 14066 11898 13385 -1678 -1550 158 C \nATOM 3786 CG GLN B 161 -3.584 19.232 35.172 1.00113.51 C \nANISOU 3786 CG GLN B 161 15445 13095 14589 -1452 -1619 105 C \nATOM 3787 CD GLN B 161 -4.569 20.078 34.410 1.00124.40 C \nANISOU 3787 CD GLN B 161 16669 14584 16014 -1173 -1583 29 C \nATOM 3788 OE1 GLN B 161 -5.065 19.673 33.363 1.00126.26 O \nANISOU 3788 OE1 GLN B 161 16730 14915 16326 -1166 -1509 22 O \nATOM 3789 NE2 GLN B 161 -4.861 21.266 34.932 1.00138.44 N \nANISOU 3789 NE2 GLN B 161 18504 16372 17725 -944 -1637 -30 N \nATOM 3790 N TYR B 162 -3.865 14.929 34.983 1.00 90.04 N \nANISOU 3790 N TYR B 162 11878 10513 11821 -2098 -1348 246 N \nATOM 3791 CA TYR B 162 -4.897 13.942 35.317 1.00 92.00 C \nANISOU 3791 CA TYR B 162 11833 10945 12180 -2111 -1234 241 C \nATOM 3792 C TYR B 162 -4.283 12.619 35.713 1.00 91.93 C \nANISOU 3792 C TYR B 162 11750 11071 12107 -2338 -1214 287 C \nATOM 3793 O TYR B 162 -5.002 11.632 35.887 1.00 91.05 O \nANISOU 3793 O TYR B 162 11416 11125 12055 -2335 -1133 277 O \nATOM 3794 CB TYR B 162 -5.862 13.740 34.127 1.00 87.66 C \nANISOU 3794 CB TYR B 162 11117 10456 11734 -1979 -1160 206 C \nATOM 3795 CG TYR B 162 -6.291 15.034 33.482 1.00 82.13 C \nANISOU 3795 CG TYR B 162 10478 9674 11053 -1778 -1186 161 C \nATOM 3796 CD1 TYR B 162 -5.584 15.539 32.394 1.00 79.70 C \nANISOU 3796 CD1 TYR B 162 10325 9272 10687 -1730 -1245 153 C \nATOM 3797 CD2 TYR B 162 -7.368 15.782 33.975 1.00 76.02 C \nANISOU 3797 CD2 TYR B 162 9609 8944 10330 -1636 -1157 123 C \nATOM 3798 CE1 TYR B 162 -5.942 16.727 31.803 1.00 81.70 C \nANISOU 3798 CE1 TYR B 162 10620 9493 10929 -1520 -1274 102 C \nATOM 3799 CE2 TYR B 162 -7.724 16.986 33.388 1.00 71.71 C \nANISOU 3799 CE2 TYR B 162 9090 8390 9765 -1450 -1184 75 C \nATOM 3800 CZ TYR B 162 -7.010 17.441 32.306 1.00 77.27 C \nANISOU 3800 CZ TYR B 162 9933 9017 10407 -1380 -1241 61 C \nATOM 3801 OH TYR B 162 -7.334 18.613 31.686 1.00 87.56 O \nANISOU 3801 OH TYR B 162 11249 10352 11667 -1170 -1271 4 O \nATOM 3802 N SER B 163 -2.962 12.620 35.882 1.00 97.10 N \nANISOU 3802 N SER B 163 12607 11670 12616 -2535 -1299 333 N \nATOM 3803 CA SER B 163 -2.211 11.397 36.146 1.00101.40 C \nANISOU 3803 CA SER B 163 13079 12396 13052 -2791 -1290 379 C \nATOM 3804 C SER B 163 -2.757 10.538 37.270 1.00 98.66 C \nANISOU 3804 C SER B 163 12504 12259 12722 -2826 -1223 377 C \nATOM 3805 O SER B 163 -3.210 9.420 37.015 1.00 96.90 O \nANISOU 3805 O SER B 163 12049 12246 12523 -2810 -1148 360 O \nATOM 3806 CB SER B 163 -0.760 11.727 36.405 1.00114.14 C \nANISOU 3806 CB SER B 163 14989 13903 14476 -3034 -1408 437 C \nATOM 3807 OG SER B 163 -0.205 12.271 35.232 1.00124.34 O \nANISOU 3807 OG SER B 163 16488 15026 15729 -3008 -1472 438 O \nATOM 3808 N GLU B 164 -2.720 11.052 38.500 1.00101.48 N \nANISOU 3808 N GLU B 164 12940 12561 13056 -2854 -1257 387 N \nATOM 3809 CA GLU B 164 -3.113 10.242 39.661 1.00104.22 C \nANISOU 3809 CA GLU B 164 13091 13113 13397 -2903 -1204 387 C \nATOM 3810 C GLU B 164 -4.613 10.117 39.775 1.00 94.06 C \nANISOU 3810 C GLU B 164 11606 11860 12272 -2658 -1119 332 C \nATOM 3811 O GLU B 164 -5.126 9.097 40.232 1.00 81.75 O \nANISOU 3811 O GLU B 164 9845 10503 10713 -2640 -1061 315 O \nATOM 3812 CB GLU B 164 -2.502 10.753 40.969 1.00111.34 C \nANISOU 3812 CB GLU B 164 14148 13954 14201 -3045 -1272 422 C \nATOM 3813 CG GLU B 164 -2.959 12.111 41.458 1.00110.60 C \nANISOU 3813 CG GLU B 164 14213 13622 14187 -2871 -1311 399 C \nATOM 3814 CD GLU B 164 -2.183 12.541 42.694 1.00110.77 C \nANISOU 3814 CD GLU B 164 14427 13577 14085 -3036 -1393 439 C \nATOM 3815 OE1 GLU B 164 -1.241 11.829 43.098 1.00104.47 O \nANISOU 3815 OE1 GLU B 164 13655 12909 13128 -3317 -1424 492 O \nATOM 3816 OE2 GLU B 164 -2.506 13.595 43.264 1.00119.28 O \nANISOU 3816 OE2 GLU B 164 15629 14487 15203 -2895 -1430 417 O \nATOM 3817 N GLU B 165 -5.313 11.160 39.344 1.00 96.92 N \nANISOU 3817 N GLU B 165 12040 12039 12747 -2471 -1120 301 N \nATOM 3818 CA GLU B 165 -6.765 11.086 39.154 1.00 89.62 C \nANISOU 3818 CA GLU B 165 10958 11137 11956 -2274 -1047 255 C \nATOM 3819 C GLU B 165 -7.113 9.849 38.338 1.00 89.16 C \nANISOU 3819 C GLU B 165 10742 11227 11907 -2253 -991 240 C \nATOM 3820 O GLU B 165 -7.973 9.062 38.746 1.00 88.52 O \nANISOU 3820 O GLU B 165 10520 11260 11854 -2179 -943 214 O \nATOM 3821 CB GLU B 165 -7.283 12.332 38.446 1.00 87.19 C \nANISOU 3821 CB GLU B 165 10736 10670 11724 -2116 -1061 227 C \nATOM 3822 CG GLU B 165 -8.802 12.351 38.308 1.00 86.71 C \nANISOU 3822 CG GLU B 165 10535 10641 11770 -1968 -995 189 C \nATOM 3823 CD GLU B 165 -9.329 13.718 37.901 1.00 82.35 C \nANISOU 3823 CD GLU B 165 10036 9997 11255 -1833 -1011 160 C \nATOM 3824 OE1 GLU B 165 -8.534 14.699 38.025 1.00 85.48 O \nANISOU 3824 OE1 GLU B 165 10588 10297 11594 -1814 -1080 162 O \nATOM 3825 OE2 GLU B 165 -10.510 13.793 37.436 1.00 70.91 O \nANISOU 3825 OE2 GLU B 165 8487 8588 9868 -1750 -963 135 O \nATOM 3826 N ALA B 166 -6.409 9.669 37.209 1.00 85.87 N \nANISOU 3826 N ALA B 166 10370 10805 11450 -2311 -1007 252 N \nATOM 3827 CA ALA B 166 -6.627 8.515 36.338 1.00 82.20 C \nANISOU 3827 CA ALA B 166 9769 10486 10978 -2284 -962 235 C \nATOM 3828 C ALA B 166 -6.259 7.236 37.046 1.00 93.58 C \nANISOU 3828 C ALA B 166 11068 12183 12307 -2378 -947 239 C \nATOM 3829 O ALA B 166 -6.966 6.229 36.904 1.00 80.36 O \nANISOU 3829 O ALA B 166 9247 10654 10632 -2262 -903 201 O \nATOM 3830 CB ALA B 166 -5.830 8.644 35.061 1.00 94.15 C \nANISOU 3830 CB ALA B 166 11368 11947 12459 -2346 -988 252 C \nATOM 3831 N ARG B 167 -5.153 7.288 37.806 1.00105.09 N \nANISOU 3831 N ARG B 167 12580 13704 13643 -2584 -991 283 N \nATOM 3832 CA ARG B 167 -4.617 6.124 38.508 1.00111.52 C \nANISOU 3832 CA ARG B 167 13243 14823 14306 -2717 -983 291 C \nATOM 3833 C ARG B 167 -5.545 5.740 39.647 1.00105.14 C \nANISOU 3833 C ARG B 167 12310 14110 13529 -2586 -948 255 C \nATOM 3834 O ARG B 167 -5.899 4.569 39.836 1.00 98.24 O \nANISOU 3834 O ARG B 167 11252 13487 12587 -2503 -914 216 O \nATOM 3835 CB ARG B 167 -3.176 6.432 39.017 1.00125.47 C \nANISOU 3835 CB ARG B 167 15145 16614 15915 -3022 -1052 357 C \nATOM 3836 CG ARG B 167 -2.829 6.013 40.451 1.00128.64 C \nANISOU 3836 CG ARG B 167 15469 17217 16193 -3168 -1062 376 C \nATOM 3837 CD ARG B 167 -1.449 6.524 40.882 1.00133.01 C \nANISOU 3837 CD ARG B 167 16231 17722 16583 -3494 -1149 450 C \nATOM 3838 NE ARG B 167 -1.486 7.576 41.913 1.00137.27 N \nANISOU 3838 NE ARG B 167 16957 18036 17164 -3502 -1196 469 N \nATOM 3839 CZ ARG B 167 -0.516 8.465 42.150 1.00134.83 C \nANISOU 3839 CZ ARG B 167 16947 17523 16758 -3696 -1295 524 C \nATOM 3840 NH1 ARG B 167 0.581 8.505 41.402 1.00132.96 N \nANISOU 3840 NH1 ARG B 167 16890 17248 16381 -3917 -1364 572 N \nATOM 3841 NH2 ARG B 167 -0.661 9.356 43.130 1.00135.91 N \nANISOU 3841 NH2 ARG B 167 17234 17475 16929 -3660 -1335 529 N \nATOM 3842 N LEU B 168 -5.946 6.753 40.392 1.00101.37 N \nANISOU 3842 N LEU B 168 11943 13431 13142 -2549 -963 262 N \nATOM 3843 CA LEU B 168 -6.768 6.532 41.575 1.00112.46 C \nANISOU 3843 CA LEU B 168 13260 14894 14573 -2449 -938 236 C \nATOM 3844 C LEU B 168 -8.163 6.026 41.204 1.00112.53 C \nANISOU 3844 C LEU B 168 13186 14898 14672 -2205 -893 178 C \nATOM 3845 O LEU B 168 -8.737 5.190 41.897 1.00105.93 O \nANISOU 3845 O LEU B 168 12240 14214 13792 -2105 -875 142 O \nATOM 3846 CB LEU B 168 -6.871 7.811 42.408 1.00110.49 C \nANISOU 3846 CB LEU B 168 13157 14428 14395 -2467 -968 257 C \nATOM 3847 CG LEU B 168 -7.293 7.636 43.861 1.00109.42 C \nANISOU 3847 CG LEU B 168 12954 14374 14247 -2450 -959 248 C \nATOM 3848 CD1 LEU B 168 -6.491 6.547 44.579 1.00105.70 C \nANISOU 3848 CD1 LEU B 168 12352 14206 13603 -2603 -962 261 C \nATOM 3849 CD2 LEU B 168 -7.163 8.979 44.571 1.00112.51 C \nANISOU 3849 CD2 LEU B 168 13511 14552 14687 -2487 -1000 273 C \nATOM 3850 N LYS B 169 -8.691 6.517 40.089 1.00113.05 N \nANISOU 3850 N LYS B 169 13324 14789 14840 -2112 -884 168 N \nATOM 3851 CA LYS B 169 -10.016 6.107 39.670 1.00111.73 C \nANISOU 3851 CA LYS B 169 13130 14584 14736 -1918 -855 122 C \nATOM 3852 C LYS B 169 -9.968 4.857 38.818 1.00 98.81 C \nANISOU 3852 C LYS B 169 11405 13116 13023 -1845 -844 90 C \nATOM 3853 O LYS B 169 -11.008 4.296 38.482 1.00 78.70 O \nANISOU 3853 O LYS B 169 8862 10552 10489 -1675 -835 47 O \nATOM 3854 CB LYS B 169 -10.685 7.233 38.926 1.00129.65 C \nANISOU 3854 CB LYS B 169 15509 16623 17129 -1869 -853 125 C \nATOM 3855 CG LYS B 169 -12.217 7.169 38.877 1.00135.70 C \nANISOU 3855 CG LYS B 169 16298 17307 17953 -1728 -836 92 C \nATOM 3856 CD LYS B 169 -12.678 7.475 37.455 1.00136.78 C \nANISOU 3856 CD LYS B 169 16486 17341 18143 -1688 -828 87 C \nATOM 3857 CE LYS B 169 -11.555 8.122 36.613 1.00149.44 C \nANISOU 3857 CE LYS B 169 18112 18911 19757 -1775 -837 114 C \nATOM 3858 NZ LYS B 169 -11.061 9.519 36.897 1.00152.65 N \nANISOU 3858 NZ LYS B 169 18592 19212 20196 -1832 -861 137 N \nATOM 3859 N ARG B 170 -8.751 4.432 38.477 1.00108.66 N \nANISOU 3859 N ARG B 170 12591 14527 14169 -1980 -852 112 N \nATOM 3860 CA ARG B 170 -8.509 3.125 37.866 1.00110.81 C \nANISOU 3860 CA ARG B 170 12734 15046 14321 -1924 -843 78 C \nATOM 3861 C ARG B 170 -8.632 2.155 39.024 1.00113.36 C \nANISOU 3861 C ARG B 170 12921 15634 14518 -1857 -843 42 C \nATOM 3862 O ARG B 170 -9.404 1.200 39.002 1.00 97.24 O \nANISOU 3862 O ARG B 170 10821 13706 12419 -1641 -841 -21 O \nATOM 3863 CB ARG B 170 -7.097 3.074 37.311 1.00116.30 C \nANISOU 3863 CB ARG B 170 13404 15862 14922 -2141 -857 122 C \nATOM 3864 CG ARG B 170 -6.829 2.073 36.198 1.00122.90 C \nANISOU 3864 CG ARG B 170 14139 16887 15669 -2096 -846 95 C \nATOM 3865 CD ARG B 170 -5.383 2.244 35.718 1.00120.96 C \nANISOU 3865 CD ARG B 170 13909 16721 15329 -2368 -869 153 C \nATOM 3866 NE ARG B 170 -5.126 3.635 35.302 1.00114.11 N \nANISOU 3866 NE ARG B 170 13257 15513 14586 -2463 -895 202 N \nATOM 3867 CZ ARG B 170 -3.941 4.251 35.333 1.00106.97 C \nANISOU 3867 CZ ARG B 170 12478 14552 13613 -2711 -942 263 C \nATOM 3868 NH1 ARG B 170 -2.850 3.607 35.738 1.00118.29 N \nANISOU 3868 NH1 ARG B 170 13840 16255 14851 -2949 -965 296 N \nATOM 3869 NH2 ARG B 170 -3.838 5.516 34.940 1.00 89.09 N \nANISOU 3869 NH2 ARG B 170 10426 11973 11450 -2723 -976 289 N \nATOM 3870 N GLU B 171 -7.896 2.479 40.082 1.00121.18 N \nANISOU 3870 N GLU B 171 13886 16703 15455 -2036 -854 81 N \nATOM 3871 CA GLU B 171 -7.835 1.674 41.299 1.00124.58 C \nANISOU 3871 CA GLU B 171 14172 17415 15748 -2014 -855 54 C \nATOM 3872 C GLU B 171 -9.176 1.473 42.013 1.00119.60 C \nANISOU 3872 C GLU B 171 13565 16707 15171 -1767 -852 -1 C \nATOM 3873 O GLU B 171 -9.271 0.626 42.905 1.00117.57 O \nANISOU 3873 O GLU B 171 13183 16704 14783 -1679 -857 -42 O \nATOM 3874 CB GLU B 171 -6.781 2.253 42.250 1.00124.14 C \nANISOU 3874 CB GLU B 171 14130 17405 15633 -2293 -874 118 C \nATOM 3875 CG GLU B 171 -5.359 2.060 41.729 1.00123.69 C \nANISOU 3875 CG GLU B 171 14038 17529 15431 -2565 -893 167 C \nATOM 3876 CD GLU B 171 -4.345 3.006 42.347 1.00127.80 C \nANISOU 3876 CD GLU B 171 14703 17934 15920 -2866 -936 246 C \nATOM 3877 OE1 GLU B 171 -3.305 3.263 41.702 1.00120.67 O \nANISOU 3877 OE1 GLU B 171 13894 17012 14944 -3092 -970 298 O \nATOM 3878 OE2 GLU B 171 -4.584 3.490 43.479 1.00134.50 O \nANISOU 3878 OE2 GLU B 171 15598 18701 16805 -2875 -945 256 O \nATOM 3879 N GLU B 172 -10.207 2.217 41.620 1.00114.44 N \nANISOU 3879 N GLU B 172 13071 15727 14683 -1662 -850 -2 N \nATOM 3880 CA GLU B 172 -11.576 1.840 42.004 1.00120.28 C \nANISOU 3880 CA GLU B 172 13871 16388 15441 -1426 -860 -57 C \nATOM 3881 C GLU B 172 -11.980 0.469 41.445 1.00130.81 C \nANISOU 3881 C GLU B 172 15154 17906 16642 -1193 -877 -132 C \nATOM 3882 O GLU B 172 -12.780 -0.227 42.069 1.00140.19 O \nANISOU 3882 O GLU B 172 16363 19152 17752 -986 -904 -191 O \nATOM 3883 CB GLU B 172 -12.623 2.867 41.599 1.00120.43 C \nANISOU 3883 CB GLU B 172 14073 16058 15628 -1399 -860 -40 C \nATOM 3884 CG GLU B 172 -13.979 2.587 42.250 1.00115.79 C \nANISOU 3884 CG GLU B 172 13584 15378 15035 -1222 -883 -82 C \nATOM 3885 CD GLU B 172 -14.975 3.726 42.141 1.00115.78 C \nANISOU 3885 CD GLU B 172 13741 15081 15169 -1264 -883 -55 C \nATOM 3886 OE1 GLU B 172 -14.632 4.864 42.518 1.00117.91 O \nANISOU 3886 OE1 GLU B 172 14006 15265 15530 -1412 -865 -8 O \nATOM 3887 OE2 GLU B 172 -16.117 3.478 41.707 1.00109.89 O \nANISOU 3887 OE2 GLU B 172 13134 14204 14416 -1150 -908 -81 O \nATOM 3888 N ILE B 173 -11.454 0.097 40.274 1.00135.17 N \nANISOU 3888 N ILE B 173 15660 18540 17159 -1208 -870 -134 N \nATOM 3889 CA ILE B 173 -11.692 -1.247 39.713 1.00139.98 C \nANISOU 3889 CA ILE B 173 16206 19366 17613 -973 -891 -212 C \nATOM 3890 C ILE B 173 -10.742 -2.280 40.337 1.00135.43 C \nANISOU 3890 C ILE B 173 15382 19258 16817 -976 -891 -245 C \nATOM 3891 O ILE B 173 -11.094 -2.977 41.296 1.00130.50 O \nANISOU 3891 O ILE B 173 14693 18823 16066 -807 -913 -302 O \nATOM 3892 CB ILE B 173 -11.610 -1.295 38.160 1.00136.68 C \nANISOU 3892 CB ILE B 173 15836 18861 17235 -965 -886 -208 C \nATOM 3893 CG1 ILE B 173 -12.147 -2.633 37.623 1.00137.36 C \nANISOU 3893 CG1 ILE B 173 15916 19111 17165 -662 -923 -300 C \nATOM 3894 CG2 ILE B 173 -10.198 -1.099 37.640 1.00140.38 C \nANISOU 3894 CG2 ILE B 173 16173 19486 17680 -1212 -858 -155 C \nATOM 3895 CD1 ILE B 173 -13.595 -2.902 37.977 1.00135.00 C \nANISOU 3895 CD1 ILE B 173 15823 18615 16856 -405 -975 -355 C \nTER 3896 ILE B 173 \nHETATM 3897 C1 NAG A 401 5.710 29.828 -66.680 1.00 83.68 C \nHETATM 3898 C2 NAG A 401 6.838 30.852 -66.364 1.00 90.43 C \nHETATM 3899 C3 NAG A 401 8.287 30.302 -66.439 1.00 98.70 C \nHETATM 3900 C4 NAG A 401 8.435 28.818 -66.142 1.00 98.24 C \nHETATM 3901 C5 NAG A 401 7.281 28.111 -66.848 1.00 96.14 C \nHETATM 3902 C6 NAG A 401 7.291 26.597 -66.749 1.00 96.77 C \nHETATM 3903 C7 NAG A 401 7.607 32.954 -67.433 1.00 96.37 C \nHETATM 3904 C8 NAG A 401 7.309 33.990 -68.484 1.00 91.89 C \nHETATM 3905 N2 NAG A 401 6.719 31.948 -67.319 1.00 98.43 N \nHETATM 3906 O3 NAG A 401 9.163 30.987 -65.565 1.00109.88 O \nHETATM 3907 O4 NAG A 401 9.699 28.413 -66.614 1.00 88.78 O \nHETATM 3908 O5 NAG A 401 6.107 28.559 -66.215 1.00 93.39 O \nHETATM 3909 O6 NAG A 401 6.980 26.209 -68.069 1.00 86.27 O \nHETATM 3910 O7 NAG A 401 8.616 33.063 -66.729 1.00 82.71 O \nHETATM 3911 C1 NAG B 201 -5.683 24.123 20.478 1.00139.78 C \nHETATM 3912 C2 NAG B 201 -6.197 25.123 19.448 1.00152.91 C \nHETATM 3913 C3 NAG B 201 -5.016 25.970 18.949 1.00145.45 C \nHETATM 3914 C4 NAG B 201 -4.206 26.564 20.111 1.00144.30 C \nHETATM 3915 C5 NAG B 201 -3.892 25.490 21.154 1.00151.00 C \nHETATM 3916 C6 NAG B 201 -3.213 26.015 22.425 1.00150.19 C \nHETATM 3917 C7 NAG B 201 -7.956 24.853 17.716 1.00154.15 C \nHETATM 3918 C8 NAG B 201 -8.474 23.983 16.601 1.00138.57 C \nHETATM 3919 N2 NAG B 201 -6.846 24.425 18.344 1.00167.86 N \nHETATM 3920 O3 NAG B 201 -5.485 26.995 18.095 1.00132.58 O \nHETATM 3921 O4 NAG B 201 -3.023 27.182 19.647 1.00138.55 O \nHETATM 3922 O5 NAG B 201 -5.164 24.970 21.495 1.00150.86 O \nHETATM 3923 O6 NAG B 201 -3.194 25.024 23.442 1.00134.09 O \nHETATM 3924 O7 NAG B 201 -8.562 25.891 17.996 1.00142.23 O \nHETATM 3925 O HOH A 501 -6.376 6.072 -54.237 1.00 31.99 O \nHETATM 3926 O HOH A 502 -5.482 10.458 -60.932 1.00 31.51 O \nHETATM 3927 O HOH A 503 -7.641 4.376 -68.956 1.00 32.53 O \nHETATM 3928 O HOH A 504 -5.594 11.918 -86.140 1.00 46.03 O \nHETATM 3929 O HOH A 505 -6.060 17.342 -41.933 1.00 48.80 O \nHETATM 3930 O HOH A 506 -19.855 12.646 -6.059 1.00 55.30 O \nHETATM 3931 O HOH A 507 -18.044 22.939 -58.123 1.00 53.39 O \nHETATM 3932 O HOH A 508 2.452 20.479 -53.601 1.00 57.16 O \nHETATM 3933 O HOH A 509 -1.266 5.324 -49.620 1.00 19.76 O \nHETATM 3934 O HOH A 510 -2.873 12.164 -51.498 1.00 30.40 O \nHETATM 3935 O HOH A 511 -10.753 24.127 -80.663 1.00 46.19 O \nHETATM 3936 O HOH A 512 -4.259 3.646 -71.495 1.00 53.73 O \nHETATM 3937 O HOH A 513 -0.824 15.308 -43.271 1.00 49.29 O \nHETATM 3938 O HOH A 514 -6.690 7.680 -85.354 1.00 45.37 O \nHETATM 3939 O HOH A 515 -6.855 1.950 -83.670 1.00 31.59 O \nHETATM 3940 O HOH A 516 3.406 20.462 -60.468 1.00 24.07 O \nHETATM 3941 O HOH A 517 -6.918 3.732 -70.839 1.00 33.39 O \nHETATM 3942 O HOH A 518 -10.262 1.708 -66.919 1.00 48.02 O \nHETATM 3943 O HOH A 519 -8.111 2.891 -79.177 1.00 30.05 O \nHETATM 3944 O HOH A 520 -22.135 6.961 -54.297 1.00 59.15 O \nHETATM 3945 O HOH A 521 -3.412 10.410 -59.558 1.00 31.17 O \nHETATM 3946 O HOH A 522 -6.744 4.470 -58.475 1.00 62.33 O \nHETATM 3947 O HOH A 523 -9.072 -1.001 -77.759 1.00 39.73 O \nHETATM 3948 O HOH A 524 -2.999 5.512 -79.745 1.00 39.76 O \nHETATM 3949 O HOH A 525 -9.469 4.803 -56.488 1.00 54.88 O \nHETATM 3950 O HOH A 526 2.903 12.699 -72.184 1.00 56.61 O \nHETATM 3951 O HOH A 527 -21.670 22.982 -46.407 1.00 59.63 O \nHETATM 3952 O HOH A 528 -8.981 5.396 -80.075 1.00 69.83 O \nHETATM 3953 O HOH A 529 -17.635 8.906 -52.670 1.00 62.21 O \nHETATM 3954 O HOH A 530 -15.792 7.875 35.056 1.00 54.80 O \nHETATM 3955 O HOH A 531 -25.725 7.243 -57.881 1.00 80.59 O \nHETATM 3956 O HOH A 532 -18.258 25.778 -44.042 1.00 54.44 O \nHETATM 3957 O HOH A 533 -15.646 30.365 -70.831 1.00 64.06 O \nHETATM 3958 O HOH A 534 3.583 9.983 -65.090 1.00 49.74 O \nHETATM 3959 O HOH A 535 -0.654 29.551 -68.898 1.00 76.55 O \nHETATM 3960 O HOH A 536 0.877 16.350 -73.586 1.00 57.63 O \nHETATM 3961 O HOH A 537 -2.646 12.420 -58.992 1.00 52.13 O \nHETATM 3962 O HOH A 538 -11.543 1.252 -64.661 1.00 59.98 O \nHETATM 3963 O HOH A 539 -15.785 16.827 -16.014 1.00 57.50 O \nHETATM 3964 O HOH B 301 -11.165 -4.912 -42.737 1.00 32.60 O \nHETATM 3965 O HOH B 302 -12.429 1.828 -46.582 1.00 29.21 O \nHETATM 3966 O HOH B 303 -10.813 1.544 21.045 1.00 46.54 O \nHETATM 3967 O HOH B 304 -16.874 7.370 11.821 1.00 48.88 O \nHETATM 3968 O HOH B 305 -10.477 -5.437 -44.863 1.00 42.66 O \nHETATM 3969 O HOH B 306 -11.998 2.215 -44.178 1.00 37.94 O \nHETATM 3970 O HOH B 307 -9.726 0.188 2.088 1.00 36.93 O \nHETATM 3971 O HOH B 308 -2.193 0.549 -52.116 1.00 23.26 O \nHETATM 3972 O HOH B 309 -10.245 1.209 -42.204 1.00 55.67 O \nHETATM 3973 O HOH B 310 -6.008 20.128 12.617 1.00 58.09 O \nHETATM 3974 O HOH B 311 0.000 0.000 -21.930 0.33 55.81 O \nHETATM 3975 O HOH B 312 -19.179 19.569 25.208 1.00 76.02 O \nHETATM 3976 O HOH B 313 -3.455 13.837 38.528 1.00 74.49 O \nHETATM 3977 O HOH B 314 1.040 16.973 7.576 1.00 67.10 O \nHETATM 3978 O HOH B 315 -16.540 16.312 19.677 1.00 66.83 O \nHETATM 3979 O HOH B 316 -11.340 -7.290 -46.099 1.00 84.95 O \nHETATM 3980 O HOH B 317 -11.847 -2.451 -42.559 1.00 51.73 O \nHETATM 3981 O HOH B 318 0.000 0.000 -18.054 0.33 75.84 O \nENDMDL \nMODEL 3 \nATOM 1 N PRO A -1 4.750 -21.816 33.812 1.00108.74 N \nANISOU 1 N PRO A -1 13644 13962 13711 -3983 -1018 181 N \nATOM 2 CA PRO A -1 4.797 -20.572 33.040 1.00107.88 C \nANISOU 2 CA PRO A -1 13518 13817 13656 -3861 -1014 198 C \nATOM 3 C PRO A -1 3.427 -19.863 33.107 1.00112.82 C \nANISOU 3 C PRO A -1 14031 14488 14346 -3841 -1113 272 C \nATOM 4 O PRO A -1 2.864 -19.757 34.202 1.00118.90 O \nANISOU 4 O PRO A -1 14761 15326 15088 -3913 -1170 308 O \nATOM 5 CB PRO A -1 5.124 -21.075 31.636 1.00101.66 C \nANISOU 5 CB PRO A -1 12763 12951 12912 -3793 -964 163 C \nATOM 6 CG PRO A -1 4.339 -22.356 31.560 1.00104.61 C \nANISOU 6 CG PRO A -1 13094 13350 13303 -3869 -1001 171 C \nATOM 7 CD PRO A -1 4.398 -22.964 32.955 1.00106.32 C \nANISOU 7 CD PRO A -1 13326 13631 13440 -3997 -1015 167 C \nATOM 8 N GLY A 0 2.903 -19.380 31.973 1.00102.11 N \nANISOU 8 N GLY A 0 12632 13095 13071 -3746 -1132 293 N \nATOM 9 CA GLY A 0 1.526 -18.893 31.903 1.00 89.42 C \nANISOU 9 CA GLY A 0 10930 11519 11529 -3726 -1226 361 C \nATOM 10 C GLY A 0 0.904 -19.276 30.578 1.00 79.86 C \nANISOU 10 C GLY A 0 9680 10264 10401 -3657 -1239 366 C \nATOM 11 O GLY A 0 1.610 -19.627 29.641 1.00 73.60 O \nANISOU 11 O GLY A 0 8934 9413 9619 -3611 -1172 320 O \nATOM 12 N ASP A 1 -0.423 -19.206 30.515 1.00 76.06 N \nANISOU 12 N ASP A 1 9117 9808 9973 -3648 -1324 421 N \nATOM 13 CA ASP A 1 -1.164 -19.578 29.313 1.00 76.02 C \nANISOU 13 CA ASP A 1 9067 9771 10046 -3582 -1346 430 C \nATOM 14 C ASP A 1 -0.840 -18.611 28.209 1.00 72.75 C \nANISOU 14 C ASP A 1 8670 9292 9681 -3475 -1313 423 C \nATOM 15 O ASP A 1 -0.449 -17.474 28.463 1.00 79.13 O \nANISOU 15 O ASP A 1 9497 10097 10471 -3450 -1304 433 O \nATOM 16 CB ASP A 1 -2.680 -19.586 29.566 1.00 76.89 C \nANISOU 16 CB ASP A 1 9092 9925 10199 -3584 -1449 495 C \nATOM 17 CG ASP A 1 -3.087 -20.492 30.712 1.00 77.18 C \nANISOU 17 CG ASP A 1 9101 10039 10185 -3688 -1489 509 C \nATOM 18 OD1 ASP A 1 -2.317 -21.416 31.093 1.00 79.02 O \nANISOU 18 OD1 ASP A 1 9375 10290 10361 -3763 -1437 463 O \nATOM 19 OD2 ASP A 1 -4.192 -20.277 31.224 1.00 76.73 O \nANISOU 19 OD2 ASP A 1 8986 10024 10142 -3696 -1573 566 O \nATOM 20 N GLN A 2 -1.029 -19.058 26.977 1.00 73.15 N \nANISOU 20 N GLN A 2 8707 9298 9789 -3414 -1298 407 N \nATOM 21 CA GLN A 2 -0.662 -18.269 25.812 1.00 68.19 C \nANISOU 21 CA GLN A 2 8096 8606 9206 -3312 -1260 395 C \nATOM 22 C GLN A 2 -1.670 -18.375 24.695 1.00 65.93 C \nANISOU 22 C GLN A 2 7752 8293 9004 -3243 -1301 418 C \nATOM 23 O GLN A 2 -2.186 -19.452 24.441 1.00 72.46 O \nANISOU 23 O GLN A 2 8547 9134 9850 -3264 -1318 413 O \nATOM 24 CB GLN A 2 0.699 -18.727 25.288 1.00 67.85 C \nANISOU 24 CB GLN A 2 8133 8516 9130 -3299 -1160 329 C \nATOM 25 CG GLN A 2 1.873 -18.223 26.117 1.00 69.48 C \nANISOU 25 CG GLN A 2 8410 8731 9258 -3326 -1106 302 C \nATOM 26 CD GLN A 2 3.197 -18.437 25.426 1.00 65.59 C \nANISOU 26 CD GLN A 2 8003 8178 8739 -3282 -1008 241 C \nATOM 27 OE1 GLN A 2 3.255 -18.604 24.205 1.00 59.84 O \nANISOU 27 OE1 GLN A 2 7279 7399 8061 -3215 -981 225 O \nATOM 28 NE2 GLN A 2 4.270 -18.468 26.210 1.00 66.69 N \nANISOU 28 NE2 GLN A 2 8217 8324 8798 -3321 -953 206 N \nATOM 29 N ILE A 3 -1.905 -17.269 23.994 1.00 63.89 N \nANISOU 29 N ILE A 3 7482 8001 8793 -3162 -1313 439 N \nATOM 30 CA ILE A 3 -2.544 -17.324 22.689 1.00 60.05 C \nANISOU 30 CA ILE A 3 6961 7472 8383 -3081 -1327 445 C \nATOM 31 C ILE A 3 -1.625 -16.691 21.677 1.00 60.33 C \nANISOU 31 C ILE A 3 7039 7450 8432 -3006 -1257 411 C \nATOM 32 O ILE A 3 -0.933 -15.734 21.989 1.00 63.82 O \nANISOU 32 O ILE A 3 7515 7895 8840 -2996 -1229 409 O \nATOM 33 CB ILE A 3 -3.954 -16.697 22.695 1.00 57.90 C \nANISOU 33 CB ILE A 3 6627 7209 8161 -3052 -1421 507 C \nATOM 34 CG1 ILE A 3 -4.733 -17.188 21.484 1.00 57.67 C \nANISOU 34 CG1 ILE A 3 6557 7149 8205 -2984 -1439 508 C \nATOM 35 CG2 ILE A 3 -3.884 -15.176 22.699 1.00 58.66 C \nANISOU 35 CG2 ILE A 3 6737 7290 8259 -3016 -1431 534 C \nATOM 36 CD1 ILE A 3 -6.223 -17.122 21.654 1.00 56.73 C \nANISOU 36 CD1 ILE A 3 6379 7050 8126 -2969 -1535 564 C \nATOM 37 N CYS A 4 -1.647 -17.203 20.451 1.00 66.68 N \nANISOU 37 N CYS A 4 7838 8211 9285 -2950 -1229 387 N \nATOM 38 CA CYS A 4 -0.781 -16.684 19.354 1.00 68.22 C \nANISOU 38 CA CYS A 4 8074 8351 9496 -2871 -1161 354 C \nATOM 39 C CYS A 4 -1.553 -16.356 18.070 1.00 66.44 C \nANISOU 39 C CYS A 4 7806 8088 9352 -2786 -1186 371 C \nATOM 40 O CYS A 4 -2.557 -16.965 17.766 1.00 63.02 O \nANISOU 40 O CYS A 4 7322 7659 8963 -2783 -1234 388 O \nATOM 41 CB CYS A 4 0.321 -17.677 19.046 1.00 68.04 C \nANISOU 41 CB CYS A 4 8113 8301 9438 -2886 -1078 295 C \nATOM 42 SG CYS A 4 1.417 -18.034 20.454 1.00 72.81 S \nANISOU 42 SG CYS A 4 8788 8937 9940 -2979 -1034 266 S \nATOM 43 N ILE A 5 -1.088 -15.347 17.338 1.00 72.56 N \nANISOU 43 N ILE A 5 8599 8830 10141 -2715 -1154 366 N \nATOM 44 CA ILE A 5 -1.642 -15.027 16.024 1.00 67.14 C \nANISOU 44 CA ILE A 5 7882 8102 9526 -2634 -1165 374 C \nATOM 45 C ILE A 5 -0.678 -15.497 14.990 1.00 62.66 C \nANISOU 45 C ILE A 5 7355 7489 8962 -2588 -1084 323 C \nATOM 46 O ILE A 5 0.502 -15.221 15.079 1.00 64.50 O \nANISOU 46 O ILE A 5 7645 7715 9148 -2579 -1019 293 O \nATOM 47 CB ILE A 5 -1.881 -13.522 15.852 1.00 73.95 C \nANISOU 47 CB ILE A 5 8733 8963 10403 -2590 -1191 408 C \nATOM 48 CG1 ILE A 5 -2.653 -12.962 17.057 1.00 81.95 C \nANISOU 48 CG1 ILE A 5 9723 10022 11395 -2648 -1266 458 C \nATOM 49 CG2 ILE A 5 -2.662 -13.248 14.577 1.00 71.79 C \nANISOU 49 CG2 ILE A 5 8426 8648 10204 -2515 -1215 420 C \nATOM 50 CD1 ILE A 5 -3.946 -13.683 17.403 1.00 84.12 C \nANISOU 50 CD1 ILE A 5 9952 10309 11701 -2678 -1343 491 C \nATOM 51 N GLY A 6 -1.183 -16.246 14.021 1.00 66.85 N \nANISOU 51 N GLY A 6 7860 7994 9546 -2558 -1087 312 N \nATOM 52 CA GLY A 6 -0.330 -16.868 13.008 1.00 68.04 C \nANISOU 52 CA GLY A 6 8051 8100 9699 -2523 -1012 263 C \nATOM 53 C GLY A 6 -1.062 -17.093 11.691 1.00 69.78 C \nANISOU 53 C GLY A 6 8229 8289 9993 -2460 -1027 265 C \nATOM 54 O GLY A 6 -2.209 -16.649 11.511 1.00 67.75 O \nANISOU 54 O GLY A 6 7915 8041 9788 -2433 -1095 303 O \nATOM 55 N TYR A 7 -0.412 -17.819 10.782 1.00 68.78 N \nANISOU 55 N TYR A 7 8135 8127 9871 -2439 -965 222 N \nATOM 56 CA TYR A 7 -0.954 -18.023 9.436 1.00 69.70 C \nANISOU 56 CA TYR A 7 8216 8213 10053 -2375 -969 217 C \nATOM 57 C TYR A 7 -0.567 -19.370 8.808 1.00 78.28 C \nANISOU 57 C TYR A 7 9324 9284 11134 -2397 -921 174 C \nATOM 58 O TYR A 7 0.258 -20.110 9.331 1.00 82.04 O \nANISOU 58 O TYR A 7 9857 9763 11553 -2459 -876 145 O \nATOM 59 CB TYR A 7 -0.551 -16.865 8.514 1.00 65.47 C \nANISOU 59 CB TYR A 7 7695 7638 9542 -2288 -940 218 C \nATOM 60 CG TYR A 7 0.949 -16.635 8.370 1.00 64.07 C \nANISOU 60 CG TYR A 7 7597 7434 9313 -2268 -855 182 C \nATOM 61 CD1 TYR A 7 1.654 -17.207 7.325 1.00 66.90 C \nANISOU 61 CD1 TYR A 7 7996 7747 9675 -2232 -791 142 C \nATOM 62 CD2 TYR A 7 1.642 -15.826 9.249 1.00 60.43 C \nANISOU 62 CD2 TYR A 7 7170 6993 8796 -2279 -840 188 C \nATOM 63 CE1 TYR A 7 2.998 -16.977 7.157 1.00 68.07 C \nANISOU 63 CE1 TYR A 7 8222 7867 9774 -2202 -715 111 C \nATOM 64 CE2 TYR A 7 3.000 -15.606 9.099 1.00 65.66 C \nANISOU 64 CE2 TYR A 7 7906 7634 9408 -2248 -763 154 C \nATOM 65 CZ TYR A 7 3.670 -16.185 8.043 1.00 68.68 C \nANISOU 65 CZ TYR A 7 8332 7966 9796 -2206 -701 117 C \nATOM 66 OH TYR A 7 5.027 -15.999 7.881 1.00 76.12 O \nANISOU 66 OH TYR A 7 9355 8882 10685 -2166 -624 84 O \nATOM 67 N HIS A 8 -1.195 -19.673 7.683 1.00 80.73 N \nANISOU 67 N HIS A 8 9591 9578 11502 -2350 -932 172 N \nATOM 68 CA HIS A 8 -1.021 -20.951 7.013 1.00 81.79 C \nANISOU 68 CA HIS A 8 9733 9708 11637 -2373 -896 135 C \nATOM 69 C HIS A 8 0.409 -21.184 6.552 1.00 85.24 C \nANISOU 69 C HIS A 8 10264 10094 12031 -2370 -805 90 C \nATOM 70 O HIS A 8 1.126 -20.255 6.186 1.00 95.04 O \nANISOU 70 O HIS A 8 11547 11295 13269 -2309 -768 86 O \nATOM 71 CB HIS A 8 -1.974 -21.029 5.829 1.00 83.51 C \nANISOU 71 CB HIS A 8 9884 9919 11926 -2309 -926 143 C \nATOM 72 CG HIS A 8 -2.271 -22.420 5.358 1.00 94.32 C \nANISOU 72 CG HIS A 8 11226 11313 13298 -2347 -919 117 C \nATOM 73 ND1 HIS A 8 -1.295 -23.337 5.043 1.00 95.94 N \nANISOU 73 ND1 HIS A 8 11492 11500 13461 -2391 -849 73 N \nATOM 74 CD2 HIS A 8 -3.452 -23.037 5.110 1.00 99.29 C \nANISOU 74 CD2 HIS A 8 11772 11989 13964 -2344 -973 130 C \nATOM 75 CE1 HIS A 8 -1.857 -24.460 4.640 1.00 99.71 C \nANISOU 75 CE1 HIS A 8 11923 12016 13947 -2424 -860 60 C \nATOM 76 NE2 HIS A 8 -3.167 -24.304 4.673 1.00 98.21 N \nANISOU 76 NE2 HIS A 8 11640 11870 13804 -2392 -935 93 N \nATOM 77 N ALA A 9 0.838 -22.435 6.622 1.00 85.74 N \nANISOU 77 N ALA A 9 10362 10161 12054 -2440 -769 57 N \nATOM 78 CA ALA A 9 2.082 -22.858 5.988 1.00 91.53 C \nANISOU 78 CA ALA A 9 11189 10838 12750 -2437 -684 12 C \nATOM 79 C ALA A 9 1.853 -24.229 5.370 1.00 94.22 C \nANISOU 79 C ALA A 9 11518 11190 13091 -2487 -671 -14 C \nATOM 80 O ALA A 9 0.923 -24.934 5.751 1.00 97.60 O \nANISOU 80 O ALA A 9 11875 11680 13527 -2543 -722 -2 O \nATOM 81 CB ALA A 9 3.229 -22.912 6.982 1.00 92.44 C \nANISOU 81 CB ALA A 9 11401 10939 12783 -2489 -637 -8 C \nATOM 82 N ASN A 10 2.681 -24.574 4.390 1.00 88.75 N \nANISOU 82 N ASN A 10 10892 10441 12388 -2465 -604 -49 N \nATOM 83 CA ASN A 10 2.653 -25.899 3.791 1.00 87.25 C \nANISOU 83 CA ASN A 10 10708 10258 12185 -2524 -581 -79 C \nATOM 84 C ASN A 10 4.014 -26.271 3.170 1.00 93.65 C \nANISOU 84 C ASN A 10 11643 10993 12947 -2526 -492 -122 C \nATOM 85 O ASN A 10 5.037 -25.651 3.465 1.00100.06 O \nANISOU 85 O ASN A 10 12544 11753 13720 -2495 -447 -131 O \nATOM 86 CB ASN A 10 1.461 -26.086 2.830 1.00 76.62 C \nANISOU 86 CB ASN A 10 9253 8947 10913 -2482 -627 -66 C \nATOM 87 CG ASN A 10 1.504 -25.154 1.615 1.00 81.72 C \nANISOU 87 CG ASN A 10 9892 9539 11618 -2365 -612 -61 C \nATOM 88 OD1 ASN A 10 2.557 -24.652 1.239 1.00 84.90 O \nANISOU 88 OD1 ASN A 10 10379 9879 12001 -2322 -554 -77 O \nATOM 89 ND2 ASN A 10 0.348 -24.955 0.968 1.00 70.36 N \nANISOU 89 ND2 ASN A 10 8355 8130 10249 -2312 -665 -40 N \nATOM 90 N ASN A 11 4.019 -27.306 2.348 1.00102.82 N \nANISOU 90 N ASN A 11 12812 12150 14103 -2563 -466 -148 N \nATOM 91 CA ASN A 11 5.237 -27.821 1.731 1.00112.57 C \nANISOU 91 CA ASN A 11 14172 13312 15287 -2577 -384 -189 C \nATOM 92 C ASN A 11 5.358 -27.360 0.275 1.00117.73 C \nANISOU 92 C ASN A 11 14824 13916 15993 -2474 -358 -193 C \nATOM 93 O ASN A 11 6.276 -27.762 -0.443 1.00120.99 O \nANISOU 93 O ASN A 11 15333 14266 16372 -2472 -293 -223 O \nATOM 94 CB ASN A 11 5.258 -29.355 1.820 1.00113.91 C \nANISOU 94 CB ASN A 11 14367 13512 15403 -2706 -368 -218 C \nATOM 95 CG ASN A 11 3.947 -29.993 1.369 1.00110.15 C \nANISOU 95 CG ASN A 11 13756 13120 14975 -2731 -424 -206 C \nATOM 96 OD1 ASN A 11 3.081 -29.335 0.779 1.00 99.60 O \nANISOU 96 OD1 ASN A 11 12323 11804 13718 -2641 -467 -181 O \nATOM 97 ND2 ASN A 11 3.790 -31.284 1.663 1.00109.74 N \nANISOU 97 ND2 ASN A 11 13700 13123 14872 -2853 -423 -225 N \nATOM 98 N SER A 12 4.416 -26.519 -0.147 1.00118.09 N \nANISOU 98 N SER A 12 14763 13989 16117 -2391 -410 -161 N \nATOM 99 CA SER A 12 4.396 -25.964 -1.496 1.00111.27 C \nANISOU 99 CA SER A 12 13883 13087 15309 -2291 -394 -161 C \nATOM 100 C SER A 12 5.718 -25.290 -1.814 1.00106.06 C \nANISOU 100 C SER A 12 13335 12348 14616 -2225 -326 -175 C \nATOM 101 O SER A 12 6.326 -24.657 -0.945 1.00108.41 O \nANISOU 101 O SER A 12 13683 12633 14876 -2214 -315 -169 O \nATOM 102 CB SER A 12 3.247 -24.963 -1.642 1.00113.56 C \nANISOU 102 CB SER A 12 14055 13414 15678 -2214 -463 -122 C \nATOM 103 OG SER A 12 3.475 -24.093 -2.720 1.00121.50 O \nANISOU 103 OG SER A 12 15064 14374 16725 -2110 -441 -119 O \nATOM 104 N THR A 13 6.149 -25.439 -3.062 1.00 99.86 N \nANISOU 104 N THR A 13 12587 11515 13842 -2179 -281 -194 N \nATOM 105 CA THR A 13 7.429 -24.892 -3.524 1.00 98.16 C \nANISOU 105 CA THR A 13 12482 11224 13591 -2107 -213 -209 C \nATOM 106 C THR A 13 7.239 -23.910 -4.687 1.00 91.16 C \nANISOU 106 C THR A 13 11547 10322 12768 -1989 -215 -195 C \nATOM 107 O THR A 13 8.205 -23.431 -5.260 1.00 86.71 O \nANISOU 107 O THR A 13 11059 9704 12182 -1917 -162 -205 O \nATOM 108 CB THR A 13 8.345 -26.017 -4.013 1.00 98.65 C \nANISOU 108 CB THR A 13 12661 11229 13593 -2161 -146 -249 C \nATOM 109 OG1 THR A 13 7.612 -26.812 -4.946 1.00103.60 O \nANISOU 109 OG1 THR A 13 13225 11879 14259 -2193 -160 -256 O \nATOM 110 CG2 THR A 13 8.804 -26.881 -2.861 1.00101.45 C \nANISOU 110 CG2 THR A 13 13093 11583 13869 -2275 -130 -267 C \nATOM 111 N GLU A 14 5.992 -23.625 -5.027 1.00 88.48 N \nANISOU 111 N GLU A 14 11084 10032 12503 -1969 -277 -171 N \nATOM 112 CA GLU A 14 5.678 -22.665 -6.066 1.00 93.03 C \nANISOU 112 CA GLU A 14 11606 10600 13140 -1865 -286 -155 C \nATOM 113 C GLU A 14 6.200 -21.287 -5.663 1.00 95.31 C \nANISOU 113 C GLU A 14 11914 10882 13418 -1790 -281 -135 C \nATOM 114 O GLU A 14 5.892 -20.761 -4.585 1.00 96.87 O \nANISOU 114 O GLU A 14 12081 11115 13609 -1809 -320 -113 O \nATOM 115 CB GLU A 14 4.176 -22.594 -6.331 1.00 94.45 C \nANISOU 115 CB GLU A 14 11656 10834 13396 -1862 -359 -133 C \nATOM 116 CG GLU A 14 3.582 -23.893 -6.864 1.00 99.20 C \nANISOU 116 CG GLU A 14 12222 11459 14012 -1923 -366 -152 C \nATOM 117 CD GLU A 14 2.065 -23.934 -6.777 1.00 97.35 C \nANISOU 117 CD GLU A 14 11861 11289 13837 -1927 -444 -129 C \nATOM 118 OE1 GLU A 14 1.508 -23.366 -5.821 1.00 87.98 O \nANISOU 118 OE1 GLU A 14 10633 10135 12662 -1930 -495 -101 O \nATOM 119 OE2 GLU A 14 1.427 -24.533 -7.665 1.00 98.69 O \nANISOU 119 OE2 GLU A 14 11977 11479 14042 -1925 -453 -139 O \nATOM 120 N GLN A 15 7.040 -20.740 -6.527 1.00 87.84 N \nANISOU 120 N GLN A 15 11020 9892 12462 -1708 -230 -144 N \nATOM 121 CA GLN A 15 7.601 -19.430 -6.326 1.00 82.06 C \nANISOU 121 CA GLN A 15 10301 9163 11715 -1628 -219 -128 C \nATOM 122 C GLN A 15 6.798 -18.391 -7.099 1.00 84.99 C \nANISOU 122 C GLN A 15 10576 9561 12155 -1557 -258 -101 C \nATOM 123 O GLN A 15 5.978 -18.718 -7.956 1.00 86.16 O \nANISOU 123 O GLN A 15 10664 9712 12361 -1556 -282 -101 O \nATOM 124 CB GLN A 15 9.046 -19.409 -6.751 1.00 80.23 C \nANISOU 124 CB GLN A 15 10186 8875 11422 -1575 -139 -152 C \nATOM 125 CG GLN A 15 9.965 -20.104 -5.772 1.00 90.71 C \nANISOU 125 CG GLN A 15 11624 10174 12669 -1633 -100 -175 C \nATOM 126 CD GLN A 15 11.397 -20.180 -6.280 1.00 94.03 C \nANISOU 126 CD GLN A 15 12175 10528 13026 -1573 -19 -201 C \nATOM 127 OE1 GLN A 15 11.717 -19.652 -7.350 1.00 90.17 O \nANISOU 127 OE1 GLN A 15 11688 10021 12553 -1483 7 -199 O \nATOM 128 NE2 GLN A 15 12.266 -20.825 -5.508 1.00 93.41 N \nANISOU 128 NE2 GLN A 15 12209 10411 12870 -1620 21 -224 N \nATOM 129 N VAL A 16 7.055 -17.129 -6.785 1.00 78.41 N \nANISOU 129 N VAL A 16 9730 8751 11310 -1500 -264 -80 N \nATOM 130 CA VAL A 16 6.275 -16.027 -7.319 1.00 70.53 C \nANISOU 130 CA VAL A 16 8645 7785 10368 -1446 -306 -52 C \nATOM 131 C VAL A 16 7.115 -14.795 -7.235 1.00 72.90 C \nANISOU 131 C VAL A 16 8968 8102 10628 -1375 -278 -42 C \nATOM 132 O VAL A 16 7.971 -14.686 -6.359 1.00 80.06 O \nANISOU 132 O VAL A 16 9935 9014 11471 -1380 -250 -48 O \nATOM 133 CB VAL A 16 4.972 -15.855 -6.517 1.00 73.84 C \nANISOU 133 CB VAL A 16 8980 8248 10828 -1501 -387 -23 C \nATOM 134 CG1 VAL A 16 4.740 -14.413 -6.126 1.00 75.37 C \nANISOU 134 CG1 VAL A 16 9131 8483 11023 -1466 -420 9 C \nATOM 135 CG2 VAL A 16 3.795 -16.412 -7.287 1.00 69.16 C \nANISOU 135 CG2 VAL A 16 8318 7653 10305 -1513 -427 -22 C \nATOM 136 N ASP A 17 6.916 -13.883 -8.171 1.00 73.77 N \nANISOU 136 N ASP A 17 9033 8226 10771 -1306 -283 -29 N \nATOM 137 CA ASP A 17 7.718 -12.648 -8.170 1.00 79.02 C \nANISOU 137 CA ASP A 17 9709 8923 11392 -1234 -256 -19 C \nATOM 138 C ASP A 17 7.000 -11.364 -7.765 1.00 71.97 C \nANISOU 138 C ASP A 17 8738 8093 10516 -1233 -312 17 C \nATOM 139 O ASP A 17 5.760 -11.295 -7.713 1.00 67.50 O \nANISOU 139 O ASP A 17 8103 7536 10006 -1274 -375 37 O \nATOM 140 CB ASP A 17 8.346 -12.450 -9.541 1.00 87.52 C \nANISOU 140 CB ASP A 17 10808 9976 12470 -1150 -206 -32 C \nATOM 141 CG ASP A 17 9.547 -13.329 -9.745 1.00 88.39 C \nANISOU 141 CG ASP A 17 11026 10030 12527 -1130 -134 -64 C \nATOM 142 OD1 ASP A 17 9.402 -14.568 -9.833 1.00 93.76 O \nANISOU 142 OD1 ASP A 17 11741 10663 13219 -1186 -127 -85 O \nATOM 143 OD2 ASP A 17 10.655 -12.762 -9.807 1.00 89.54 O \nANISOU 143 OD2 ASP A 17 11224 10182 12614 -1058 -85 -70 O \nATOM 144 N THR A 18 7.843 -10.375 -7.480 1.00 66.87 N \nANISOU 144 N THR A 18 8107 7488 9812 -1184 -284 24 N \nATOM 145 CA THR A 18 7.450 -9.083 -6.957 1.00 66.87 C \nANISOU 145 CA THR A 18 8046 7558 9803 -1186 -326 56 C \nATOM 146 C THR A 18 8.447 -8.051 -7.481 1.00 70.20 C \nANISOU 146 C THR A 18 8476 8024 10174 -1098 -278 55 C \nATOM 147 O THR A 18 9.596 -8.382 -7.830 1.00 72.57 O \nANISOU 147 O THR A 18 8845 8301 10429 -1038 -212 31 O \nATOM 148 CB THR A 18 7.469 -9.127 -5.404 1.00 68.47 C \nANISOU 148 CB THR A 18 8262 7789 9966 -1252 -349 64 C \nATOM 149 OG1 THR A 18 6.308 -9.818 -4.927 1.00 76.74 O \nANISOU 149 OG1 THR A 18 9277 8816 11064 -1333 -408 75 O \nATOM 150 CG2 THR A 18 7.476 -7.777 -4.780 1.00 74.10 C \nANISOU 150 CG2 THR A 18 8933 8581 10641 -1248 -372 92 C \nATOM 151 N ILE A 19 8.026 -6.795 -7.509 1.00 75.39 N \nANISOU 151 N ILE A 19 9067 8747 10831 -1090 -312 84 N \nATOM 152 CA ILE A 19 8.888 -5.675 -7.965 1.00 82.57 C \nANISOU 152 CA ILE A 19 9967 9721 11685 -1011 -274 88 C \nATOM 153 C ILE A 19 10.140 -5.486 -7.118 1.00 86.42 C \nANISOU 153 C ILE A 19 10506 10248 12083 -975 -226 76 C \nATOM 154 O ILE A 19 11.134 -4.986 -7.605 1.00 94.85 O \nANISOU 154 O ILE A 19 11592 11350 13098 -889 -174 67 O \nATOM 155 CB ILE A 19 8.110 -4.344 -8.091 1.00 83.86 C \nANISOU 155 CB ILE A 19 10047 9956 11861 -1028 -324 121 C \nATOM 156 CG1 ILE A 19 7.534 -3.945 -6.748 1.00 93.97 C \nANISOU 156 CG1 ILE A 19 11301 11277 13125 -1108 -378 145 C \nATOM 157 CG2 ILE A 19 6.973 -4.480 -9.096 1.00 79.08 C \nANISOU 157 CG2 ILE A 19 9400 9307 11339 -1044 -363 129 C \nATOM 158 CD1 ILE A 19 8.404 -2.956 -6.023 1.00 99.86 C \nANISOU 158 CD1 ILE A 19 12042 12118 13783 -1086 -355 153 C \nATOM 159 N MET A 20 10.089 -5.917 -5.862 1.00 92.36 N \nANISOU 159 N MET A 20 11284 10996 12815 -1038 -242 75 N \nATOM 160 CA MET A 20 11.208 -5.797 -4.921 1.00 91.38 C \nANISOU 160 CA MET A 20 11212 10906 12603 -1013 -200 62 C \nATOM 161 C MET A 20 11.838 -7.126 -4.544 1.00 89.12 C \nANISOU 161 C MET A 20 11023 10539 12298 -1024 -160 29 C \nATOM 162 O MET A 20 12.910 -7.148 -3.941 1.00 88.33 O \nANISOU 162 O MET A 20 10987 10451 12123 -986 -113 12 O \nATOM 163 CB MET A 20 10.741 -5.126 -3.624 1.00 96.50 C \nANISOU 163 CB MET A 20 11816 11624 13227 -1083 -249 87 C \nATOM 164 CG MET A 20 10.643 -3.620 -3.683 1.00 94.25 C \nANISOU 164 CG MET A 20 11455 11443 12911 -1064 -269 114 C \nATOM 165 SD MET A 20 10.035 -3.047 -2.096 1.00105.99 S \nANISOU 165 SD MET A 20 12903 12999 14371 -1164 -329 143 S \nATOM 166 CE MET A 20 9.812 -1.308 -2.447 1.00114.92 C \nANISOU 166 CE MET A 20 13945 14249 15472 -1150 -353 175 C \nATOM 167 N GLU A 21 11.156 -8.225 -4.841 1.00 91.25 N \nANISOU 167 N GLU A 21 11307 10733 12632 -1079 -179 21 N \nATOM 168 CA GLU A 21 11.637 -9.554 -4.446 1.00 95.53 C \nANISOU 168 CA GLU A 21 11940 11201 13156 -1111 -146 -9 C \nATOM 169 C GLU A 21 11.412 -10.593 -5.544 1.00 81.26 C \nANISOU 169 C GLU A 21 10159 9314 11402 -1112 -131 -27 C \nATOM 170 O GLU A 21 10.344 -10.661 -6.133 1.00 69.74 O \nANISOU 170 O GLU A 21 8633 7848 10016 -1141 -176 -13 O \nATOM 171 CB GLU A 21 10.948 -10.017 -3.155 1.00107.67 C \nANISOU 171 CB GLU A 21 13464 12743 14701 -1217 -195 -1 C \nATOM 172 CG GLU A 21 11.507 -9.421 -1.873 1.00115.80 C \nANISOU 172 CG GLU A 21 14509 13833 15658 -1226 -190 4 C \nATOM 173 CD GLU A 21 10.951 -10.090 -0.620 1.00122.34 C \nANISOU 173 CD GLU A 21 15341 14654 16488 -1333 -230 7 C \nATOM 174 OE1 GLU A 21 11.685 -10.889 -0.001 1.00126.19 O \nANISOU 174 OE1 GLU A 21 15913 15106 16926 -1353 -192 -19 O \nATOM 175 OE2 GLU A 21 9.779 -9.835 -0.258 1.00114.17 O \nANISOU 175 OE2 GLU A 21 14229 13649 15503 -1397 -300 37 O \nATOM 176 N LYS A 22 12.427 -11.411 -5.771 1.00 83.38 N \nANISOU 176 N LYS A 22 10531 9521 11628 -1082 -68 -59 N \nATOM 177 CA LYS A 22 12.408 -12.427 -6.795 1.00 92.47 C \nANISOU 177 CA LYS A 22 11723 10598 12814 -1083 -44 -79 C \nATOM 178 C LYS A 22 12.449 -13.792 -6.113 1.00102.06 C \nANISOU 178 C LYS A 22 13009 11755 14014 -1172 -37 -102 C \nATOM 179 O LYS A 22 13.107 -13.956 -5.091 1.00109.16 O \nANISOU 179 O LYS A 22 13973 12654 14850 -1191 -16 -114 O \nATOM 180 CB LYS A 22 13.602 -12.207 -7.743 1.00103.61 C \nANISOU 180 CB LYS A 22 13204 11984 14180 -972 26 -96 C \nATOM 181 CG LYS A 22 14.018 -13.416 -8.611 1.00110.35 C \nANISOU 181 CG LYS A 22 14146 12746 15036 -972 71 -125 C \nATOM 182 CD LYS A 22 13.137 -13.514 -9.860 1.00110.72 C \nANISOU 182 CD LYS A 22 14121 12784 15164 -973 46 -116 C \nATOM 183 CE LYS A 22 13.422 -14.730 -10.759 1.00105.57 C \nANISOU 183 CE LYS A 22 13544 12048 14518 -985 85 -143 C \nATOM 184 NZ LYS A 22 12.157 -15.273 -11.356 1.00 97.45 N \nANISOU 184 NZ LYS A 22 12435 11016 13575 -1050 38 -138 N \nATOM 185 N ASN A 23 11.734 -14.765 -6.683 1.00110.43 N \nANISOU 185 N ASN A 23 14055 12775 15130 -1229 -55 -110 N \nATOM 186 CA ASN A 23 11.759 -16.167 -6.215 1.00110.96 C \nANISOU 186 CA ASN A 23 14187 12793 15181 -1320 -45 -134 C \nATOM 187 C ASN A 23 11.251 -16.310 -4.782 1.00105.13 C \nANISOU 187 C ASN A 23 13422 12091 14431 -1408 -90 -124 C \nATOM 188 O ASN A 23 11.951 -16.793 -3.902 1.00 99.02 O \nANISOU 188 O ASN A 23 12731 11297 13594 -1445 -61 -142 O \nATOM 189 CB ASN A 23 13.157 -16.806 -6.373 1.00107.65 C \nANISOU 189 CB ASN A 23 13914 12304 14685 -1290 35 -168 C \nATOM 190 CG ASN A 23 13.584 -16.972 -7.831 1.00114.09 C \nANISOU 190 CG ASN A 23 14766 13072 15513 -1221 78 -180 C \nATOM 191 OD1 ASN A 23 14.616 -16.429 -8.250 1.00123.92 O \nANISOU 191 OD1 ASN A 23 16073 14301 16711 -1122 129 -186 O \nATOM 192 ND2 ASN A 23 12.813 -17.732 -8.606 1.00113.90 N \nANISOU 192 ND2 ASN A 23 14702 13027 15546 -1269 58 -184 N \nATOM 193 N VAL A 24 10.022 -15.862 -4.565 1.00106.45 N \nANISOU 193 N VAL A 24 13477 12311 14660 -1441 -161 -94 N \nATOM 194 CA VAL A 24 9.400 -15.895 -3.235 1.00 97.07 C \nANISOU 194 CA VAL A 24 12251 11164 13468 -1521 -212 -78 C \nATOM 195 C VAL A 24 8.422 -17.046 -3.109 1.00 85.94 C \nANISOU 195 C VAL A 24 10807 9748 12100 -1615 -252 -81 C \nATOM 196 O VAL A 24 7.392 -17.067 -3.788 1.00 77.13 O \nANISOU 196 O VAL A 24 9610 8642 11053 -1615 -295 -67 O \nATOM 197 CB VAL A 24 8.657 -14.579 -2.941 1.00 98.85 C \nANISOU 197 CB VAL A 24 12379 11456 13725 -1498 -269 -39 C \nATOM 198 CG1 VAL A 24 7.780 -14.712 -1.699 1.00 96.83 C \nANISOU 198 CG1 VAL A 24 12075 11238 13477 -1587 -332 -19 C \nATOM 199 CG2 VAL A 24 9.672 -13.459 -2.785 1.00 97.62 C \nANISOU 199 CG2 VAL A 24 12252 11327 13510 -1420 -230 -37 C \nATOM 200 N THR A 25 8.745 -17.993 -2.227 1.00 82.14 N \nANISOU 200 N THR A 25 10386 9253 11572 -1694 -239 -99 N \nATOM 201 CA THR A 25 7.967 -19.213 -2.112 1.00 77.97 C \nANISOU 201 CA THR A 25 9832 8725 11068 -1788 -269 -106 C \nATOM 202 C THR A 25 6.601 -18.894 -1.519 1.00 75.38 C \nANISOU 202 C THR A 25 9390 8457 10792 -1826 -353 -71 C \nATOM 203 O THR A 25 6.495 -18.112 -0.582 1.00 75.32 O \nANISOU 203 O THR A 25 9361 8488 10770 -1829 -382 -49 O \nATOM 204 CB THR A 25 8.705 -20.262 -1.275 1.00 73.10 C \nANISOU 204 CB THR A 25 9314 8084 10378 -1869 -232 -135 C \nATOM 205 OG1 THR A 25 10.114 -20.180 -1.535 1.00 78.39 O \nANISOU 205 OG1 THR A 25 10104 8696 10984 -1816 -155 -162 O \nATOM 206 CG2 THR A 25 8.203 -21.656 -1.607 1.00 67.26 C \nANISOU 206 CG2 THR A 25 8568 7335 9652 -1954 -238 -153 C \nATOM 207 N VAL A 26 5.557 -19.487 -2.079 1.00 71.56 N \nANISOU 207 N VAL A 26 8837 7985 10367 -1851 -392 -66 N \nATOM 208 CA VAL A 26 4.203 -19.135 -1.695 1.00 72.27 C \nANISOU 208 CA VAL A 26 8822 8127 10511 -1868 -474 -32 C \nATOM 209 C VAL A 26 3.394 -20.390 -1.388 1.00 80.10 C \nANISOU 209 C VAL A 26 9776 9144 11514 -1953 -508 -37 C \nATOM 210 O VAL A 26 3.792 -21.497 -1.747 1.00 84.30 O \nANISOU 210 O VAL A 26 10352 9657 12023 -1995 -469 -68 O \nATOM 211 CB VAL A 26 3.528 -18.259 -2.787 1.00 75.81 C \nANISOU 211 CB VAL A 26 9203 8574 11028 -1786 -499 -12 C \nATOM 212 CG1 VAL A 26 2.541 -19.052 -3.653 1.00 76.72 C \nANISOU 212 CG1 VAL A 26 9257 8692 11202 -1794 -527 -17 C \nATOM 213 CG2 VAL A 26 2.849 -17.051 -2.168 1.00 76.17 C \nANISOU 213 CG2 VAL A 26 9189 8657 11093 -1768 -558 28 C \nATOM 214 N THR A 27 2.263 -20.197 -0.713 1.00 80.37 N \nANISOU 214 N THR A 27 9730 9228 11579 -1980 -582 -5 N \nATOM 215 CA THR A 27 1.442 -21.281 -0.239 1.00 74.19 C \nANISOU 215 CA THR A 27 8901 8487 10800 -2057 -623 -5 C \nATOM 216 C THR A 27 0.476 -21.754 -1.329 1.00 78.11 C \nANISOU 216 C THR A 27 9325 8994 11360 -2030 -649 -6 C \nATOM 217 O THR A 27 0.331 -22.954 -1.538 1.00 79.94 O \nANISOU 217 O THR A 27 9549 9244 11581 -2083 -640 -28 O \nATOM 218 CB THR A 27 0.788 -20.887 1.089 1.00 76.71 C \nANISOU 218 CB THR A 27 9180 8855 11113 -2097 -686 29 C \nATOM 219 OG1 THR A 27 0.857 -21.979 2.009 1.00 87.66 O \nANISOU 219 OG1 THR A 27 10581 10274 12451 -2195 -688 17 O \nATOM 220 CG2 THR A 27 -0.638 -20.414 0.938 1.00 73.22 C \nANISOU 220 CG2 THR A 27 8640 8443 10736 -2062 -765 66 C \nATOM 221 N HIS A 28 -0.153 -20.820 -2.042 1.00 84.49 N \nANISOU 221 N HIS A 28 10083 9793 12227 -1949 -679 15 N \nATOM 222 CA HIS A 28 -1.030 -21.120 -3.183 1.00 80.07 C \nANISOU 222 CA HIS A 28 9459 9237 11728 -1908 -700 12 C \nATOM 223 C HIS A 28 -0.771 -20.082 -4.272 1.00 82.77 C \nANISOU 223 C HIS A 28 9810 9535 12105 -1816 -676 14 C \nATOM 224 O HIS A 28 -0.570 -18.895 -3.995 1.00 71.41 O \nANISOU 224 O HIS A 28 8384 8085 10665 -1779 -684 36 O \nATOM 225 CB HIS A 28 -2.524 -21.068 -2.816 1.00 81.45 C \nANISOU 225 CB HIS A 28 9541 9459 11946 -1905 -785 44 C \nATOM 226 CG HIS A 28 -2.980 -22.111 -1.841 1.00 88.38 C \nANISOU 226 CG HIS A 28 10390 10395 12796 -1988 -818 46 C \nATOM 227 ND1 HIS A 28 -4.123 -22.860 -2.037 1.00 89.12 N \nANISOU 227 ND1 HIS A 28 10404 10540 12920 -1993 -866 50 N \nATOM 228 CD2 HIS A 28 -2.482 -22.498 -0.644 1.00 91.11 C \nANISOU 228 CD2 HIS A 28 10772 10762 13082 -2067 -811 44 C \nATOM 229 CE1 HIS A 28 -4.290 -23.679 -1.012 1.00 91.86 C \nANISOU 229 CE1 HIS A 28 10737 10942 13226 -2073 -887 52 C \nATOM 230 NE2 HIS A 28 -3.308 -23.481 -0.155 1.00 91.06 N \nANISOU 230 NE2 HIS A 28 10707 10822 13071 -2123 -854 48 N \nATOM 231 N ALA A 29 -0.840 -20.527 -5.520 1.00 89.36 N \nANISOU 231 N ALA A 29 10633 10352 12969 -1783 -651 -7 N \nATOM 232 CA ALA A 29 -0.599 -19.649 -6.643 1.00 91.12 C \nANISOU 232 CA ALA A 29 10862 10536 13224 -1699 -627 -8 C \nATOM 233 C ALA A 29 -1.395 -20.075 -7.874 1.00 93.60 C \nANISOU 233 C ALA A 29 11119 10851 13594 -1663 -639 -18 C \nATOM 234 O ALA A 29 -1.876 -21.203 -7.948 1.00 98.89 O \nANISOU 234 O ALA A 29 11756 11551 14266 -1705 -650 -33 O \nATOM 235 CB ALA A 29 0.891 -19.613 -6.945 1.00 88.96 C \nANISOU 235 CB ALA A 29 10682 10220 12901 -1688 -546 -33 C \nATOM 236 N GLN A 30 -1.540 -19.153 -8.825 1.00 92.96 N \nANISOU 236 N GLN A 30 11023 10744 13552 -1586 -638 -11 N \nATOM 237 CA GLN A 30 -2.146 -19.452 -10.122 1.00 89.35 C \nANISOU 237 CA GLN A 30 10521 10282 13145 -1543 -640 -24 C \nATOM 238 C GLN A 30 -1.217 -19.059 -11.274 1.00 94.69 C \nANISOU 238 C GLN A 30 11244 10915 13819 -1489 -576 -43 C \nATOM 239 O GLN A 30 -0.822 -17.905 -11.416 1.00 92.94 O \nANISOU 239 O GLN A 30 11043 10674 13597 -1441 -566 -28 O \nATOM 240 CB GLN A 30 -3.482 -18.751 -10.290 1.00 84.39 C \nANISOU 240 CB GLN A 30 9823 9667 12575 -1497 -710 3 C \nATOM 241 CG GLN A 30 -4.674 -19.591 -9.897 1.00 84.48 C \nANISOU 241 CG GLN A 30 9768 9724 12608 -1524 -768 9 C \nATOM 242 CD GLN A 30 -5.964 -19.108 -10.552 1.00 82.37 C \nANISOU 242 CD GLN A 30 9438 9456 12402 -1459 -824 24 C \nATOM 243 OE1 GLN A 30 -6.102 -19.138 -11.773 1.00 88.05 O \nANISOU 243 OE1 GLN A 30 10142 10159 13153 -1411 -804 6 O \nATOM 244 NE2 GLN A 30 -6.922 -18.683 -9.742 1.00 78.42 N \nANISOU 244 NE2 GLN A 30 8908 8972 11915 -1457 -893 57 N \nATOM 245 N ASP A 31 -0.846 -20.047 -12.073 1.00 95.43 N \nANISOU 245 N ASP A 31 11355 10998 13905 -1503 -532 -75 N \nATOM 246 CA ASP A 31 -0.204 -19.796 -13.348 1.00 93.72 C \nANISOU 246 CA ASP A 31 11169 10744 13697 -1447 -479 -92 C \nATOM 247 C ASP A 31 -1.327 -19.344 -14.262 1.00 85.58 C \nANISOU 247 C ASP A 31 10061 9722 12733 -1390 -521 -83 C \nATOM 248 O ASP A 31 -2.378 -19.991 -14.317 1.00 90.46 O \nANISOU 248 O ASP A 31 10615 10372 13382 -1406 -563 -85 O \nATOM 249 CB ASP A 31 0.470 -21.068 -13.897 1.00 91.48 C \nANISOU 249 CB ASP A 31 10930 10447 13381 -1489 -423 -128 C \nATOM 250 CG ASP A 31 1.354 -20.799 -15.119 1.00 93.00 C \nANISOU 250 CG ASP A 31 11173 10594 13568 -1433 -361 -145 C \nATOM 251 OD1 ASP A 31 1.838 -19.667 -15.288 1.00 94.87 O \nANISOU 251 OD1 ASP A 31 11433 10809 13804 -1371 -347 -130 O \nATOM 252 OD2 ASP A 31 1.578 -21.727 -15.931 1.00 99.73 O \nANISOU 252 OD2 ASP A 31 12042 11436 14413 -1453 -326 -172 O \nATOM 253 N ILE A 32 -1.103 -18.240 -14.962 1.00 75.45 N \nANISOU 253 N ILE A 32 8785 8415 11468 -1322 -508 -73 N \nATOM 254 CA ILE A 32 -2.042 -17.780 -15.991 1.00 74.12 C \nANISOU 254 CA ILE A 32 8558 8247 11360 -1265 -538 -69 C \nATOM 255 C ILE A 32 -1.473 -17.909 -17.430 1.00 76.04 C \nANISOU 255 C ILE A 32 8819 8464 11610 -1223 -482 -94 C \nATOM 256 O ILE A 32 -2.221 -17.962 -18.378 1.00 68.42 O \nANISOU 256 O ILE A 32 7805 7500 10690 -1189 -498 -101 O \nATOM 257 CB ILE A 32 -2.496 -16.331 -15.708 1.00 75.54 C \nANISOU 257 CB ILE A 32 8719 8425 11558 -1227 -580 -35 C \nATOM 258 CG1 ILE A 32 -1.287 -15.388 -15.488 1.00 68.92 C \nANISOU 258 CG1 ILE A 32 7939 7574 10675 -1209 -537 -27 C \nATOM 259 CG2 ILE A 32 -3.443 -16.317 -14.514 1.00 75.50 C \nANISOU 259 CG2 ILE A 32 8680 8446 11561 -1264 -649 -10 C \nATOM 260 CD1 ILE A 32 -1.674 -13.955 -15.200 1.00 60.33 C \nANISOU 260 CD1 ILE A 32 6833 6496 9595 -1183 -576 6 C \nATOM 261 N LEU A 33 -0.145 -17.948 -17.574 1.00 79.05 N \nANISOU 261 N LEU A 33 9274 8819 11944 -1221 -417 -107 N \nATOM 262 CA LEU A 33 0.516 -18.225 -18.865 1.00 78.69 C \nANISOU 262 CA LEU A 33 9258 8746 11895 -1188 -359 -130 C \nATOM 263 C LEU A 33 0.401 -19.671 -19.363 1.00 76.79 C \nANISOU 263 C LEU A 33 9015 8510 11654 -1234 -340 -161 C \nATOM 264 O LEU A 33 0.962 -20.601 -18.781 1.00 84.27 O \nANISOU 264 O LEU A 33 10009 9454 12555 -1297 -315 -175 O \nATOM 265 CB LEU A 33 1.998 -17.867 -18.771 1.00 82.59 C \nANISOU 265 CB LEU A 33 9842 9210 12330 -1169 -297 -133 C \nATOM 266 CG LEU A 33 2.839 -18.044 -20.028 1.00 79.39 C \nANISOU 266 CG LEU A 33 9482 8772 11911 -1128 -234 -154 C \nATOM 267 CD1 LEU A 33 2.465 -17.020 -21.053 1.00 81.35 C \nANISOU 267 CD1 LEU A 33 9684 9026 12201 -1056 -244 -143 C \nATOM 268 CD2 LEU A 33 4.314 -17.929 -19.723 1.00 84.77 C \nANISOU 268 CD2 LEU A 33 10263 9422 12522 -1115 -173 -158 C \nATOM 269 N GLU A 34 -0.319 -19.864 -20.456 1.00 80.36 N \nANISOU 269 N GLU A 34 9412 8971 12151 -1206 -350 -172 N \nATOM 270 CA GLU A 34 -0.471 -21.211 -21.053 1.00 79.29 C \nANISOU 270 CA GLU A 34 9263 8849 12012 -1249 -331 -203 C \nATOM 271 C GLU A 34 0.723 -21.540 -21.933 1.00 71.49 C \nANISOU 271 C GLU A 34 8353 7822 10989 -1243 -257 -224 C \nATOM 272 O GLU A 34 1.174 -20.698 -22.684 1.00 70.67 O \nANISOU 272 O GLU A 34 8269 7690 10892 -1178 -232 -218 O \nATOM 273 CB GLU A 34 -1.744 -21.299 -21.867 1.00 83.60 C \nANISOU 273 CB GLU A 34 9719 9427 12619 -1216 -372 -208 C \nATOM 274 CG GLU A 34 -1.917 -22.618 -22.589 1.00 88.35 C \nANISOU 274 CG GLU A 34 10298 10054 13216 -1256 -351 -240 C \nATOM 275 CD GLU A 34 -1.938 -23.780 -21.630 1.00 97.59 C \nANISOU 275 CD GLU A 34 11471 11263 14347 -1346 -358 -249 C \nATOM 276 OE1 GLU A 34 -2.651 -23.649 -20.612 1.00108.34 O \nANISOU 276 OE1 GLU A 34 12791 12655 15719 -1359 -412 -230 O \nATOM 277 OE2 GLU A 34 -1.263 -24.801 -21.895 1.00 89.27 O \nANISOU 277 OE2 GLU A 34 10460 10209 13249 -1405 -312 -274 O \nATOM 278 N LYS A 35 1.262 -22.750 -21.800 1.00 67.54 N \nANISOU 278 N LYS A 35 7900 7319 10442 -1315 -222 -247 N \nATOM 279 CA LYS A 35 2.524 -23.108 -22.467 1.00 69.50 C \nANISOU 279 CA LYS A 35 8245 7519 10643 -1317 -150 -265 C \nATOM 280 C LYS A 35 2.488 -24.401 -23.293 1.00 73.33 C \nANISOU 280 C LYS A 35 8733 8016 11115 -1372 -122 -296 C \nATOM 281 O LYS A 35 3.475 -24.763 -23.906 1.00 70.62 O \nANISOU 281 O LYS A 35 8473 7629 10731 -1379 -64 -311 O \nATOM 282 CB LYS A 35 3.632 -23.205 -21.430 1.00 70.11 C \nANISOU 282 CB LYS A 35 8424 7563 10653 -1354 -117 -263 C \nATOM 283 CG LYS A 35 4.116 -21.862 -20.906 1.00 73.32 C \nANISOU 283 CG LYS A 35 8856 7949 11054 -1287 -119 -237 C \nATOM 284 CD LYS A 35 4.949 -21.999 -19.630 1.00 73.99 C \nANISOU 284 CD LYS A 35 9022 8016 11076 -1329 -101 -234 C \nATOM 285 CE LYS A 35 4.056 -22.363 -18.447 1.00 72.43 C \nANISOU 285 CE LYS A 35 8766 7865 10889 -1397 -159 -225 C \nATOM 286 NZ LYS A 35 4.840 -22.717 -17.251 1.00 74.90 N \nANISOU 286 NZ LYS A 35 9159 8161 11136 -1454 -139 -228 N \nATOM 287 N THR A 36 1.349 -25.081 -23.324 1.00 74.68 N \nANISOU 287 N THR A 36 8811 8246 11316 -1409 -165 -305 N \nATOM 288 CA THR A 36 1.277 -26.390 -23.928 1.00 76.50 C \nANISOU 288 CA THR A 36 9035 8505 11525 -1477 -142 -334 C \nATOM 289 C THR A 36 0.355 -26.393 -25.111 1.00 82.70 C \nANISOU 289 C THR A 36 9730 9327 12366 -1432 -161 -344 C \nATOM 290 O THR A 36 -0.687 -25.752 -25.078 1.00 93.31 O \nANISOU 290 O THR A 36 10987 10700 13767 -1376 -214 -330 O \nATOM 291 CB THR A 36 0.763 -27.439 -22.906 1.00 80.83 C \nANISOU 291 CB THR A 36 9551 9115 12048 -1574 -172 -341 C \nATOM 292 OG1 THR A 36 1.361 -27.202 -21.629 1.00 87.60 O \nANISOU 292 OG1 THR A 36 10472 9946 12866 -1604 -172 -326 O \nATOM 293 CG2 THR A 36 1.100 -28.858 -23.349 1.00 83.00 C \nANISOU 293 CG2 THR A 36 9854 9411 12269 -1669 -133 -373 C \nATOM 294 N HIS A 37 0.701 -27.167 -26.138 1.00 84.03 N \nANISOU 294 N HIS A 37 9920 9493 12514 -1459 -118 -369 N \nATOM 295 CA HIS A 37 -0.176 -27.363 -27.293 1.00 75.86 C \nANISOU 295 CA HIS A 37 8798 8502 11525 -1428 -132 -384 C \nATOM 296 C HIS A 37 -0.132 -28.783 -27.773 1.00 77.47 C \nANISOU 296 C HIS A 37 8998 8749 11687 -1516 -105 -416 C \nATOM 297 O HIS A 37 0.850 -29.475 -27.542 1.00 78.25 O \nANISOU 297 O HIS A 37 9192 8819 11720 -1592 -59 -426 O \nATOM 298 CB HIS A 37 0.244 -26.424 -28.410 1.00 74.18 C \nANISOU 298 CB HIS A 37 8611 8236 11339 -1340 -104 -380 C \nATOM 299 CG HIS A 37 1.635 -26.637 -28.906 1.00 67.63 C \nANISOU 299 CG HIS A 37 7900 7343 10454 -1358 -33 -388 C \nATOM 300 ND1 HIS A 37 1.904 -27.336 -30.058 1.00 65.45 N \nANISOU 300 ND1 HIS A 37 7641 7067 10161 -1380 7 -411 N \nATOM 301 CD2 HIS A 37 2.822 -26.183 -28.453 1.00 68.45 C \nANISOU 301 CD2 HIS A 37 8113 7381 10515 -1346 4 -375 C \nATOM 302 CE1 HIS A 37 3.200 -27.316 -30.288 1.00 69.90 C \nANISOU 302 CE1 HIS A 37 8325 7561 10673 -1382 65 -411 C \nATOM 303 NE2 HIS A 37 3.785 -26.632 -29.319 1.00 72.47 N \nANISOU 303 NE2 HIS A 37 8709 7847 10981 -1359 65 -390 N \nATOM 304 N ASN A 38 -1.174 -29.207 -28.485 1.00 77.50 N \nANISOU 304 N ASN A 38 8899 8823 11727 -1506 -131 -431 N \nATOM 305 CA ASN A 38 -1.301 -30.614 -28.905 1.00 72.29 C \nANISOU 305 CA ASN A 38 8214 8228 11025 -1597 -113 -462 C \nATOM 306 C ASN A 38 -0.519 -30.988 -30.158 1.00 76.18 C \nANISOU 306 C ASN A 38 8769 8687 11491 -1613 -51 -482 C \nATOM 307 O ASN A 38 -0.674 -32.081 -30.685 1.00 81.37 O \nANISOU 307 O ASN A 38 9400 9402 12116 -1685 -35 -509 O \nATOM 308 CB ASN A 38 -2.778 -30.989 -29.073 1.00 70.63 C \nANISOU 308 CB ASN A 38 7860 8121 10856 -1579 -168 -472 C \nATOM 309 CG ASN A 38 -3.341 -30.576 -30.401 1.00 71.46 C \nANISOU 309 CG ASN A 38 7905 8233 11014 -1496 -170 -482 C \nATOM 310 OD1 ASN A 38 -2.806 -29.696 -31.068 1.00 81.12 O \nANISOU 310 OD1 ASN A 38 9181 9382 12260 -1432 -144 -474 O \nATOM 311 ND2 ASN A 38 -4.433 -31.198 -30.790 1.00 65.50 N \nANISOU 311 ND2 ASN A 38 7039 7572 10276 -1494 -200 -501 N \nATOM 312 N GLY A 39 0.307 -30.074 -30.644 1.00 80.17 N \nANISOU 312 N GLY A 39 9352 9104 12004 -1547 -18 -470 N \nATOM 313 CA GLY A 39 1.204 -30.333 -31.773 1.00 73.42 C \nANISOU 313 CA GLY A 39 8575 8203 11118 -1556 44 -484 C \nATOM 314 C GLY A 39 0.527 -30.683 -33.083 1.00 68.53 C \nANISOU 314 C GLY A 39 7875 7636 10527 -1540 44 -505 C \nATOM 315 O GLY A 39 1.209 -31.092 -34.016 1.00 65.38 O \nANISOU 315 O GLY A 39 7536 7210 10094 -1565 94 -520 O \nATOM 316 N LYS A 40 -0.804 -30.560 -33.161 1.00 70.71 N \nANISOU 316 N LYS A 40 8020 7987 10860 -1499 -10 -509 N \nATOM 317 CA LYS A 40 -1.554 -30.991 -34.364 1.00 71.54 C \nANISOU 317 CA LYS A 40 8038 8155 10989 -1486 -12 -534 C \nATOM 318 C LYS A 40 -2.417 -29.886 -34.922 1.00 69.08 C \nANISOU 318 C LYS A 40 7649 7841 10757 -1366 -49 -524 C \nATOM 319 O LYS A 40 -2.701 -28.937 -34.233 1.00 92.50 O \nANISOU 319 O LYS A 40 10607 10779 13760 -1307 -85 -500 O \nATOM 320 CB LYS A 40 -2.445 -32.210 -34.066 1.00 69.88 C \nANISOU 320 CB LYS A 40 7733 8060 10759 -1562 -40 -556 C \nATOM 321 CG LYS A 40 -1.690 -33.500 -33.821 1.00 71.60 C \nANISOU 321 CG LYS A 40 8016 8299 10891 -1699 0 -574 C \nATOM 322 CD LYS A 40 -0.856 -33.909 -35.019 1.00 76.80 C \nANISOU 322 CD LYS A 40 8746 8923 11511 -1733 62 -591 C \nATOM 323 CE LYS A 40 0.543 -34.348 -34.599 1.00 82.52 C \nANISOU 323 CE LYS A 40 9626 9571 12158 -1822 115 -588 C \nATOM 324 NZ LYS A 40 1.425 -34.592 -35.785 1.00 89.51 N \nANISOU 324 NZ LYS A 40 10598 10404 13007 -1841 176 -599 N \nATOM 325 N LEU A 41 -2.842 -30.037 -36.169 1.00 58.71 N \nANISOU 325 N LEU A 41 6282 6559 9465 -1337 -39 -545 N \nATOM 326 CA LEU A 41 -3.831 -29.187 -36.747 1.00 55.01 C \nANISOU 326 CA LEU A 41 5732 6103 9067 -1235 -77 -543 C \nATOM 327 C LEU A 41 -5.193 -29.847 -36.554 1.00 60.81 C \nANISOU 327 C LEU A 41 6344 6942 9821 -1238 -127 -561 C \nATOM 328 O LEU A 41 -5.380 -31.016 -36.861 1.00 62.15 O \nANISOU 328 O LEU A 41 6471 7188 9954 -1305 -115 -588 O \nATOM 329 CB LEU A 41 -3.596 -28.954 -38.238 1.00 51.69 C \nANISOU 329 CB LEU A 41 5318 5662 8659 -1196 -40 -557 C \nATOM 330 CG LEU A 41 -2.259 -28.335 -38.644 1.00 53.22 C \nANISOU 330 CG LEU A 41 5629 5763 8831 -1182 13 -542 C \nATOM 331 CD1 LEU A 41 -2.294 -27.991 -40.122 1.00 52.82 C \nANISOU 331 CD1 LEU A 41 5561 5705 8803 -1129 37 -554 C \nATOM 332 CD2 LEU A 41 -1.889 -27.106 -37.830 1.00 50.58 C \nANISOU 332 CD2 LEU A 41 5343 5360 8514 -1125 -2 -507 C \nATOM 333 N CYS A 42 -6.142 -29.075 -36.033 1.00 63.73 N \nANISOU 333 N CYS A 42 6657 7314 10242 -1163 -185 -545 N \nATOM 334 CA CYS A 42 -7.441 -29.615 -35.650 1.00 72.51 C \nANISOU 334 CA CYS A 42 7660 8521 11371 -1152 -239 -556 C \nATOM 335 C CYS A 42 -8.582 -28.843 -36.263 1.00 68.05 C \nANISOU 335 C CYS A 42 7023 7961 10871 -1042 -280 -559 C \nATOM 336 O CYS A 42 -8.369 -27.752 -36.807 1.00 71.39 O \nANISOU 336 O CYS A 42 7486 8310 11329 -978 -271 -547 O \nATOM 337 CB CYS A 42 -7.565 -29.600 -34.122 1.00 78.66 C \nANISOU 337 CB CYS A 42 8445 9304 12138 -1180 -277 -532 C \nATOM 338 SG CYS A 42 -6.148 -30.288 -33.246 1.00 98.90 S \nANISOU 338 SG CYS A 42 11115 11838 14624 -1305 -230 -525 S \nATOM 339 N ASP A 43 -9.791 -29.382 -36.120 1.00 64.35 N \nANISOU 339 N ASP A 43 6454 7582 10413 -1018 -325 -573 N \nATOM 340 CA ASP A 43 -10.980 -28.640 -36.516 1.00 75.14 C \nANISOU 340 CA ASP A 43 7761 8949 11840 -907 -372 -574 C \nATOM 341 C ASP A 43 -11.121 -27.381 -35.669 1.00 77.96 C \nANISOU 341 C ASP A 43 8164 9226 12233 -854 -411 -536 C \nATOM 342 O ASP A 43 -10.442 -27.240 -34.656 1.00 86.10 O \nANISOU 342 O ASP A 43 9252 10221 13242 -903 -408 -511 O \nATOM 343 CB ASP A 43 -12.227 -29.481 -36.364 1.00 75.10 C \nANISOU 343 CB ASP A 43 7645 9058 11833 -887 -416 -594 C \nATOM 344 CG ASP A 43 -12.143 -30.760 -37.154 1.00 83.21 C \nANISOU 344 CG ASP A 43 8617 10182 12817 -946 -379 -632 C \nATOM 345 OD1 ASP A 43 -11.114 -30.925 -37.851 1.00 90.38 O \nANISOU 345 OD1 ASP A 43 9583 11056 13701 -1002 -320 -641 O \nATOM 346 OD2 ASP A 43 -13.084 -31.581 -37.094 1.00 78.93 O \nANISOU 346 OD2 ASP A 43 7975 9752 12262 -936 -409 -652 O \nATOM 347 N LEU A 44 -11.955 -26.453 -36.123 1.00 78.04 N \nANISOU 347 N LEU A 44 8153 9204 12295 -758 -444 -532 N \nATOM 348 CA LEU A 44 -12.484 -25.400 -35.263 1.00 78.33 C \nANISOU 348 CA LEU A 44 8211 9186 12363 -705 -497 -499 C \nATOM 349 C LEU A 44 -13.970 -25.630 -35.097 1.00 82.47 C \nANISOU 349 C LEU A 44 8654 9769 12911 -637 -559 -508 C \nATOM 350 O LEU A 44 -14.717 -25.582 -36.087 1.00 86.28 O \nANISOU 350 O LEU A 44 9092 10270 13419 -570 -565 -532 O \nATOM 351 CB LEU A 44 -12.296 -23.999 -35.861 1.00 78.90 C \nANISOU 351 CB LEU A 44 8339 9168 12472 -648 -491 -485 C \nATOM 352 CG LEU A 44 -10.943 -23.296 -35.753 1.00 77.92 C \nANISOU 352 CG LEU A 44 8305 8969 12330 -686 -447 -462 C \nATOM 353 CD1 LEU A 44 -11.028 -21.876 -36.324 1.00 60.88 C \nANISOU 353 CD1 LEU A 44 6182 6741 10208 -622 -453 -448 C \nATOM 354 CD2 LEU A 44 -10.481 -23.272 -34.304 1.00 79.31 C \nANISOU 354 CD2 LEU A 44 8521 9133 12482 -737 -462 -433 C \nATOM 355 N ASP A 45 -14.409 -25.807 -33.853 1.00 80.61 N \nANISOU 355 N ASP A 45 8404 9558 12667 -647 -605 -487 N \nATOM 356 CA ASP A 45 -15.840 -25.838 -33.547 1.00 90.22 C \nANISOU 356 CA ASP A 45 9557 10817 13906 -568 -671 -487 C \nATOM 357 C ASP A 45 -16.535 -26.856 -34.432 1.00 84.94 C \nANISOU 357 C ASP A 45 8795 10249 13230 -540 -666 -528 C \nATOM 358 O ASP A 45 -17.499 -26.532 -35.120 1.00 82.09 O \nANISOU 358 O ASP A 45 8401 9888 12900 -447 -691 -543 O \nATOM 359 CB ASP A 45 -16.472 -24.447 -33.759 1.00 97.87 C \nANISOU 359 CB ASP A 45 10566 11696 14924 -478 -707 -469 C \nATOM 360 CG ASP A 45 -15.579 -23.302 -33.248 1.00102.52 C \nANISOU 360 CG ASP A 45 11250 12185 15517 -510 -695 -433 C \nATOM 361 OD1 ASP A 45 -14.992 -23.435 -32.151 1.00 93.69 O \nANISOU 361 OD1 ASP A 45 10159 11065 14372 -573 -696 -410 O \nATOM 362 OD2 ASP A 45 -15.474 -22.279 -33.959 1.00111.66 O \nANISOU 362 OD2 ASP A 45 12452 13273 16702 -473 -684 -430 O \nATOM 363 N GLY A 46 -15.988 -28.073 -34.454 1.00 80.99 N \nANISOU 363 N GLY A 46 8259 9832 12682 -624 -630 -549 N \nATOM 364 CA GLY A 46 -16.540 -29.179 -35.244 1.00 77.84 C \nANISOU 364 CA GLY A 46 7765 9549 12263 -617 -620 -590 C \nATOM 365 C GLY A 46 -16.451 -29.047 -36.753 1.00 80.35 C \nANISOU 365 C GLY A 46 8077 9854 12599 -585 -580 -620 C \nATOM 366 O GLY A 46 -17.049 -29.843 -37.481 1.00 81.20 O \nANISOU 366 O GLY A 46 8101 10057 12694 -563 -576 -655 O \nATOM 367 N VAL A 47 -15.725 -28.032 -37.228 1.00 85.68 N \nANISOU 367 N VAL A 47 8837 10418 13301 -581 -550 -607 N \nATOM 368 CA VAL A 47 -15.533 -27.809 -38.665 1.00 81.17 C \nANISOU 368 CA VAL A 47 8270 9826 12746 -555 -509 -633 C \nATOM 369 C VAL A 47 -14.076 -27.968 -39.111 1.00 81.80 C \nANISOU 369 C VAL A 47 8416 9870 12797 -645 -440 -634 C \nATOM 370 O VAL A 47 -13.207 -27.180 -38.758 1.00 85.16 O \nANISOU 370 O VAL A 47 8927 10204 13226 -668 -423 -606 O \nATOM 371 CB VAL A 47 -16.028 -26.410 -39.093 1.00 82.91 C \nANISOU 371 CB VAL A 47 8531 9950 13021 -458 -534 -621 C \nATOM 372 CG1 VAL A 47 -15.689 -26.144 -40.554 1.00 81.30 C \nANISOU 372 CG1 VAL A 47 8338 9722 12829 -442 -487 -645 C \nATOM 373 CG2 VAL A 47 -17.534 -26.289 -38.852 1.00 78.85 C \nANISOU 373 CG2 VAL A 47 7961 9467 12533 -358 -600 -625 C \nATOM 374 N LYS A 48 -13.848 -28.974 -39.949 1.00 80.05 N \nANISOU 374 N LYS A 48 8151 9721 12542 -691 -399 -668 N \nATOM 375 CA LYS A 48 -12.523 -29.315 -40.429 1.00 75.42 C \nANISOU 375 CA LYS A 48 7627 9110 11920 -779 -333 -672 C \nATOM 376 C LYS A 48 -11.949 -28.176 -41.261 1.00 74.19 C \nANISOU 376 C LYS A 48 7542 8850 11795 -738 -304 -662 C \nATOM 377 O LYS A 48 -12.715 -27.352 -41.793 1.00 79.50 O \nANISOU 377 O LYS A 48 8196 9496 12516 -646 -330 -665 O \nATOM 378 CB LYS A 48 -12.616 -30.572 -41.269 1.00 75.07 C \nANISOU 378 CB LYS A 48 7515 9173 11837 -827 -302 -712 C \nATOM 379 CG LYS A 48 -11.296 -31.221 -41.642 1.00 80.20 C \nANISOU 379 CG LYS A 48 8227 9814 12433 -937 -236 -719 C \nATOM 380 CD LYS A 48 -11.508 -32.622 -42.227 1.00 83.56 C \nANISOU 380 CD LYS A 48 8575 10366 12809 -1002 -214 -757 C \nATOM 381 CE LYS A 48 -10.448 -32.930 -43.277 1.00 85.67 C \nANISOU 381 CE LYS A 48 8901 10608 13043 -1069 -147 -771 C \nATOM 382 NZ LYS A 48 -9.079 -32.990 -42.693 1.00 87.11 N \nANISOU 382 NZ LYS A 48 9200 10713 13184 -1160 -108 -747 N \nATOM 383 N PRO A 49 -10.600 -28.087 -41.332 1.00 61.62 N \nANISOU 383 N PRO A 49 6037 7200 10174 -803 -252 -649 N \nATOM 384 CA PRO A 49 -10.033 -27.097 -42.223 1.00 59.03 C \nANISOU 384 CA PRO A 49 5767 6791 9869 -764 -222 -642 C \nATOM 385 C PRO A 49 -9.822 -27.640 -43.604 1.00 66.71 C \nANISOU 385 C PRO A 49 6721 7798 10828 -778 -176 -674 C \nATOM 386 O PRO A 49 -10.151 -28.793 -43.890 1.00 77.54 O \nANISOU 386 O PRO A 49 8029 9260 12172 -819 -169 -704 O \nATOM 387 CB PRO A 49 -8.684 -26.790 -41.604 1.00 58.26 C \nANISOU 387 CB PRO A 49 5774 6622 9742 -819 -188 -612 C \nATOM 388 CG PRO A 49 -8.328 -28.018 -40.847 1.00 57.39 C \nANISOU 388 CG PRO A 49 5662 6564 9578 -914 -178 -618 C \nATOM 389 CD PRO A 49 -9.605 -28.624 -40.392 1.00 55.42 C \nANISOU 389 CD PRO A 49 5312 6404 9340 -898 -230 -633 C \nATOM 390 N LEU A 50 -9.307 -26.792 -44.476 1.00 68.84 N \nANISOU 390 N LEU A 50 7038 8002 11115 -743 -147 -668 N \nATOM 391 CA LEU A 50 -9.062 -27.169 -45.843 1.00 69.08 C \nANISOU 391 CA LEU A 50 7058 8057 11134 -752 -104 -696 C \nATOM 392 C LEU A 50 -7.581 -27.355 -46.046 1.00 66.84 C \nANISOU 392 C LEU A 50 6867 7726 10804 -821 -43 -684 C \nATOM 393 O LEU A 50 -6.840 -26.376 -46.220 1.00 75.30 O \nANISOU 393 O LEU A 50 8009 8717 11883 -792 -24 -660 O \nATOM 394 CB LEU A 50 -9.593 -26.092 -46.790 1.00 76.64 C \nANISOU 394 CB LEU A 50 8001 8979 12141 -661 -114 -700 C \nATOM 395 CG LEU A 50 -9.275 -26.292 -48.278 1.00 79.56 C \nANISOU 395 CG LEU A 50 8365 9362 12501 -663 -67 -725 C \nATOM 396 CD1 LEU A 50 -9.868 -27.581 -48.785 1.00 86.25 C \nANISOU 396 CD1 LEU A 50 9130 10315 13327 -695 -61 -765 C \nATOM 397 CD2 LEU A 50 -9.817 -25.143 -49.097 1.00 82.63 C \nANISOU 397 CD2 LEU A 50 8745 9714 12938 -575 -80 -727 C \nATOM 398 N ILE A 51 -7.122 -28.603 -46.024 1.00 60.37 N \nANISOU 398 N ILE A 51 6052 6957 9931 -912 -13 -700 N \nATOM 399 CA ILE A 51 -5.697 -28.872 -46.220 1.00 57.64 C \nANISOU 399 CA ILE A 51 5808 6560 9533 -980 46 -689 C \nATOM 400 C ILE A 51 -5.386 -29.077 -47.681 1.00 62.46 C \nANISOU 400 C ILE A 51 6421 7179 10131 -983 90 -710 C \nATOM 401 O ILE A 51 -5.720 -30.107 -48.248 1.00 73.30 O \nANISOU 401 O ILE A 51 7740 8631 11478 -1031 102 -741 O \nATOM 402 CB ILE A 51 -5.170 -30.047 -45.391 1.00 62.41 C \nANISOU 402 CB ILE A 51 6444 7195 10075 -1090 61 -691 C \nATOM 403 CG1 ILE A 51 -5.480 -29.894 -43.877 1.00 58.48 C \nANISOU 403 CG1 ILE A 51 5941 6694 9586 -1092 16 -670 C \nATOM 404 CG2 ILE A 51 -3.659 -30.122 -45.522 1.00 71.53 C \nANISOU 404 CG2 ILE A 51 7726 8274 11177 -1145 119 -676 C \nATOM 405 CD1 ILE A 51 -6.751 -30.578 -43.449 1.00 61.05 C \nANISOU 405 CD1 ILE A 51 6151 7123 9922 -1094 -32 -690 C \nATOM 406 N LEU A 52 -4.802 -28.061 -48.325 1.00 65.42 N \nANISOU 406 N LEU A 52 6852 7480 10523 -929 112 -693 N \nATOM 407 CA LEU A 52 -4.160 -28.269 -49.627 1.00 69.17 C \nANISOU 407 CA LEU A 52 7360 7949 10974 -944 164 -706 C \nATOM 408 C LEU A 52 -2.787 -28.837 -49.254 1.00 74.12 C \nANISOU 408 C LEU A 52 8100 8529 11532 -1027 210 -690 C \nATOM 409 O LEU A 52 -2.047 -28.247 -48.432 1.00 97.83 O \nANISOU 409 O LEU A 52 11183 11461 14527 -1016 213 -658 O \nATOM 410 CB LEU A 52 -4.027 -26.969 -50.422 1.00 67.42 C \nANISOU 410 CB LEU A 52 7155 7671 10789 -856 169 -692 C \nATOM 411 CG LEU A 52 -5.148 -26.075 -50.982 1.00 59.80 C \nANISOU 411 CG LEU A 52 6111 6721 9888 -765 132 -702 C \nATOM 412 CD1 LEU A 52 -6.463 -26.309 -50.314 1.00 58.22 C \nANISOU 412 CD1 LEU A 52 5822 6576 9722 -745 76 -717 C \nATOM 413 CD2 LEU A 52 -4.751 -24.604 -50.862 1.00 56.12 C \nANISOU 413 CD2 LEU A 52 5696 6179 9447 -698 126 -668 C \nATOM 414 N ARG A 53 -2.446 -29.995 -49.765 1.00 61.50 N \nANISOU 414 N ARG A 53 6515 6970 9882 -1112 246 -712 N \nATOM 415 CA ARG A 53 -1.323 -30.675 -49.168 1.00 65.20 C \nANISOU 415 CA ARG A 53 7091 7399 10282 -1201 281 -699 C \nATOM 416 C ARG A 53 -0.049 -30.121 -49.751 1.00 58.81 C \nANISOU 416 C ARG A 53 6401 6498 9446 -1180 330 -677 C \nATOM 417 O ARG A 53 0.715 -29.509 -49.039 1.00 59.12 O \nANISOU 417 O ARG A 53 6524 6464 9477 -1156 336 -647 O \nATOM 418 CB ARG A 53 -1.429 -32.242 -49.191 1.00 67.81 C \nANISOU 418 CB ARG A 53 7400 7812 10553 -1323 296 -729 C \nATOM 419 CG ARG A 53 -1.594 -32.896 -50.549 1.00 75.18 C \nANISOU 419 CG ARG A 53 8295 8804 11467 -1356 325 -759 C \nATOM 420 CD ARG A 53 -1.528 -34.423 -50.458 1.00 71.51 C \nANISOU 420 CD ARG A 53 7824 8417 10930 -1491 343 -784 C \nATOM 421 NE ARG A 53 -2.745 -34.960 -49.850 1.00 68.90 N \nANISOU 421 NE ARG A 53 7365 8198 10617 -1503 296 -806 N \nATOM 422 CZ ARG A 53 -2.785 -35.729 -48.759 1.00 80.26 C \nANISOU 422 CZ ARG A 53 8802 9677 12016 -1585 281 -806 C \nATOM 423 NH1 ARG A 53 -1.655 -36.085 -48.137 1.00 83.18 N \nANISOU 423 NH1 ARG A 53 9299 9979 12325 -1669 313 -789 N \nATOM 424 NH2 ARG A 53 -3.955 -36.172 -48.286 1.00 78.88 N \nANISOU 424 NH2 ARG A 53 8500 9614 11858 -1582 236 -825 N \nATOM 425 N ASP A 54 0.189 -30.369 -51.023 1.00 58.64 N \nANISOU 425 N ASP A 54 6386 6486 9407 -1189 365 -691 N \nATOM 426 CA ASP A 54 1.343 -29.815 -51.705 1.00 62.14 C \nANISOU 426 CA ASP A 54 6936 6849 9826 -1157 410 -669 C \nATOM 427 C ASP A 54 0.881 -28.824 -52.750 1.00 59.54 C \nANISOU 427 C ASP A 54 6545 6526 9551 -1061 402 -670 C \nATOM 428 O ASP A 54 1.674 -28.339 -53.534 1.00 59.26 O \nANISOU 428 O ASP A 54 6575 6442 9499 -1026 437 -656 O \nATOM 429 CB ASP A 54 2.141 -30.947 -52.356 1.00 70.55 C \nANISOU 429 CB ASP A 54 8079 7912 10815 -1255 462 -682 C \nATOM 430 CG ASP A 54 3.118 -31.577 -51.396 1.00 81.97 C \nANISOU 430 CG ASP A 54 9646 9304 12193 -1335 485 -668 C \nATOM 431 OD1 ASP A 54 3.745 -30.802 -50.621 1.00 85.96 O \nANISOU 431 OD1 ASP A 54 10224 9735 12702 -1283 484 -638 O \nATOM 432 OD2 ASP A 54 3.251 -32.829 -51.415 1.00 81.82 O \nANISOU 432 OD2 ASP A 54 9650 9320 12115 -1450 505 -688 O \nATOM 433 N CYS A 55 -0.421 -28.532 -52.751 1.00 63.62 N \nANISOU 433 N CYS A 55 6940 7104 10130 -1017 356 -688 N \nATOM 434 CA CYS A 55 -1.013 -27.554 -53.670 1.00 66.71 C \nANISOU 434 CA CYS A 55 7268 7503 10575 -927 342 -692 C \nATOM 435 C CYS A 55 -1.116 -26.135 -53.075 1.00 51.29 C \nANISOU 435 C CYS A 55 5319 5501 8668 -838 311 -662 C \nATOM 436 O CYS A 55 -1.291 -25.970 -51.871 1.00 43.03 O \nANISOU 436 O CYS A 55 4275 4443 7633 -838 280 -648 O \nATOM 437 CB CYS A 55 -2.372 -28.056 -54.171 1.00 69.45 C \nANISOU 437 CB CYS A 55 7488 7943 10956 -927 313 -731 C \nATOM 438 SG CYS A 55 -2.150 -29.364 -55.388 1.00 75.47 S \nANISOU 438 SG CYS A 55 8245 8767 11665 -1012 360 -765 S \nATOM 439 N SER A 56 -0.978 -25.138 -53.928 1.00 48.75 N \nANISOU 439 N SER A 56 5000 5156 8368 -769 320 -652 N \nATOM 440 CA SER A 56 -1.177 -23.729 -53.526 1.00 55.29 C \nANISOU 440 CA SER A 56 5819 5950 9237 -688 289 -627 C \nATOM 441 C SER A 56 -2.541 -23.241 -53.895 1.00 54.32 C \nANISOU 441 C SER A 56 5595 5870 9175 -638 246 -648 C \nATOM 442 O SER A 56 -3.252 -23.889 -54.676 1.00 69.05 O \nANISOU 442 O SER A 56 7395 7788 11051 -652 246 -682 O \nATOM 443 CB SER A 56 -0.152 -22.842 -54.217 1.00 57.07 C \nANISOU 443 CB SER A 56 6112 6130 9441 -641 326 -602 C \nATOM 444 OG SER A 56 -0.450 -22.759 -55.598 1.00 61.85 O \nANISOU 444 OG SER A 56 6677 6764 10059 -621 341 -621 O \nATOM 445 N VAL A 57 -2.901 -22.066 -53.396 1.00 53.50 N \nANISOU 445 N VAL A 57 5479 5740 9107 -579 211 -628 N \nATOM 446 CA VAL A 57 -4.257 -21.507 -53.674 1.00 46.53 C \nANISOU 446 CA VAL A 57 4512 4886 8282 -528 165 -646 C \nATOM 447 C VAL A 57 -4.519 -21.336 -55.159 1.00 43.40 C \nANISOU 447 C VAL A 57 4081 4513 7896 -501 185 -669 C \nATOM 448 O VAL A 57 -5.619 -21.676 -55.697 1.00 48.93 O \nANISOU 448 O VAL A 57 4706 5259 8626 -488 165 -703 O \nATOM 449 CB VAL A 57 -4.475 -20.185 -52.982 1.00 41.07 C \nANISOU 449 CB VAL A 57 3829 4157 7617 -477 129 -617 C \nATOM 450 CG1 VAL A 57 -5.727 -19.532 -53.467 1.00 37.55 C \nANISOU 450 CG1 VAL A 57 3319 3728 7222 -426 90 -635 C \nATOM 451 CG2 VAL A 57 -4.581 -20.383 -51.482 1.00 41.39 C \nANISOU 451 CG2 VAL A 57 3882 4186 7658 -501 97 -601 C \nATOM 452 N ALA A 58 -3.482 -20.941 -55.871 1.00 37.79 N \nANISOU 452 N ALA A 58 3427 3776 7155 -495 228 -652 N \nATOM 453 CA ALA A 58 -3.621 -20.812 -57.316 1.00 34.55 C \nANISOU 453 CA ALA A 58 2989 3389 6749 -475 252 -672 C \nATOM 454 C ALA A 58 -3.740 -22.140 -58.014 1.00 35.15 C \nANISOU 454 C ALA A 58 3038 3513 6806 -526 277 -707 C \nATOM 455 O ALA A 58 -4.661 -22.379 -58.808 1.00 35.21 O \nANISOU 455 O ALA A 58 2974 3568 6838 -514 267 -741 O \nATOM 456 CB ALA A 58 -2.471 -20.042 -57.859 1.00 34.81 C \nANISOU 456 CB ALA A 58 3088 3387 6751 -452 290 -643 C \nATOM 457 N GLY A 59 -2.790 -23.036 -57.711 1.00 39.95 N \nANISOU 457 N GLY A 59 3707 4109 7363 -589 311 -698 N \nATOM 458 CA GLY A 59 -2.881 -24.482 -58.149 1.00 40.19 C \nANISOU 458 CA GLY A 59 3716 4193 7363 -661 334 -730 C \nATOM 459 C GLY A 59 -4.243 -25.122 -57.907 1.00 36.07 C \nANISOU 459 C GLY A 59 3091 3739 6873 -668 294 -767 C \nATOM 460 O GLY A 59 -4.777 -25.741 -58.763 1.00 34.26 O \nANISOU 460 O GLY A 59 2804 3570 6643 -682 302 -801 O \nATOM 461 N TRP A 60 -4.837 -24.835 -56.778 1.00 35.57 N \nANISOU 461 N TRP A 60 3006 3670 6840 -647 248 -758 N \nATOM 462 CA TRP A 60 -6.146 -25.329 -56.443 1.00 37.68 C \nANISOU 462 CA TRP A 60 3180 4000 7137 -638 205 -788 C \nATOM 463 C TRP A 60 -7.230 -24.671 -57.247 1.00 43.88 C \nANISOU 463 C TRP A 60 3896 4807 7971 -564 180 -811 C \nATOM 464 O TRP A 60 -8.101 -25.359 -57.808 1.00 44.98 O \nANISOU 464 O TRP A 60 3957 5018 8116 -562 173 -850 O \nATOM 465 CB TRP A 60 -6.421 -25.165 -54.933 1.00 38.49 C \nANISOU 465 CB TRP A 60 3287 4083 7254 -635 163 -767 C \nATOM 466 CG TRP A 60 -7.882 -25.204 -54.558 1.00 39.91 C \nANISOU 466 CG TRP A 60 3376 4309 7476 -591 107 -789 C \nATOM 467 CD1 TRP A 60 -8.801 -26.075 -54.988 1.00 43.25 C \nANISOU 467 CD1 TRP A 60 3714 4816 7902 -594 97 -829 C \nATOM 468 CD2 TRP A 60 -8.528 -24.397 -53.585 1.00 40.79 C \nANISOU 468 CD2 TRP A 60 3482 4390 7628 -539 55 -771 C \nATOM 469 NE1 TRP A 60 -10.028 -25.845 -54.393 1.00 47.19 N \nANISOU 469 NE1 TRP A 60 4152 5337 8440 -537 40 -838 N \nATOM 470 CE2 TRP A 60 -9.888 -24.777 -53.559 1.00 43.83 C \nANISOU 470 CE2 TRP A 60 3779 4836 8040 -503 14 -801 C \nATOM 471 CE3 TRP A 60 -8.106 -23.356 -52.771 1.00 40.17 C \nANISOU 471 CE3 TRP A 60 3463 4239 7560 -518 39 -732 C \nATOM 472 CZ2 TRP A 60 -10.823 -24.136 -52.793 1.00 45.83 C \nANISOU 472 CZ2 TRP A 60 4010 5070 8332 -444 -42 -793 C \nATOM 473 CZ3 TRP A 60 -9.051 -22.709 -51.987 1.00 42.54 C \nANISOU 473 CZ3 TRP A 60 3738 4525 7900 -468 -17 -723 C \nATOM 474 CH2 TRP A 60 -10.380 -23.108 -51.982 1.00 46.73 C \nANISOU 474 CH2 TRP A 60 4190 5107 8457 -432 -57 -752 C \nATOM 475 N LEU A 61 -7.204 -23.330 -57.339 1.00 48.90 N \nANISOU 475 N LEU A 61 4559 5385 8636 -502 168 -789 N \nATOM 476 CA LEU A 61 -8.344 -22.626 -58.003 1.00 40.09 C \nANISOU 476 CA LEU A 61 3385 4281 7567 -431 138 -811 C \nATOM 477 C LEU A 61 -8.286 -22.787 -59.497 1.00 41.42 C \nANISOU 477 C LEU A 61 3531 4481 7725 -429 175 -838 C \nATOM 478 O LEU A 61 -9.326 -22.863 -60.156 1.00 48.33 O \nANISOU 478 O LEU A 61 4340 5398 8626 -391 158 -874 O \nATOM 479 CB LEU A 61 -8.399 -21.170 -57.620 1.00 37.98 C \nANISOU 479 CB LEU A 61 3154 3950 7328 -378 111 -781 C \nATOM 480 CG LEU A 61 -8.797 -20.847 -56.195 1.00 38.55 C \nANISOU 480 CG LEU A 61 3234 3995 7419 -366 64 -759 C \nATOM 481 CD1 LEU A 61 -8.786 -19.336 -55.993 1.00 36.18 C \nANISOU 481 CD1 LEU A 61 2972 3636 7140 -322 42 -730 C \nATOM 482 CD2 LEU A 61 -10.184 -21.373 -55.895 1.00 40.12 C \nANISOU 482 CD2 LEU A 61 3359 4238 7647 -339 18 -790 C \nATOM 483 N LEU A 62 -7.102 -22.872 -60.054 1.00 38.39 N \nANISOU 483 N LEU A 62 3204 4078 7303 -466 224 -822 N \nATOM 484 CA LEU A 62 -7.015 -23.048 -61.526 1.00 46.23 C \nANISOU 484 CA LEU A 62 4178 5103 8284 -467 260 -847 C \nATOM 485 C LEU A 62 -7.046 -24.519 -61.959 1.00 49.07 C \nANISOU 485 C LEU A 62 4501 5534 8609 -532 286 -879 C \nATOM 486 O LEU A 62 -6.958 -24.816 -63.134 1.00 43.42 O \nANISOU 486 O LEU A 62 3768 4853 7878 -543 317 -901 O \nATOM 487 CB LEU A 62 -5.716 -22.391 -62.040 1.00 43.82 C \nANISOU 487 CB LEU A 62 3953 4747 7949 -471 303 -813 C \nATOM 488 CG LEU A 62 -5.549 -20.921 -61.807 1.00 39.28 C \nANISOU 488 CG LEU A 62 3412 4118 7396 -414 286 -781 C \nATOM 489 CD1 LEU A 62 -4.152 -20.518 -62.132 1.00 37.53 C \nANISOU 489 CD1 LEU A 62 3269 3859 7133 -422 329 -745 C \nATOM 490 CD2 LEU A 62 -6.533 -20.188 -62.677 1.00 40.11 C \nANISOU 490 CD2 LEU A 62 3463 4240 7539 -361 266 -805 C \nATOM 491 N GLY A 63 -7.026 -25.426 -60.985 1.00 55.29 N \nANISOU 491 N GLY A 63 5285 6344 9378 -582 276 -879 N \nATOM 492 CA GLY A 63 -7.124 -26.850 -61.247 1.00 57.27 C \nANISOU 492 CA GLY A 63 5495 6674 9590 -653 295 -910 C \nATOM 493 C GLY A 63 -5.849 -27.469 -61.780 1.00 60.84 C \nANISOU 493 C GLY A 63 6021 7114 9982 -731 352 -899 C \nATOM 494 O GLY A 63 -5.877 -28.247 -62.722 1.00 57.30 O \nANISOU 494 O GLY A 63 5542 6725 9505 -773 381 -927 O \nATOM 495 N ASN A 64 -4.714 -27.116 -61.200 1.00 64.41 N \nANISOU 495 N ASN A 64 6573 7489 10411 -749 370 -857 N \nATOM 496 CA ASN A 64 -3.471 -27.804 -61.536 1.00 65.85 C \nANISOU 496 CA ASN A 64 6842 7651 10528 -826 423 -845 C \nATOM 497 C ASN A 64 -3.747 -29.320 -61.430 1.00 63.41 C \nANISOU 497 C ASN A 64 6493 7423 10178 -920 430 -876 C \nATOM 498 O ASN A 64 -4.245 -29.763 -60.416 1.00 57.59 O \nANISOU 498 O ASN A 64 5720 6715 9446 -941 400 -881 O \nATOM 499 CB ASN A 64 -2.353 -27.368 -60.567 1.00 64.44 C \nANISOU 499 CB ASN A 64 6773 7383 10327 -830 432 -799 C \nATOM 500 CG ASN A 64 -1.025 -28.082 -60.810 1.00 61.36 C \nANISOU 500 CG ASN A 64 6492 6959 9865 -906 485 -784 C \nATOM 501 OD1 ASN A 64 -0.964 -29.292 -60.867 1.00 67.28 O \nANISOU 501 OD1 ASN A 64 7241 7752 10570 -994 503 -804 O \nATOM 502 ND2 ASN A 64 0.052 -27.322 -60.889 1.00 59.44 N \nANISOU 502 ND2 ASN A 64 6345 6637 9603 -871 511 -747 N \nATOM 503 N PRO A 65 -3.357 -30.103 -62.454 1.00 62.05 N \nANISOU 503 N PRO A 65 6330 7287 9958 -982 472 -894 N \nATOM 504 CA PRO A 65 -3.613 -31.533 -62.597 1.00 66.49 C \nANISOU 504 CA PRO A 65 6849 7942 10473 -1080 484 -927 C \nATOM 505 C PRO A 65 -3.224 -32.414 -61.403 1.00 71.44 C \nANISOU 505 C PRO A 65 7519 8571 11055 -1168 482 -917 C \nATOM 506 O PRO A 65 -3.774 -33.516 -61.227 1.00 77.49 O \nANISOU 506 O PRO A 65 8217 9434 11792 -1239 475 -947 O \nATOM 507 CB PRO A 65 -2.773 -31.926 -63.803 1.00 64.14 C \nANISOU 507 CB PRO A 65 6609 7639 10123 -1134 538 -928 C \nATOM 508 CG PRO A 65 -2.644 -30.705 -64.599 1.00 59.21 C \nANISOU 508 CG PRO A 65 5999 6961 9538 -1040 543 -914 C \nATOM 509 CD PRO A 65 -2.558 -29.596 -63.580 1.00 62.75 C \nANISOU 509 CD PRO A 65 6480 7331 10031 -964 512 -880 C \nATOM 510 N MET A 66 -2.314 -31.917 -60.576 1.00 69.01 N \nANISOU 510 N MET A 66 7316 8164 10739 -1163 487 -877 N \nATOM 511 CA MET A 66 -1.859 -32.634 -59.396 1.00 68.48 C \nANISOU 511 CA MET A 66 7305 8085 10630 -1242 487 -865 C \nATOM 512 C MET A 66 -2.647 -32.265 -58.159 1.00 63.34 C \nANISOU 512 C MET A 66 6596 7444 10027 -1196 433 -860 C \nATOM 513 O MET A 66 -2.396 -32.746 -57.076 1.00 72.96 O \nANISOU 513 O MET A 66 7848 8654 11218 -1252 425 -850 O \nATOM 514 CB MET A 66 -0.370 -32.380 -59.222 1.00 76.72 C \nANISOU 514 CB MET A 66 8506 9016 11629 -1264 526 -825 C \nATOM 515 CG MET A 66 0.393 -32.774 -60.507 1.00 89.60 C \nANISOU 515 CG MET A 66 10199 10637 13207 -1309 579 -829 C \nATOM 516 SD MET A 66 2.158 -33.079 -60.333 1.00115.98 S \nANISOU 516 SD MET A 66 13738 13867 16463 -1375 633 -792 S \nATOM 517 CE MET A 66 2.813 -31.402 -60.559 1.00123.35 C \nANISOU 517 CE MET A 66 14733 14696 17439 -1234 637 -750 C \nATOM 518 N CYS A 67 -3.658 -31.440 -58.337 1.00 67.35 N \nANISOU 518 N CYS A 67 7014 7971 10604 -1096 395 -870 N \nATOM 519 CA CYS A 67 -4.477 -30.926 -57.244 1.00 60.23 C \nANISOU 519 CA CYS A 67 6061 7070 9754 -1038 341 -863 C \nATOM 520 C CYS A 67 -5.900 -31.477 -57.347 1.00 57.63 C \nANISOU 520 C CYS A 67 5594 6855 9449 -1022 304 -904 C \nATOM 521 O CYS A 67 -6.788 -31.060 -56.611 1.00 51.53 O \nANISOU 521 O CYS A 67 4764 6094 8722 -961 255 -903 O \nATOM 522 CB CYS A 67 -4.470 -29.373 -57.303 1.00 56.76 C \nANISOU 522 CB CYS A 67 5645 6549 9373 -928 324 -836 C \nATOM 523 SG CYS A 67 -2.824 -28.618 -57.128 1.00 61.86 S \nANISOU 523 SG CYS A 67 6444 7073 9989 -927 364 -787 S \nATOM 524 N ASP A 68 -6.077 -32.462 -58.208 1.00 63.28 N \nANISOU 524 N ASP A 68 6260 7658 10126 -1080 329 -937 N \nATOM 525 CA ASP A 68 -7.399 -33.083 -58.428 1.00 71.76 C \nANISOU 525 CA ASP A 68 7198 8857 11212 -1064 299 -980 C \nATOM 526 C ASP A 68 -8.198 -33.447 -57.188 1.00 73.29 C \nANISOU 526 C ASP A 68 7327 9104 11415 -1059 251 -984 C \nATOM 527 O ASP A 68 -9.424 -33.445 -57.230 1.00 70.50 O \nANISOU 527 O ASP A 68 6867 8824 11095 -992 212 -1010 O \nATOM 528 CB ASP A 68 -7.277 -34.307 -59.321 1.00 78.87 C \nANISOU 528 CB ASP A 68 8063 9853 12049 -1157 337 -1013 C \nATOM 529 CG ASP A 68 -7.439 -33.966 -60.779 1.00 79.49 C \nANISOU 529 CG ASP A 68 8116 9943 12143 -1114 360 -1034 C \nATOM 530 OD1 ASP A 68 -6.404 -33.797 -61.464 1.00 82.21 O \nANISOU 530 OD1 ASP A 68 8551 10224 12462 -1148 404 -1017 O \nATOM 531 OD2 ASP A 68 -8.599 -33.867 -61.235 1.00 84.84 O \nANISOU 531 OD2 ASP A 68 8685 10694 12856 -1043 333 -1067 O \nATOM 532 N GLU A 69 -7.521 -33.753 -56.089 1.00 75.05 N \nANISOU 532 N GLU A 69 7617 9292 11607 -1126 252 -958 N \nATOM 533 CA GLU A 69 -8.230 -34.068 -54.852 1.00 72.76 C \nANISOU 533 CA GLU A 69 7270 9051 11324 -1124 205 -957 C \nATOM 534 C GLU A 69 -9.051 -32.920 -54.315 1.00 76.33 C \nANISOU 534 C GLU A 69 7694 9457 11852 -1001 153 -943 C \nATOM 535 O GLU A 69 -9.774 -33.065 -53.324 1.00 67.01 O \nANISOU 535 O GLU A 69 6461 8315 10684 -981 108 -942 O \nATOM 536 CB GLU A 69 -7.254 -34.546 -53.780 1.00 76.02 C \nANISOU 536 CB GLU A 69 7774 9424 11687 -1223 220 -930 C \nATOM 537 CG GLU A 69 -6.059 -33.659 -53.535 1.00 80.19 C \nANISOU 537 CG GLU A 69 8439 9808 12221 -1213 244 -889 C \nATOM 538 CD GLU A 69 -5.184 -34.156 -52.387 1.00 92.21 C \nANISOU 538 CD GLU A 69 10049 11293 13692 -1305 255 -865 C \nATOM 539 OE1 GLU A 69 -5.718 -34.475 -51.276 1.00 74.16 O \nANISOU 539 OE1 GLU A 69 7719 9051 11407 -1319 217 -864 O \nATOM 540 OE2 GLU A 69 -3.951 -34.240 -52.629 1.00101.36 O \nANISOU 540 OE2 GLU A 69 11326 12379 14806 -1361 302 -849 O \nATOM 541 N PHE A 70 -8.889 -31.747 -54.936 1.00 86.21 N \nANISOU 541 N PHE A 70 8986 10620 13148 -922 158 -930 N \nATOM 542 CA PHE A 70 -9.576 -30.516 -54.480 1.00 80.85 C \nANISOU 542 CA PHE A 70 8299 9883 12538 -812 111 -913 C \nATOM 543 C PHE A 70 -10.478 -30.003 -55.582 1.00 83.94 C \nANISOU 543 C PHE A 70 8626 10296 12970 -723 101 -941 C \nATOM 544 O PHE A 70 -10.797 -28.802 -55.638 1.00 83.07 O \nANISOU 544 O PHE A 70 8534 10116 12911 -638 78 -927 O \nATOM 545 CB PHE A 70 -8.573 -29.428 -54.045 1.00 76.85 C \nANISOU 545 CB PHE A 70 7905 9248 12044 -798 122 -868 C \nATOM 546 CG PHE A 70 -7.486 -29.931 -53.123 1.00 67.09 C \nANISOU 546 CG PHE A 70 6752 7979 10759 -888 144 -842 C \nATOM 547 CD1 PHE A 70 -7.793 -30.342 -51.816 1.00 60.56 C \nANISOU 547 CD1 PHE A 70 5908 7178 9926 -915 110 -833 C \nATOM 548 CD2 PHE A 70 -6.159 -30.011 -53.573 1.00 62.31 C \nANISOU 548 CD2 PHE A 70 6246 7318 10111 -944 198 -826 C \nATOM 549 CE1 PHE A 70 -6.789 -30.803 -50.950 1.00 59.80 C \nANISOU 549 CE1 PHE A 70 5893 7049 9781 -1000 130 -811 C \nATOM 550 CE2 PHE A 70 -5.161 -30.495 -52.734 1.00 62.29 C \nANISOU 550 CE2 PHE A 70 6329 7280 10059 -1024 220 -805 C \nATOM 551 CZ PHE A 70 -5.483 -30.892 -51.412 1.00 61.54 C \nANISOU 551 CZ PHE A 70 6216 7210 9958 -1055 186 -798 C \nATOM 552 N ILE A 71 -10.890 -30.926 -56.455 1.00 84.95 N \nANISOU 552 N ILE A 71 8680 10526 13072 -749 118 -981 N \nATOM 553 CA ILE A 71 -11.755 -30.592 -57.554 1.00 83.54 C \nANISOU 553 CA ILE A 71 8436 10381 12926 -671 112 -1014 C \nATOM 554 C ILE A 71 -13.119 -30.103 -57.019 1.00 87.10 C \nANISOU 554 C ILE A 71 8822 10846 13426 -565 50 -1023 C \nATOM 555 O ILE A 71 -13.741 -29.262 -57.640 1.00 89.58 O \nANISOU 555 O ILE A 71 9124 11129 13783 -478 35 -1033 O \nATOM 556 CB ILE A 71 -11.935 -31.771 -58.538 1.00 88.90 C \nANISOU 556 CB ILE A 71 9041 11178 13558 -724 143 -1057 C \nATOM 557 CG1 ILE A 71 -12.635 -31.312 -59.818 1.00 89.04 C \nANISOU 557 CG1 ILE A 71 9010 11216 13607 -644 146 -1089 C \nATOM 558 CG2 ILE A 71 -12.761 -32.888 -57.900 1.00 97.13 C \nANISOU 558 CG2 ILE A 71 9985 12348 14573 -747 115 -1082 C \nATOM 559 CD1 ILE A 71 -12.580 -32.336 -60.938 1.00 90.94 C \nANISOU 559 CD1 ILE A 71 9195 11560 13799 -704 187 -1128 C \nATOM 560 N ASN A 72 -13.583 -30.625 -55.882 1.00 84.62 N \nANISOU 560 N ASN A 72 8470 10578 13104 -574 14 -1019 N \nATOM 561 CA ASN A 72 -14.886 -30.214 -55.326 1.00 86.61 C \nANISOU 561 CA ASN A 72 8667 10843 13399 -471 -47 -1025 C \nATOM 562 C ASN A 72 -14.964 -30.364 -53.823 1.00 86.19 C \nANISOU 562 C ASN A 72 8622 10785 13343 -488 -85 -998 C \nATOM 563 O ASN A 72 -15.655 -31.210 -53.284 1.00 93.92 O \nANISOU 563 O ASN A 72 9522 11862 14300 -490 -112 -1014 O \nATOM 564 CB ASN A 72 -16.041 -30.908 -56.042 1.00 86.21 C \nANISOU 564 CB ASN A 72 8500 10914 13342 -420 -59 -1076 C \nATOM 565 CG ASN A 72 -16.816 -29.950 -56.907 1.00 89.59 C \nANISOU 565 CG ASN A 72 8923 11300 13819 -309 -73 -1094 C \nATOM 566 OD1 ASN A 72 -17.317 -28.920 -56.430 1.00108.30 O \nANISOU 566 OD1 ASN A 72 11329 13587 16234 -230 -113 -1075 O \nATOM 567 ND2 ASN A 72 -16.916 -30.258 -58.183 1.00 91.89 N \nANISOU 567 ND2 ASN A 72 9173 11644 14096 -307 -41 -1130 N \nATOM 568 N VAL A 73 -14.214 -29.501 -53.164 1.00 89.20 N \nANISOU 568 N VAL A 73 9098 11052 13741 -500 -86 -955 N \nATOM 569 CA VAL A 73 -14.118 -29.509 -51.722 1.00 82.56 C \nANISOU 569 CA VAL A 73 8282 10190 12897 -522 -118 -923 C \nATOM 570 C VAL A 73 -15.429 -29.016 -51.081 1.00 78.32 C \nANISOU 570 C VAL A 73 7700 9655 12401 -420 -184 -923 C \nATOM 571 O VAL A 73 -16.202 -28.298 -51.711 1.00 67.51 O \nANISOU 571 O VAL A 73 6318 8261 11072 -328 -203 -937 O \nATOM 572 CB VAL A 73 -12.913 -28.651 -51.233 1.00 80.74 C \nANISOU 572 CB VAL A 73 8168 9837 12670 -558 -98 -878 C \nATOM 573 CG1 VAL A 73 -11.606 -29.172 -51.808 1.00 82.94 C \nANISOU 573 CG1 VAL A 73 8502 10108 12902 -653 -34 -877 C \nATOM 574 CG2 VAL A 73 -13.096 -27.168 -51.553 1.00 77.31 C \nANISOU 574 CG2 VAL A 73 7780 9304 12288 -473 -114 -861 C \nATOM 575 N PRO A 74 -15.647 -29.366 -49.807 1.00 80.98 N \nANISOU 575 N PRO A 74 8024 10016 12728 -437 -219 -905 N \nATOM 576 CA PRO A 74 -16.752 -28.847 -49.020 1.00 80.10 C \nANISOU 576 CA PRO A 74 7891 9892 12652 -346 -284 -895 C \nATOM 577 C PRO A 74 -16.325 -27.756 -48.073 1.00 82.69 C \nANISOU 577 C PRO A 74 8310 10102 13007 -342 -305 -848 C \nATOM 578 O PRO A 74 -15.184 -27.314 -48.114 1.00 84.95 O \nANISOU 578 O PRO A 74 8676 10316 13287 -398 -268 -825 O \nATOM 579 CB PRO A 74 -17.212 -30.076 -48.232 1.00 86.45 C \nANISOU 579 CB PRO A 74 8614 10817 13418 -379 -306 -906 C \nATOM 580 CG PRO A 74 -15.987 -30.915 -48.071 1.00 86.55 C \nANISOU 580 CG PRO A 74 8653 10855 13376 -512 -257 -900 C \nATOM 581 CD PRO A 74 -14.991 -30.500 -49.131 1.00 87.25 C \nANISOU 581 CD PRO A 74 8810 10875 13466 -547 -200 -901 C \nATOM 582 N GLU A 75 -17.257 -27.326 -47.227 1.00 86.70 N \nANISOU 582 N GLU A 75 8807 10594 13541 -273 -364 -834 N \nATOM 583 CA GLU A 75 -17.052 -26.178 -46.345 1.00 84.61 C \nANISOU 583 CA GLU A 75 8624 10219 13303 -258 -392 -791 C \nATOM 584 C GLU A 75 -15.837 -26.333 -45.439 1.00 83.01 C \nANISOU 584 C GLU A 75 8479 9988 13072 -357 -369 -758 C \nATOM 585 O GLU A 75 -15.472 -27.442 -45.089 1.00 97.18 O \nANISOU 585 O GLU A 75 10241 11857 14825 -429 -352 -765 O \nATOM 586 CB GLU A 75 -18.308 -25.982 -45.518 1.00 83.48 C \nANISOU 586 CB GLU A 75 8451 10086 13182 -178 -461 -784 C \nATOM 587 CG GLU A 75 -18.262 -24.807 -44.565 1.00 91.48 C \nANISOU 587 CG GLU A 75 9544 10993 14220 -160 -497 -739 C \nATOM 588 CD GLU A 75 -19.584 -24.601 -43.857 1.00101.19 C \nANISOU 588 CD GLU A 75 10751 12227 15470 -73 -567 -734 C \nATOM 589 OE1 GLU A 75 -20.603 -25.193 -44.299 1.00 98.84 O \nANISOU 589 OE1 GLU A 75 10380 12004 15172 -5 -586 -767 O \nATOM 590 OE2 GLU A 75 -19.591 -23.823 -42.868 1.00116.84 O \nANISOU 590 OE2 GLU A 75 12791 14137 17464 -71 -602 -695 O \nATOM 591 N TRP A 76 -15.227 -25.216 -45.041 1.00 75.90 N \nANISOU 591 N TRP A 76 7665 8984 12189 -360 -369 -721 N \nATOM 592 CA TRP A 76 -14.026 -25.261 -44.210 1.00 70.83 C \nANISOU 592 CA TRP A 76 7087 8308 11519 -445 -345 -690 C \nATOM 593 C TRP A 76 -13.934 -24.144 -43.166 1.00 74.52 C \nANISOU 593 C TRP A 76 7619 8691 12007 -427 -379 -648 C \nATOM 594 O TRP A 76 -14.480 -23.065 -43.350 1.00 84.77 O \nANISOU 594 O TRP A 76 8938 9932 13340 -361 -407 -638 O \nATOM 595 CB TRP A 76 -12.764 -25.240 -45.091 1.00 70.33 C \nANISOU 595 CB TRP A 76 7075 8214 11434 -498 -277 -693 C \nATOM 596 CG TRP A 76 -12.524 -23.874 -45.779 1.00 65.53 C \nANISOU 596 CG TRP A 76 6522 7520 10856 -448 -268 -679 C \nATOM 597 CD1 TRP A 76 -12.023 -22.770 -45.210 1.00 58.45 C \nANISOU 597 CD1 TRP A 76 5695 6543 9970 -442 -275 -643 C \nATOM 598 CD2 TRP A 76 -12.805 -23.530 -47.143 1.00 54.58 C \nANISOU 598 CD2 TRP A 76 5117 6131 9489 -402 -249 -704 C \nATOM 599 NE1 TRP A 76 -11.990 -21.759 -46.113 1.00 56.48 N \nANISOU 599 NE1 TRP A 76 5471 6247 9743 -398 -264 -642 N \nATOM 600 CE2 TRP A 76 -12.457 -22.209 -47.314 1.00 56.28 C \nANISOU 600 CE2 TRP A 76 5395 6265 9725 -373 -248 -679 C \nATOM 601 CE3 TRP A 76 -13.321 -24.223 -48.221 1.00 49.71 C \nANISOU 601 CE3 TRP A 76 4437 5580 8871 -385 -234 -745 C \nATOM 602 CZ2 TRP A 76 -12.589 -21.561 -48.534 1.00 56.17 C \nANISOU 602 CZ2 TRP A 76 5383 6230 9729 -331 -231 -694 C \nATOM 603 CZ3 TRP A 76 -13.448 -23.600 -49.416 1.00 50.61 C \nANISOU 603 CZ3 TRP A 76 4554 5669 9005 -341 -217 -760 C \nATOM 604 CH2 TRP A 76 -13.099 -22.283 -49.570 1.00 52.81 C \nANISOU 604 CH2 TRP A 76 4897 5864 9304 -314 -216 -735 C \nATOM 605 N SER A 77 -13.171 -24.403 -42.101 1.00 71.33 N \nANISOU 605 N SER A 77 7252 8278 11574 -495 -373 -623 N \nATOM 606 CA SER A 77 -12.958 -23.447 -41.038 1.00 72.43 C \nANISOU 606 CA SER A 77 7450 8347 11722 -492 -401 -582 C \nATOM 607 C SER A 77 -11.756 -22.525 -41.325 1.00 67.20 C \nANISOU 607 C SER A 77 6872 7608 11055 -512 -359 -560 C \nATOM 608 O SER A 77 -11.877 -21.309 -41.218 1.00 70.95 O \nANISOU 608 O SER A 77 7383 8021 11553 -472 -379 -538 O \nATOM 609 CB SER A 77 -12.791 -24.186 -39.706 1.00 78.18 C \nANISOU 609 CB SER A 77 8173 9110 12421 -551 -418 -567 C \nATOM 610 OG SER A 77 -11.686 -25.080 -39.716 1.00 81.24 O \nANISOU 610 OG SER A 77 8582 9523 12762 -640 -365 -574 O \nATOM 611 N TYR A 78 -10.632 -23.103 -41.738 1.00 64.36 N \nANISOU 611 N TYR A 78 6540 7255 10659 -573 -300 -568 N \nATOM 612 CA TYR A 78 -9.471 -22.326 -42.235 1.00 64.38 C \nANISOU 612 CA TYR A 78 6617 7195 10651 -581 -254 -551 C \nATOM 613 C TYR A 78 -8.712 -23.109 -43.294 1.00 59.79 C \nANISOU 613 C TYR A 78 6041 6637 10039 -619 -193 -576 C \nATOM 614 O TYR A 78 -9.100 -24.197 -43.634 1.00 64.05 O \nANISOU 614 O TYR A 78 6527 7242 10567 -644 -188 -605 O \nATOM 615 CB TYR A 78 -8.533 -21.930 -41.094 1.00 69.85 C \nANISOU 615 CB TYR A 78 7380 7843 11318 -619 -248 -516 C \nATOM 616 CG TYR A 78 -7.954 -23.121 -40.333 1.00 73.98 C \nANISOU 616 CG TYR A 78 7915 8399 11796 -699 -230 -519 C \nATOM 617 CD1 TYR A 78 -6.638 -23.511 -40.548 1.00 78.78 C \nANISOU 617 CD1 TYR A 78 8588 8986 12359 -753 -170 -518 C \nATOM 618 CD2 TYR A 78 -8.721 -23.839 -39.424 1.00 69.12 C \nANISOU 618 CD2 TYR A 78 7250 7833 11179 -720 -271 -523 C \nATOM 619 CE1 TYR A 78 -6.101 -24.584 -39.882 1.00 78.76 C \nANISOU 619 CE1 TYR A 78 8608 9008 12310 -832 -152 -522 C \nATOM 620 CE2 TYR A 78 -8.198 -24.902 -38.739 1.00 78.22 C \nANISOU 620 CE2 TYR A 78 8414 9020 12287 -800 -254 -526 C \nATOM 621 CZ TYR A 78 -6.887 -25.278 -38.978 1.00 84.91 C \nANISOU 621 CZ TYR A 78 9332 9841 13089 -860 -194 -527 C \nATOM 622 OH TYR A 78 -6.351 -26.331 -38.292 1.00 89.70 O \nANISOU 622 OH TYR A 78 9962 10476 13645 -947 -176 -531 O \nATOM 623 N ILE A 79 -7.666 -22.520 -43.863 1.00 55.85 N \nANISOU 623 N ILE A 79 5606 6089 9526 -621 -149 -564 N \nATOM 624 CA ILE A 79 -6.946 -23.121 -44.971 1.00 49.94 C \nANISOU 624 CA ILE A 79 4872 5354 8750 -650 -92 -584 C \nATOM 625 C ILE A 79 -5.500 -23.227 -44.569 1.00 56.21 C \nANISOU 625 C ILE A 79 5756 6106 9495 -701 -46 -563 C \nATOM 626 O ILE A 79 -4.940 -22.331 -43.981 1.00 67.96 O \nANISOU 626 O ILE A 79 7298 7543 10980 -683 -48 -532 O \nATOM 627 CB ILE A 79 -7.067 -22.293 -46.276 1.00 51.42 C \nANISOU 627 CB ILE A 79 5052 5522 8962 -591 -77 -592 C \nATOM 628 CG1 ILE A 79 -8.543 -22.289 -46.795 1.00 51.56 C \nANISOU 628 CG1 ILE A 79 4985 5581 9025 -537 -119 -619 C \nATOM 629 CG2 ILE A 79 -6.142 -22.842 -47.375 1.00 50.58 C \nANISOU 629 CG2 ILE A 79 4976 5421 8821 -623 -15 -606 C \nATOM 630 CD1 ILE A 79 -8.821 -21.246 -47.857 1.00 49.26 C \nANISOU 630 CD1 ILE A 79 4690 5262 8763 -475 -117 -623 C \nATOM 631 N VAL A 80 -4.903 -24.361 -44.878 1.00 56.68 N \nANISOU 631 N VAL A 80 5835 6190 9512 -766 -5 -580 N \nATOM 632 CA VAL A 80 -3.527 -24.573 -44.504 1.00 53.74 C \nANISOU 632 CA VAL A 80 5559 5772 9085 -816 40 -563 C \nATOM 633 C VAL A 80 -2.747 -24.881 -45.754 1.00 48.98 C \nANISOU 633 C VAL A 80 4996 5160 8453 -829 96 -575 C \nATOM 634 O VAL A 80 -3.151 -25.731 -46.538 1.00 40.49 O \nANISOU 634 O VAL A 80 3875 4137 7374 -858 107 -605 O \nATOM 635 CB VAL A 80 -3.374 -25.692 -43.426 1.00 59.73 C \nANISOU 635 CB VAL A 80 6332 6558 9806 -900 36 -566 C \nATOM 636 CG1 VAL A 80 -4.617 -26.578 -43.377 1.00 59.03 C \nANISOU 636 CG1 VAL A 80 6140 6556 9734 -920 -1 -595 C \nATOM 637 CG2 VAL A 80 -2.094 -26.507 -43.619 1.00 54.63 C \nANISOU 637 CG2 VAL A 80 5777 5887 9092 -974 97 -569 C \nATOM 638 N GLU A 81 -1.626 -24.179 -45.894 1.00 46.50 N \nANISOU 638 N GLU A 81 4768 4783 8116 -807 131 -551 N \nATOM 639 CA GLU A 81 -0.815 -24.220 -47.074 1.00 53.06 C \nANISOU 639 CA GLU A 81 5647 5595 8920 -802 184 -555 C \nATOM 640 C GLU A 81 0.577 -24.384 -46.585 1.00 56.55 C \nANISOU 640 C GLU A 81 6205 5980 9302 -834 226 -534 C \nATOM 641 O GLU A 81 0.863 -24.069 -45.425 1.00 72.75 O \nANISOU 641 O GLU A 81 8293 8005 11345 -835 211 -513 O \nATOM 642 CB GLU A 81 -0.956 -22.891 -47.814 1.00 56.46 C \nANISOU 642 CB GLU A 81 6058 6008 9387 -715 178 -542 C \nATOM 643 CG GLU A 81 -0.541 -22.915 -49.278 1.00 53.56 C \nANISOU 643 CG GLU A 81 5703 5641 9007 -701 220 -554 C \nATOM 644 CD GLU A 81 -0.714 -21.562 -49.937 1.00 47.54 C \nANISOU 644 CD GLU A 81 4918 4868 8278 -620 211 -541 C \nATOM 645 OE1 GLU A 81 -0.641 -20.574 -49.187 1.00 40.79 O \nANISOU 645 OE1 GLU A 81 4076 3989 7434 -582 188 -514 O \nATOM 646 OE2 GLU A 81 -0.830 -21.491 -51.185 1.00 42.65 O \nANISOU 646 OE2 GLU A 81 4274 4264 7665 -600 230 -556 O \nATOM 647 N LYS A 82 1.446 -24.928 -47.392 1.00 58.93 N \nANISOU 647 N LYS A 82 6571 6262 9557 -862 278 -540 N \nATOM 648 CA LYS A 82 2.817 -25.070 -46.949 1.00 72.32 C \nANISOU 648 CA LYS A 82 8393 7895 11190 -884 320 -520 C \nATOM 649 C LYS A 82 3.492 -23.772 -47.284 1.00 74.24 C \nANISOU 649 C LYS A 82 8676 8096 11436 -794 334 -492 C \nATOM 650 O LYS A 82 2.885 -22.891 -47.904 1.00 84.02 O \nANISOU 650 O LYS A 82 9845 9357 12721 -731 314 -491 O \nATOM 651 CB LYS A 82 3.507 -26.260 -47.619 1.00 81.91 C \nANISOU 651 CB LYS A 82 9675 9101 12344 -959 370 -538 C \nATOM 652 CG LYS A 82 2.657 -27.536 -47.499 1.00 86.38 C \nANISOU 652 CG LYS A 82 10175 9736 12911 -1051 353 -570 C \nATOM 653 CD LYS A 82 3.360 -28.734 -46.877 1.00 89.80 C \nANISOU 653 CD LYS A 82 10696 10153 13272 -1158 380 -576 C \nATOM 654 CE LYS A 82 2.334 -29.758 -46.372 1.00 89.84 C \nANISOU 654 CE LYS A 82 10609 10242 13283 -1238 347 -603 C \nATOM 655 NZ LYS A 82 1.670 -29.337 -45.088 1.00 89.87 N \nANISOU 655 NZ LYS A 82 10559 10262 13325 -1215 295 -592 N \nATOM 656 N ALA A 83 4.740 -23.636 -46.879 1.00 77.01 N \nANISOU 656 N ALA A 83 9140 8389 11732 -786 370 -470 N \nATOM 657 CA ALA A 83 5.482 -22.411 -47.160 1.00 78.31 C \nANISOU 657 CA ALA A 83 9344 8523 11888 -696 387 -441 C \nATOM 658 C ALA A 83 5.863 -22.349 -48.648 1.00 78.77 C \nANISOU 658 C ALA A 83 9416 8579 11933 -666 424 -446 C \nATOM 659 O ALA A 83 5.738 -21.290 -49.274 1.00 71.15 O \nANISOU 659 O ALA A 83 8410 7630 10994 -592 418 -434 O \nATOM 660 CB ALA A 83 6.715 -22.339 -46.292 1.00 82.82 C \nANISOU 660 CB ALA A 83 10033 9035 12398 -688 415 -419 C \nATOM 661 N ASN A 84 6.314 -23.477 -49.206 1.00 81.27 N \nANISOU 661 N ASN A 84 9791 8880 12207 -728 462 -462 N \nATOM 662 CA ASN A 84 6.643 -23.578 -50.638 1.00 88.11 C \nANISOU 662 CA ASN A 84 10673 9747 13058 -712 498 -468 C \nATOM 663 C ASN A 84 5.992 -24.788 -51.320 1.00 86.62 C \nANISOU 663 C ASN A 84 10440 9598 12873 -796 501 -503 C \nATOM 664 O ASN A 84 6.662 -25.801 -51.574 1.00 93.94 O \nANISOU 664 O ASN A 84 11451 10499 13742 -863 540 -511 O \nATOM 665 CB ASN A 84 8.159 -23.660 -50.848 1.00 99.95 C \nANISOU 665 CB ASN A 84 12318 11178 14481 -693 553 -447 C \nATOM 666 CG ASN A 84 8.876 -22.356 -50.553 1.00101.26 C \nANISOU 666 CG ASN A 84 12519 11320 14636 -590 558 -412 C \nATOM 667 OD1 ASN A 84 8.382 -21.500 -49.832 1.00109.47 O \nANISOU 667 OD1 ASN A 84 13494 12383 15715 -552 520 -402 O \nATOM 668 ND2 ASN A 84 10.061 -22.209 -51.117 1.00110.90 N \nANISOU 668 ND2 ASN A 84 13842 12496 15798 -544 604 -394 N \nATOM 669 N PRO A 85 4.680 -24.702 -51.599 1.00 81.09 N \nANISOU 669 N PRO A 85 9610 8963 12236 -795 461 -525 N \nATOM 670 CA PRO A 85 3.938 -25.785 -52.246 1.00 73.66 C \nANISOU 670 CA PRO A 85 8609 8078 11302 -866 460 -561 C \nATOM 671 C PRO A 85 4.548 -26.165 -53.554 1.00 71.71 C \nANISOU 671 C PRO A 85 8408 7822 11017 -879 507 -567 C \nATOM 672 O PRO A 85 4.902 -25.293 -54.348 1.00 74.50 O \nANISOU 672 O PRO A 85 8772 8159 11377 -806 522 -552 O \nATOM 673 CB PRO A 85 2.546 -25.180 -52.476 1.00 73.98 C \nANISOU 673 CB PRO A 85 8511 8178 11419 -818 410 -576 C \nATOM 674 CG PRO A 85 2.566 -23.805 -51.886 1.00 74.51 C \nANISOU 674 CG PRO A 85 8574 8218 11518 -736 384 -547 C \nATOM 675 CD PRO A 85 3.766 -23.715 -51.006 1.00 78.92 C \nANISOU 675 CD PRO A 85 9246 8714 12025 -739 408 -518 C \nATOM 676 N ALA A 86 4.678 -27.461 -53.787 1.00 75.69 N \nANISOU 676 N ALA A 86 8942 8341 11477 -975 530 -589 N \nATOM 677 CA ALA A 86 5.314 -27.942 -55.010 1.00 78.23 C \nANISOU 677 CA ALA A 86 9320 8651 11752 -1001 577 -595 C \nATOM 678 C ALA A 86 4.394 -27.801 -56.225 1.00 79.05 C \nANISOU 678 C ALA A 86 9311 8822 11901 -978 567 -619 C \nATOM 679 O ALA A 86 4.856 -27.779 -57.367 1.00 85.29 O \nANISOU 679 O ALA A 86 10134 9605 12669 -967 601 -618 O \nATOM 680 CB ALA A 86 5.751 -29.388 -54.846 1.00 81.05 C \nANISOU 680 CB ALA A 86 9750 9004 12040 -1124 606 -610 C \nATOM 681 N ASN A 87 3.096 -27.687 -55.980 1.00 69.72 N \nANISOU 681 N ASN A 87 8002 7708 10782 -966 520 -640 N \nATOM 682 CA ASN A 87 2.122 -27.638 -57.041 1.00 67.26 C \nANISOU 682 CA ASN A 87 7582 7464 10512 -945 507 -668 C \nATOM 683 C ASN A 87 1.404 -26.292 -57.108 1.00 70.42 C \nANISOU 683 C ASN A 87 7905 7868 10981 -842 470 -661 C \nATOM 684 O ASN A 87 0.283 -26.134 -56.646 1.00 68.35 O \nANISOU 684 O ASN A 87 7550 7648 10770 -823 424 -676 O \nATOM 685 CB ASN A 87 1.113 -28.752 -56.838 1.00 75.95 C \nANISOU 685 CB ASN A 87 8592 8647 11618 -1019 485 -706 C \nATOM 686 CG ASN A 87 1.765 -30.120 -56.825 1.00 70.63 C \nANISOU 686 CG ASN A 87 7989 7980 10869 -1137 521 -716 C \nATOM 687 OD1 ASN A 87 2.623 -30.423 -57.661 1.00 63.42 O \nANISOU 687 OD1 ASN A 87 7155 7037 9905 -1167 567 -712 O \nATOM 688 ND2 ASN A 87 1.322 -30.968 -55.905 1.00 69.58 N \nANISOU 688 ND2 ASN A 87 7825 7891 10723 -1208 501 -731 N \nATOM 689 N ASP A 88 2.068 -25.325 -57.724 1.00 70.49 N \nANISOU 689 N ASP A 88 7959 7837 10988 -776 491 -637 N \nATOM 690 CA ASP A 88 1.554 -23.988 -57.849 1.00 61.21 C \nANISOU 690 CA ASP A 88 6728 6663 9866 -686 461 -626 C \nATOM 691 C ASP A 88 1.083 -23.780 -59.290 1.00 61.48 C \nANISOU 691 C ASP A 88 6702 6737 9920 -660 470 -647 C \nATOM 692 O ASP A 88 0.249 -24.538 -59.839 1.00 56.82 O \nANISOU 692 O ASP A 88 6040 6205 9344 -697 464 -684 O \nATOM 693 CB ASP A 88 2.666 -23.007 -57.468 1.00 73.38 C \nANISOU 693 CB ASP A 88 8357 8141 11382 -630 477 -583 C \nATOM 694 CG ASP A 88 2.155 -21.592 -57.179 1.00 80.61 C \nANISOU 694 CG ASP A 88 9221 9060 12347 -551 440 -567 C \nATOM 695 OD1 ASP A 88 0.922 -21.338 -57.202 1.00 92.05 O \nANISOU 695 OD1 ASP A 88 10576 10549 13852 -538 398 -587 O \nATOM 696 OD2 ASP A 88 3.009 -20.730 -56.953 1.00 80.03 O \nANISOU 696 OD2 ASP A 88 9205 8951 12251 -502 453 -533 O \nATOM 697 N LEU A 89 1.603 -22.762 -59.942 1.00 55.22 N \nANISOU 697 N LEU A 89 5935 5921 9124 -597 486 -625 N \nATOM 698 CA LEU A 89 1.437 -22.666 -61.379 1.00 53.39 C \nANISOU 698 CA LEU A 89 5669 5721 8895 -582 506 -641 C \nATOM 699 C LEU A 89 2.360 -23.707 -62.019 1.00 50.38 C \nANISOU 699 C LEU A 89 5363 5328 8450 -643 558 -643 C \nATOM 700 O LEU A 89 3.350 -24.111 -61.466 1.00 54.28 O \nANISOU 700 O LEU A 89 5954 5774 8894 -672 582 -622 O \nATOM 701 CB LEU A 89 1.781 -21.245 -61.902 1.00 47.51 C \nANISOU 701 CB LEU A 89 4931 4961 8160 -500 509 -615 C \nATOM 702 CG LEU A 89 1.095 -20.103 -61.169 1.00 46.50 C \nANISOU 702 CG LEU A 89 4754 4834 8081 -447 462 -604 C \nATOM 703 CD1 LEU A 89 1.487 -18.760 -61.763 1.00 41.47 C \nANISOU 703 CD1 LEU A 89 4122 4193 7440 -378 469 -579 C \nATOM 704 CD2 LEU A 89 -0.448 -20.303 -61.172 1.00 43.06 C \nANISOU 704 CD2 LEU A 89 4215 4443 7705 -454 418 -643 C \nATOM 705 N CYS A 90 2.033 -24.084 -63.223 1.00 55.37 N \nANISOU 705 N CYS A 90 5953 6002 9081 -661 574 -669 N \nATOM 706 CA CYS A 90 2.825 -25.033 -63.967 1.00 60.82 C \nANISOU 706 CA CYS A 90 6712 6687 9711 -722 622 -672 C \nATOM 707 C CYS A 90 3.428 -24.381 -65.204 1.00 61.07 C \nANISOU 707 C CYS A 90 6772 6709 9724 -674 653 -656 C \nATOM 708 O CYS A 90 4.298 -24.928 -65.894 1.00 74.54 O \nANISOU 708 O CYS A 90 8555 8396 11372 -707 696 -648 O \nATOM 709 CB CYS A 90 1.920 -26.197 -64.353 1.00 62.18 C \nANISOU 709 CB CYS A 90 6807 6931 9888 -796 616 -718 C \nATOM 710 SG CYS A 90 0.428 -25.817 -65.285 1.00 70.46 S \nANISOU 710 SG CYS A 90 7708 8061 11002 -754 586 -759 S \nATOM 711 N TYR A 91 2.917 -23.219 -65.524 1.00 57.38 N \nANISOU 711 N TYR A 91 6240 6259 9302 -598 630 -653 N \nATOM 712 CA TYR A 91 3.583 -22.366 -66.443 1.00 59.22 C \nANISOU 712 CA TYR A 91 6505 6480 9516 -541 655 -629 C \nATOM 713 C TYR A 91 4.081 -21.203 -65.601 1.00 55.15 C \nANISOU 713 C TYR A 91 6023 5925 9004 -470 641 -590 C \nATOM 714 O TYR A 91 3.364 -20.730 -64.730 1.00 62.43 O \nANISOU 714 O TYR A 91 6894 6853 9972 -452 600 -593 O \nATOM 715 CB TYR A 91 2.599 -21.899 -67.503 1.00 57.43 C \nANISOU 715 CB TYR A 91 6176 6312 9334 -515 641 -658 C \nATOM 716 CG TYR A 91 3.111 -21.967 -68.916 1.00 56.27 C \nANISOU 716 CG TYR A 91 6049 6180 9151 -515 681 -657 C \nATOM 717 CD1 TYR A 91 3.252 -23.198 -69.584 1.00 49.98 C \nANISOU 717 CD1 TYR A 91 5271 5401 8318 -589 711 -679 C \nATOM 718 CD2 TYR A 91 3.387 -20.777 -69.633 1.00 48.12 C \nANISOU 718 CD2 TYR A 91 5011 5152 8119 -445 686 -636 C \nATOM 719 CE1 TYR A 91 3.694 -23.230 -70.910 1.00 53.69 C \nANISOU 719 CE1 TYR A 91 5759 5887 8755 -590 746 -678 C \nATOM 720 CE2 TYR A 91 3.817 -20.798 -70.988 1.00 54.47 C \nANISOU 720 CE2 TYR A 91 5828 5976 8891 -443 721 -635 C \nATOM 721 CZ TYR A 91 3.964 -22.006 -71.615 1.00 58.73 C \nANISOU 721 CZ TYR A 91 6390 6527 9398 -513 750 -656 C \nATOM 722 OH TYR A 91 4.414 -22.002 -72.921 1.00 69.93 O \nANISOU 722 OH TYR A 91 7826 7963 10782 -510 784 -652 O \nATOM 723 N PRO A 92 5.312 -20.753 -65.832 1.00 51.57 N \nANISOU 723 N PRO A 92 5659 5436 8500 -430 674 -552 N \nATOM 724 CA PRO A 92 5.796 -19.585 -65.087 1.00 50.97 C \nANISOU 724 CA PRO A 92 5606 5336 8421 -357 661 -515 C \nATOM 725 C PRO A 92 5.073 -18.278 -65.478 1.00 44.32 C \nANISOU 725 C PRO A 92 4674 4541 7626 -299 632 -516 C \nATOM 726 O PRO A 92 4.657 -18.116 -66.606 1.00 48.35 O \nANISOU 726 O PRO A 92 5134 5089 8149 -294 637 -533 O \nATOM 727 CB PRO A 92 7.285 -19.498 -65.477 1.00 50.16 C \nANISOU 727 CB PRO A 92 5619 5196 8246 -322 708 -478 C \nATOM 728 CG PRO A 92 7.367 -20.141 -66.827 1.00 51.28 C \nANISOU 728 CG PRO A 92 5766 5354 8365 -354 740 -494 C \nATOM 729 CD PRO A 92 6.162 -21.054 -66.986 1.00 55.64 C \nANISOU 729 CD PRO A 92 6236 5944 8962 -432 720 -543 C \nATOM 730 N GLY A 93 4.895 -17.376 -64.527 1.00 38.26 N \nANISOU 730 N GLY A 93 3887 3769 6879 -261 600 -498 N \nATOM 731 CA GLY A 93 4.121 -16.193 -64.780 1.00 39.91 C \nANISOU 731 CA GLY A 93 4015 4019 7129 -221 569 -501 C \nATOM 732 C GLY A 93 3.588 -15.563 -63.536 1.00 43.49 C \nANISOU 732 C GLY A 93 4440 4466 7616 -210 525 -493 C \nATOM 733 O GLY A 93 3.820 -16.040 -62.425 1.00 45.79 O \nANISOU 733 O GLY A 93 4772 4725 7903 -231 518 -486 O \nATOM 734 N ASN A 94 2.898 -14.441 -63.721 1.00 45.00 N \nANISOU 734 N ASN A 94 4568 4691 7839 -180 495 -494 N \nATOM 735 CA ASN A 94 2.342 -13.712 -62.609 1.00 51.33 C \nANISOU 735 CA ASN A 94 5344 5490 8671 -171 451 -485 C \nATOM 736 C ASN A 94 0.873 -14.080 -62.352 1.00 52.85 C \nANISOU 736 C ASN A 94 5468 5684 8926 -204 408 -523 C \nATOM 737 O ASN A 94 0.061 -14.207 -63.278 1.00 70.53 O \nANISOU 737 O ASN A 94 7656 7949 11195 -212 403 -555 O \nATOM 738 CB ASN A 94 2.434 -12.205 -62.926 1.00 60.33 C \nANISOU 738 CB ASN A 94 6457 6665 9799 -124 442 -461 C \nATOM 739 CG ASN A 94 2.137 -11.327 -61.719 1.00 74.23 C \nANISOU 739 CG ASN A 94 8206 8423 11573 -115 402 -442 C \nATOM 740 OD1 ASN A 94 1.202 -10.506 -61.762 1.00 69.04 O \nANISOU 740 OD1 ASN A 94 7496 7787 10948 -116 366 -451 O \nATOM 741 ND2 ASN A 94 2.895 -11.514 -60.626 1.00 81.60 N \nANISOU 741 ND2 ASN A 94 9195 9330 12481 -109 408 -418 N \nATOM 742 N PHE A 95 0.507 -14.185 -61.090 1.00 51.55 N \nANISOU 742 N PHE A 95 5306 5499 8784 -219 375 -519 N \nATOM 743 CA PHE A 95 -0.885 -14.211 -60.705 1.00 36.28 C \nANISOU 743 CA PHE A 95 3311 3568 6906 -233 326 -547 C \nATOM 744 C PHE A 95 -1.220 -12.862 -60.139 1.00 34.40 C \nANISOU 744 C PHE A 95 3058 3331 6680 -206 290 -526 C \nATOM 745 O PHE A 95 -0.922 -12.551 -58.975 1.00 38.15 O \nANISOU 745 O PHE A 95 3560 3788 7147 -205 274 -500 O \nATOM 746 CB PHE A 95 -1.148 -15.289 -59.702 1.00 40.50 C \nANISOU 746 CB PHE A 95 3852 4082 7454 -271 312 -559 C \nATOM 747 CG PHE A 95 -2.580 -15.709 -59.595 1.00 37.50 C \nANISOU 747 CG PHE A 95 3406 3716 7126 -285 271 -595 C \nATOM 748 CD1 PHE A 95 -2.931 -16.987 -59.827 1.00 46.25 C \nANISOU 748 CD1 PHE A 95 4492 4841 8241 -321 279 -627 C \nATOM 749 CD2 PHE A 95 -3.537 -14.860 -59.150 1.00 38.92 C \nANISOU 749 CD2 PHE A 95 3551 3892 7343 -263 223 -596 C \nATOM 750 CE1 PHE A 95 -4.262 -17.413 -59.729 1.00 49.79 C \nANISOU 750 CE1 PHE A 95 4875 5311 8734 -324 242 -662 C \nATOM 751 CE2 PHE A 95 -4.885 -15.260 -59.006 1.00 43.63 C \nANISOU 751 CE2 PHE A 95 4093 4497 7986 -265 183 -630 C \nATOM 752 CZ PHE A 95 -5.253 -16.549 -59.322 1.00 45.16 C \nANISOU 752 CZ PHE A 95 4257 4716 8187 -291 193 -664 C \nATOM 753 N ASN A 96 -1.876 -12.012 -60.949 1.00 33.07 N \nANISOU 753 N ASN A 96 2848 3187 6530 -188 276 -537 N \nATOM 754 CA ASN A 96 -2.246 -10.649 -60.555 1.00 33.01 C \nANISOU 754 CA ASN A 96 2829 3186 6528 -172 242 -518 C \nATOM 755 C ASN A 96 -3.071 -10.580 -59.253 1.00 33.89 C \nANISOU 755 C ASN A 96 2934 3270 6673 -186 191 -517 C \nATOM 756 O ASN A 96 -3.944 -11.399 -58.995 1.00 45.85 O \nANISOU 756 O ASN A 96 4425 4768 8225 -201 168 -546 O \nATOM 757 CB ASN A 96 -2.975 -9.976 -61.680 1.00 36.62 C \nANISOU 757 CB ASN A 96 3246 3668 7000 -163 235 -538 C \nATOM 758 CG ASN A 96 -2.848 -8.464 -61.629 1.00 41.93 C \nANISOU 758 CG ASN A 96 3919 4363 7650 -151 221 -510 C \nATOM 759 OD1 ASN A 96 -1.722 -7.922 -61.628 1.00 38.89 O \nANISOU 759 OD1 ASN A 96 3558 4004 7215 -134 248 -476 O \nATOM 760 ND2 ASN A 96 -3.997 -7.763 -61.528 1.00 45.59 N \nANISOU 760 ND2 ASN A 96 4359 4820 8144 -160 177 -524 N \nATOM 761 N ASP A 97 -2.760 -9.590 -58.419 1.00 36.12 N \nANISOU 761 N ASP A 97 3235 3552 6937 -180 173 -484 N \nATOM 762 CA ASP A 97 -3.362 -9.359 -57.099 1.00 31.35 C \nANISOU 762 CA ASP A 97 2633 2923 6354 -194 126 -474 C \nATOM 763 C ASP A 97 -3.624 -10.658 -56.385 1.00 32.58 C \nANISOU 763 C ASP A 97 2793 3052 6534 -213 118 -491 C \nATOM 764 O ASP A 97 -4.683 -10.878 -55.826 1.00 40.77 O \nANISOU 764 O ASP A 97 3809 4072 7611 -222 75 -507 O \nATOM 765 CB ASP A 97 -4.647 -8.539 -57.229 1.00 32.25 C \nANISOU 765 CB ASP A 97 2719 3033 6503 -196 79 -488 C \nATOM 766 CG ASP A 97 -4.409 -7.123 -57.672 1.00 36.04 C \nANISOU 766 CG ASP A 97 3198 3543 6950 -191 80 -467 C \nATOM 767 OD1 ASP A 97 -3.625 -6.358 -57.021 1.00 33.92 O \nANISOU 767 OD1 ASP A 97 2951 3294 6643 -191 83 -430 O \nATOM 768 OD2 ASP A 97 -4.986 -6.758 -58.670 1.00 45.68 O \nANISOU 768 OD2 ASP A 97 4399 4776 8183 -188 78 -488 O \nATOM 769 N TYR A 98 -2.618 -11.501 -56.332 1.00 33.33 N \nANISOU 769 N TYR A 98 2920 3144 6601 -220 158 -484 N \nATOM 770 CA TYR A 98 -2.679 -12.799 -55.615 1.00 33.40 C \nANISOU 770 CA TYR A 98 2938 3132 6619 -249 157 -497 C \nATOM 771 C TYR A 98 -3.002 -12.696 -54.204 1.00 35.19 C \nANISOU 771 C TYR A 98 3172 3340 6858 -262 117 -483 C \nATOM 772 O TYR A 98 -3.894 -13.380 -53.716 1.00 44.12 O \nANISOU 772 O TYR A 98 4277 4464 8024 -279 86 -503 O \nATOM 773 CB TYR A 98 -1.323 -13.560 -55.815 1.00 33.46 C \nANISOU 773 CB TYR A 98 2999 3135 6579 -258 212 -486 C \nATOM 774 CG TYR A 98 -1.405 -15.017 -55.464 1.00 40.52 C \nANISOU 774 CG TYR A 98 3900 4018 7476 -299 220 -508 C \nATOM 775 CD1 TYR A 98 -2.626 -15.737 -55.577 1.00 36.40 C \nANISOU 775 CD1 TYR A 98 3321 3511 6998 -319 191 -544 C \nATOM 776 CD2 TYR A 98 -0.271 -15.706 -54.988 1.00 41.16 C \nANISOU 776 CD2 TYR A 98 4048 4078 7513 -321 255 -492 C \nATOM 777 CE1 TYR A 98 -2.696 -17.080 -55.193 1.00 37.65 C \nANISOU 777 CE1 TYR A 98 3479 3674 7154 -363 196 -563 C \nATOM 778 CE2 TYR A 98 -0.352 -17.040 -54.633 1.00 44.18 C \nANISOU 778 CE2 TYR A 98 4438 4455 7893 -370 261 -512 C \nATOM 779 CZ TYR A 98 -1.554 -17.721 -54.778 1.00 41.44 C \nANISOU 779 CZ TYR A 98 4025 4134 7587 -394 232 -547 C \nATOM 780 OH TYR A 98 -1.588 -19.058 -54.467 1.00 47.79 O \nANISOU 780 OH TYR A 98 4833 4946 8381 -448 240 -567 O \nATOM 781 N GLU A 99 -2.263 -11.802 -53.507 1.00 36.43 N \nANISOU 781 N GLU A 99 3364 3494 6985 -251 118 -446 N \nATOM 782 CA GLU A 99 -2.363 -11.683 -52.041 1.00 36.32 C \nANISOU 782 CA GLU A 99 3365 3461 6972 -267 85 -426 C \nATOM 783 C GLU A 99 -3.707 -11.107 -51.654 1.00 36.83 C \nANISOU 783 C GLU A 99 3392 3520 7080 -269 26 -433 C \nATOM 784 O GLU A 99 -4.249 -11.448 -50.617 1.00 45.25 O \nANISOU 784 O GLU A 99 4456 4569 8167 -286 -10 -433 O \nATOM 785 CB GLU A 99 -1.250 -10.823 -51.495 1.00 37.33 C \nANISOU 785 CB GLU A 99 3535 3596 7052 -251 102 -387 C \nATOM 786 CG GLU A 99 0.139 -11.361 -51.730 1.00 37.12 C \nANISOU 786 CG GLU A 99 3561 3567 6976 -240 159 -377 C \nATOM 787 CD GLU A 99 0.625 -11.153 -53.137 1.00 45.73 C \nANISOU 787 CD GLU A 99 4651 4680 8046 -212 198 -381 C \nATOM 788 OE1 GLU A 99 0.035 -10.332 -53.885 1.00 43.44 O \nANISOU 788 OE1 GLU A 99 4319 4415 7773 -198 184 -386 O \nATOM 789 OE2 GLU A 99 1.628 -11.818 -53.515 1.00 58.19 O \nANISOU 789 OE2 GLU A 99 6275 6248 9588 -205 245 -378 O \nATOM 790 N GLU A 100 -4.280 -10.315 -52.533 1.00 35.41 N \nANISOU 790 N GLU A 100 3188 3353 6915 -252 16 -442 N \nATOM 791 CA GLU A 100 -5.634 -9.769 -52.270 1.00 37.89 C \nANISOU 791 CA GLU A 100 3477 3652 7268 -252 -41 -452 C \nATOM 792 C GLU A 100 -6.665 -10.797 -52.420 1.00 36.62 C \nANISOU 792 C GLU A 100 3285 3481 7150 -251 -61 -488 C \nATOM 793 O GLU A 100 -7.570 -10.928 -51.579 1.00 50.09 O \nANISOU 793 O GLU A 100 4982 5167 8883 -255 -107 -492 O \nATOM 794 CB GLU A 100 -5.910 -8.585 -53.208 1.00 43.53 C \nANISOU 794 CB GLU A 100 4181 4381 7976 -239 -43 -451 C \nATOM 795 CG GLU A 100 -5.251 -7.277 -52.761 1.00 41.40 C \nANISOU 795 CG GLU A 100 3934 4130 7665 -245 -45 -412 C \nATOM 796 CD GLU A 100 -6.025 -6.616 -51.669 1.00 44.03 C \nANISOU 796 CD GLU A 100 4277 4442 8011 -264 -101 -397 C \nATOM 797 OE1 GLU A 100 -7.290 -6.753 -51.721 1.00 49.52 O \nANISOU 797 OE1 GLU A 100 4960 5107 8747 -264 -140 -420 O \nATOM 798 OE2 GLU A 100 -5.365 -6.016 -50.755 1.00 34.34 O \nANISOU 798 OE2 GLU A 100 3071 3227 6749 -277 -104 -363 O \nATOM 799 N LEU A 101 -6.515 -11.614 -53.442 1.00 37.39 N \nANISOU 799 N LEU A 101 3363 3596 7249 -246 -25 -516 N \nATOM 800 CA LEU A 101 -7.346 -12.908 -53.589 1.00 38.64 C \nANISOU 800 CA LEU A 101 3482 3760 7438 -249 -35 -554 C \nATOM 801 C LEU A 101 -7.222 -13.808 -52.372 1.00 39.59 C \nANISOU 801 C LEU A 101 3610 3875 7557 -275 -47 -547 C \nATOM 802 O LEU A 101 -8.207 -14.193 -51.768 1.00 40.24 O \nANISOU 802 O LEU A 101 3667 3954 7668 -272 -89 -560 O \nATOM 803 CB LEU A 101 -6.928 -13.684 -54.807 1.00 33.86 C \nANISOU 803 CB LEU A 101 2861 3181 6822 -251 13 -579 C \nATOM 804 CG LEU A 101 -7.727 -14.926 -55.075 1.00 37.64 C \nANISOU 804 CG LEU A 101 3293 3682 7324 -256 7 -619 C \nATOM 805 CD1 LEU A 101 -9.250 -14.690 -55.037 1.00 40.88 C \nANISOU 805 CD1 LEU A 101 3665 4089 7778 -223 -46 -643 C \nATOM 806 CD2 LEU A 101 -7.332 -15.548 -56.417 1.00 35.79 C \nANISOU 806 CD2 LEU A 101 3044 3479 7076 -261 55 -644 C \nATOM 807 N LYS A 102 -5.996 -14.123 -52.013 1.00 37.69 N \nANISOU 807 N LYS A 102 3408 3633 7278 -299 -10 -526 N \nATOM 808 CA LYS A 102 -5.734 -14.896 -50.813 1.00 40.86 C \nANISOU 808 CA LYS A 102 3827 4028 7671 -330 -18 -517 C \nATOM 809 C LYS A 102 -6.460 -14.295 -49.591 1.00 42.17 C \nANISOU 809 C LYS A 102 3991 4176 7858 -327 -75 -499 C \nATOM 810 O LYS A 102 -7.022 -14.983 -48.727 1.00 45.62 O \nANISOU 810 O LYS A 102 4411 4613 8309 -343 -105 -504 O \nATOM 811 CB LYS A 102 -4.221 -14.943 -50.525 1.00 41.20 C \nANISOU 811 CB LYS A 102 3930 4061 7663 -348 28 -490 C \nATOM 812 CG LYS A 102 -3.548 -16.241 -50.950 1.00 45.48 C \nANISOU 812 CG LYS A 102 4490 4613 8180 -380 74 -507 C \nATOM 813 CD LYS A 102 -2.035 -16.068 -50.990 1.00 46.81 C \nANISOU 813 CD LYS A 102 4729 4763 8294 -380 124 -481 C \nATOM 814 CE LYS A 102 -1.363 -17.397 -51.044 1.00 47.93 C \nANISOU 814 CE LYS A 102 4906 4902 8403 -424 163 -493 C \nATOM 815 NZ LYS A 102 -1.399 -18.029 -49.717 1.00 48.21 N \nANISOU 815 NZ LYS A 102 4958 4927 8433 -464 143 -488 N \nATOM 816 N HIS A 103 -6.398 -12.990 -49.463 1.00 39.58 N \nANISOU 816 N HIS A 103 3682 3833 7525 -310 -90 -474 N \nATOM 817 CA HIS A 103 -6.985 -12.339 -48.281 1.00 35.63 C \nANISOU 817 CA HIS A 103 3188 3312 7036 -314 -142 -452 C \nATOM 818 C HIS A 103 -8.516 -12.436 -48.384 1.00 38.16 C \nANISOU 818 C HIS A 103 3471 3625 7402 -293 -192 -477 C \nATOM 819 O HIS A 103 -9.239 -12.492 -47.442 1.00 33.51 O \nANISOU 819 O HIS A 103 2879 3022 6831 -296 -238 -471 O \nATOM 820 CB HIS A 103 -6.602 -10.882 -48.225 1.00 32.71 C \nANISOU 820 CB HIS A 103 2845 2938 6646 -307 -146 -421 C \nATOM 821 CG HIS A 103 -7.251 -10.159 -47.117 1.00 32.27 C \nANISOU 821 CG HIS A 103 2800 2863 6599 -316 -200 -400 C \nATOM 822 ND1 HIS A 103 -8.268 -9.249 -47.312 1.00 31.62 N \nANISOU 822 ND1 HIS A 103 2712 2764 6536 -305 -242 -401 N \nATOM 823 CD2 HIS A 103 -7.033 -10.201 -45.783 1.00 33.33 C \nANISOU 823 CD2 HIS A 103 2954 2987 6721 -338 -220 -376 C \nATOM 824 CE1 HIS A 103 -8.674 -8.780 -46.143 1.00 33.11 C \nANISOU 824 CE1 HIS A 103 2919 2934 6726 -321 -287 -378 C \nATOM 825 NE2 HIS A 103 -7.912 -9.315 -45.199 1.00 33.28 N \nANISOU 825 NE2 HIS A 103 2954 2963 6730 -341 -274 -362 N \nATOM 826 N LEU A 104 -9.015 -12.469 -49.566 1.00 39.07 N \nANISOU 826 N LEU A 104 3561 3750 7535 -269 -183 -505 N \nATOM 827 CA LEU A 104 -10.436 -12.609 -49.714 1.00 45.13 C \nANISOU 827 CA LEU A 104 4297 4510 8341 -241 -228 -531 C \nATOM 828 C LEU A 104 -10.945 -13.969 -49.213 1.00 52.71 C \nANISOU 828 C LEU A 104 5220 5491 9316 -244 -242 -552 C \nATOM 829 O LEU A 104 -12.029 -14.058 -48.619 1.00 54.75 O \nANISOU 829 O LEU A 104 5464 5740 9599 -223 -292 -558 O \nATOM 830 CB LEU A 104 -10.704 -12.460 -51.191 1.00 46.51 C \nANISOU 830 CB LEU A 104 4451 4696 8524 -216 -205 -560 C \nATOM 831 CG LEU A 104 -12.131 -12.516 -51.647 1.00 50.41 C \nANISOU 831 CG LEU A 104 4917 5183 9054 -176 -242 -593 C \nATOM 832 CD1 LEU A 104 -12.950 -11.410 -51.041 1.00 50.33 C \nANISOU 832 CD1 LEU A 104 4940 5128 9055 -163 -296 -576 C \nATOM 833 CD2 LEU A 104 -12.125 -12.425 -53.167 1.00 52.08 C \nANISOU 833 CD2 LEU A 104 5110 5412 9266 -158 -208 -622 C \nATOM 834 N LEU A 105 -10.134 -15.013 -49.390 1.00 54.01 N \nANISOU 834 N LEU A 105 5374 5686 9460 -272 -198 -562 N \nATOM 835 CA LEU A 105 -10.453 -16.325 -48.813 1.00 55.08 C \nANISOU 835 CA LEU A 105 5476 5853 9598 -290 -208 -578 C \nATOM 836 C LEU A 105 -10.348 -16.422 -47.342 1.00 57.60 C \nANISOU 836 C LEU A 105 5815 6161 9910 -315 -236 -551 C \nATOM 837 O LEU A 105 -10.122 -17.518 -46.804 1.00 73.55 O \nANISOU 837 O LEU A 105 7820 8209 11915 -349 -228 -557 O \nATOM 838 CB LEU A 105 -9.512 -17.389 -49.329 1.00 52.18 C \nANISOU 838 CB LEU A 105 5106 5520 9202 -328 -152 -592 C \nATOM 839 CG LEU A 105 -9.423 -17.486 -50.865 1.00 55.53 C \nANISOU 839 CG LEU A 105 5511 5964 9626 -313 -113 -620 C \nATOM 840 CD1 LEU A 105 -8.407 -18.524 -51.199 1.00 56.67 C \nANISOU 840 CD1 LEU A 105 5665 6133 9733 -361 -60 -627 C \nATOM 841 CD2 LEU A 105 -10.744 -17.805 -51.550 1.00 56.80 C \nANISOU 841 CD2 LEU A 105 5610 6154 9819 -272 -139 -659 C \nATOM 842 N SER A 106 -10.510 -15.311 -46.668 1.00 55.02 N \nANISOU 842 N SER A 106 5522 5796 9589 -305 -270 -521 N \nATOM 843 CA SER A 106 -10.257 -15.305 -45.254 1.00 56.99 C \nANISOU 843 CA SER A 106 5795 6033 9826 -333 -292 -492 C \nATOM 844 C SER A 106 -11.535 -14.875 -44.645 1.00 54.76 C \nANISOU 844 C SER A 106 5502 5732 9572 -303 -357 -488 C \nATOM 845 O SER A 106 -11.635 -14.734 -43.439 1.00 48.73 O \nANISOU 845 O SER A 106 4756 4955 8805 -319 -391 -463 O \nATOM 846 CB SER A 106 -9.153 -14.314 -44.930 1.00 56.32 C \nANISOU 846 CB SER A 106 5764 5922 9711 -352 -271 -456 C \nATOM 847 OG SER A 106 -9.309 -13.161 -45.716 1.00 60.13 O \nANISOU 847 OG SER A 106 6257 6388 10199 -325 -271 -452 O \nATOM 848 N ARG A 107 -12.501 -14.610 -45.518 1.00 53.75 N \nANISOU 848 N ARG A 107 5353 5599 9472 -258 -375 -512 N \nATOM 849 CA ARG A 107 -13.800 -14.210 -45.063 1.00 65.00 C \nANISOU 849 CA ARG A 107 6776 6998 10922 -219 -437 -511 C \nATOM 850 C ARG A 107 -14.784 -15.145 -45.755 1.00 58.91 C \nANISOU 850 C ARG A 107 5948 6261 10173 -175 -446 -554 C \nATOM 851 O ARG A 107 -15.981 -15.035 -45.629 1.00 56.89 O \nANISOU 851 O ARG A 107 5684 5992 9939 -127 -494 -564 O \nATOM 852 CB ARG A 107 -14.030 -12.711 -45.418 1.00 73.17 C \nANISOU 852 CB ARG A 107 7857 7984 11960 -205 -453 -496 C \nATOM 853 CG ARG A 107 -14.348 -11.808 -44.180 1.00 82.78 C \nANISOU 853 CG ARG A 107 9120 9160 13174 -219 -504 -457 C \nATOM 854 CD ARG A 107 -15.210 -12.578 -43.131 1.00 90.52 C \nANISOU 854 CD ARG A 107 10080 10144 14168 -203 -553 -457 C \nATOM 855 NE ARG A 107 -16.661 -12.337 -42.968 1.00 88.76 N \nANISOU 855 NE ARG A 107 9866 9889 13970 -151 -614 -464 N \nATOM 856 CZ ARG A 107 -17.512 -11.896 -43.899 1.00 97.36 C \nANISOU 856 CZ ARG A 107 10964 10951 15075 -104 -627 -487 C \nATOM 857 NH1 ARG A 107 -17.120 -11.565 -45.128 1.00 93.23 N \nANISOU 857 NH1 ARG A 107 10440 10434 14551 -104 -585 -506 N \nATOM 858 NH2 ARG A 107 -18.804 -11.755 -43.580 1.00107.09 N \nANISOU 858 NH2 ARG A 107 12214 12150 16324 -54 -684 -491 N \nATOM 859 N ILE A 108 -14.216 -16.105 -46.453 1.00 53.21 N \nANISOU 859 N ILE A 108 5189 5587 9440 -193 -398 -578 N \nATOM 860 CA ILE A 108 -14.968 -17.081 -47.173 1.00 50.85 C \nANISOU 860 CA ILE A 108 4829 5339 9154 -159 -397 -621 C \nATOM 861 C ILE A 108 -14.755 -18.413 -46.510 1.00 53.56 C \nANISOU 861 C ILE A 108 5131 5741 9480 -195 -391 -627 C \nATOM 862 O ILE A 108 -13.707 -18.644 -45.922 1.00 52.39 O \nANISOU 862 O ILE A 108 5009 5593 9306 -254 -365 -605 O \nATOM 863 CB ILE A 108 -14.508 -17.245 -48.595 1.00 45.27 C \nANISOU 863 CB ILE A 108 4106 4653 8441 -161 -345 -648 C \nATOM 864 CG1 ILE A 108 -14.778 -15.954 -49.360 1.00 41.89 C \nANISOU 864 CG1 ILE A 108 3713 4175 8027 -127 -350 -646 C \nATOM 865 CG2 ILE A 108 -15.244 -18.426 -49.234 1.00 47.31 C \nANISOU 865 CG2 ILE A 108 4292 4979 8706 -134 -342 -693 C \nATOM 866 CD1 ILE A 108 -14.443 -16.023 -50.850 1.00 41.63 C \nANISOU 866 CD1 ILE A 108 3663 4162 7990 -122 -301 -674 C \nATOM 867 N ASN A 109 -15.786 -19.246 -46.594 1.00 52.11 N \nANISOU 867 N ASN A 109 4886 5608 9307 -156 -417 -656 N \nATOM 868 CA ASN A 109 -15.869 -20.464 -45.850 1.00 54.08 C \nANISOU 868 CA ASN A 109 5087 5922 9537 -184 -425 -662 C \nATOM 869 C ASN A 109 -16.155 -21.675 -46.710 1.00 55.86 C \nANISOU 869 C ASN A 109 5238 6235 9753 -180 -401 -707 C \nATOM 870 O ASN A 109 -15.832 -22.814 -46.311 1.00 63.78 O \nANISOU 870 O ASN A 109 6202 7304 10726 -232 -386 -714 O \nATOM 871 CB ASN A 109 -17.011 -20.357 -44.879 1.00 60.08 C \nANISOU 871 CB ASN A 109 5835 6678 10314 -134 -492 -652 C \nATOM 872 CG ASN A 109 -16.598 -19.843 -43.521 1.00 63.67 C \nANISOU 872 CG ASN A 109 6341 7087 10762 -171 -517 -608 C \nATOM 873 OD1 ASN A 109 -17.398 -19.200 -42.806 1.00 71.56 O \nANISOU 873 OD1 ASN A 109 7364 8048 11778 -131 -572 -588 O \nATOM 874 ND2 ASN A 109 -15.381 -20.147 -43.128 1.00 57.63 N \nANISOU 874 ND2 ASN A 109 5599 6328 9969 -247 -478 -591 N \nATOM 875 N HIS A 110 -16.782 -21.416 -47.864 1.00 51.91 N \nANISOU 875 N HIS A 110 4715 5736 9271 -122 -397 -737 N \nATOM 876 CA HIS A 110 -17.194 -22.459 -48.790 1.00 58.65 C \nANISOU 876 CA HIS A 110 5492 6675 10115 -108 -377 -782 C \nATOM 877 C HIS A 110 -17.509 -21.956 -50.212 1.00 54.24 C \nANISOU 877 C HIS A 110 4932 6103 9575 -59 -357 -811 C \nATOM 878 O HIS A 110 -18.045 -20.875 -50.398 1.00 47.31 O \nANISOU 878 O HIS A 110 4095 5158 8725 -4 -383 -805 O \nATOM 879 CB HIS A 110 -18.350 -23.258 -48.208 1.00 66.69 C \nANISOU 879 CB HIS A 110 6442 7766 11134 -61 -423 -799 C \nATOM 880 CG HIS A 110 -18.768 -24.423 -49.050 1.00 71.38 C \nANISOU 880 CG HIS A 110 6946 8468 11709 -50 -403 -847 C \nATOM 881 ND1 HIS A 110 -20.097 -24.779 -49.212 1.00 75.44 N \nANISOU 881 ND1 HIS A 110 7393 9038 12231 38 -442 -877 N \nATOM 882 CD2 HIS A 110 -18.042 -25.322 -49.757 1.00 69.97 C \nANISOU 882 CD2 HIS A 110 6732 8354 11499 -116 -350 -868 C \nATOM 883 CE1 HIS A 110 -20.169 -25.843 -49.988 1.00 76.01 C \nANISOU 883 CE1 HIS A 110 7387 9215 12279 26 -412 -916 C \nATOM 884 NE2 HIS A 110 -18.939 -26.194 -50.330 1.00 77.29 N \nANISOU 884 NE2 HIS A 110 7567 9382 12416 -72 -356 -912 N \nATOM 885 N PHE A 111 -17.098 -22.749 -51.198 1.00 55.28 N \nANISOU 885 N PHE A 111 5022 6296 9687 -90 -309 -841 N \nATOM 886 CA PHE A 111 -17.272 -22.462 -52.591 1.00 61.01 C \nANISOU 886 CA PHE A 111 5737 7020 10421 -57 -283 -871 C \nATOM 887 C PHE A 111 -18.275 -23.385 -53.242 1.00 73.40 C \nANISOU 887 C PHE A 111 7218 8682 11988 -8 -290 -920 C \nATOM 888 O PHE A 111 -18.685 -24.390 -52.666 1.00 89.25 O \nANISOU 888 O PHE A 111 9164 10769 13978 -12 -307 -932 O \nATOM 889 CB PHE A 111 -15.966 -22.743 -53.306 1.00 69.28 C \nANISOU 889 CB PHE A 111 6805 8077 11443 -133 -218 -869 C \nATOM 890 CG PHE A 111 -15.001 -21.580 -53.317 1.00 64.47 C \nANISOU 890 CG PHE A 111 6282 7378 10837 -157 -198 -832 C \nATOM 891 CD1 PHE A 111 -15.460 -20.287 -53.228 1.00 65.93 C \nANISOU 891 CD1 PHE A 111 6509 7489 11050 -106 -230 -816 C \nATOM 892 CD2 PHE A 111 -13.646 -21.806 -53.447 1.00 60.48 C \nANISOU 892 CD2 PHE A 111 5813 6866 10300 -229 -147 -815 C \nATOM 893 CE1 PHE A 111 -14.581 -19.240 -53.248 1.00 68.32 C \nANISOU 893 CE1 PHE A 111 6881 7727 11350 -129 -212 -783 C \nATOM 894 CE2 PHE A 111 -12.753 -20.763 -53.439 1.00 62.20 C \nANISOU 894 CE2 PHE A 111 6104 7014 10517 -243 -130 -781 C \nATOM 895 CZ PHE A 111 -13.215 -19.469 -53.369 1.00 64.41 C \nANISOU 895 CZ PHE A 111 6416 7233 10825 -193 -161 -765 C \nATOM 896 N GLU A 112 -18.674 -23.043 -54.461 1.00 73.60 N \nANISOU 896 N GLU A 112 7234 8705 12026 39 -275 -951 N \nATOM 897 CA GLU A 112 -19.388 -23.990 -55.323 1.00 71.37 C \nANISOU 897 CA GLU A 112 6864 8523 11733 74 -266 -1002 C \nATOM 898 C GLU A 112 -18.954 -23.821 -56.787 1.00 65.48 C \nANISOU 898 C GLU A 112 6120 7778 10983 60 -215 -1026 C \nATOM 899 O GLU A 112 -19.385 -22.924 -57.494 1.00 63.54 O \nANISOU 899 O GLU A 112 5902 7478 10760 115 -221 -1037 O \nATOM 900 CB GLU A 112 -20.908 -23.890 -55.155 1.00 72.80 C \nANISOU 900 CB GLU A 112 7010 8717 11934 185 -321 -1025 C \nATOM 901 CG GLU A 112 -21.654 -25.071 -55.785 1.00 85.59 C \nANISOU 901 CG GLU A 112 8524 10464 13532 222 -315 -1077 C \nATOM 902 CD GLU A 112 -23.177 -24.995 -55.653 1.00 87.10 C \nANISOU 902 CD GLU A 112 8682 10672 13739 347 -370 -1102 C \nATOM 903 OE1 GLU A 112 -23.662 -24.265 -54.776 1.00 98.71 O \nANISOU 903 OE1 GLU A 112 10206 12066 15232 394 -418 -1075 O \nATOM 904 OE2 GLU A 112 -23.880 -25.672 -56.426 1.00 81.47 O \nANISOU 904 OE2 GLU A 112 7892 10051 13013 400 -364 -1150 O \nATOM 905 N LYS A 113 -18.023 -24.666 -57.184 1.00 62.54 N \nANISOU 905 N LYS A 113 5725 7461 10575 -22 -165 -1032 N \nATOM 906 CA LYS A 113 -17.476 -24.695 -58.532 1.00 61.71 C \nANISOU 906 CA LYS A 113 5620 7370 10459 -49 -113 -1052 C \nATOM 907 C LYS A 113 -18.589 -24.885 -59.566 1.00 64.66 C \nANISOU 907 C LYS A 113 5927 7800 10841 27 -119 -1104 C \nATOM 908 O LYS A 113 -19.300 -25.852 -59.536 1.00 66.74 O \nANISOU 908 O LYS A 113 6109 8160 11088 50 -131 -1136 O \nATOM 909 CB LYS A 113 -16.481 -25.824 -58.599 1.00 59.59 C \nANISOU 909 CB LYS A 113 5331 7166 10143 -150 -67 -1052 C \nATOM 910 CG LYS A 113 -15.658 -25.939 -59.854 1.00 62.14 C \nANISOU 910 CG LYS A 113 5667 7497 10444 -198 -9 -1063 C \nATOM 911 CD LYS A 113 -15.012 -27.331 -59.791 1.00 71.61 C \nANISOU 911 CD LYS A 113 6834 8784 11591 -294 26 -1072 C \nATOM 912 CE LYS A 113 -13.881 -27.554 -60.765 1.00 71.75 C \nANISOU 912 CE LYS A 113 6888 8798 11575 -367 87 -1070 C \nATOM 913 NZ LYS A 113 -12.671 -27.031 -60.116 1.00 75.41 N \nANISOU 913 NZ LYS A 113 7451 9170 12033 -415 102 -1021 N \nATOM 914 N ILE A 114 -18.746 -23.900 -60.440 1.00 73.59 N \nANISOU 914 N ILE A 114 7095 8870 11995 70 -113 -1111 N \nATOM 915 CA ILE A 114 -19.796 -23.882 -61.452 1.00 73.58 C \nANISOU 915 CA ILE A 114 7048 8905 12004 149 -119 -1160 C \nATOM 916 C ILE A 114 -19.194 -23.843 -62.833 1.00 76.16 C \nANISOU 916 C ILE A 114 7374 9246 12318 114 -65 -1179 C \nATOM 917 O ILE A 114 -18.270 -23.016 -63.098 1.00 77.02 O \nANISOU 917 O ILE A 114 7554 9280 12430 72 -39 -1148 O \nATOM 918 CB ILE A 114 -20.649 -22.588 -61.377 1.00 85.37 C \nANISOU 918 CB ILE A 114 8599 10303 13537 235 -161 -1156 C \nATOM 919 CG1 ILE A 114 -21.574 -22.627 -60.176 1.00 90.48 C \nANISOU 919 CG1 ILE A 114 9241 10941 14198 296 -221 -1147 C \nATOM 920 CG2 ILE A 114 -21.500 -22.433 -62.639 1.00 86.45 C \nANISOU 920 CG2 ILE A 114 8707 10460 13679 306 -155 -1206 C \nATOM 921 CD1 ILE A 114 -22.424 -21.382 -60.066 1.00 88.91 C \nANISOU 921 CD1 ILE A 114 9110 10641 14030 375 -265 -1142 C \nATOM 922 N GLN A 115 -19.759 -24.632 -63.744 1.00 70.34 N \nANISOU 922 N GLN A 115 6559 8603 11564 138 -48 -1229 N \nATOM 923 CA GLN A 115 -19.383 -24.474 -65.155 1.00 69.84 C \nANISOU 923 CA GLN A 115 6495 8549 11492 119 -2 -1252 C \nATOM 924 C GLN A 115 -20.021 -23.213 -65.751 1.00 70.34 C \nANISOU 924 C GLN A 115 6605 8532 11588 195 -19 -1262 C \nATOM 925 O GLN A 115 -21.232 -23.048 -65.715 1.00 69.79 O \nANISOU 925 O GLN A 115 6516 8465 11537 286 -57 -1290 O \nATOM 926 CB GLN A 115 -19.768 -25.659 -65.961 1.00 67.21 C \nANISOU 926 CB GLN A 115 6066 8343 11128 117 22 -1302 C \nATOM 927 CG GLN A 115 -19.013 -25.739 -67.264 1.00 69.55 C \nANISOU 927 CG GLN A 115 6365 8660 11403 62 78 -1315 C \nATOM 928 CD GLN A 115 -19.479 -26.891 -68.126 1.00 67.72 C \nANISOU 928 CD GLN A 115 6033 8562 11137 61 101 -1369 C \nATOM 929 OE1 GLN A 115 -20.678 -27.143 -68.205 1.00 75.43 O \nANISOU 929 OE1 GLN A 115 6946 9595 12120 146 72 -1410 O \nATOM 930 NE2 GLN A 115 -18.537 -27.605 -68.744 1.00 61.37 N \nANISOU 930 NE2 GLN A 115 5215 7809 10292 -35 152 -1370 N \nATOM 931 N ILE A 116 -19.187 -22.317 -66.275 1.00 72.32 N \nANISOU 931 N ILE A 116 6923 8714 11844 157 8 -1237 N \nATOM 932 CA ILE A 116 -19.596 -20.955 -66.592 1.00 67.44 C \nANISOU 932 CA ILE A 116 6366 8004 11252 208 -11 -1232 C \nATOM 933 C ILE A 116 -19.686 -20.748 -68.094 1.00 65.60 C \nANISOU 933 C ILE A 116 6121 7793 11013 218 24 -1269 C \nATOM 934 O ILE A 116 -20.549 -20.004 -68.587 1.00 65.52 O \nANISOU 934 O ILE A 116 6130 7744 11021 284 5 -1293 O \nATOM 935 CB ILE A 116 -18.652 -19.940 -65.879 1.00 70.09 C \nANISOU 935 CB ILE A 116 6790 8247 11596 160 -14 -1172 C \nATOM 936 CG1 ILE A 116 -19.440 -18.767 -65.354 1.00 72.44 C \nANISOU 936 CG1 ILE A 116 7146 8457 11922 219 -63 -1160 C \nATOM 937 CG2 ILE A 116 -17.429 -19.515 -66.699 1.00 67.51 C \nANISOU 937 CG2 ILE A 116 6497 7904 11250 97 37 -1152 C \nATOM 938 CD1 ILE A 116 -20.267 -19.165 -64.158 1.00 71.30 C \nANISOU 938 CD1 ILE A 116 6985 8314 11790 264 -114 -1158 C \nATOM 939 N ILE A 117 -18.770 -21.378 -68.819 1.00 62.30 N \nANISOU 939 N ILE A 117 5675 7430 10566 150 75 -1271 N \nATOM 940 CA ILE A 117 -18.837 -21.503 -70.279 1.00 66.78 C \nANISOU 940 CA ILE A 117 6210 8043 11119 153 113 -1310 C \nATOM 941 C ILE A 117 -18.149 -22.821 -70.665 1.00 78.62 C \nANISOU 941 C ILE A 117 7651 9641 12580 82 157 -1322 C \nATOM 942 O ILE A 117 -16.909 -22.935 -70.598 1.00 85.19 O \nANISOU 942 O ILE A 117 8518 10459 13390 2 189 -1285 O \nATOM 943 CB ILE A 117 -18.219 -20.307 -71.061 1.00 61.46 C \nANISOU 943 CB ILE A 117 5602 7300 10448 133 136 -1291 C \nATOM 944 CG1 ILE A 117 -16.988 -19.754 -70.378 1.00 62.49 C \nANISOU 944 CG1 ILE A 117 5801 7369 10573 72 145 -1228 C \nATOM 945 CG2 ILE A 117 -19.239 -19.186 -71.186 1.00 61.72 C \nANISOU 945 CG2 ILE A 117 5673 7266 10510 208 99 -1306 C \nATOM 946 CD1 ILE A 117 -16.317 -18.595 -71.086 1.00 60.78 C \nANISOU 946 CD1 ILE A 117 5642 7100 10353 52 168 -1205 C \nATOM 947 N PRO A 118 -18.960 -23.818 -71.074 1.00 85.28 N \nANISOU 947 N PRO A 118 8407 10584 13410 111 157 -1373 N \nATOM 948 CA PRO A 118 -18.507 -25.177 -71.346 1.00 80.21 C \nANISOU 948 CA PRO A 118 7699 10050 12725 43 192 -1389 C \nATOM 949 C PRO A 118 -17.386 -25.269 -72.369 1.00 78.19 C \nANISOU 949 C PRO A 118 7466 9804 12439 -37 249 -1380 C \nATOM 950 O PRO A 118 -17.321 -24.475 -73.311 1.00 90.78 O \nANISOU 950 O PRO A 118 9089 11361 14043 -19 265 -1386 O \nATOM 951 CB PRO A 118 -19.763 -25.863 -71.888 1.00 82.27 C \nANISOU 951 CB PRO A 118 7866 10413 12979 112 181 -1453 C \nATOM 952 CG PRO A 118 -20.901 -25.080 -71.342 1.00 80.41 C \nANISOU 952 CG PRO A 118 7650 10118 12785 221 127 -1460 C \nATOM 953 CD PRO A 118 -20.414 -23.669 -71.318 1.00 82.31 C \nANISOU 953 CD PRO A 118 7993 10226 13054 217 123 -1421 C \nATOM 954 N LYS A 119 -16.536 -26.265 -72.173 1.00 73.71 N \nANISOU 954 N LYS A 119 6886 9288 11832 -127 278 -1366 N \nATOM 955 CA LYS A 119 -15.328 -26.495 -72.954 1.00 72.76 C \nANISOU 955 CA LYS A 119 6799 9172 11675 -214 332 -1349 C \nATOM 956 C LYS A 119 -15.680 -26.983 -74.337 1.00 74.88 C \nANISOU 956 C LYS A 119 7004 9527 11920 -215 362 -1399 C \nATOM 957 O LYS A 119 -14.898 -26.846 -75.291 1.00 83.96 O \nANISOU 957 O LYS A 119 8184 10669 13048 -262 404 -1391 O \nATOM 958 CB LYS A 119 -14.441 -27.531 -72.234 1.00 72.11 C \nANISOU 958 CB LYS A 119 6727 9121 11552 -310 349 -1323 C \nATOM 959 CG LYS A 119 -13.077 -27.779 -72.854 1.00 76.56 C \nANISOU 959 CG LYS A 119 7347 9670 12071 -403 403 -1298 C \nATOM 960 CD LYS A 119 -12.416 -29.028 -72.252 1.00 79.50 C \nANISOU 960 CD LYS A 119 7719 10093 12392 -503 420 -1286 C \nATOM 961 CE LYS A 119 -11.044 -29.301 -72.868 1.00 81.55 C \nANISOU 961 CE LYS A 119 8050 10331 12604 -595 474 -1260 C \nATOM 962 NZ LYS A 119 -9.993 -28.520 -72.168 1.00 93.01 N \nANISOU 962 NZ LYS A 119 9612 11665 14063 -603 476 -1200 N \nATOM 963 N SER A 120 -16.866 -27.563 -74.451 1.00 78.87 N \nANISOU 963 N SER A 120 7420 10121 12427 -161 342 -1450 N \nATOM 964 CA SER A 120 -17.346 -28.111 -75.724 1.00 73.77 C \nANISOU 964 CA SER A 120 6699 9574 11756 -154 369 -1504 C \nATOM 965 C SER A 120 -18.087 -27.037 -76.567 1.00 70.95 C \nANISOU 965 C SER A 120 6353 9171 11435 -63 359 -1531 C \nATOM 966 O SER A 120 -18.441 -27.283 -77.711 1.00 79.61 O \nANISOU 966 O SER A 120 7400 10333 12514 -53 383 -1574 O \nATOM 967 CB SER A 120 -18.213 -29.326 -75.439 1.00 69.62 C \nANISOU 967 CB SER A 120 6068 9180 11206 -141 354 -1548 C \nATOM 968 OG SER A 120 -19.004 -29.102 -74.281 1.00 73.20 O \nANISOU 968 OG SER A 120 6514 9607 11692 -66 301 -1543 O \nATOM 969 N SER A 121 -18.248 -25.831 -76.036 1.00 62.73 N \nANISOU 969 N SER A 121 5381 8015 10438 -8 327 -1503 N \nATOM 970 CA SER A 121 -18.829 -24.730 -76.807 1.00 65.36 C \nANISOU 970 CA SER A 121 5742 8293 10799 62 320 -1523 C \nATOM 971 C SER A 121 -17.871 -24.155 -77.844 1.00 61.08 C \nANISOU 971 C SER A 121 5247 7717 10243 8 364 -1505 C \nATOM 972 O SER A 121 -18.300 -23.608 -78.835 1.00 70.96 O \nANISOU 972 O SER A 121 6496 8965 11500 45 372 -1534 O \nATOM 973 CB SER A 121 -19.250 -23.611 -75.877 1.00 66.20 C \nANISOU 973 CB SER A 121 5914 8290 10950 124 272 -1496 C \nATOM 974 OG SER A 121 -18.101 -22.868 -75.528 1.00 77.55 O \nANISOU 974 OG SER A 121 7434 9641 12391 66 283 -1436 O \nATOM 975 N TRP A 122 -16.573 -24.271 -77.610 1.00 63.73 N \nANISOU 975 N TRP A 122 5629 8027 10557 -77 390 -1456 N \nATOM 976 CA TRP A 122 -15.535 -23.690 -78.495 1.00 66.18 C \nANISOU 976 CA TRP A 122 5993 8301 10850 -125 430 -1429 C \nATOM 977 C TRP A 122 -15.466 -24.527 -79.768 1.00 70.67 C \nANISOU 977 C TRP A 122 6504 8967 11380 -164 473 -1468 C \nATOM 978 O TRP A 122 -14.552 -25.340 -79.979 1.00 80.89 O \nANISOU 978 O TRP A 122 7800 10302 12633 -247 510 -1453 O \nATOM 979 CB TRP A 122 -14.148 -23.610 -77.784 1.00 65.17 C \nANISOU 979 CB TRP A 122 5938 8116 10706 -195 445 -1364 C \nATOM 980 CG TRP A 122 -14.176 -22.894 -76.443 1.00 57.49 C \nANISOU 980 CG TRP A 122 5017 7058 9767 -164 404 -1325 C \nATOM 981 CD1 TRP A 122 -14.014 -23.444 -75.238 1.00 57.99 C \nANISOU 981 CD1 TRP A 122 5086 7118 9831 -185 385 -1303 C \nATOM 982 CD2 TRP A 122 -14.458 -21.519 -76.224 1.00 54.09 C \nANISOU 982 CD2 TRP A 122 4636 6544 9372 -110 376 -1307 C \nATOM 983 NE1 TRP A 122 -14.184 -22.506 -74.257 1.00 57.28 N \nANISOU 983 NE1 TRP A 122 5044 6946 9776 -144 346 -1273 N \nATOM 984 CE2 TRP A 122 -14.473 -21.310 -74.848 1.00 52.15 C \nANISOU 984 CE2 TRP A 122 4422 6246 9147 -99 339 -1274 C \nATOM 985 CE3 TRP A 122 -14.748 -20.451 -77.070 1.00 56.64 C \nANISOU 985 CE3 TRP A 122 4980 6835 9708 -75 377 -1317 C \nATOM 986 CZ2 TRP A 122 -14.708 -20.061 -74.275 1.00 53.09 C \nANISOU 986 CZ2 TRP A 122 4594 6282 9297 -58 305 -1249 C \nATOM 987 CZ3 TRP A 122 -14.989 -19.195 -76.497 1.00 56.12 C \nANISOU 987 CZ3 TRP A 122 4967 6685 9670 -36 342 -1292 C \nATOM 988 CH2 TRP A 122 -14.949 -19.023 -75.109 1.00 55.26 C \nANISOU 988 CH2 TRP A 122 4890 6525 9579 -29 307 -1258 C \nATOM 989 N SER A 123 -16.438 -24.295 -80.634 1.00 72.74 N \nANISOU 989 N SER A 123 6722 9263 11653 -104 470 -1519 N \nATOM 990 CA SER A 123 -16.571 -25.016 -81.905 1.00 80.01 C \nANISOU 990 CA SER A 123 7579 10281 12538 -129 507 -1565 C \nATOM 991 C SER A 123 -15.553 -24.617 -82.965 1.00 88.82 C \nANISOU 991 C SER A 123 8739 11380 13629 -186 552 -1543 C \nATOM 992 O SER A 123 -15.187 -25.440 -83.803 1.00 99.52 O \nANISOU 992 O SER A 123 10058 12813 14942 -244 590 -1560 O \nATOM 993 CB SER A 123 -17.962 -24.777 -82.467 1.00 81.84 C \nANISOU 993 CB SER A 123 7759 10547 12791 -36 487 -1627 C \nATOM 994 OG SER A 123 -18.877 -24.704 -81.397 1.00 92.97 O \nANISOU 994 OG SER A 123 9158 11934 14233 37 438 -1635 O \nATOM 995 N ASP A 124 -15.104 -23.359 -82.940 1.00 93.21 N \nANISOU 995 N ASP A 124 9371 11838 14207 -171 546 -1504 N \nATOM 996 CA ASP A 124 -14.255 -22.824 -84.013 1.00 90.10 C \nANISOU 996 CA ASP A 124 9015 11430 13789 -210 585 -1485 C \nATOM 997 C ASP A 124 -12.796 -22.697 -83.586 1.00 86.91 C \nANISOU 997 C ASP A 124 8685 10973 13363 -273 604 -1417 C \nATOM 998 O ASP A 124 -11.938 -22.233 -84.364 1.00 83.48 O \nANISOU 998 O ASP A 124 8291 10523 12905 -304 636 -1391 O \nATOM 999 CB ASP A 124 -14.805 -21.473 -84.484 1.00 90.61 C \nANISOU 999 CB ASP A 124 9106 11439 13883 -149 568 -1494 C \nATOM 1000 CG ASP A 124 -16.304 -21.528 -84.772 1.00 97.37 C \nANISOU 1000 CG ASP A 124 9905 12330 14762 -73 544 -1561 C \nATOM 1001 OD1 ASP A 124 -16.736 -22.459 -85.485 1.00102.63 O \nANISOU 1001 OD1 ASP A 124 10500 13090 15406 -78 563 -1610 O \nATOM 1002 OD2 ASP A 124 -17.052 -20.667 -84.270 1.00 95.48 O \nANISOU 1002 OD2 ASP A 124 9693 12026 14558 -9 505 -1565 O \nATOM 1003 N HIS A 125 -12.509 -23.104 -82.353 1.00 75.71 N \nANISOU 1003 N HIS A 125 7288 9530 11950 -290 586 -1388 N \nATOM 1004 CA HIS A 125 -11.151 -23.052 -81.863 1.00 73.12 C \nANISOU 1004 CA HIS A 125 7033 9150 11597 -344 605 -1326 C \nATOM 1005 C HIS A 125 -10.793 -24.418 -81.311 1.00 73.17 C \nANISOU 1005 C HIS A 125 7025 9203 11572 -409 616 -1325 C \nATOM 1006 O HIS A 125 -11.653 -25.195 -80.885 1.00 69.97 O \nANISOU 1006 O HIS A 125 6555 8855 11175 -399 596 -1362 O \nATOM 1007 CB HIS A 125 -10.998 -22.015 -80.754 1.00 71.18 C \nANISOU 1007 CB HIS A 125 6847 8812 11386 -306 570 -1283 C \nATOM 1008 CG HIS A 125 -11.458 -20.642 -81.126 1.00 67.26 C \nANISOU 1008 CG HIS A 125 6367 8271 10919 -248 552 -1284 C \nATOM 1009 ND1 HIS A 125 -12.794 -20.289 -81.163 1.00 61.50 N \nANISOU 1009 ND1 HIS A 125 5596 7546 10226 -185 519 -1329 N \nATOM 1010 CD2 HIS A 125 -10.753 -19.517 -81.411 1.00 69.94 C \nANISOU 1010 CD2 HIS A 125 6762 8560 11251 -245 562 -1245 C \nATOM 1011 CE1 HIS A 125 -12.887 -19.019 -81.521 1.00 69.89 C \nANISOU 1011 CE1 HIS A 125 6694 8560 11301 -154 510 -1319 C \nATOM 1012 NE2 HIS A 125 -11.666 -18.519 -81.662 1.00 70.44 N \nANISOU 1012 NE2 HIS A 125 6818 8602 11346 -191 535 -1268 N \nATOM 1013 N GLU A 126 -9.506 -24.705 -81.322 1.00 71.70 N \nANISOU 1013 N GLU A 126 6904 8994 11345 -475 649 -1282 N \nATOM 1014 CA GLU A 126 -9.021 -25.970 -80.832 1.00 70.90 C \nANISOU 1014 CA GLU A 126 6806 8929 11205 -551 664 -1276 C \nATOM 1015 C GLU A 126 -8.736 -25.881 -79.329 1.00 74.15 C \nANISOU 1015 C GLU A 126 7264 9277 11633 -548 636 -1238 C \nATOM 1016 O GLU A 126 -7.665 -25.458 -78.922 1.00 78.04 O \nANISOU 1016 O GLU A 126 7842 9696 12111 -564 647 -1186 O \nATOM 1017 CB GLU A 126 -7.761 -26.387 -81.591 1.00 68.36 C \nANISOU 1017 CB GLU A 126 6543 8606 10823 -627 715 -1249 C \nATOM 1018 CG GLU A 126 -7.397 -27.838 -81.379 1.00 74.35 C \nANISOU 1018 CG GLU A 126 7299 9422 11530 -721 736 -1256 C \nATOM 1019 CD GLU A 126 -8.544 -28.743 -81.770 1.00 76.82 C \nANISOU 1019 CD GLU A 126 7497 9850 11839 -729 729 -1320 C \nATOM 1020 OE1 GLU A 126 -9.080 -29.362 -80.832 1.00 87.42 O \nANISOU 1020 OE1 GLU A 126 8800 11226 13190 -735 704 -1335 O \nATOM 1021 OE2 GLU A 126 -8.925 -28.794 -82.981 1.00 73.42 O \nANISOU 1021 OE2 GLU A 126 7017 9482 11399 -725 748 -1356 O \nATOM 1022 N ALA A 127 -9.692 -26.343 -78.523 1.00 82.80 N \nANISOU 1022 N ALA A 127 8300 10407 12753 -526 601 -1266 N \nATOM 1023 CA ALA A 127 -9.590 -26.316 -77.060 1.00 86.86 C \nANISOU 1023 CA ALA A 127 8846 10872 13285 -522 571 -1237 C \nATOM 1024 C ALA A 127 -8.650 -27.387 -76.501 1.00 89.41 C \nANISOU 1024 C ALA A 127 9210 11204 13557 -615 594 -1213 C \nATOM 1025 O ALA A 127 -7.756 -27.101 -75.705 1.00 81.18 O \nANISOU 1025 O ALA A 127 8251 10087 12508 -632 595 -1164 O \nATOM 1026 CB ALA A 127 -10.980 -26.445 -76.429 1.00 80.60 C \nANISOU 1026 CB ALA A 127 7973 10117 12532 -462 524 -1275 C \nATOM 1027 N SER A 128 -8.852 -28.622 -76.951 1.00110.04 N \nANISOU 1027 N SER A 128 11768 13913 16129 -678 614 -1248 N \nATOM 1028 CA SER A 128 -8.182 -29.799 -76.369 1.00116.37 C \nANISOU 1028 CA SER A 128 12597 14741 16878 -777 631 -1235 C \nATOM 1029 C SER A 128 -6.648 -29.804 -76.476 1.00110.26 C \nANISOU 1029 C SER A 128 11943 13894 16056 -844 671 -1185 C \nATOM 1030 O SER A 128 -5.980 -30.544 -75.727 1.00100.42 O \nANISOU 1030 O SER A 128 10749 12634 14770 -917 681 -1163 O \nATOM 1031 CB SER A 128 -8.730 -31.066 -77.023 1.00119.22 C \nANISOU 1031 CB SER A 128 12869 15233 17197 -836 648 -1286 C \nATOM 1032 OG SER A 128 -8.389 -31.096 -78.399 1.00120.95 O \nANISOU 1032 OG SER A 128 13092 15478 17386 -862 687 -1298 O \nATOM 1033 N SER A 129 -6.103 -28.986 -77.385 1.00 98.09 N \nANISOU 1033 N SER A 129 10448 12306 14515 -816 694 -1166 N \nATOM 1034 CA SER A 129 -4.648 -28.847 -77.521 1.00 97.01 C \nANISOU 1034 CA SER A 129 10431 12095 14335 -858 730 -1115 C \nATOM 1035 C SER A 129 -4.097 -27.816 -76.535 1.00 91.46 C \nANISOU 1035 C SER A 129 9803 11286 13660 -802 711 -1065 C \nATOM 1036 O SER A 129 -2.932 -27.428 -76.598 1.00 73.18 O \nANISOU 1036 O SER A 129 7588 8902 11316 -808 736 -1020 O \nATOM 1037 CB SER A 129 -4.258 -28.471 -78.939 1.00104.37 C \nANISOU 1037 CB SER A 129 11377 13032 15247 -853 764 -1115 C \nATOM 1038 OG SER A 129 -2.999 -27.823 -78.945 1.00113.76 O \nANISOU 1038 OG SER A 129 12679 14131 16413 -845 786 -1059 O \nATOM 1039 N GLY A 130 -4.952 -27.371 -75.628 1.00 91.36 N \nANISOU 1039 N GLY A 130 9744 11267 13703 -745 666 -1074 N \nATOM 1040 CA GLY A 130 -4.521 -26.504 -74.568 1.00 87.03 C \nANISOU 1040 CA GLY A 130 9257 10631 13178 -702 644 -1030 C \nATOM 1041 C GLY A 130 -3.664 -27.235 -73.569 1.00 78.69 C \nANISOU 1041 C GLY A 130 8275 9540 12082 -767 654 -1001 C \nATOM 1042 O GLY A 130 -4.048 -27.342 -72.405 1.00 75.64 O \nANISOU 1042 O GLY A 130 7876 9144 11719 -761 622 -999 O \nATOM 1043 N VAL A 131 -2.494 -27.699 -74.023 1.00 71.60 N \nANISOU 1043 N VAL A 131 7463 8618 11123 -827 698 -977 N \nATOM 1044 CA VAL A 131 -1.663 -28.629 -73.244 1.00 65.95 C \nANISOU 1044 CA VAL A 131 6828 7877 10355 -909 715 -956 C \nATOM 1045 C VAL A 131 -0.176 -28.299 -73.399 1.00 61.88 C \nANISOU 1045 C VAL A 131 6446 7274 9791 -915 752 -905 C \nATOM 1046 O VAL A 131 0.247 -27.771 -74.427 1.00 56.66 O \nANISOU 1046 O VAL A 131 5808 6602 9119 -886 776 -894 O \nATOM 1047 CB VAL A 131 -1.952 -30.079 -73.695 1.00 66.10 C \nANISOU 1047 CB VAL A 131 6803 7985 10328 -1009 734 -995 C \nATOM 1048 CG1 VAL A 131 -0.798 -31.029 -73.347 1.00 73.34 C \nANISOU 1048 CG1 VAL A 131 7832 8866 11168 -1111 769 -970 C \nATOM 1049 CG2 VAL A 131 -3.251 -30.565 -73.079 1.00 61.14 C \nANISOU 1049 CG2 VAL A 131 6060 7437 9735 -1007 695 -1037 C \nATOM 1050 N SER A 132 0.619 -28.616 -72.390 1.00 62.28 N \nANISOU 1050 N SER A 132 6587 7265 9810 -949 758 -875 N \nATOM 1051 CA SER A 132 2.065 -28.380 -72.468 1.00 77.03 C \nANISOU 1051 CA SER A 132 8594 9048 11626 -950 793 -827 C \nATOM 1052 C SER A 132 2.870 -29.263 -71.511 1.00 77.12 C \nANISOU 1052 C SER A 132 8707 9012 11581 -1027 808 -808 C \nATOM 1053 O SER A 132 2.370 -29.725 -70.493 1.00 62.42 O \nANISOU 1053 O SER A 132 6813 7167 9735 -1058 782 -822 O \nATOM 1054 CB SER A 132 2.369 -26.888 -72.191 1.00 87.12 C \nANISOU 1054 CB SER A 132 9894 10266 12940 -840 778 -790 C \nATOM 1055 OG SER A 132 3.770 -26.620 -72.188 1.00 93.84 O \nANISOU 1055 OG SER A 132 10878 11040 13738 -826 811 -742 O \nATOM 1056 N SER A 133 4.140 -29.443 -71.851 1.00 93.04 N \nANISOU 1056 N SER A 133 10855 10965 13532 -1052 849 -775 N \nATOM 1057 CA SER A 133 5.084 -30.270 -71.066 1.00 93.25 C \nANISOU 1057 CA SER A 133 11008 10931 13493 -1127 870 -754 C \nATOM 1058 C SER A 133 5.465 -29.584 -69.757 1.00 89.94 C \nANISOU 1058 C SER A 133 10640 10440 13094 -1068 850 -722 C \nATOM 1059 O SER A 133 5.842 -30.247 -68.793 1.00 79.48 O \nANISOU 1059 O SER A 133 9383 9080 11735 -1127 852 -716 O \nATOM 1060 CB SER A 133 6.368 -30.532 -71.865 1.00 93.82 C \nANISOU 1060 CB SER A 133 11218 10943 13485 -1155 920 -725 C \nATOM 1061 OG SER A 133 6.107 -30.605 -73.257 1.00106.53 O \nANISOU 1061 OG SER A 133 12778 12609 15090 -1164 938 -743 O \nATOM 1062 N ALA A 134 5.390 -28.249 -69.737 1.00 95.63 N \nANISOU 1062 N ALA A 134 11331 11140 13864 -954 831 -702 N \nATOM 1063 CA ALA A 134 5.670 -27.466 -68.518 1.00 86.44 C \nANISOU 1063 CA ALA A 134 10201 9919 12723 -890 809 -672 C \nATOM 1064 C ALA A 134 4.705 -27.847 -67.389 1.00 77.21 C \nANISOU 1064 C ALA A 134 8955 8785 11597 -923 768 -697 C \nATOM 1065 O ALA A 134 5.030 -27.726 -66.203 1.00 70.52 O \nANISOU 1065 O ALA A 134 8157 7891 10748 -916 755 -678 O \nATOM 1066 CB ALA A 134 5.587 -25.985 -68.814 1.00 75.39 C \nANISOU 1066 CB ALA A 134 8761 8515 11368 -774 794 -652 C \nATOM 1067 N CYS A 135 3.525 -28.320 -67.782 1.00 79.24 N \nANISOU 1067 N CYS A 135 9091 9128 11889 -956 748 -741 N \nATOM 1068 CA CYS A 135 2.493 -28.756 -66.848 1.00 88.59 C \nANISOU 1068 CA CYS A 135 10189 10361 13111 -985 708 -769 C \nATOM 1069 C CYS A 135 2.235 -30.267 -66.961 1.00 92.71 C \nANISOU 1069 C CYS A 135 10691 10945 13588 -1104 721 -802 C \nATOM 1070 O CYS A 135 1.343 -30.708 -67.681 1.00 90.21 O \nANISOU 1070 O CYS A 135 10273 10715 13287 -1126 715 -841 O \nATOM 1071 CB CYS A 135 1.184 -27.984 -67.110 1.00 85.79 C \nANISOU 1071 CB CYS A 135 9698 10064 12836 -910 667 -794 C \nATOM 1072 SG CYS A 135 0.086 -27.768 -65.694 1.00103.82 S \nANISOU 1072 SG CYS A 135 11900 12367 15181 -882 607 -805 S \nATOM 1073 N PRO A 136 3.001 -31.067 -66.220 1.00102.37 N \nANISOU 1073 N PRO A 136 12014 12130 14754 -1184 739 -789 N \nATOM 1074 CA PRO A 136 2.756 -32.491 -66.186 1.00109.90 C \nANISOU 1074 CA PRO A 136 12949 13148 15659 -1307 749 -819 C \nATOM 1075 C PRO A 136 1.512 -32.845 -65.376 1.00109.56 C \nANISOU 1075 C PRO A 136 12781 13188 15660 -1319 703 -851 C \nATOM 1076 O PRO A 136 1.015 -32.033 -64.601 1.00123.73 O \nANISOU 1076 O PRO A 136 14531 14966 17515 -1240 665 -842 O \nATOM 1077 CB PRO A 136 4.025 -33.049 -65.517 1.00116.42 C \nANISOU 1077 CB PRO A 136 13936 13890 16410 -1379 780 -789 C \nATOM 1078 CG PRO A 136 5.029 -31.941 -65.574 1.00117.29 C \nANISOU 1078 CG PRO A 136 14150 13893 16521 -1285 796 -744 C \nATOM 1079 CD PRO A 136 4.201 -30.708 -65.450 1.00115.07 C \nANISOU 1079 CD PRO A 136 13761 13631 16328 -1166 755 -744 C \nATOM 1080 N TYR A 137 1.032 -34.064 -65.567 1.00110.05 N \nANISOU 1080 N TYR A 137 12787 13343 15685 -1420 708 -886 N \nATOM 1081 CA TYR A 137 -0.104 -34.610 -64.834 1.00110.16 C \nANISOU 1081 CA TYR A 137 12682 13452 15723 -1442 668 -918 C \nATOM 1082 C TYR A 137 0.295 -35.947 -64.233 1.00116.15 C \nANISOU 1082 C TYR A 137 13489 14240 16404 -1583 685 -925 C \nATOM 1083 O TYR A 137 0.557 -36.078 -63.031 1.00121.73 O \nANISOU 1083 O TYR A 137 14242 14909 17100 -1608 671 -908 O \nATOM 1084 CB TYR A 137 -1.309 -34.808 -65.769 1.00103.23 C \nANISOU 1084 CB TYR A 137 11655 12693 14876 -1421 654 -964 C \nATOM 1085 CG TYR A 137 -2.366 -35.799 -65.283 1.00 93.84 C \nANISOU 1085 CG TYR A 137 10345 11630 13680 -1476 626 -1003 C \nATOM 1086 CD1 TYR A 137 -2.665 -35.940 -63.930 1.00 95.50 C \nANISOU 1086 CD1 TYR A 137 10541 11844 13903 -1481 592 -997 C \nATOM 1087 CD2 TYR A 137 -3.070 -36.584 -66.190 1.00 95.91 C \nANISOU 1087 CD2 TYR A 137 10506 12017 13920 -1519 634 -1047 C \nATOM 1088 CE1 TYR A 137 -3.627 -36.840 -63.498 1.00 93.12 C \nANISOU 1088 CE1 TYR A 137 10125 11666 13590 -1526 566 -1032 C \nATOM 1089 CE2 TYR A 137 -4.038 -37.485 -65.769 1.00 94.89 C \nANISOU 1089 CE2 TYR A 137 10259 12016 13778 -1562 609 -1084 C \nATOM 1090 CZ TYR A 137 -4.313 -37.602 -64.422 1.00 93.61 C \nANISOU 1090 CZ TYR A 137 10084 11855 13628 -1564 574 -1075 C \nATOM 1091 OH TYR A 137 -5.270 -38.479 -64.000 1.00 95.91 O \nANISOU 1091 OH TYR A 137 10255 12281 13903 -1601 548 -1109 O \nATOM 1092 N GLN A 138 0.303 -36.952 -65.089 1.00105.69 N \nANISOU 1092 N GLN A 138 12148 12990 15020 -1681 713 -951 N \nATOM 1093 CA GLN A 138 0.705 -38.265 -64.693 1.00100.73 C \nANISOU 1093 CA GLN A 138 11569 12398 14305 -1830 734 -959 C \nATOM 1094 C GLN A 138 1.826 -38.610 -65.664 1.00 97.92 C \nANISOU 1094 C GLN A 138 11342 11987 13877 -1900 788 -945 C \nATOM 1095 O GLN A 138 1.801 -39.656 -66.332 1.00 87.06 O \nANISOU 1095 O GLN A 138 9952 10692 12437 -2013 813 -970 O \nATOM 1096 CB GLN A 138 -0.494 -39.195 -64.805 1.00 97.01 C \nANISOU 1096 CB GLN A 138 10940 12094 13827 -1886 712 -1008 C \nATOM 1097 CG GLN A 138 -0.370 -40.442 -63.979 1.00 97.74 C \nANISOU 1097 CG GLN A 138 11049 12244 13845 -2029 715 -1018 C \nATOM 1098 CD GLN A 138 -0.645 -40.243 -62.502 1.00 88.57 C \nANISOU 1098 CD GLN A 138 9874 11064 12715 -2001 676 -1006 C \nATOM 1099 OE1 GLN A 138 -1.715 -39.784 -62.108 1.00 85.11 O \nANISOU 1099 OE1 GLN A 138 9311 10680 12347 -1909 631 -1019 O \nATOM 1100 NE2 GLN A 138 0.297 -40.652 -61.674 1.00 90.71 N \nANISOU 1100 NE2 GLN A 138 10276 11262 12928 -2088 694 -981 N \nATOM 1101 N GLY A 139 2.817 -37.713 -65.728 1.00 92.23 N \nANISOU 1101 N GLY A 139 10747 11131 13164 -1830 806 -904 N \nATOM 1102 CA GLY A 139 3.905 -37.795 -66.696 1.00 95.76 C \nANISOU 1102 CA GLY A 139 11324 11509 13552 -1862 855 -884 C \nATOM 1103 C GLY A 139 3.520 -37.136 -68.012 1.00104.82 C \nANISOU 1103 C GLY A 139 12398 12687 14742 -1780 860 -893 C \nATOM 1104 O GLY A 139 4.279 -36.345 -68.582 1.00114.48 O \nANISOU 1104 O GLY A 139 13705 13823 15968 -1710 881 -862 O \nATOM 1105 N THR A 140 2.330 -37.477 -68.496 1.00105.65 N \nANISOU 1105 N THR A 140 12344 12922 14876 -1788 840 -937 N \nATOM 1106 CA THR A 140 1.797 -36.935 -69.734 1.00111.10 C \nANISOU 1106 CA THR A 140 12949 13658 15607 -1716 841 -954 C \nATOM 1107 C THR A 140 1.756 -35.409 -69.666 1.00108.80 C \nANISOU 1107 C THR A 140 12652 13289 15397 -1561 820 -929 C \nATOM 1108 O THR A 140 1.558 -34.842 -68.592 1.00111.94 O \nANISOU 1108 O THR A 140 13042 13649 15841 -1501 788 -915 O \nATOM 1109 CB THR A 140 0.357 -37.433 -69.994 1.00113.46 C \nANISOU 1109 CB THR A 140 13064 14110 15936 -1725 814 -1008 C \nATOM 1110 OG1 THR A 140 -0.504 -36.948 -68.957 1.00124.97 O \nANISOU 1110 OG1 THR A 140 14436 15583 17463 -1648 764 -1014 O \nATOM 1111 CG2 THR A 140 0.280 -38.957 -70.034 1.00115.31 C \nANISOU 1111 CG2 THR A 140 13280 14447 16086 -1883 831 -1037 C \nATOM 1112 N PRO A 141 1.941 -34.742 -70.815 1.00105.42 N \nANISOU 1112 N PRO A 141 12228 12844 14983 -1500 838 -922 N \nATOM 1113 CA PRO A 141 1.750 -33.305 -70.838 1.00108.41 C \nANISOU 1113 CA PRO A 141 12582 13173 15438 -1360 816 -904 C \nATOM 1114 C PRO A 141 0.284 -32.933 -70.632 1.00109.79 C \nANISOU 1114 C PRO A 141 12597 13428 15691 -1294 768 -940 C \nATOM 1115 O PRO A 141 -0.579 -33.387 -71.377 1.00119.55 O \nANISOU 1115 O PRO A 141 13726 14764 16933 -1312 765 -982 O \nATOM 1116 CB PRO A 141 2.209 -32.906 -72.246 1.00104.30 C \nANISOU 1116 CB PRO A 141 12090 12639 14900 -1334 848 -896 C \nATOM 1117 CG PRO A 141 2.055 -34.127 -73.070 1.00100.54 C \nANISOU 1117 CG PRO A 141 11587 12247 14365 -1447 874 -929 C \nATOM 1118 CD PRO A 141 2.346 -35.265 -72.134 1.00106.28 C \nANISOU 1118 CD PRO A 141 12367 12980 15036 -1562 879 -931 C \nATOM 1119 N SER A 142 0.009 -32.142 -69.602 1.00110.56 N \nANISOU 1119 N SER A 142 12682 13482 15843 -1218 732 -923 N \nATOM 1120 CA SER A 142 -1.355 -31.683 -69.314 1.00 98.64 C \nANISOU 1120 CA SER A 142 11040 12032 14409 -1145 684 -952 C \nATOM 1121 C SER A 142 -1.346 -30.165 -69.086 1.00 85.82 C \nANISOU 1121 C SER A 142 9429 10332 12846 -1026 661 -923 C \nATOM 1122 O SER A 142 -0.445 -29.455 -69.556 1.00 80.42 O \nANISOU 1122 O SER A 142 8827 9580 12149 -992 686 -891 O \nATOM 1123 CB SER A 142 -1.936 -32.469 -68.136 1.00 99.38 C \nANISOU 1123 CB SER A 142 11086 12174 14501 -1194 654 -968 C \nATOM 1124 OG SER A 142 -1.218 -32.133 -66.969 1.00105.97 O \nANISOU 1124 OG SER A 142 12014 12918 15333 -1188 648 -929 O \nATOM 1125 N PHE A 143 -2.345 -29.684 -68.360 1.00 77.68 N \nANISOU 1125 N PHE A 143 8319 9319 11877 -965 614 -935 N \nATOM 1126 CA PHE A 143 -2.594 -28.263 -68.186 1.00 69.93 C \nANISOU 1126 CA PHE A 143 7330 8286 10955 -858 587 -916 C \nATOM 1127 C PHE A 143 -3.714 -28.059 -67.184 1.00 61.66 C \nANISOU 1127 C PHE A 143 6205 7261 9963 -816 533 -931 C \nATOM 1128 O PHE A 143 -4.428 -28.969 -66.879 1.00 59.83 O \nANISOU 1128 O PHE A 143 5906 7100 9727 -855 518 -962 O \nATOM 1129 CB PHE A 143 -2.985 -27.645 -69.508 1.00 63.84 C \nANISOU 1129 CB PHE A 143 6510 7539 10206 -806 595 -934 C \nATOM 1130 CG PHE A 143 -3.074 -26.158 -69.470 1.00 61.83 C \nANISOU 1130 CG PHE A 143 6263 7231 10000 -710 574 -911 C \nATOM 1131 CD1 PHE A 143 -1.915 -25.375 -69.499 1.00 61.68 C \nANISOU 1131 CD1 PHE A 143 6339 7136 9959 -686 597 -864 C \nATOM 1132 CD2 PHE A 143 -4.303 -25.524 -69.424 1.00 60.18 C \nANISOU 1132 CD2 PHE A 143 5967 7047 9852 -643 532 -935 C \nATOM 1133 CE1 PHE A 143 -1.993 -23.982 -69.502 1.00 51.67 C \nANISOU 1133 CE1 PHE A 143 5071 5832 8729 -603 578 -843 C \nATOM 1134 CE2 PHE A 143 -4.381 -24.140 -69.416 1.00 52.19 C \nANISOU 1134 CE2 PHE A 143 4965 5987 8877 -566 514 -914 C \nATOM 1135 CZ PHE A 143 -3.233 -23.374 -69.445 1.00 48.32 C \nANISOU 1135 CZ PHE A 143 4562 5434 8364 -550 536 -868 C \nATOM 1136 N PHE A 144 -3.831 -26.864 -66.653 1.00 55.82 N \nANISOU 1136 N PHE A 144 5478 6463 9268 -738 505 -906 N \nATOM 1137 CA PHE A 144 -4.892 -26.537 -65.705 1.00 57.88 C \nANISOU 1137 CA PHE A 144 5675 6735 9581 -691 451 -916 C \nATOM 1138 C PHE A 144 -6.229 -27.098 -66.176 1.00 57.64 C \nANISOU 1138 C PHE A 144 5529 6798 9574 -680 430 -968 C \nATOM 1139 O PHE A 144 -6.528 -27.105 -67.373 1.00 58.92 O \nANISOU 1139 O PHE A 144 5652 7001 9737 -668 447 -995 O \nATOM 1140 CB PHE A 144 -5.030 -25.007 -65.544 1.00 58.15 C \nANISOU 1140 CB PHE A 144 5724 6708 9663 -602 426 -891 C \nATOM 1141 CG PHE A 144 -3.780 -24.313 -65.044 1.00 49.70 C \nANISOU 1141 CG PHE A 144 4757 5556 8571 -596 444 -840 C \nATOM 1142 CD1 PHE A 144 -3.046 -23.444 -65.879 1.00 44.33 C \nANISOU 1142 CD1 PHE A 144 4123 4841 7879 -562 471 -817 C \nATOM 1143 CD2 PHE A 144 -3.343 -24.556 -63.774 1.00 44.60 C \nANISOU 1143 CD2 PHE A 144 4159 4875 7912 -623 433 -816 C \nATOM 1144 CE1 PHE A 144 -1.889 -22.828 -65.409 1.00 52.12 C \nANISOU 1144 CE1 PHE A 144 5201 5762 8839 -549 487 -771 C \nATOM 1145 CE2 PHE A 144 -2.214 -23.939 -63.278 1.00 48.27 C \nANISOU 1145 CE2 PHE A 144 4718 5269 8354 -612 449 -771 C \nATOM 1146 CZ PHE A 144 -1.474 -23.079 -64.083 1.00 54.92 C \nANISOU 1146 CZ PHE A 144 5605 6080 9183 -572 476 -748 C \nATOM 1147 N ARG A 145 -7.023 -27.567 -65.228 1.00 53.10 N \nANISOU 1147 N ARG A 145 4901 6260 9016 -681 393 -983 N \nATOM 1148 CA ARG A 145 -8.308 -28.183 -65.539 1.00 53.25 C \nANISOU 1148 CA ARG A 145 4807 6376 9050 -664 370 -1032 C \nATOM 1149 C ARG A 145 -9.462 -27.215 -65.570 1.00 49.47 C \nANISOU 1149 C ARG A 145 4275 5887 8633 -560 326 -1046 C \nATOM 1150 O ARG A 145 -10.481 -27.514 -66.183 1.00 53.55 O \nANISOU 1150 O ARG A 145 4708 6476 9164 -527 314 -1090 O \nATOM 1151 CB ARG A 145 -8.595 -29.278 -64.524 1.00 57.78 C \nANISOU 1151 CB ARG A 145 5345 7008 9600 -719 352 -1041 C \nATOM 1152 CG ARG A 145 -7.563 -30.403 -64.567 1.00 68.12 C \nANISOU 1152 CG ARG A 145 6705 8340 10839 -837 396 -1035 C \nATOM 1153 CD ARG A 145 -8.042 -31.634 -63.836 1.00 79.87 C \nANISOU 1153 CD ARG A 145 8131 9919 12296 -900 381 -1057 C \nATOM 1154 NE ARG A 145 -6.984 -32.629 -63.695 1.00 92.62 N \nANISOU 1154 NE ARG A 145 9813 11540 13838 -1021 421 -1045 N \nATOM 1155 CZ ARG A 145 -6.614 -33.506 -64.632 1.00 98.78 C \nANISOU 1155 CZ ARG A 145 10592 12378 14563 -1102 462 -1065 C \nATOM 1156 NH1 ARG A 145 -7.197 -33.527 -65.839 1.00101.66 N \nANISOU 1156 NH1 ARG A 145 10884 12806 14936 -1072 472 -1100 N \nATOM 1157 NH2 ARG A 145 -5.645 -34.373 -64.361 1.00 93.39 N \nANISOU 1157 NH2 ARG A 145 9984 11688 13810 -1217 495 -1052 N \nATOM 1158 N ASN A 146 -9.313 -26.063 -64.895 1.00 44.55 N \nANISOU 1158 N ASN A 146 3705 5177 8045 -510 302 -1011 N \nATOM 1159 CA ASN A 146 -10.437 -25.153 -64.697 1.00 42.09 C \nANISOU 1159 CA ASN A 146 3356 4847 7789 -420 254 -1021 C \nATOM 1160 C ASN A 146 -10.464 -24.024 -65.719 1.00 42.18 C \nANISOU 1160 C ASN A 146 3386 4819 7822 -368 263 -1021 C \nATOM 1161 O ASN A 146 -11.231 -23.050 -65.617 1.00 35.93 O \nANISOU 1161 O ASN A 146 2586 3993 7071 -299 228 -1023 O \nATOM 1162 CB ASN A 146 -10.403 -24.552 -63.332 1.00 43.14 C \nANISOU 1162 CB ASN A 146 3530 4917 7944 -401 217 -985 C \nATOM 1163 CG ASN A 146 -10.901 -25.456 -62.285 1.00 42.23 C \nANISOU 1163 CG ASN A 146 3374 4848 7823 -422 189 -993 C \nATOM 1164 OD1 ASN A 146 -11.753 -26.277 -62.549 1.00 50.07 O \nANISOU 1164 OD1 ASN A 146 4286 5924 8813 -417 179 -1033 O \nATOM 1165 ND2 ASN A 146 -10.301 -25.362 -61.072 1.00 47.67 N \nANISOU 1165 ND2 ASN A 146 4118 5489 8505 -451 178 -955 N \nATOM 1166 N VAL A 147 -9.608 -24.160 -66.716 1.00 42.98 N \nANISOU 1166 N VAL A 147 3514 4925 7890 -407 312 -1018 N \nATOM 1167 CA VAL A 147 -9.270 -23.078 -67.592 1.00 42.38 C \nANISOU 1167 CA VAL A 147 3472 4807 7823 -374 328 -1006 C \nATOM 1168 C VAL A 147 -8.756 -23.654 -68.906 1.00 46.55 C \nANISOU 1168 C VAL A 147 3994 5380 8314 -415 378 -1024 C \nATOM 1169 O VAL A 147 -8.012 -24.622 -68.929 1.00 60.91 O \nANISOU 1169 O VAL A 147 5833 7222 10088 -484 411 -1019 O \nATOM 1170 CB VAL A 147 -8.224 -22.215 -66.849 1.00 44.27 C \nANISOU 1170 CB VAL A 147 3799 4965 8056 -376 331 -950 C \nATOM 1171 CG1 VAL A 147 -6.871 -22.188 -67.536 1.00 42.60 C \nANISOU 1171 CG1 VAL A 147 3653 4734 7800 -414 383 -924 C \nATOM 1172 CG2 VAL A 147 -8.772 -20.809 -66.613 1.00 44.14 C \nANISOU 1172 CG2 VAL A 147 3791 4899 8081 -309 294 -937 C \nATOM 1173 N VAL A 148 -9.212 -23.080 -70.008 1.00 50.00 N \nANISOU 1173 N VAL A 148 4403 5830 8766 -374 384 -1047 N \nATOM 1174 CA VAL A 148 -8.925 -23.587 -71.327 1.00 46.31 C \nANISOU 1174 CA VAL A 148 3917 5411 8267 -406 427 -1069 C \nATOM 1175 C VAL A 148 -7.916 -22.721 -72.089 1.00 45.32 C \nANISOU 1175 C VAL A 148 3856 5240 8123 -405 460 -1037 C \nATOM 1176 O VAL A 148 -8.119 -21.521 -72.255 1.00 41.59 O \nANISOU 1176 O VAL A 148 3395 4728 7677 -352 444 -1026 O \nATOM 1177 CB VAL A 148 -10.209 -23.669 -72.156 1.00 41.66 C \nANISOU 1177 CB VAL A 148 3242 4884 7702 -361 413 -1125 C \nATOM 1178 CG1 VAL A 148 -9.937 -24.450 -73.422 1.00 43.15 C \nANISOU 1178 CG1 VAL A 148 3403 5140 7852 -407 458 -1152 C \nATOM 1179 CG2 VAL A 148 -11.295 -24.305 -71.327 1.00 43.40 C \nANISOU 1179 CG2 VAL A 148 3399 5147 7944 -339 373 -1154 C \nATOM 1180 N TRP A 149 -6.908 -23.369 -72.640 1.00 42.57 N \nANISOU 1180 N TRP A 149 3545 4905 7726 -465 506 -1025 N \nATOM 1181 CA TRP A 149 -5.917 -22.710 -73.486 1.00 42.92 C \nANISOU 1181 CA TRP A 149 3647 4918 7744 -464 541 -996 C \nATOM 1182 C TRP A 149 -6.253 -22.873 -74.925 1.00 48.44 C \nANISOU 1182 C TRP A 149 4299 5672 8433 -467 565 -1032 C \nATOM 1183 O TRP A 149 -5.897 -23.878 -75.553 1.00 57.95 O \nANISOU 1183 O TRP A 149 5499 6921 9597 -525 599 -1046 O \nATOM 1184 CB TRP A 149 -4.545 -23.343 -73.246 1.00 40.77 C \nANISOU 1184 CB TRP A 149 3457 4618 7416 -526 579 -960 C \nATOM 1185 CG TRP A 149 -3.434 -22.720 -73.975 1.00 42.16 C \nANISOU 1185 CG TRP A 149 3701 4760 7558 -518 614 -924 C \nATOM 1186 CD1 TRP A 149 -3.523 -21.788 -74.928 1.00 43.79 C \nANISOU 1186 CD1 TRP A 149 3893 4971 7774 -475 620 -924 C \nATOM 1187 CD2 TRP A 149 -2.032 -23.028 -73.842 1.00 43.35 C \nANISOU 1187 CD2 TRP A 149 3949 4868 7653 -556 651 -882 C \nATOM 1188 NE1 TRP A 149 -2.268 -21.468 -75.391 1.00 44.14 N \nANISOU 1188 NE1 TRP A 149 4013 4986 7773 -479 656 -884 N \nATOM 1189 CE2 TRP A 149 -1.343 -22.228 -74.738 1.00 44.23 C \nANISOU 1189 CE2 TRP A 149 4097 4965 7744 -524 676 -858 C \nATOM 1190 CE3 TRP A 149 -1.307 -23.911 -73.048 1.00 47.20 C \nANISOU 1190 CE3 TRP A 149 4502 5330 8103 -612 664 -864 C \nATOM 1191 CZ2 TRP A 149 0.041 -22.233 -74.830 1.00 48.25 C \nANISOU 1191 CZ2 TRP A 149 4705 5430 8197 -535 712 -814 C \nATOM 1192 CZ3 TRP A 149 0.059 -23.944 -73.168 1.00 47.45 C \nANISOU 1192 CZ3 TRP A 149 4637 5312 8079 -629 701 -823 C \nATOM 1193 CH2 TRP A 149 0.717 -23.113 -74.043 1.00 49.34 C \nANISOU 1193 CH2 TRP A 149 4911 5535 8300 -586 724 -798 C \nATOM 1194 N LEU A 150 -6.994 -21.914 -75.468 1.00 47.86 N \nANISOU 1194 N LEU A 150 4190 5599 8394 -408 547 -1049 N \nATOM 1195 CA LEU A 150 -7.560 -22.052 -76.826 1.00 44.09 C \nANISOU 1195 CA LEU A 150 3656 5181 7915 -403 564 -1092 C \nATOM 1196 C LEU A 150 -6.477 -21.843 -77.835 1.00 48.92 C \nANISOU 1196 C LEU A 150 4316 5789 8484 -429 609 -1067 C \nATOM 1197 O LEU A 150 -5.560 -21.056 -77.602 1.00 67.14 O \nANISOU 1197 O LEU A 150 6690 8041 10779 -417 617 -1019 O \nATOM 1198 CB LEU A 150 -8.711 -21.090 -77.025 1.00 46.03 C \nANISOU 1198 CB LEU A 150 3859 5421 8208 -333 529 -1119 C \nATOM 1199 CG LEU A 150 -9.909 -21.283 -76.106 1.00 50.59 C \nANISOU 1199 CG LEU A 150 4390 6005 8827 -296 482 -1147 C \nATOM 1200 CD1 LEU A 150 -10.923 -20.172 -76.331 1.00 57.50 C \nANISOU 1200 CD1 LEU A 150 5249 6856 9743 -227 449 -1167 C \nATOM 1201 CD2 LEU A 150 -10.577 -22.624 -76.352 1.00 58.25 C \nANISOU 1201 CD2 LEU A 150 5287 7059 9787 -319 487 -1196 C \nATOM 1202 N ILE A 151 -6.567 -22.544 -78.956 1.00 49.54 N \nANISOU 1202 N ILE A 151 4358 5929 8536 -462 639 -1099 N \nATOM 1203 CA ILE A 151 -5.689 -22.329 -80.096 1.00 52.16 C \nANISOU 1203 CA ILE A 151 4726 6265 8828 -482 681 -1082 C \nATOM 1204 C ILE A 151 -6.484 -22.391 -81.386 1.00 51.48 C \nANISOU 1204 C ILE A 151 4569 6244 8746 -474 691 -1132 C \nATOM 1205 O ILE A 151 -7.653 -22.713 -81.369 1.00 49.78 O \nANISOU 1205 O ILE A 151 4281 6073 8561 -454 668 -1181 O \nATOM 1206 CB ILE A 151 -4.488 -23.283 -80.152 1.00 58.08 C \nANISOU 1206 CB ILE A 151 5540 7011 9518 -554 721 -1054 C \nATOM 1207 CG1 ILE A 151 -4.913 -24.732 -80.380 1.00 68.44 C \nANISOU 1207 CG1 ILE A 151 6801 8396 10807 -620 733 -1097 C \nATOM 1208 CG2 ILE A 151 -3.669 -23.157 -78.890 1.00 56.04 C \nANISOU 1208 CG2 ILE A 151 5359 6682 9252 -557 713 -1005 C \nATOM 1209 CD1 ILE A 151 -3.844 -25.592 -81.030 1.00 76.96 C \nANISOU 1209 CD1 ILE A 151 7937 9487 11817 -699 781 -1081 C \nATOM 1210 N LYS A 152 -5.831 -22.024 -82.487 1.00 55.38 N \nANISOU 1210 N LYS A 152 5088 6744 9208 -483 724 -1118 N \nATOM 1211 CA LYS A 152 -6.489 -21.934 -83.776 1.00 56.67 C \nANISOU 1211 CA LYS A 152 5192 6966 9373 -474 736 -1162 C \nATOM 1212 C LYS A 152 -6.940 -23.265 -84.333 1.00 69.78 C \nANISOU 1212 C LYS A 152 6793 8708 11012 -524 754 -1210 C \nATOM 1213 O LYS A 152 -6.264 -24.294 -84.171 1.00 73.36 O \nANISOU 1213 O LYS A 152 7274 9176 11424 -591 778 -1197 O \nATOM 1214 CB LYS A 152 -5.554 -21.254 -84.785 1.00 50.98 C \nANISOU 1214 CB LYS A 152 4517 6236 8618 -477 769 -1129 C \nATOM 1215 CG LYS A 152 -4.328 -22.017 -85.149 1.00 49.04 C \nANISOU 1215 CG LYS A 152 4330 5991 8311 -538 812 -1098 C \nATOM 1216 CD LYS A 152 -3.466 -21.212 -86.111 1.00 54.03 C \nANISOU 1216 CD LYS A 152 5005 6613 8909 -525 839 -1064 C \nATOM 1217 CE LYS A 152 -2.230 -21.967 -86.592 1.00 53.46 C \nANISOU 1217 CE LYS A 152 5003 6539 8770 -582 883 -1032 C \nATOM 1218 NZ LYS A 152 -1.778 -21.443 -87.919 1.00 58.12 N \nANISOU 1218 NZ LYS A 152 5601 7155 9328 -576 912 -1021 N \nATOM 1219 N LYS A 153 -8.080 -23.228 -85.017 1.00 82.99 N \nANISOU 1219 N LYS A 153 8387 10436 12708 -494 744 -1266 N \nATOM 1220 CA LYS A 153 -8.606 -24.377 -85.744 1.00 83.60 C \nANISOU 1220 CA LYS A 153 8394 10609 12762 -534 763 -1318 C \nATOM 1221 C LYS A 153 -8.461 -24.079 -87.230 1.00 83.52 C \nANISOU 1221 C LYS A 153 8372 10633 12726 -542 795 -1332 C \nATOM 1222 O LYS A 153 -8.779 -22.983 -87.674 1.00 79.91 O \nANISOU 1222 O LYS A 153 7916 10152 12295 -489 786 -1335 O \nATOM 1223 CB LYS A 153 -10.062 -24.588 -85.382 1.00 87.87 C \nANISOU 1223 CB LYS A 153 8850 11192 13343 -483 727 -1374 C \nATOM 1224 CG LYS A 153 -10.554 -25.996 -85.632 1.00 91.94 C \nANISOU 1224 CG LYS A 153 9291 11812 13830 -528 739 -1421 C \nATOM 1225 CD LYS A 153 -12.053 -26.069 -85.368 1.00100.23 C \nANISOU 1225 CD LYS A 153 10255 12908 14920 -457 703 -1478 C \nATOM 1226 CE LYS A 153 -12.474 -27.421 -84.818 1.00 98.34 C \nANISOU 1226 CE LYS A 153 9952 12755 14660 -492 697 -1507 C \nATOM 1227 NZ LYS A 153 -13.683 -27.302 -83.956 1.00101.96 N \nANISOU 1227 NZ LYS A 153 10360 13218 15164 -410 649 -1535 N \nATOM 1228 N ASN A 154 -7.988 -25.060 -87.995 1.00 87.02 N \nANISOU 1228 N ASN A 154 8808 11137 13117 -613 834 -1341 N \nATOM 1229 CA ASN A 154 -7.423 -24.795 -89.315 1.00 82.84 C \nANISOU 1229 CA ASN A 154 8297 10626 12553 -636 870 -1334 C \nATOM 1230 C ASN A 154 -6.330 -23.772 -89.104 1.00 80.70 C \nANISOU 1230 C ASN A 154 8119 10267 12276 -617 875 -1267 C \nATOM 1231 O ASN A 154 -5.645 -23.825 -88.079 1.00 83.62 O \nANISOU 1231 O ASN A 154 8552 10578 12644 -626 867 -1224 O \nATOM 1232 CB ASN A 154 -8.486 -24.311 -90.303 1.00 84.47 C \nANISOU 1232 CB ASN A 154 8430 10882 12782 -589 865 -1389 C \nATOM 1233 CG ASN A 154 -9.289 -25.453 -90.884 1.00 88.00 C \nANISOU 1233 CG ASN A 154 8788 11437 13210 -620 877 -1453 C \nATOM 1234 OD1 ASN A 154 -9.285 -25.697 -92.101 1.00 82.64 O \nANISOU 1234 OD1 ASN A 154 8080 10820 12500 -649 907 -1477 O \nATOM 1235 ND2 ASN A 154 -10.005 -26.155 -90.015 1.00 87.90 N \nANISOU 1235 ND2 ASN A 154 8728 11455 13216 -612 852 -1480 N \nATOM 1236 N ASN A 155 -6.141 -22.859 -90.044 1.00 72.98 N \nANISOU 1236 N ASN A 155 7151 9285 11294 -592 887 -1259 N \nATOM 1237 CA ASN A 155 -5.334 -21.690 -89.757 1.00 79.64 C \nANISOU 1237 CA ASN A 155 8064 10056 12139 -555 882 -1201 C \nATOM 1238 C ASN A 155 -6.223 -20.467 -89.506 1.00 73.88 C \nANISOU 1238 C ASN A 155 7305 9302 11464 -483 845 -1216 C \nATOM 1239 O ASN A 155 -6.296 -19.532 -90.306 1.00 71.20 O \nANISOU 1239 O ASN A 155 6960 8969 11123 -458 850 -1217 O \nATOM 1240 CB ASN A 155 -4.335 -21.480 -90.874 1.00 86.10 C \nANISOU 1240 CB ASN A 155 8925 10886 12905 -580 922 -1170 C \nATOM 1241 CG ASN A 155 -3.369 -22.634 -90.979 1.00 89.12 C \nANISOU 1241 CG ASN A 155 9359 11274 13229 -652 956 -1148 C \nATOM 1242 OD1 ASN A 155 -3.431 -23.578 -90.187 1.00 81.04 O \nANISOU 1242 OD1 ASN A 155 8339 10248 12204 -689 950 -1155 O \nATOM 1243 ND2 ASN A 155 -2.481 -22.573 -91.958 1.00 97.75 N \nANISOU 1243 ND2 ASN A 155 10495 12375 14270 -676 991 -1120 N \nATOM 1244 N THR A 156 -6.951 -20.530 -88.403 1.00 63.08 N \nANISOU 1244 N THR A 156 5919 7910 10140 -455 808 -1231 N \nATOM 1245 CA THR A 156 -7.935 -19.514 -88.088 1.00 70.55 C \nANISOU 1245 CA THR A 156 6839 8830 11135 -393 770 -1251 C \nATOM 1246 C THR A 156 -8.277 -19.427 -86.583 1.00 72.45 C \nANISOU 1246 C THR A 156 7094 9018 11415 -364 729 -1239 C \nATOM 1247 O THR A 156 -8.761 -20.386 -85.985 1.00 67.73 O \nANISOU 1247 O THR A 156 6465 8441 10830 -375 718 -1263 O \nATOM 1248 CB THR A 156 -9.229 -19.745 -88.859 1.00 70.27 C \nANISOU 1248 CB THR A 156 6727 8853 11119 -373 764 -1323 C \nATOM 1249 OG1 THR A 156 -8.908 -20.011 -90.223 1.00 83.70 O \nANISOU 1249 OG1 THR A 156 8410 10611 12780 -408 804 -1337 O \nATOM 1250 CG2 THR A 156 -10.130 -18.502 -88.778 1.00 75.58 C \nANISOU 1250 CG2 THR A 156 7395 9491 11833 -311 730 -1340 C \nATOM 1251 N TYR A 157 -8.023 -18.255 -86.003 1.00 69.12 N \nANISOU 1251 N TYR A 157 6716 8535 11009 -331 708 -1200 N \nATOM 1252 CA TYR A 157 -8.469 -17.935 -84.652 1.00 57.87 C \nANISOU 1252 CA TYR A 157 5304 7059 9625 -298 665 -1190 C \nATOM 1253 C TYR A 157 -9.498 -16.786 -84.812 1.00 60.10 C \nANISOU 1253 C TYR A 157 5570 7323 9942 -248 634 -1215 C \nATOM 1254 O TYR A 157 -9.162 -15.615 -84.740 1.00 56.32 O \nANISOU 1254 O TYR A 157 5128 6809 9461 -234 625 -1182 O \nATOM 1255 CB TYR A 157 -7.273 -17.539 -83.781 1.00 51.99 C \nANISOU 1255 CB TYR A 157 4631 6260 8863 -306 667 -1122 C \nATOM 1256 CG TYR A 157 -7.578 -17.428 -82.269 1.00 43.14 C \nANISOU 1256 CG TYR A 157 3526 5088 7777 -285 627 -1107 C \nATOM 1257 CD1 TYR A 157 -6.954 -18.228 -81.371 1.00 40.66 C \nANISOU 1257 CD1 TYR A 157 3241 4756 7451 -313 631 -1082 C \nATOM 1258 CD2 TYR A 157 -8.481 -16.492 -81.773 1.00 37.98 C \nANISOU 1258 CD2 TYR A 157 2863 4403 7164 -240 585 -1118 C \nATOM 1259 CE1 TYR A 157 -7.233 -18.160 -80.025 1.00 39.26 C \nANISOU 1259 CE1 TYR A 157 3077 4538 7304 -296 595 -1069 C \nATOM 1260 CE2 TYR A 157 -8.738 -16.377 -80.416 1.00 35.86 C \nANISOU 1260 CE2 TYR A 157 2612 4088 6924 -223 548 -1102 C \nATOM 1261 CZ TYR A 157 -8.133 -17.217 -79.558 1.00 36.45 C \nANISOU 1261 CZ TYR A 157 2708 4152 6989 -249 553 -1079 C \nATOM 1262 OH TYR A 157 -8.383 -17.140 -78.200 1.00 35.95 O \nANISOU 1262 OH TYR A 157 2660 4048 6953 -234 517 -1063 O \nATOM 1263 N PRO A 158 -10.756 -17.136 -85.066 1.00 62.35 N \nANISOU 1263 N PRO A 158 5801 7636 10254 -222 617 -1275 N \nATOM 1264 CA PRO A 158 -11.745 -16.088 -85.200 1.00 58.68 C \nANISOU 1264 CA PRO A 158 5333 7144 9817 -176 587 -1300 C \nATOM 1265 C PRO A 158 -11.913 -15.341 -83.906 1.00 54.77 C \nANISOU 1265 C PRO A 158 4880 6579 9352 -150 545 -1270 C \nATOM 1266 O PRO A 158 -11.564 -15.857 -82.838 1.00 57.90 O \nANISOU 1266 O PRO A 158 5289 6955 9755 -157 534 -1244 O \nATOM 1267 CB PRO A 158 -13.058 -16.876 -85.556 1.00 63.23 C \nANISOU 1267 CB PRO A 158 5846 7765 10415 -146 577 -1373 C \nATOM 1268 CG PRO A 158 -12.842 -18.273 -85.083 1.00 59.38 C \nANISOU 1268 CG PRO A 158 5325 7317 9918 -172 587 -1377 C \nATOM 1269 CD PRO A 158 -11.360 -18.496 -85.190 1.00 65.97 C \nANISOU 1269 CD PRO A 158 6199 8153 10714 -232 623 -1323 C \nATOM 1270 N THR A 159 -12.520 -14.165 -83.978 1.00 52.84 N \nANISOU 1270 N THR A 159 4656 6298 9122 -122 520 -1276 N \nATOM 1271 CA THR A 159 -12.616 -13.326 -82.803 1.00 48.72 C \nANISOU 1271 CA THR A 159 4180 5712 8621 -105 480 -1243 C \nATOM 1272 C THR A 159 -13.682 -13.812 -81.849 1.00 54.89 C \nANISOU 1272 C THR A 159 4946 6466 9442 -66 440 -1271 C \nATOM 1273 O THR A 159 -14.811 -13.970 -82.237 1.00 67.55 O \nANISOU 1273 O THR A 159 6524 8080 11064 -29 426 -1325 O \nATOM 1274 CB THR A 159 -12.788 -11.861 -83.182 1.00 39.32 C \nANISOU 1274 CB THR A 159 3023 4493 7422 -102 469 -1234 C \nATOM 1275 OG1 THR A 159 -11.570 -11.449 -83.820 1.00 37.96 O \nANISOU 1275 OG1 THR A 159 2864 4350 7208 -138 505 -1193 O \nATOM 1276 CG2 THR A 159 -12.971 -11.011 -81.967 1.00 36.71 C \nANISOU 1276 CG2 THR A 159 2739 4100 7111 -90 426 -1203 C \nATOM 1277 N ILE A 160 -13.273 -14.070 -80.600 1.00 59.82 N \nANISOU 1277 N ILE A 160 5592 7062 10077 -71 422 -1234 N \nATOM 1278 CA ILE A 160 -14.129 -14.600 -79.568 1.00 51.68 C \nANISOU 1278 CA ILE A 160 4547 6010 9079 -37 384 -1252 C \nATOM 1279 C ILE A 160 -14.901 -13.491 -78.923 1.00 60.84 C \nANISOU 1279 C ILE A 160 5750 7103 10264 -3 338 -1248 C \nATOM 1280 O ILE A 160 -14.336 -12.445 -78.600 1.00 68.12 O \nANISOU 1280 O ILE A 160 6720 7986 11176 -23 331 -1205 O \nATOM 1281 CB ILE A 160 -13.303 -15.309 -78.501 1.00 46.27 C \nANISOU 1281 CB ILE A 160 3870 5320 8389 -65 386 -1212 C \nATOM 1282 CG1 ILE A 160 -12.710 -16.618 -79.095 1.00 43.67 C \nANISOU 1282 CG1 ILE A 160 3501 5059 8033 -104 429 -1224 C \nATOM 1283 CG2 ILE A 160 -14.151 -15.693 -77.280 1.00 47.93 C \nANISOU 1283 CG2 ILE A 160 4072 5505 8633 -31 341 -1223 C \nATOM 1284 CD1 ILE A 160 -11.608 -17.246 -78.241 1.00 42.86 C \nANISOU 1284 CD1 ILE A 160 3423 4949 7912 -146 442 -1179 C \nATOM 1285 N LYS A 161 -16.195 -13.733 -78.718 1.00 59.70 N \nANISOU 1285 N LYS A 161 5589 6948 10148 49 305 -1294 N \nATOM 1286 CA LYS A 161 -17.085 -12.772 -78.109 1.00 64.07 C \nANISOU 1286 CA LYS A 161 6190 7431 10723 85 258 -1295 C \nATOM 1287 C LYS A 161 -18.114 -13.578 -77.342 1.00 60.12 C \nANISOU 1287 C LYS A 161 5664 6928 10252 139 223 -1326 C \nATOM 1288 O LYS A 161 -19.019 -14.160 -77.903 1.00 76.59 O \nANISOU 1288 O LYS A 161 7710 9046 12344 184 222 -1380 O \nATOM 1289 CB LYS A 161 -17.726 -11.889 -79.175 1.00 72.61 C \nANISOU 1289 CB LYS A 161 7291 8499 11796 98 260 -1329 C \nATOM 1290 CG LYS A 161 -17.542 -10.403 -78.929 1.00 78.94 C \nANISOU 1290 CG LYS A 161 8164 9242 12589 73 241 -1293 C \nATOM 1291 CD LYS A 161 -18.020 -9.602 -80.132 1.00 81.26 C \nANISOU 1291 CD LYS A 161 8476 9536 12866 72 252 -1326 C \nATOM 1292 CE LYS A 161 -17.845 -8.103 -79.891 1.00 88.49 C \nANISOU 1292 CE LYS A 161 9459 10401 13763 36 233 -1290 C \nATOM 1293 NZ LYS A 161 -18.794 -7.593 -78.859 1.00 91.04 N \nANISOU 1293 NZ LYS A 161 9838 10645 14107 65 179 -1290 N \nATOM 1294 N ARG A 162 -17.917 -13.642 -76.043 1.00 58.57 N \nANISOU 1294 N ARG A 162 5488 6698 10069 136 196 -1289 N \nATOM 1295 CA ARG A 162 -18.723 -14.446 -75.142 1.00 56.09 C \nANISOU 1295 CA ARG A 162 5147 6386 9777 183 162 -1307 C \nATOM 1296 C ARG A 162 -18.995 -13.601 -73.915 1.00 52.39 C \nANISOU 1296 C ARG A 162 4742 5836 9327 195 113 -1272 C \nATOM 1297 O ARG A 162 -18.113 -12.845 -73.473 1.00 55.95 O \nANISOU 1297 O ARG A 162 5238 6254 9768 148 116 -1221 O \nATOM 1298 CB ARG A 162 -17.965 -15.745 -74.708 1.00 53.98 C \nANISOU 1298 CB ARG A 162 4828 6180 9501 148 184 -1293 C \nATOM 1299 CG ARG A 162 -17.480 -16.596 -75.860 1.00 58.85 C \nANISOU 1299 CG ARG A 162 5390 6878 10092 117 235 -1319 C \nATOM 1300 CD ARG A 162 -18.620 -17.404 -76.500 1.00 64.55 C \nANISOU 1300 CD ARG A 162 6046 7661 10818 171 233 -1386 C \nATOM 1301 NE ARG A 162 -19.086 -18.380 -75.527 1.00 67.61 N \nANISOU 1301 NE ARG A 162 6393 8080 11216 195 207 -1394 N \nATOM 1302 CZ ARG A 162 -18.798 -19.665 -75.537 1.00 62.70 C \nANISOU 1302 CZ ARG A 162 5707 7542 10575 166 229 -1406 C \nATOM 1303 NH1 ARG A 162 -18.066 -20.179 -76.504 1.00 62.02 N \nANISOU 1303 NH1 ARG A 162 5592 7513 10458 111 278 -1413 N \nATOM 1304 NH2 ARG A 162 -19.276 -20.422 -74.573 1.00 63.82 N \nANISOU 1304 NH2 ARG A 162 5814 7710 10724 189 201 -1411 N \nATOM 1305 N SER A 163 -20.150 -13.822 -73.300 1.00 46.57 N \nANISOU 1305 N SER A 163 4006 5076 8612 258 70 -1297 N \nATOM 1306 CA SER A 163 -20.472 -13.110 -72.082 1.00 50.94 C \nANISOU 1306 CA SER A 163 4620 5554 9182 270 22 -1264 C \nATOM 1307 C SER A 163 -21.350 -13.926 -71.178 1.00 46.18 C \nANISOU 1307 C SER A 163 3991 4956 8598 329 -16 -1281 C \nATOM 1308 O SER A 163 -22.049 -14.791 -71.634 1.00 58.49 O \nANISOU 1308 O SER A 163 5494 6568 10160 380 -13 -1329 O \nATOM 1309 CB SER A 163 -21.131 -11.748 -72.410 1.00 59.30 C \nANISOU 1309 CB SER A 163 5754 6537 10239 285 -2 -1271 C \nATOM 1310 OG SER A 163 -22.542 -11.846 -72.453 1.00 64.41 O \nANISOU 1310 OG SER A 163 6414 7157 10901 365 -36 -1317 O \nATOM 1311 N TYR A 164 -21.290 -13.643 -69.886 1.00 42.60 N \nANISOU 1311 N TYR A 164 3576 4455 8157 323 -52 -1241 N \nATOM 1312 CA TYR A 164 -21.947 -14.431 -68.856 1.00 44.65 C \nANISOU 1312 CA TYR A 164 3809 4724 8432 371 -89 -1246 C \nATOM 1313 C TYR A 164 -22.645 -13.540 -67.884 1.00 51.85 C \nANISOU 1313 C TYR A 164 4797 5546 9358 401 -145 -1224 C \nATOM 1314 O TYR A 164 -22.020 -12.653 -67.288 1.00 54.46 O \nANISOU 1314 O TYR A 164 5184 5823 9684 349 -153 -1176 O \nATOM 1315 CB TYR A 164 -20.956 -15.307 -68.098 1.00 41.38 C \nANISOU 1315 CB TYR A 164 3353 4359 8012 318 -72 -1212 C \nATOM 1316 CG TYR A 164 -21.602 -16.091 -66.966 1.00 44.08 C \nANISOU 1316 CG TYR A 164 3666 4715 8365 360 -112 -1214 C \nATOM 1317 CD1 TYR A 164 -22.379 -17.220 -67.239 1.00 43.32 C \nANISOU 1317 CD1 TYR A 164 3495 4696 8269 415 -114 -1262 C \nATOM 1318 CD2 TYR A 164 -21.469 -15.681 -65.614 1.00 38.07 C \nANISOU 1318 CD2 TYR A 164 2952 3899 7614 346 -149 -1168 C \nATOM 1319 CE1 TYR A 164 -22.984 -17.939 -66.210 1.00 43.91 C \nANISOU 1319 CE1 TYR A 164 3538 4795 8350 456 -151 -1262 C \nATOM 1320 CE2 TYR A 164 -22.077 -16.371 -64.621 1.00 40.67 C \nANISOU 1320 CE2 TYR A 164 3254 4244 7952 385 -186 -1169 C \nATOM 1321 CZ TYR A 164 -22.855 -17.508 -64.926 1.00 45.72 C \nANISOU 1321 CZ TYR A 164 3816 4965 8590 443 -188 -1217 C \nATOM 1322 OH TYR A 164 -23.502 -18.251 -63.923 1.00 54.81 O \nANISOU 1322 OH TYR A 164 4932 6146 9746 487 -226 -1218 O \nATOM 1323 N ASN A 165 -23.940 -13.778 -67.726 1.00 58.16 N \nANISOU 1323 N ASN A 165 5599 6331 10170 487 -183 -1260 N \nATOM 1324 CA ASN A 165 -24.736 -13.026 -66.799 1.00 68.71 C \nANISOU 1324 CA ASN A 165 7012 7579 11517 525 -239 -1243 C \nATOM 1325 C ASN A 165 -24.912 -13.891 -65.556 1.00 64.12 C \nANISOU 1325 C ASN A 165 6394 7024 10946 550 -270 -1227 C \nATOM 1326 O ASN A 165 -25.620 -14.871 -65.584 1.00 71.22 O \nANISOU 1326 O ASN A 165 7233 7980 11848 617 -279 -1263 O \nATOM 1327 CB ASN A 165 -26.078 -12.644 -67.456 1.00 77.89 C \nANISOU 1327 CB ASN A 165 8216 8697 12680 610 -263 -1292 C \nATOM 1328 CG ASN A 165 -26.871 -11.625 -66.661 1.00 84.11 C \nANISOU 1328 CG ASN A 165 9110 9375 13472 638 -319 -1273 C \nATOM 1329 OD1 ASN A 165 -26.609 -11.429 -65.475 1.00 88.32 O \nANISOU 1329 OD1 ASN A 165 9670 9875 14011 611 -348 -1227 O \nATOM 1330 ND2 ASN A 165 -27.857 -10.985 -67.311 1.00 91.58 N \nANISOU 1330 ND2 ASN A 165 10123 10261 14413 691 -335 -1309 N \nATOM 1331 N ASN A 166 -24.246 -13.512 -64.471 1.00 55.69 N \nANISOU 1331 N ASN A 166 5360 5921 9880 495 -285 -1172 N \nATOM 1332 CA ASN A 166 -24.449 -14.159 -63.194 1.00 57.53 C \nANISOU 1332 CA ASN A 166 5572 6165 10122 515 -319 -1152 C \nATOM 1333 C ASN A 166 -25.959 -14.155 -62.826 1.00 64.29 C \nANISOU 1333 C ASN A 166 6457 6983 10988 620 -375 -1178 C \nATOM 1334 O ASN A 166 -26.513 -13.169 -62.363 1.00 60.67 O \nANISOU 1334 O ASN A 166 6088 6431 10533 637 -416 -1161 O \nATOM 1335 CB ASN A 166 -23.610 -13.479 -62.114 1.00 54.10 C \nANISOU 1335 CB ASN A 166 5189 5681 9685 443 -332 -1089 C \nATOM 1336 CG ASN A 166 -23.628 -14.207 -60.769 1.00 51.96 C \nANISOU 1336 CG ASN A 166 4891 5430 9420 448 -362 -1065 C \nATOM 1337 OD1 ASN A 166 -24.235 -15.253 -60.626 1.00 60.18 O \nANISOU 1337 OD1 ASN A 166 5870 6530 10465 503 -373 -1093 O \nATOM 1338 ND2 ASN A 166 -23.041 -13.586 -59.752 1.00 46.96 N \nANISOU 1338 ND2 ASN A 166 4307 4750 8786 395 -378 -1013 N \nATOM 1339 N THR A 167 -26.601 -15.299 -63.024 1.00 67.26 N \nANISOU 1339 N THR A 167 6754 7437 11364 689 -376 -1219 N \nATOM 1340 CA THR A 167 -28.007 -15.459 -62.698 1.00 64.52 C \nANISOU 1340 CA THR A 167 6423 7070 11022 802 -426 -1246 C \nATOM 1341 C THR A 167 -28.246 -15.811 -61.226 1.00 70.27 C \nANISOU 1341 C THR A 167 7150 7794 11756 821 -472 -1213 C \nATOM 1342 O THR A 167 -29.385 -16.051 -60.843 1.00 76.53 O \nANISOU 1342 O THR A 167 7949 8579 12550 921 -516 -1231 O \nATOM 1343 CB THR A 167 -28.639 -16.539 -63.566 1.00 57.89 C \nANISOU 1343 CB THR A 167 5492 6330 10175 877 -407 -1308 C \nATOM 1344 OG1 THR A 167 -27.995 -17.804 -63.361 1.00 61.48 O \nANISOU 1344 OG1 THR A 167 5838 6903 10620 838 -380 -1307 O \nATOM 1345 CG2 THR A 167 -28.532 -16.203 -65.007 1.00 56.47 C \nANISOU 1345 CG2 THR A 167 5315 6153 9988 867 -365 -1344 C \nATOM 1346 N ASN A 168 -27.186 -15.842 -60.415 1.00 67.87 N \nANISOU 1346 N ASN A 168 6840 7497 11453 730 -463 -1164 N \nATOM 1347 CA ASN A 168 -27.282 -16.317 -59.029 1.00 66.08 C \nANISOU 1347 CA ASN A 168 6598 7282 11228 737 -501 -1132 C \nATOM 1348 C ASN A 168 -27.317 -15.170 -58.065 1.00 67.43 C \nANISOU 1348 C ASN A 168 6874 7341 11406 714 -543 -1084 C \nATOM 1349 O ASN A 168 -27.213 -14.031 -58.495 1.00 74.47 O \nANISOU 1349 O ASN A 168 7846 8153 12298 686 -540 -1075 O \nATOM 1350 CB ASN A 168 -26.095 -17.206 -58.708 1.00 68.60 C \nANISOU 1350 CB ASN A 168 6841 7686 11538 650 -464 -1112 C \nATOM 1351 CG ASN A 168 -25.940 -18.350 -59.695 1.00 74.53 C \nANISOU 1351 CG ASN A 168 7490 8553 12276 653 -418 -1158 C \nATOM 1352 OD1 ASN A 168 -26.665 -19.344 -59.624 1.00 99.43 O \nANISOU 1352 OD1 ASN A 168 10570 11788 15421 717 -432 -1189 O \nATOM 1353 ND2 ASN A 168 -24.978 -18.233 -60.606 1.00 65.83 N \nANISOU 1353 ND2 ASN A 168 6380 7465 11167 582 -363 -1160 N \nATOM 1354 N GLN A 169 -27.488 -15.470 -56.783 1.00 71.45 N \nANISOU 1354 N GLN A 169 7382 7850 11917 723 -583 -1053 N \nATOM 1355 CA GLN A 169 -27.587 -14.438 -55.740 1.00 80.00 C \nANISOU 1355 CA GLN A 169 8563 8831 13003 702 -627 -1006 C \nATOM 1356 C GLN A 169 -26.305 -14.337 -54.957 1.00 77.17 C \nANISOU 1356 C GLN A 169 8199 8481 12641 594 -609 -956 C \nATOM 1357 O GLN A 169 -26.245 -13.654 -53.928 1.00 76.03 O \nANISOU 1357 O GLN A 169 8119 8272 12496 566 -644 -912 O \nATOM 1358 CB GLN A 169 -28.763 -14.697 -54.768 1.00 84.06 C \nANISOU 1358 CB GLN A 169 9095 9324 13519 793 -692 -1002 C \nATOM 1359 CG GLN A 169 -30.121 -14.245 -55.267 1.00 87.69 C \nANISOU 1359 CG GLN A 169 9619 9721 13979 902 -727 -1036 C \nATOM 1360 CD GLN A 169 -30.744 -15.252 -56.197 1.00 90.56 C \nANISOU 1360 CD GLN A 169 9897 10173 14339 991 -708 -1096 C \nATOM 1361 OE1 GLN A 169 -31.265 -16.282 -55.752 1.00 91.86 O \nANISOU 1361 OE1 GLN A 169 9989 10416 14499 1059 -728 -1110 O \nATOM 1362 NE2 GLN A 169 -30.715 -14.955 -57.494 1.00 85.41 N \nANISOU 1362 NE2 GLN A 169 9251 9516 13686 992 -671 -1133 N \nATOM 1363 N GLU A 170 -25.275 -15.007 -55.454 1.00 73.73 N \nANISOU 1363 N GLU A 170 7692 8122 12199 534 -554 -962 N \nATOM 1364 CA GLU A 170 -23.976 -14.956 -54.810 1.00 71.37 C \nANISOU 1364 CA GLU A 170 7392 7832 11892 436 -530 -918 C \nATOM 1365 C GLU A 170 -22.937 -14.378 -55.724 1.00 65.72 C \nANISOU 1365 C GLU A 170 6691 7109 11169 368 -477 -914 C \nATOM 1366 O GLU A 170 -22.931 -14.623 -56.922 1.00 73.81 O \nANISOU 1366 O GLU A 170 7683 8169 12191 381 -441 -951 O \nATOM 1367 CB GLU A 170 -23.531 -16.350 -54.374 1.00 76.45 C \nANISOU 1367 CB GLU A 170 7946 8575 12528 416 -512 -922 C \nATOM 1368 CG GLU A 170 -24.534 -17.086 -53.486 1.00 79.79 C \nANISOU 1368 CG GLU A 170 8334 9028 12953 484 -562 -928 C \nATOM 1369 CD GLU A 170 -25.485 -17.939 -54.275 1.00 80.74 C \nANISOU 1369 CD GLU A 170 8386 9219 13072 571 -562 -983 C \nATOM 1370 OE1 GLU A 170 -25.665 -17.653 -55.470 1.00 85.57 O \nANISOU 1370 OE1 GLU A 170 9003 9824 13687 594 -537 -1016 O \nATOM 1371 OE2 GLU A 170 -26.056 -18.885 -53.699 1.00 90.42 O \nANISOU 1371 OE2 GLU A 170 9551 10514 14292 616 -588 -993 O \nATOM 1372 N ASP A 171 -22.038 -13.607 -55.140 1.00 58.88 N \nANISOU 1372 N ASP A 171 5875 6203 10295 297 -472 -868 N \nATOM 1373 CA ASP A 171 -20.837 -13.193 -55.835 1.00 55.83 C \nANISOU 1373 CA ASP A 171 5493 5827 9894 229 -419 -856 C \nATOM 1374 C ASP A 171 -20.170 -14.423 -56.368 1.00 55.95 C \nANISOU 1374 C ASP A 171 5429 5929 9902 209 -369 -877 C \nATOM 1375 O ASP A 171 -20.079 -15.428 -55.661 1.00 51.57 O \nANISOU 1375 O ASP A 171 4828 5421 9345 204 -374 -875 O \nATOM 1376 CB ASP A 171 -19.883 -12.480 -54.871 1.00 55.63 C \nANISOU 1376 CB ASP A 171 5513 5768 9856 160 -421 -801 C \nATOM 1377 CG ASP A 171 -20.504 -11.219 -54.250 1.00 62.06 C \nANISOU 1377 CG ASP A 171 6410 6499 10671 165 -471 -775 C \nATOM 1378 OD1 ASP A 171 -21.466 -10.662 -54.821 1.00 78.24 O \nANISOU 1378 OD1 ASP A 171 8496 8505 12726 209 -493 -798 O \nATOM 1379 OD2 ASP A 171 -20.027 -10.773 -53.198 1.00 62.22 O \nANISOU 1379 OD2 ASP A 171 6463 6496 10681 122 -488 -732 O \nATOM 1380 N LEU A 172 -19.691 -14.392 -57.609 1.00 59.69 N \nANISOU 1380 N LEU A 172 5885 6427 10367 193 -322 -899 N \nATOM 1381 CA LEU A 172 -18.851 -15.506 -58.051 1.00 57.72 C \nANISOU 1381 CA LEU A 172 5573 6255 10104 157 -272 -911 C \nATOM 1382 C LEU A 172 -17.461 -15.110 -58.570 1.00 54.67 C \nANISOU 1382 C LEU A 172 5207 5869 9696 90 -219 -887 C \nATOM 1383 O LEU A 172 -17.268 -14.065 -59.178 1.00 48.71 O \nANISOU 1383 O LEU A 172 4493 5078 8938 83 -209 -880 O \nATOM 1384 CB LEU A 172 -19.585 -16.438 -58.998 1.00 59.51 C \nANISOU 1384 CB LEU A 172 5732 6546 10334 205 -260 -966 C \nATOM 1385 CG LEU A 172 -20.158 -15.981 -60.306 1.00 62.51 C \nANISOU 1385 CG LEU A 172 6114 6917 10720 246 -248 -1004 C \nATOM 1386 CD1 LEU A 172 -19.196 -16.212 -61.435 1.00 69.36 C \nANISOU 1386 CD1 LEU A 172 6957 7828 11569 198 -187 -1014 C \nATOM 1387 CD2 LEU A 172 -21.419 -16.782 -60.588 1.00 66.19 C \nANISOU 1387 CD2 LEU A 172 6526 7430 11196 326 -271 -1053 C \nATOM 1388 N LEU A 173 -16.491 -15.977 -58.276 1.00 50.63 N \nANISOU 1388 N LEU A 173 4670 5402 9167 40 -186 -875 N \nATOM 1389 CA LEU A 173 -15.107 -15.688 -58.547 1.00 45.02 C \nANISOU 1389 CA LEU A 173 3987 4688 8431 -17 -140 -846 C \nATOM 1390 C LEU A 173 -14.733 -16.325 -59.847 1.00 45.13 C \nANISOU 1390 C LEU A 173 3963 4754 8431 -28 -89 -877 C \nATOM 1391 O LEU A 173 -14.749 -17.532 -59.944 1.00 34.78 O \nANISOU 1391 O LEU A 173 2602 3500 7112 -39 -74 -900 O \nATOM 1392 CB LEU A 173 -14.238 -16.197 -57.405 1.00 43.40 C \nANISOU 1392 CB LEU A 173 3794 4488 8209 -65 -134 -812 C \nATOM 1393 CG LEU A 173 -12.744 -16.423 -57.701 1.00 43.76 C \nANISOU 1393 CG LEU A 173 3859 4548 8221 -122 -77 -792 C \nATOM 1394 CD1 LEU A 173 -12.006 -15.059 -57.847 1.00 40.19 C \nANISOU 1394 CD1 LEU A 173 3464 4052 7756 -130 -66 -756 C \nATOM 1395 CD2 LEU A 173 -12.140 -17.270 -56.617 1.00 39.27 C \nANISOU 1395 CD2 LEU A 173 3293 3992 7635 -164 -74 -772 C \nATOM 1396 N ILE A 174 -14.356 -15.469 -60.841 1.00 46.52 N \nANISOU 1396 N ILE A 174 4163 4914 8599 -31 -63 -876 N \nATOM 1397 CA ILE A 174 -13.954 -15.935 -62.184 1.00 36.24 C \nANISOU 1397 CA ILE A 174 2831 3657 7281 -43 -13 -903 C \nATOM 1398 C ILE A 174 -12.459 -15.650 -62.386 1.00 39.09 C \nANISOU 1398 C ILE A 174 3229 4014 7610 -93 33 -866 C \nATOM 1399 O ILE A 174 -11.938 -14.696 -61.894 1.00 45.82 O \nANISOU 1399 O ILE A 174 4129 4827 8454 -103 26 -828 O \nATOM 1400 CB ILE A 174 -14.749 -15.238 -63.272 1.00 33.26 C \nANISOU 1400 CB ILE A 174 2449 3270 6916 -2 -19 -933 C \nATOM 1401 CG1 ILE A 174 -16.269 -15.197 -62.882 1.00 32.31 C \nANISOU 1401 CG1 ILE A 174 2317 3132 6828 60 -74 -961 C \nATOM 1402 CG2 ILE A 174 -14.550 -15.893 -64.613 1.00 30.96 C \nANISOU 1402 CG2 ILE A 174 2116 3036 6612 -9 27 -968 C \nATOM 1403 CD1 ILE A 174 -17.117 -14.506 -63.929 1.00 31.16 C \nANISOU 1403 CD1 ILE A 174 2179 2969 6692 103 -80 -994 C \nATOM 1404 N LEU A 175 -11.763 -16.543 -63.077 1.00 44.03 N \nANISOU 1404 N LEU A 175 3833 4684 8211 -123 79 -878 N \nATOM 1405 CA LEU A 175 -10.352 -16.437 -63.316 1.00 42.29 C \nANISOU 1405 CA LEU A 175 3653 4461 7956 -163 125 -846 C \nATOM 1406 C LEU A 175 -10.040 -16.743 -64.781 1.00 45.93 C \nANISOU 1406 C LEU A 175 4093 4961 8399 -172 171 -870 C \nATOM 1407 O LEU A 175 -10.613 -17.657 -65.368 1.00 53.78 O \nANISOU 1407 O LEU A 175 5036 6001 9397 -171 178 -911 O \nATOM 1408 CB LEU A 175 -9.585 -17.406 -62.460 1.00 44.51 C \nANISOU 1408 CB LEU A 175 3947 4750 8214 -207 139 -828 C \nATOM 1409 CG LEU A 175 -9.734 -17.222 -60.949 1.00 51.03 C \nANISOU 1409 CG LEU A 175 4794 5541 9052 -207 99 -801 C \nATOM 1410 CD1 LEU A 175 -10.753 -18.170 -60.364 1.00 49.90 C \nANISOU 1410 CD1 LEU A 175 4601 5429 8931 -200 66 -830 C \nATOM 1411 CD2 LEU A 175 -8.404 -17.445 -60.244 1.00 49.41 C \nANISOU 1411 CD2 LEU A 175 4642 5320 8812 -250 126 -763 C \nATOM 1412 N TRP A 176 -9.135 -15.956 -65.361 1.00 43.47 N \nANISOU 1412 N TRP A 176 3819 4636 8063 -179 201 -844 N \nATOM 1413 CA TRP A 176 -8.718 -16.121 -66.752 1.00 35.11 C \nANISOU 1413 CA TRP A 176 2749 3611 6982 -188 245 -860 C \nATOM 1414 C TRP A 176 -7.284 -15.735 -66.853 1.00 33.09 C \nANISOU 1414 C TRP A 176 2546 3341 6684 -208 283 -817 C \nATOM 1415 O TRP A 176 -6.670 -15.288 -65.874 1.00 31.26 O \nANISOU 1415 O TRP A 176 2358 3077 6442 -211 274 -778 O \nATOM 1416 CB TRP A 176 -9.580 -15.265 -67.693 1.00 33.33 C \nANISOU 1416 CB TRP A 176 2500 3388 6775 -152 232 -886 C \nATOM 1417 CG TRP A 176 -9.465 -13.794 -67.470 1.00 33.58 C \nANISOU 1417 CG TRP A 176 2570 3383 6807 -137 214 -855 C \nATOM 1418 CD1 TRP A 176 -8.660 -12.939 -68.119 1.00 31.68 C \nANISOU 1418 CD1 TRP A 176 2354 3146 6537 -142 240 -830 C \nATOM 1419 CD2 TRP A 176 -10.160 -13.041 -66.504 1.00 34.36 C \nANISOU 1419 CD2 TRP A 176 2685 3441 6931 -118 164 -844 C \nATOM 1420 NE1 TRP A 176 -8.802 -11.708 -67.622 1.00 32.22 N \nANISOU 1420 NE1 TRP A 176 2449 3186 6608 -132 212 -806 N \nATOM 1421 CE2 TRP A 176 -9.714 -11.729 -66.614 1.00 32.15 C \nANISOU 1421 CE2 TRP A 176 2439 3145 6631 -120 164 -813 C \nATOM 1422 CE3 TRP A 176 -11.122 -13.363 -65.522 1.00 38.50 C \nANISOU 1422 CE3 TRP A 176 3199 3944 7487 -101 118 -856 C \nATOM 1423 CZ2 TRP A 176 -10.194 -10.712 -65.834 1.00 35.57 C \nANISOU 1423 CZ2 TRP A 176 2900 3541 7076 -113 122 -795 C \nATOM 1424 CZ3 TRP A 176 -11.593 -12.325 -64.687 1.00 39.40 C \nANISOU 1424 CZ3 TRP A 176 3345 4011 7614 -88 74 -835 C \nATOM 1425 CH2 TRP A 176 -11.142 -11.020 -64.873 1.00 40.41 C \nANISOU 1425 CH2 TRP A 176 3509 4123 7721 -98 77 -806 C \nATOM 1426 N GLY A 177 -6.729 -15.891 -68.028 1.00 29.88 N \nANISOU 1426 N GLY A 177 2139 2961 6251 -218 325 -823 N \nATOM 1427 CA GLY A 177 -5.299 -15.756 -68.197 1.00 33.12 C \nANISOU 1427 CA GLY A 177 2605 3365 6616 -233 366 -784 C \nATOM 1428 C GLY A 177 -4.902 -15.300 -69.589 1.00 34.66 C \nANISOU 1428 C GLY A 177 2797 3585 6787 -225 400 -786 C \nATOM 1429 O GLY A 177 -5.736 -15.245 -70.461 1.00 32.05 O \nANISOU 1429 O GLY A 177 2421 3282 6476 -216 396 -822 O \nATOM 1430 N ILE A 178 -3.592 -15.035 -69.760 1.00 35.06 N \nANISOU 1430 N ILE A 178 2900 3629 6791 -227 436 -746 N \nATOM 1431 CA ILE A 178 -3.048 -14.581 -71.019 1.00 35.84 C \nANISOU 1431 CA ILE A 178 3003 3754 6859 -217 470 -740 C \nATOM 1432 C ILE A 178 -1.723 -15.313 -71.248 1.00 41.55 C \nANISOU 1432 C ILE A 178 3783 4474 7531 -237 517 -715 C \nATOM 1433 O ILE A 178 -1.003 -15.593 -70.273 1.00 39.85 O \nANISOU 1433 O ILE A 178 3620 4225 7296 -243 521 -686 O \nATOM 1434 CB ILE A 178 -2.806 -13.050 -71.053 1.00 37.25 C \nANISOU 1434 CB ILE A 178 3191 3935 7027 -183 459 -709 C \nATOM 1435 CG1 ILE A 178 -2.236 -12.631 -72.390 1.00 38.42 C \nANISOU 1435 CG1 ILE A 178 3339 4119 7139 -174 495 -702 C \nATOM 1436 CG2 ILE A 178 -1.778 -12.624 -70.043 1.00 37.21 C \nANISOU 1436 CG2 ILE A 178 3241 3904 6992 -170 462 -659 C \nATOM 1437 CD1 ILE A 178 -2.116 -11.142 -72.581 1.00 40.10 C \nANISOU 1437 CD1 ILE A 178 3548 4351 7337 -147 485 -678 C \nATOM 1438 N HIS A 179 -1.443 -15.678 -72.517 1.00 38.98 N \nANISOU 1438 N HIS A 179 3452 4178 7180 -249 553 -728 N \nATOM 1439 CA HIS A 179 -0.223 -16.380 -72.822 1.00 37.50 C \nANISOU 1439 CA HIS A 179 3328 3982 6939 -269 598 -705 C \nATOM 1440 C HIS A 179 0.708 -15.483 -73.548 1.00 32.82 C \nANISOU 1440 C HIS A 179 2766 3399 6304 -233 625 -670 C \nATOM 1441 O HIS A 179 0.475 -15.159 -74.700 1.00 30.12 O \nANISOU 1441 O HIS A 179 2390 3094 5958 -226 636 -685 O \nATOM 1442 CB HIS A 179 -0.453 -17.678 -73.671 1.00 37.13 C \nANISOU 1442 CB HIS A 179 3262 3963 6884 -319 624 -743 C \nATOM 1443 CG HIS A 179 0.827 -18.307 -74.166 1.00 32.78 C \nANISOU 1443 CG HIS A 179 2785 3399 6269 -343 672 -718 C \nATOM 1444 ND1 HIS A 179 1.075 -18.550 -75.501 1.00 38.18 N \nANISOU 1444 ND1 HIS A 179 3466 4116 6925 -356 706 -728 N \nATOM 1445 CD2 HIS A 179 1.921 -18.713 -73.503 1.00 30.68 C \nANISOU 1445 CD2 HIS A 179 2607 3089 5961 -353 692 -683 C \nATOM 1446 CE1 HIS A 179 2.287 -19.066 -75.634 1.00 33.37 C \nANISOU 1446 CE1 HIS A 179 2943 3480 6258 -373 744 -697 C \nATOM 1447 NE2 HIS A 179 2.802 -19.201 -74.431 1.00 37.02 N \nANISOU 1447 NE2 HIS A 179 3463 3893 6710 -372 737 -671 N \nATOM 1448 N HIS A 180 1.825 -15.189 -72.908 1.00 31.51 N \nANISOU 1448 N HIS A 180 2669 3203 6099 -209 638 -624 N \nATOM 1449 CA HIS A 180 2.887 -14.457 -73.551 1.00 29.63 C \nANISOU 1449 CA HIS A 180 2470 2980 5809 -168 667 -585 C \nATOM 1450 C HIS A 180 3.730 -15.478 -74.290 1.00 30.64 C \nANISOU 1450 C HIS A 180 2656 3098 5889 -193 713 -581 C \nATOM 1451 O HIS A 180 4.469 -16.232 -73.652 1.00 32.81 O \nANISOU 1451 O HIS A 180 3004 3328 6135 -209 730 -564 O \nATOM 1452 CB HIS A 180 3.708 -13.678 -72.506 1.00 30.56 C \nANISOU 1452 CB HIS A 180 2636 3075 5901 -124 661 -538 C \nATOM 1453 CG HIS A 180 2.912 -12.736 -71.648 1.00 27.12 C \nANISOU 1453 CG HIS A 180 2153 2645 5507 -110 615 -539 C \nATOM 1454 ND1 HIS A 180 2.262 -11.646 -72.155 1.00 27.17 N \nANISOU 1454 ND1 HIS A 180 2099 2693 5530 -94 594 -547 N \nATOM 1455 CD2 HIS A 180 2.631 -12.741 -70.339 1.00 27.36 C \nANISOU 1455 CD2 HIS A 180 2189 2644 5562 -116 584 -535 C \nATOM 1456 CE1 HIS A 180 1.625 -10.984 -71.204 1.00 25.89 C \nANISOU 1456 CE1 HIS A 180 1913 2524 5401 -91 553 -546 C \nATOM 1457 NE2 HIS A 180 1.855 -11.607 -70.074 1.00 29.56 N \nANISOU 1457 NE2 HIS A 180 2416 2946 5872 -101 546 -538 N \nATOM 1458 N SER A 181 3.646 -15.480 -75.614 1.00 30.78 N \nANISOU 1458 N SER A 181 2646 3154 5894 -198 734 -595 N \nATOM 1459 CA SER A 181 4.486 -16.266 -76.459 1.00 38.45 C \nANISOU 1459 CA SER A 181 3675 4121 6814 -218 778 -587 C \nATOM 1460 C SER A 181 5.888 -15.747 -76.581 1.00 42.55 C \nANISOU 1460 C SER A 181 4274 4625 7266 -165 807 -532 C \nATOM 1461 O SER A 181 6.200 -14.649 -76.078 1.00 53.02 O \nANISOU 1461 O SER A 181 5600 5959 8587 -107 793 -501 O \nATOM 1462 CB SER A 181 3.844 -16.358 -77.866 1.00 45.61 C \nANISOU 1462 CB SER A 181 4517 5081 7730 -240 788 -622 C \nATOM 1463 OG SER A 181 3.280 -15.086 -78.285 1.00 41.07 O \nANISOU 1463 OG SER A 181 3876 4549 7179 -200 767 -625 O \nATOM 1464 N ASN A 182 6.747 -16.490 -77.285 1.00 47.04 N \nANISOU 1464 N ASN A 182 4913 5179 7781 -180 848 -520 N \nATOM 1465 CA ASN A 182 8.231 -16.206 -77.312 1.00 53.62 C \nANISOU 1465 CA ASN A 182 5848 5985 8541 -123 880 -465 C \nATOM 1466 C ASN A 182 8.728 -15.434 -78.521 1.00 55.86 C \nANISOU 1466 C ASN A 182 6122 6317 8784 -75 901 -442 C \nATOM 1467 O ASN A 182 9.620 -14.593 -78.394 1.00 62.84 O \nANISOU 1467 O ASN A 182 7044 7208 9624 -1 909 -397 O \nATOM 1468 CB ASN A 182 9.012 -17.475 -77.201 1.00 55.20 C \nANISOU 1468 CB ASN A 182 6155 6125 8695 -166 912 -458 C \nATOM 1469 CG ASN A 182 8.912 -18.062 -75.838 1.00 63.34 C \nANISOU 1469 CG ASN A 182 7219 7102 9743 -197 895 -463 C \nATOM 1470 OD1 ASN A 182 8.973 -17.323 -74.822 1.00 64.88 O \nANISOU 1470 OD1 ASN A 182 7410 7287 9954 -150 872 -445 O \nATOM 1471 ND2 ASN A 182 8.803 -19.381 -75.772 1.00 62.11 N \nANISOU 1471 ND2 ASN A 182 7100 6917 9581 -278 908 -488 N \nATOM 1472 N ASP A 183 8.070 -15.632 -79.649 1.00 56.74 N \nANISOU 1472 N ASP A 183 6172 6472 8912 -112 905 -474 N \nATOM 1473 CA ASP A 183 8.448 -14.978 -80.889 1.00 54.82 C \nANISOU 1473 CA ASP A 183 5915 6282 8633 -76 925 -457 C \nATOM 1474 C ASP A 183 7.305 -14.969 -81.892 1.00 56.47 C \nANISOU 1474 C ASP A 183 6024 6546 8884 -120 916 -505 C \nATOM 1475 O ASP A 183 6.280 -15.659 -81.712 1.00 51.94 O \nANISOU 1475 O ASP A 183 5403 5969 8363 -179 899 -553 O \nATOM 1476 CB ASP A 183 9.666 -15.697 -81.522 1.00 59.41 C \nANISOU 1476 CB ASP A 183 6604 6832 9139 -72 970 -427 C \nATOM 1477 CG ASP A 183 9.525 -17.240 -81.549 1.00 59.81 C \nANISOU 1477 CG ASP A 183 6700 6835 9188 -160 986 -456 C \nATOM 1478 OD1 ASP A 183 10.239 -17.931 -80.824 1.00 64.21 O \nANISOU 1478 OD1 ASP A 183 7357 7327 9714 -171 999 -437 O \nATOM 1479 OD2 ASP A 183 8.756 -17.759 -82.321 1.00 64.51 O \nANISOU 1479 OD2 ASP A 183 7238 7465 9809 -220 987 -496 O \nATOM 1480 N ALA A 184 7.505 -14.222 -82.985 1.00 53.83 N \nANISOU 1480 N ALA A 184 5661 6269 8522 -89 928 -493 N \nATOM 1481 CA ALA A 184 6.460 -14.063 -83.992 1.00 54.24 C \nANISOU 1481 CA ALA A 184 5621 6377 8609 -123 921 -537 C \nATOM 1482 C ALA A 184 6.014 -15.425 -84.542 1.00 59.65 C \nANISOU 1482 C ALA A 184 6305 7052 9305 -198 937 -579 C \nATOM 1483 O ALA A 184 4.844 -15.636 -84.814 1.00 66.33 O \nANISOU 1483 O ALA A 184 7074 7927 10203 -238 919 -630 O \nATOM 1484 CB ALA A 184 6.911 -13.152 -85.118 1.00 45.80 C \nANISOU 1484 CB ALA A 184 4534 5371 7497 -83 937 -513 C \nATOM 1485 N ALA A 185 6.964 -16.334 -84.704 1.00 62.86 N \nANISOU 1485 N ALA A 185 6803 7422 9659 -216 970 -557 N \nATOM 1486 CA ALA A 185 6.686 -17.661 -85.275 1.00 62.59 C \nANISOU 1486 CA ALA A 185 6776 7385 9620 -296 989 -592 C \nATOM 1487 C ALA A 185 5.716 -18.457 -84.394 1.00 60.44 C \nANISOU 1487 C ALA A 185 6465 7095 9404 -350 964 -636 C \nATOM 1488 O ALA A 185 4.679 -18.942 -84.887 1.00 64.47 O \nANISOU 1488 O ALA A 185 6899 7648 9950 -399 957 -689 O \nATOM 1489 CB ALA A 185 7.991 -18.429 -85.499 1.00 63.16 C \nANISOU 1489 CB ALA A 185 6972 7411 9617 -307 1029 -553 C \nATOM 1490 N GLU A 186 6.051 -18.592 -83.109 1.00 54.32 N \nANISOU 1490 N GLU A 186 5741 6264 8633 -340 952 -617 N \nATOM 1491 CA GLU A 186 5.169 -19.269 -82.145 1.00 55.67 C \nANISOU 1491 CA GLU A 186 5875 6421 8855 -385 925 -654 C \nATOM 1492 C GLU A 186 3.834 -18.633 -82.118 1.00 56.18 C \nANISOU 1492 C GLU A 186 5827 6529 8989 -371 888 -694 C \nATOM 1493 O GLU A 186 2.808 -19.307 -82.044 1.00 62.03 O \nANISOU 1493 O GLU A 186 6506 7293 9770 -416 872 -742 O \nATOM 1494 CB GLU A 186 5.717 -19.261 -80.732 1.00 55.90 C \nANISOU 1494 CB GLU A 186 5972 6387 8880 -365 914 -623 C \nATOM 1495 CG GLU A 186 4.923 -20.104 -79.743 1.00 62.12 C \nANISOU 1495 CG GLU A 186 6732 7161 9711 -419 889 -658 C \nATOM 1496 CD GLU A 186 5.375 -19.957 -78.285 1.00 67.56 C \nANISOU 1496 CD GLU A 186 7478 7791 10401 -396 874 -629 C \nATOM 1497 OE1 GLU A 186 6.290 -19.145 -77.999 1.00 76.17 O \nANISOU 1497 OE1 GLU A 186 8628 8852 11462 -332 880 -582 O \nATOM 1498 OE2 GLU A 186 4.821 -20.696 -77.430 1.00 63.52 O \nANISOU 1498 OE2 GLU A 186 6951 7267 9917 -442 855 -653 O \nATOM 1499 N GLN A 187 3.832 -17.315 -82.193 1.00 59.45 N \nANISOU 1499 N GLN A 187 6216 6960 9414 -309 873 -674 N \nATOM 1500 CA GLN A 187 2.560 -16.599 -82.123 1.00 50.88 C \nANISOU 1500 CA GLN A 187 5035 5906 8391 -295 836 -710 C \nATOM 1501 C GLN A 187 1.668 -17.059 -83.249 1.00 49.53 C \nANISOU 1501 C GLN A 187 4795 5788 8237 -333 842 -762 C \nATOM 1502 O GLN A 187 0.545 -17.508 -83.005 1.00 62.90 O \nANISOU 1502 O GLN A 187 6428 7493 9978 -357 819 -809 O \nATOM 1503 CB GLN A 187 2.771 -15.093 -82.157 1.00 43.64 C \nANISOU 1503 CB GLN A 187 4105 5006 7469 -233 823 -679 C \nATOM 1504 CG GLN A 187 1.451 -14.291 -82.221 1.00 37.98 C \nANISOU 1504 CG GLN A 187 3301 4320 6809 -226 786 -716 C \nATOM 1505 CD GLN A 187 0.630 -14.379 -80.929 1.00 38.17 C \nANISOU 1505 CD GLN A 187 3305 4309 6887 -230 746 -735 C \nATOM 1506 OE1 GLN A 187 1.142 -14.675 -79.865 1.00 34.37 O \nANISOU 1506 OE1 GLN A 187 2873 3785 6401 -226 741 -709 O \nATOM 1507 NE2 GLN A 187 -0.654 -14.065 -81.026 1.00 42.58 N \nANISOU 1507 NE2 GLN A 187 3797 4886 7497 -233 715 -778 N \nATOM 1508 N THR A 188 2.175 -16.978 -84.480 1.00 45.70 N \nANISOU 1508 N THR A 188 4320 5336 7710 -335 874 -753 N \nATOM 1509 CA THR A 188 1.424 -17.386 -85.681 1.00 44.14 C \nANISOU 1509 CA THR A 188 4058 5193 7520 -371 885 -801 C \nATOM 1510 C THR A 188 0.990 -18.834 -85.654 1.00 49.01 C \nANISOU 1510 C THR A 188 4662 5817 8143 -436 893 -841 C \nATOM 1511 O THR A 188 -0.114 -19.157 -86.065 1.00 54.16 O \nANISOU 1511 O THR A 188 5237 6512 8829 -457 882 -895 O \nATOM 1512 CB THR A 188 2.209 -17.106 -86.979 1.00 48.63 C \nANISOU 1512 CB THR A 188 4650 5794 8033 -365 921 -778 C \nATOM 1513 OG1 THR A 188 3.557 -16.702 -86.699 1.00 52.50 O \nANISOU 1513 OG1 THR A 188 5226 6250 8471 -326 938 -714 O \nATOM 1514 CG2 THR A 188 1.554 -15.966 -87.770 1.00 52.58 C \nANISOU 1514 CG2 THR A 188 5080 6345 8553 -335 909 -795 C \nATOM 1515 N LYS A 189 1.878 -19.723 -85.206 1.00 62.38 N \nANISOU 1515 N LYS A 189 6434 7471 9795 -470 914 -815 N \nATOM 1516 CA LYS A 189 1.576 -21.175 -85.182 1.00 61.22 C \nANISOU 1516 CA LYS A 189 6281 7339 9641 -547 925 -849 C \nATOM 1517 C LYS A 189 0.502 -21.521 -84.186 1.00 62.87 C \nANISOU 1517 C LYS A 189 6430 7551 9906 -555 888 -887 C \nATOM 1518 O LYS A 189 -0.303 -22.419 -84.429 1.00 59.86 O \nANISOU 1518 O LYS A 189 5989 7217 9537 -602 887 -936 O \nATOM 1519 CB LYS A 189 2.801 -22.048 -84.943 1.00 67.89 C \nANISOU 1519 CB LYS A 189 7236 8138 10422 -590 957 -812 C \nATOM 1520 CG LYS A 189 3.540 -21.877 -83.637 1.00 74.70 C \nANISOU 1520 CG LYS A 189 8178 8926 11277 -565 947 -769 C \nATOM 1521 CD LYS A 189 4.341 -23.150 -83.284 1.00 91.91 C \nANISOU 1521 CD LYS A 189 10453 11067 13402 -636 974 -756 C \nATOM 1522 CE LYS A 189 5.804 -22.868 -82.864 1.00 97.36 C \nANISOU 1522 CE LYS A 189 11277 11681 14036 -601 995 -692 C \nATOM 1523 NZ LYS A 189 6.631 -24.095 -82.628 1.00 92.15 N \nANISOU 1523 NZ LYS A 189 10726 10974 13313 -674 1024 -678 N \nATOM 1524 N LEU A 190 0.484 -20.820 -83.052 1.00 56.26 N \nANISOU 1524 N LEU A 190 5607 6668 9100 -509 858 -865 N \nATOM 1525 CA LEU A 190 -0.533 -21.088 -82.068 1.00 53.11 C \nANISOU 1525 CA LEU A 190 5155 6270 8754 -511 821 -897 C \nATOM 1526 C LEU A 190 -1.838 -20.439 -82.412 1.00 58.08 C \nANISOU 1526 C LEU A 190 5690 6939 9438 -475 791 -940 C \nATOM 1527 O LEU A 190 -2.912 -21.038 -82.223 1.00 60.61 O \nANISOU 1527 O LEU A 190 5943 7292 9792 -489 771 -988 O \nATOM 1528 CB LEU A 190 -0.102 -20.598 -80.697 1.00 48.52 C \nANISOU 1528 CB LEU A 190 4625 5626 8185 -479 799 -857 C \nATOM 1529 CG LEU A 190 0.935 -21.505 -80.052 1.00 50.96 C \nANISOU 1529 CG LEU A 190 5025 5891 8447 -523 821 -827 C \nATOM 1530 CD1 LEU A 190 1.392 -20.947 -78.706 1.00 46.91 C \nANISOU 1530 CD1 LEU A 190 4564 5317 7944 -486 800 -788 C \nATOM 1531 CD2 LEU A 190 0.369 -22.910 -79.841 1.00 50.50 C \nANISOU 1531 CD2 LEU A 190 4935 5863 8388 -598 821 -868 C \nATOM 1532 N TYR A 191 -1.744 -19.199 -82.885 1.00 61.65 N \nANISOU 1532 N TYR A 191 6140 7388 9896 -425 788 -922 N \nATOM 1533 CA TYR A 191 -2.921 -18.322 -82.871 1.00 58.40 C \nANISOU 1533 CA TYR A 191 5662 6990 9537 -383 751 -953 C \nATOM 1534 C TYR A 191 -3.281 -17.678 -84.128 1.00 65.60 C \nANISOU 1534 C TYR A 191 6534 7944 10447 -368 761 -973 C \nATOM 1535 O TYR A 191 -4.376 -17.160 -84.217 1.00 67.03 O \nANISOU 1535 O TYR A 191 6662 8138 10670 -343 734 -1009 O \nATOM 1536 CB TYR A 191 -2.711 -17.187 -81.921 1.00 51.05 C \nANISOU 1536 CB TYR A 191 4761 6013 8624 -337 724 -915 C \nATOM 1537 CG TYR A 191 -2.288 -17.584 -80.562 1.00 45.39 C \nANISOU 1537 CG TYR A 191 4090 5247 7910 -343 711 -888 C \nATOM 1538 CD1 TYR A 191 -3.182 -18.207 -79.708 1.00 45.35 C \nANISOU 1538 CD1 TYR A 191 4049 5237 7944 -354 681 -919 C \nATOM 1539 CD2 TYR A 191 -1.021 -17.343 -80.115 1.00 45.94 C \nANISOU 1539 CD2 TYR A 191 4236 5279 7939 -334 728 -832 C \nATOM 1540 CE1 TYR A 191 -2.813 -18.610 -78.427 1.00 42.81 C \nANISOU 1540 CE1 TYR A 191 3769 4874 7624 -365 669 -895 C \nATOM 1541 CE2 TYR A 191 -0.640 -17.754 -78.847 1.00 47.08 C \nANISOU 1541 CE2 TYR A 191 4427 5378 8085 -342 718 -810 C \nATOM 1542 CZ TYR A 191 -1.547 -18.377 -78.023 1.00 43.77 C \nANISOU 1542 CZ TYR A 191 3969 4955 7706 -361 688 -842 C \nATOM 1543 OH TYR A 191 -1.152 -18.760 -76.777 1.00 44.52 O \nANISOU 1543 OH TYR A 191 4109 5007 7798 -372 678 -820 O \nATOM 1544 N GLN A 192 -2.363 -17.666 -85.085 1.00 70.75 N \nANISOU 1544 N GLN A 192 7218 8614 11049 -382 799 -950 N \nATOM 1545 CA GLN A 192 -2.674 -17.124 -86.376 1.00 67.20 C \nANISOU 1545 CA GLN A 192 6730 8212 10592 -375 812 -970 C \nATOM 1546 C GLN A 192 -2.407 -15.626 -86.317 1.00 61.55 C \nANISOU 1546 C GLN A 192 6029 7483 9876 -328 798 -935 C \nATOM 1547 O GLN A 192 -1.414 -15.181 -86.873 1.00 57.70 O \nANISOU 1547 O GLN A 192 5577 7004 9340 -319 824 -895 O \nATOM 1548 CB GLN A 192 -4.110 -17.407 -86.767 1.00 79.78 C \nANISOU 1548 CB GLN A 192 8242 9843 12227 -378 794 -1039 C \nATOM 1549 CG GLN A 192 -4.332 -18.013 -88.166 1.00 93.15 C \nANISOU 1549 CG GLN A 192 9896 11601 13898 -411 825 -1077 C \nATOM 1550 CD GLN A 192 -3.132 -17.909 -89.124 1.00 87.75 C \nANISOU 1550 CD GLN A 192 9256 10931 13152 -430 866 -1038 C \nATOM 1551 OE1 GLN A 192 -2.296 -18.799 -89.157 1.00 92.08 O \nANISOU 1551 OE1 GLN A 192 9850 11476 13661 -469 894 -1017 O \nATOM 1552 NE2 GLN A 192 -3.069 -16.843 -89.918 1.00 76.39 N \nANISOU 1552 NE2 GLN A 192 7809 9512 11704 -404 871 -1029 N \nATOM 1553 N ASN A 193 -3.229 -14.856 -85.594 1.00 56.75 N \nANISOU 1553 N ASN A 193 5396 6853 9312 -298 758 -947 N \nATOM 1554 CA ASN A 193 -3.122 -13.409 -85.648 1.00 52.85 C \nANISOU 1554 CA ASN A 193 4908 6361 8814 -265 744 -921 C \nATOM 1555 C ASN A 193 -1.863 -12.924 -84.915 1.00 48.01 C \nANISOU 1555 C ASN A 193 4357 5720 8165 -244 750 -854 C \nATOM 1556 O ASN A 193 -1.593 -13.372 -83.820 1.00 49.53 O \nANISOU 1556 O ASN A 193 4582 5870 8367 -243 740 -836 O \nATOM 1557 CB ASN A 193 -4.397 -12.772 -85.065 1.00 60.58 C \nANISOU 1557 CB ASN A 193 5851 7321 9846 -247 699 -954 C \nATOM 1558 CG ASN A 193 -5.655 -13.645 -85.290 1.00 52.95 C \nANISOU 1558 CG ASN A 193 4833 6366 8920 -258 687 -1020 C \nATOM 1559 OD1 ASN A 193 -5.888 -14.060 -86.371 1.00 47.35 O \nANISOU 1559 OD1 ASN A 193 4092 5698 8199 -274 710 -1053 O \nATOM 1560 ND2 ASN A 193 -6.417 -13.942 -84.247 1.00 51.51 N \nANISOU 1560 ND2 ASN A 193 4641 6149 8781 -246 653 -1039 N \nATOM 1561 N PRO A 194 -1.095 -12.003 -85.520 1.00 42.76 N \nANISOU 1561 N PRO A 194 3707 5085 7456 -224 767 -816 N \nATOM 1562 CA PRO A 194 0.145 -11.500 -85.009 1.00 42.04 C \nANISOU 1562 CA PRO A 194 3671 4982 7322 -194 777 -754 C \nATOM 1563 C PRO A 194 -0.026 -10.431 -83.936 1.00 47.42 C \nANISOU 1563 C PRO A 194 4352 5646 8020 -167 741 -732 C \nATOM 1564 O PRO A 194 0.792 -10.310 -83.024 1.00 44.21 O \nANISOU 1564 O PRO A 194 3992 5214 7594 -143 740 -688 O \nATOM 1565 CB PRO A 194 0.799 -10.857 -86.237 1.00 41.49 C \nANISOU 1565 CB PRO A 194 3597 4969 7198 -182 805 -731 C \nATOM 1566 CG PRO A 194 -0.327 -10.460 -87.080 1.00 41.72 C \nANISOU 1566 CG PRO A 194 3562 5034 7254 -202 793 -780 C \nATOM 1567 CD PRO A 194 -1.346 -11.521 -86.894 1.00 45.50 C \nANISOU 1567 CD PRO A 194 4016 5487 7784 -231 782 -836 C \nATOM 1568 N THR A 195 -1.105 -9.669 -84.047 1.00 51.61 N \nANISOU 1568 N THR A 195 4835 6190 8584 -172 711 -763 N \nATOM 1569 CA THR A 195 -1.392 -8.625 -83.051 1.00 51.68 C \nANISOU 1569 CA THR A 195 4845 6184 8608 -157 674 -746 C \nATOM 1570 C THR A 195 -2.716 -8.903 -82.394 1.00 53.12 C \nANISOU 1570 C THR A 195 5004 6324 8854 -171 636 -792 C \nATOM 1571 O THR A 195 -3.762 -8.986 -83.063 1.00 56.18 O \nANISOU 1571 O THR A 195 5354 6721 9270 -185 628 -842 O \nATOM 1572 CB THR A 195 -1.410 -7.219 -83.706 1.00 47.16 C \nANISOU 1572 CB THR A 195 4248 5667 8004 -153 670 -733 C \nATOM 1573 OG1 THR A 195 -0.260 -7.082 -84.513 1.00 47.24 O \nANISOU 1573 OG1 THR A 195 4271 5726 7953 -137 707 -697 O \nATOM 1574 CG2 THR A 195 -1.363 -6.165 -82.630 1.00 44.97 C \nANISOU 1574 CG2 THR A 195 3981 5383 7723 -140 638 -702 C \nATOM 1575 N THR A 196 -2.687 -9.073 -81.091 1.00 54.65 N \nANISOU 1575 N THR A 196 5223 6473 9070 -162 613 -776 N \nATOM 1576 CA THR A 196 -3.866 -9.642 -80.388 1.00 57.96 C \nANISOU 1576 CA THR A 196 5624 6849 9549 -171 579 -818 C \nATOM 1577 C THR A 196 -4.080 -8.969 -79.036 1.00 51.18 C \nANISOU 1577 C THR A 196 4785 5953 8710 -160 540 -796 C \nATOM 1578 O THR A 196 -3.240 -8.200 -78.604 1.00 51.42 O \nANISOU 1578 O THR A 196 4840 5991 8705 -148 542 -749 O \nATOM 1579 CB THR A 196 -3.721 -11.185 -80.172 1.00 58.57 C \nANISOU 1579 CB THR A 196 5709 6908 9638 -185 596 -834 C \nATOM 1580 OG1 THR A 196 -2.511 -11.483 -79.464 1.00 55.29 O \nANISOU 1580 OG1 THR A 196 5344 6471 9191 -179 613 -785 O \nATOM 1581 CG2 THR A 196 -3.663 -11.892 -81.441 1.00 68.02 C \nANISOU 1581 CG2 THR A 196 6884 8142 10818 -203 631 -860 C \nATOM 1582 N TYR A 197 -5.171 -9.362 -78.353 1.00 42.85 N \nANISOU 1582 N TYR A 197 3717 4860 7706 -162 505 -830 N \nATOM 1583 CA TYR A 197 -5.626 -8.708 -77.134 1.00 39.40 C \nANISOU 1583 CA TYR A 197 3295 4384 7293 -156 462 -817 C \nATOM 1584 C TYR A 197 -6.651 -9.552 -76.434 1.00 36.71 C \nANISOU 1584 C TYR A 197 2941 4003 7003 -153 432 -854 C \nATOM 1585 O TYR A 197 -7.471 -10.237 -77.105 1.00 35.07 O \nANISOU 1585 O TYR A 197 2701 3805 6820 -153 435 -903 O \nATOM 1586 CB TYR A 197 -6.270 -7.307 -77.488 1.00 37.87 C \nANISOU 1586 CB TYR A 197 3093 4202 7094 -160 438 -823 C \nATOM 1587 CG TYR A 197 -7.492 -7.452 -78.359 1.00 33.09 C \nANISOU 1587 CG TYR A 197 2459 3597 6517 -163 429 -881 C \nATOM 1588 CD1 TYR A 197 -8.729 -7.403 -77.826 1.00 33.39 C \nANISOU 1588 CD1 TYR A 197 2497 3591 6598 -156 388 -914 C \nATOM 1589 CD2 TYR A 197 -7.394 -7.658 -79.712 1.00 40.78 C \nANISOU 1589 CD2 TYR A 197 3409 4615 7473 -170 463 -904 C \nATOM 1590 CE1 TYR A 197 -9.862 -7.602 -78.573 1.00 33.56 C \nANISOU 1590 CE1 TYR A 197 2498 3611 6644 -149 381 -970 C \nATOM 1591 CE2 TYR A 197 -8.536 -7.839 -80.503 1.00 41.78 C \nANISOU 1591 CE2 TYR A 197 3508 4742 7623 -169 456 -961 C \nATOM 1592 CZ TYR A 197 -9.775 -7.820 -79.890 1.00 40.43 C \nANISOU 1592 CZ TYR A 197 3341 4524 7496 -155 414 -995 C \nATOM 1593 OH TYR A 197 -10.933 -7.961 -80.605 1.00 48.24 O \nANISOU 1593 OH TYR A 197 4310 5511 8508 -144 406 -1052 O \nATOM 1594 N ILE A 198 -6.682 -9.467 -75.111 1.00 32.88 N \nANISOU 1594 N ILE A 198 2478 3479 6534 -148 403 -832 N \nATOM 1595 CA ILE A 198 -7.794 -9.995 -74.367 1.00 34.73 C \nANISOU 1595 CA ILE A 198 2701 3677 6817 -141 365 -864 C \nATOM 1596 C ILE A 198 -8.491 -8.788 -73.782 1.00 44.45 C \nANISOU 1596 C ILE A 198 3950 4879 8062 -135 322 -857 C \nATOM 1597 O ILE A 198 -7.829 -7.857 -73.264 1.00 44.15 O \nANISOU 1597 O ILE A 198 3938 4840 7996 -143 317 -813 O \nATOM 1598 CB ILE A 198 -7.361 -10.882 -73.196 1.00 40.86 C \nANISOU 1598 CB ILE A 198 3494 4430 7603 -145 361 -845 C \nATOM 1599 CG1 ILE A 198 -6.785 -12.179 -73.673 1.00 40.33 C \nANISOU 1599 CG1 ILE A 198 3417 4387 7521 -160 401 -855 C \nATOM 1600 CG2 ILE A 198 -8.558 -11.202 -72.277 1.00 39.50 C \nANISOU 1600 CG2 ILE A 198 3310 4222 7478 -132 314 -872 C \nATOM 1601 CD1 ILE A 198 -5.312 -12.102 -74.022 1.00 45.52 C \nANISOU 1601 CD1 ILE A 198 4109 5060 8126 -169 444 -813 C \nATOM 1602 N SER A 199 -9.818 -8.798 -73.812 1.00 48.47 N \nANISOU 1602 N SER A 199 4445 5364 8608 -122 289 -900 N \nATOM 1603 CA SER A 199 -10.608 -7.636 -73.376 1.00 50.68 C \nANISOU 1603 CA SER A 199 4752 5609 8897 -121 246 -898 C \nATOM 1604 C SER A 199 -11.691 -8.161 -72.468 1.00 53.02 C \nANISOU 1604 C SER A 199 5051 5858 9238 -98 204 -923 C \nATOM 1605 O SER A 199 -12.524 -8.954 -72.874 1.00 56.47 O \nANISOU 1605 O SER A 199 5460 6296 9701 -74 201 -969 O \nATOM 1606 CB SER A 199 -11.175 -6.896 -74.592 1.00 55.21 C \nANISOU 1606 CB SER A 199 5320 6198 9458 -127 251 -928 C \nATOM 1607 OG SER A 199 -12.423 -6.307 -74.292 1.00 56.18 O \nANISOU 1607 OG SER A 199 5467 6273 9604 -118 207 -953 O \nATOM 1608 N VAL A 200 -11.646 -7.773 -71.200 1.00 55.55 N \nANISOU 1608 N VAL A 200 5401 6141 9564 -102 172 -890 N \nATOM 1609 CA VAL A 200 -12.589 -8.301 -70.200 1.00 49.38 C \nANISOU 1609 CA VAL A 200 4623 5317 8822 -78 129 -907 C \nATOM 1610 C VAL A 200 -13.276 -7.128 -69.502 1.00 49.21 C \nANISOU 1610 C VAL A 200 4649 5246 8805 -83 82 -893 C \nATOM 1611 O VAL A 200 -12.599 -6.160 -69.106 1.00 45.25 O \nANISOU 1611 O VAL A 200 4175 4745 8273 -114 80 -851 O \nATOM 1612 CB VAL A 200 -11.887 -9.085 -69.126 1.00 44.48 C \nANISOU 1612 CB VAL A 200 4000 4695 8204 -84 132 -878 C \nATOM 1613 CG1 VAL A 200 -12.895 -9.814 -68.269 1.00 36.19 C \nANISOU 1613 CG1 VAL A 200 2941 3615 7193 -57 93 -900 C \nATOM 1614 CG2 VAL A 200 -10.914 -10.026 -69.729 1.00 51.91 C \nANISOU 1614 CG2 VAL A 200 4914 5683 9127 -96 183 -877 C \nATOM 1615 N GLY A 201 -14.599 -7.204 -69.376 1.00 45.49 N \nANISOU 1615 N GLY A 201 4188 4733 8363 -52 44 -930 N \nATOM 1616 CA GLY A 201 -15.406 -6.115 -68.834 1.00 49.12 C \nANISOU 1616 CA GLY A 201 4703 5136 8824 -57 -3 -923 C \nATOM 1617 C GLY A 201 -16.555 -6.551 -67.956 1.00 51.06 C \nANISOU 1617 C GLY A 201 4966 5328 9106 -16 -51 -942 C \nATOM 1618 O GLY A 201 -17.308 -7.465 -68.273 1.00 49.41 O \nANISOU 1618 O GLY A 201 4727 5122 8923 31 -54 -986 O \nATOM 1619 N THR A 202 -16.679 -5.895 -66.812 1.00 51.17 N \nANISOU 1619 N THR A 202 5026 5299 9119 -32 -90 -909 N \nATOM 1620 CA THR A 202 -17.864 -6.003 -65.981 1.00 47.44 C \nANISOU 1620 CA THR A 202 4587 4765 8674 5 -143 -922 C \nATOM 1621 C THR A 202 -18.433 -4.574 -65.811 1.00 56.17 C \nANISOU 1621 C THR A 202 5770 5813 9759 -23 -179 -910 C \nATOM 1622 O THR A 202 -18.143 -3.675 -66.594 1.00 67.41 O \nANISOU 1622 O THR A 202 7211 7251 11152 -63 -161 -907 O \nATOM 1623 CB THR A 202 -17.535 -6.636 -64.644 1.00 45.05 C \nANISOU 1623 CB THR A 202 4272 4459 8386 8 -161 -892 C \nATOM 1624 OG1 THR A 202 -16.824 -5.720 -63.796 1.00 40.77 O \nANISOU 1624 OG1 THR A 202 3766 3906 7819 -43 -171 -839 O \nATOM 1625 CG2 THR A 202 -16.677 -7.807 -64.813 1.00 44.99 C \nANISOU 1625 CG2 THR A 202 4199 4511 8382 10 -119 -893 C \nATOM 1626 N SER A 203 -19.237 -4.357 -64.784 1.00 59.89 N \nANISOU 1626 N SER A 203 6291 6221 10244 -8 -231 -902 N \nATOM 1627 CA SER A 203 -19.643 -3.018 -64.424 1.00 57.40 C \nANISOU 1627 CA SER A 203 6056 5851 9902 -50 -266 -881 C \nATOM 1628 C SER A 203 -18.492 -2.225 -63.801 1.00 55.27 C \nANISOU 1628 C SER A 203 5790 5612 9597 -121 -257 -824 C \nATOM 1629 O SER A 203 -18.452 -0.982 -63.845 1.00 65.17 O \nANISOU 1629 O SER A 203 7093 6854 10813 -177 -268 -804 O \nATOM 1630 CB SER A 203 -20.802 -3.061 -63.465 1.00 57.83 C \nANISOU 1630 CB SER A 203 6167 5828 9978 -11 -324 -886 C \nATOM 1631 OG SER A 203 -20.379 -3.567 -62.235 1.00 61.19 O \nANISOU 1631 OG SER A 203 6571 6261 10417 -11 -339 -852 O \nATOM 1632 N THR A 204 -17.561 -2.941 -63.220 1.00 48.74 N \nANISOU 1632 N THR A 204 4912 4828 8778 -119 -237 -799 N \nATOM 1633 CA THR A 204 -16.484 -2.333 -62.423 1.00 46.28 C \nANISOU 1633 CA THR A 204 4604 4545 8436 -172 -232 -744 C \nATOM 1634 C THR A 204 -15.143 -2.477 -63.102 1.00 48.55 C \nANISOU 1634 C THR A 204 4838 4910 8699 -190 -174 -730 C \nATOM 1635 O THR A 204 -14.253 -1.699 -62.855 1.00 54.05 O \nANISOU 1635 O THR A 204 5539 5643 9357 -233 -162 -691 O \nATOM 1636 CB THR A 204 -16.448 -3.014 -61.035 1.00 55.68 C \nANISOU 1636 CB THR A 204 5790 5716 9650 -155 -258 -722 C \nATOM 1637 OG1 THR A 204 -16.474 -1.998 -60.003 1.00 60.65 O \nANISOU 1637 OG1 THR A 204 6472 6316 10255 -200 -295 -683 O \nATOM 1638 CG2 THR A 204 -15.180 -3.928 -60.867 1.00 56.02 C \nANISOU 1638 CG2 THR A 204 5773 5819 9694 -153 -214 -705 C \nATOM 1639 N LEU A 205 -15.033 -3.452 -64.013 1.00 47.42 N \nANISOU 1639 N LEU A 205 4646 4795 8574 -154 -138 -763 N \nATOM 1640 CA LEU A 205 -13.786 -3.843 -64.601 1.00 43.75 C \nANISOU 1640 CA LEU A 205 4136 4397 8091 -162 -84 -751 C \nATOM 1641 C LEU A 205 -13.782 -3.494 -66.092 1.00 44.08 C \nANISOU 1641 C LEU A 205 4163 4471 8114 -167 -53 -777 C \nATOM 1642 O LEU A 205 -14.767 -3.714 -66.791 1.00 42.87 O \nANISOU 1642 O LEU A 205 4013 4294 7983 -142 -61 -822 O \nATOM 1643 CB LEU A 205 -13.583 -5.370 -64.419 1.00 40.63 C \nANISOU 1643 CB LEU A 205 3697 4014 7728 -125 -66 -767 C \nATOM 1644 CG LEU A 205 -12.264 -5.892 -64.999 1.00 40.01 C \nANISOU 1644 CG LEU A 205 3581 3995 7626 -133 -9 -754 C \nATOM 1645 CD1 LEU A 205 -11.089 -5.533 -64.128 1.00 32.98 C \nANISOU 1645 CD1 LEU A 205 2703 3121 6705 -158 1 -701 C \nATOM 1646 CD2 LEU A 205 -12.385 -7.420 -65.223 1.00 43.19 C \nANISOU 1646 CD2 LEU A 205 3942 4410 8058 -103 9 -786 C \nATOM 1647 N ASN A 206 -12.607 -3.082 -66.560 1.00 44.53 N \nANISOU 1647 N ASN A 206 4201 4587 8131 -193 -13 -750 N \nATOM 1648 CA ASN A 206 -12.391 -2.620 -67.894 1.00 47.04 C \nANISOU 1648 CA ASN A 206 4505 4947 8422 -206 19 -764 C \nATOM 1649 C ASN A 206 -10.902 -2.790 -68.199 1.00 47.75 C \nANISOU 1649 C ASN A 206 4561 5104 8477 -211 68 -732 C \nATOM 1650 O ASN A 206 -10.134 -1.838 -68.101 1.00 52.35 O \nANISOU 1650 O ASN A 206 5150 5727 9014 -240 76 -694 O \nATOM 1651 CB ASN A 206 -12.827 -1.138 -68.035 1.00 42.22 C \nANISOU 1651 CB ASN A 206 3936 4329 7777 -251 -6 -755 C \nATOM 1652 CG ASN A 206 -12.783 -0.638 -69.465 1.00 43.39 C \nANISOU 1652 CG ASN A 206 4071 4519 7896 -268 23 -776 C \nATOM 1653 OD1 ASN A 206 -12.642 -1.407 -70.439 1.00 57.03 O \nANISOU 1653 OD1 ASN A 206 5762 6272 9637 -241 58 -804 O \nATOM 1654 ND2 ASN A 206 -12.886 0.643 -69.622 1.00 40.90 N \nANISOU 1654 ND2 ASN A 206 3785 4217 7539 -318 10 -762 N \nATOM 1655 N GLN A 207 -10.516 -4.002 -68.604 1.00 41.08 N \nANISOU 1655 N GLN A 207 3683 4274 7650 -182 101 -748 N \nATOM 1656 CA GLN A 207 -9.147 -4.274 -68.937 1.00 38.59 C \nANISOU 1656 CA GLN A 207 3349 4012 7303 -182 148 -720 C \nATOM 1657 C GLN A 207 -8.912 -4.621 -70.428 1.00 40.12 C \nANISOU 1657 C GLN A 207 3512 4248 7485 -175 191 -745 C \nATOM 1658 O GLN A 207 -9.790 -4.969 -71.166 1.00 37.12 O \nANISOU 1658 O GLN A 207 3118 3856 7129 -165 188 -790 O \nATOM 1659 CB GLN A 207 -8.571 -5.357 -68.042 1.00 39.95 C \nANISOU 1659 CB GLN A 207 3520 4171 7490 -165 156 -705 C \nATOM 1660 CG GLN A 207 -8.796 -6.747 -68.486 1.00 43.95 C \nANISOU 1660 CG GLN A 207 4000 4673 8027 -146 175 -741 C \nATOM 1661 CD GLN A 207 -8.030 -7.808 -67.650 1.00 43.73 C \nANISOU 1661 CD GLN A 207 3975 4639 8001 -142 190 -722 C \nATOM 1662 OE1 GLN A 207 -7.992 -8.998 -68.007 1.00 40.75 O \nANISOU 1662 OE1 GLN A 207 3578 4270 7637 -137 212 -746 O \nATOM 1663 NE2 GLN A 207 -7.460 -7.393 -66.553 1.00 43.39 N \nANISOU 1663 NE2 GLN A 207 3960 4585 7943 -149 177 -682 N \nATOM 1664 N ARG A 208 -7.690 -4.437 -70.874 1.00 40.86 N \nANISOU 1664 N ARG A 208 3598 4393 7534 -177 231 -714 N \nATOM 1665 CA ARG A 208 -7.314 -4.862 -72.177 1.00 38.51 C \nANISOU 1665 CA ARG A 208 3275 4135 7222 -171 273 -732 C \nATOM 1666 C ARG A 208 -5.868 -5.296 -72.091 1.00 46.07 C \nANISOU 1666 C ARG A 208 4237 5123 8144 -158 313 -693 C \nATOM 1667 O ARG A 208 -5.015 -4.491 -71.755 1.00 45.66 O \nANISOU 1667 O ARG A 208 4198 5102 8050 -159 319 -650 O \nATOM 1668 CB ARG A 208 -7.444 -3.778 -73.187 1.00 38.15 C \nANISOU 1668 CB ARG A 208 3221 4130 7144 -189 279 -736 C \nATOM 1669 CG ARG A 208 -7.975 -4.305 -74.506 1.00 36.59 C \nANISOU 1669 CG ARG A 208 2999 3944 6961 -185 300 -783 C \nATOM 1670 CD ARG A 208 -8.014 -3.263 -75.548 1.00 36.13 C \nANISOU 1670 CD ARG A 208 2933 3930 6865 -207 310 -786 C \nATOM 1671 NE ARG A 208 -6.865 -3.367 -76.448 1.00 38.35 N \nANISOU 1671 NE ARG A 208 3193 4275 7103 -202 358 -765 N \nATOM 1672 CZ ARG A 208 -6.924 -3.609 -77.755 1.00 39.50 C \nANISOU 1672 CZ ARG A 208 3315 4454 7240 -203 386 -792 C \nATOM 1673 NH1 ARG A 208 -8.107 -3.847 -78.346 1.00 42.19 N \nANISOU 1673 NH1 ARG A 208 3647 4770 7615 -207 374 -847 N \nATOM 1674 NH2 ARG A 208 -5.788 -3.644 -78.457 1.00 37.42 N \nANISOU 1674 NH2 ARG A 208 3040 4248 6932 -197 428 -765 N \nATOM 1675 N LEU A 209 -5.609 -6.591 -72.361 1.00 49.78 N \nANISOU 1675 N LEU A 209 4700 5587 8629 -147 340 -710 N \nATOM 1676 CA LEU A 209 -4.282 -7.205 -72.148 1.00 38.61 C \nANISOU 1676 CA LEU A 209 3304 4183 7182 -136 376 -676 C \nATOM 1677 C LEU A 209 -3.685 -7.491 -73.498 1.00 39.18 C \nANISOU 1677 C LEU A 209 3366 4298 7224 -133 422 -681 C \nATOM 1678 O LEU A 209 -4.353 -7.910 -74.404 1.00 39.00 O \nANISOU 1678 O LEU A 209 3315 4282 7221 -140 428 -722 O \nATOM 1679 CB LEU A 209 -4.412 -8.485 -71.411 1.00 42.78 C \nANISOU 1679 CB LEU A 209 3841 4671 7742 -138 372 -689 C \nATOM 1680 CG LEU A 209 -5.098 -8.430 -70.045 1.00 45.17 C \nANISOU 1680 CG LEU A 209 4153 4929 8080 -140 326 -688 C \nATOM 1681 CD1 LEU A 209 -5.436 -9.803 -69.493 1.00 40.48 C \nANISOU 1681 CD1 LEU A 209 3556 4307 7520 -145 321 -711 C \nATOM 1682 CD2 LEU A 209 -4.281 -7.624 -69.084 1.00 46.37 C \nANISOU 1682 CD2 LEU A 209 4337 5081 8201 -136 319 -638 C \nATOM 1683 N VAL A 210 -2.424 -7.114 -73.656 1.00 48.54 N \nANISOU 1683 N VAL A 210 4571 5515 8355 -117 452 -638 N \nATOM 1684 CA VAL A 210 -1.696 -7.325 -74.920 1.00 47.03 C \nANISOU 1684 CA VAL A 210 4377 5367 8126 -110 497 -634 C \nATOM 1685 C VAL A 210 -0.498 -8.175 -74.583 1.00 42.95 C \nANISOU 1685 C VAL A 210 3905 4835 7580 -94 529 -605 C \nATOM 1686 O VAL A 210 0.194 -7.881 -73.602 1.00 49.04 O \nANISOU 1686 O VAL A 210 4709 5594 8330 -75 525 -567 O \nATOM 1687 CB VAL A 210 -1.214 -6.000 -75.538 1.00 46.45 C \nANISOU 1687 CB VAL A 210 4292 5355 8002 -100 505 -606 C \nATOM 1688 CG1 VAL A 210 -0.199 -6.307 -76.623 1.00 56.48 C \nANISOU 1688 CG1 VAL A 210 5570 6665 9225 -82 553 -590 C \nATOM 1689 CG2 VAL A 210 -2.371 -5.269 -76.167 1.00 49.41 C \nANISOU 1689 CG2 VAL A 210 4630 5747 8399 -125 481 -641 C \nATOM 1690 N PRO A 211 -0.294 -9.264 -75.317 1.00 36.74 N \nANISOU 1690 N PRO A 211 3124 4043 6791 -104 561 -624 N \nATOM 1691 CA PRO A 211 0.782 -10.217 -75.016 1.00 35.36 C \nANISOU 1691 CA PRO A 211 3005 3844 6587 -98 592 -600 C \nATOM 1692 C PRO A 211 2.110 -9.600 -75.299 1.00 34.87 C \nANISOU 1692 C PRO A 211 2980 3810 6458 -60 623 -551 C \nATOM 1693 O PRO A 211 2.259 -8.937 -76.357 1.00 35.01 O \nANISOU 1693 O PRO A 211 2973 3880 6448 -48 637 -546 O \nATOM 1694 CB PRO A 211 0.503 -11.363 -75.987 1.00 32.38 C \nANISOU 1694 CB PRO A 211 2615 3469 6219 -128 617 -638 C \nATOM 1695 CG PRO A 211 -0.317 -10.788 -77.066 1.00 34.49 C \nANISOU 1695 CG PRO A 211 2825 3778 6500 -134 610 -669 C \nATOM 1696 CD PRO A 211 -1.177 -9.779 -76.355 1.00 35.37 C \nANISOU 1696 CD PRO A 211 2909 3883 6645 -127 565 -673 C \nATOM 1697 N LYS A 212 3.032 -9.728 -74.378 1.00 34.95 N \nANISOU 1697 N LYS A 212 3046 3793 6441 -36 630 -514 N \nATOM 1698 CA LYS A 212 4.419 -9.259 -74.535 1.00 37.25 C \nANISOU 1698 CA LYS A 212 3384 4108 6662 14 662 -464 C \nATOM 1699 C LYS A 212 5.292 -10.298 -75.198 1.00 39.21 C \nANISOU 1699 C LYS A 212 3691 4336 6872 16 706 -457 C \nATOM 1700 O LYS A 212 5.736 -11.251 -74.555 1.00 37.70 O \nANISOU 1700 O LYS A 212 3559 4089 6675 5 717 -453 O \nATOM 1701 CB LYS A 212 5.028 -9.008 -73.130 1.00 38.00 C \nANISOU 1701 CB LYS A 212 3522 4175 6741 42 650 -429 C \nATOM 1702 CG LYS A 212 4.739 -7.617 -72.569 1.00 39.49 C \nANISOU 1702 CG LYS A 212 3669 4407 6930 59 618 -412 C \nATOM 1703 CD LYS A 212 3.779 -7.701 -71.422 1.00 38.10 C \nANISOU 1703 CD LYS A 212 3476 4190 6811 26 575 -433 C \nATOM 1704 CE LYS A 212 4.321 -6.977 -70.217 1.00 41.59 C \nANISOU 1704 CE LYS A 212 3938 4636 7227 54 560 -395 C \nATOM 1705 NZ LYS A 212 3.601 -7.378 -68.948 1.00 39.97 N \nANISOU 1705 NZ LYS A 212 3737 4376 7073 23 524 -411 N \nATOM 1706 N ILE A 213 5.511 -10.138 -76.484 1.00 44.90 N \nANISOU 1706 N ILE A 213 4396 5099 7564 23 731 -457 N \nATOM 1707 CA ILE A 213 6.225 -11.160 -77.271 1.00 53.75 C \nANISOU 1707 CA ILE A 213 5572 6200 8649 15 772 -455 C \nATOM 1708 C ILE A 213 7.727 -10.865 -77.070 1.00 61.81 C \nANISOU 1708 C ILE A 213 6672 7218 9596 81 801 -398 C \nATOM 1709 O ILE A 213 8.245 -9.909 -77.633 1.00 67.48 O \nANISOU 1709 O ILE A 213 7376 7994 10271 130 810 -369 O \nATOM 1710 CB ILE A 213 5.905 -11.027 -78.784 1.00 49.61 C \nANISOU 1710 CB ILE A 213 5001 5729 8118 1 788 -474 C \nATOM 1711 CG1 ILE A 213 4.401 -10.880 -79.045 1.00 52.72 C \nANISOU 1711 CG1 ILE A 213 5309 6144 8580 -43 756 -527 C \nATOM 1712 CG2 ILE A 213 6.535 -12.162 -79.567 1.00 43.96 C \nANISOU 1712 CG2 ILE A 213 4342 4992 7368 -18 828 -475 C \nATOM 1713 CD1 ILE A 213 3.644 -12.194 -79.049 1.00 55.12 C \nANISOU 1713 CD1 ILE A 213 5605 6412 8926 -100 754 -574 C \nATOM 1714 N ALA A 214 8.425 -11.688 -76.318 1.00 64.24 N \nANISOU 1714 N ALA A 214 7063 7461 9884 83 815 -383 N \nATOM 1715 CA ALA A 214 9.863 -11.517 -76.180 1.00 68.63 C \nANISOU 1715 CA ALA A 214 7706 8005 10364 151 845 -332 C \nATOM 1716 C ALA A 214 10.597 -12.822 -75.845 1.00 65.60 C \nANISOU 1716 C ALA A 214 7434 7540 9953 131 873 -326 C \nATOM 1717 O ALA A 214 9.988 -13.839 -75.548 1.00 62.37 O \nANISOU 1717 O ALA A 214 7027 7087 9582 60 866 -361 O \nATOM 1718 CB ALA A 214 10.130 -10.489 -75.100 1.00 69.60 C \nANISOU 1718 CB ALA A 214 7820 8146 10478 205 824 -303 C \nATOM 1719 N THR A 215 11.915 -12.752 -75.870 1.00 71.25 N \nANISOU 1719 N THR A 215 8242 8237 10594 197 904 -282 N \nATOM 1720 CA THR A 215 12.800 -13.900 -75.541 1.00 75.21 C \nANISOU 1720 CA THR A 215 8872 8653 11052 186 935 -270 C \nATOM 1721 C THR A 215 13.045 -13.945 -74.031 1.00 75.77 C \nANISOU 1721 C THR A 215 8988 8673 11127 199 920 -259 C \nATOM 1722 O THR A 215 13.293 -12.918 -73.402 1.00 76.49 O \nANISOU 1722 O THR A 215 9057 8796 11209 265 906 -234 O \nATOM 1723 CB THR A 215 14.167 -13.789 -76.290 1.00 72.94 C \nANISOU 1723 CB THR A 215 8678 8361 10675 260 976 -224 C \nATOM 1724 OG1 THR A 215 13.952 -13.903 -77.709 1.00 71.24 O \nANISOU 1724 OG1 THR A 215 8428 8186 10453 237 991 -235 O \nATOM 1725 CG2 THR A 215 15.150 -14.872 -75.844 1.00 74.93 C \nANISOU 1725 CG2 THR A 215 9081 8515 10874 255 1006 -208 C \nATOM 1726 N ARG A 216 12.952 -15.122 -73.439 1.00 83.59 N \nANISOU 1726 N ARG A 216 10038 9591 12130 133 924 -279 N \nATOM 1727 CA ARG A 216 13.155 -15.232 -71.994 1.00 92.17 C \nANISOU 1727 CA ARG A 216 11170 10629 13220 138 911 -272 C \nATOM 1728 C ARG A 216 14.029 -16.403 -71.626 1.00 87.39 C \nANISOU 1728 C ARG A 216 10706 9933 12564 113 942 -263 C \nATOM 1729 O ARG A 216 14.275 -17.292 -72.446 1.00 79.92 O \nANISOU 1729 O ARG A 216 9817 8960 11590 68 970 -270 O \nATOM 1730 CB ARG A 216 11.834 -15.403 -71.263 1.00 97.66 C \nANISOU 1730 CB ARG A 216 11774 11333 13999 68 869 -312 C \nATOM 1731 CG ARG A 216 10.934 -14.180 -71.272 1.00 96.93 C \nANISOU 1731 CG ARG A 216 11557 11315 13958 91 831 -320 C \nATOM 1732 CD ARG A 216 9.513 -14.573 -70.897 1.00 83.52 C \nANISOU 1732 CD ARG A 216 9773 9620 12339 15 794 -366 C \nATOM 1733 NE ARG A 216 8.498 -13.750 -71.515 1.00 74.63 N \nANISOU 1733 NE ARG A 216 8535 8561 11260 14 768 -387 N \nATOM 1734 CZ ARG A 216 7.746 -14.124 -72.546 1.00 77.97 C \nANISOU 1734 CZ ARG A 216 8904 9010 11712 -30 769 -421 C \nATOM 1735 NH1 ARG A 216 7.885 -15.317 -73.112 1.00 84.24 N \nANISOU 1735 NH1 ARG A 216 9737 9778 12491 -79 795 -439 N \nATOM 1736 NH2 ARG A 216 6.850 -13.288 -73.027 1.00 78.28 N \nANISOU 1736 NH2 ARG A 216 8849 9104 11788 -26 744 -439 N \nATOM 1737 N SER A 217 14.486 -16.360 -70.375 1.00 81.63 N \nANISOU 1737 N SER A 217 10035 9159 11820 138 937 -247 N \nATOM 1738 CA SER A 217 15.189 -17.469 -69.739 1.00 81.49 C \nANISOU 1738 CA SER A 217 10153 9050 11761 102 960 -244 C \nATOM 1739 C SER A 217 14.188 -18.562 -69.388 1.00 83.22 C \nANISOU 1739 C SER A 217 10336 9249 12033 -20 942 -289 C \nATOM 1740 O SER A 217 13.075 -18.302 -68.948 1.00 81.85 O \nANISOU 1740 O SER A 217 10050 9117 11932 -52 904 -316 O \nATOM 1741 CB SER A 217 15.922 -17.005 -68.471 1.00 81.21 C \nANISOU 1741 CB SER A 217 10182 8980 11695 170 958 -215 C \nATOM 1742 OG SER A 217 15.117 -16.125 -67.668 1.00 77.25 O \nANISOU 1742 OG SER A 217 9566 8532 11254 182 915 -224 O \nATOM 1743 N LYS A 218 14.589 -19.806 -69.595 1.00 91.05 N \nANISOU 1743 N LYS A 218 11429 10180 12985 -90 971 -298 N \nATOM 1744 CA LYS A 218 13.682 -20.934 -69.419 1.00 87.34 C \nANISOU 1744 CA LYS A 218 10923 9706 12555 -211 958 -342 C \nATOM 1745 C LYS A 218 13.503 -21.179 -67.935 1.00 84.18 C \nANISOU 1745 C LYS A 218 10537 9271 12175 -239 936 -348 C \nATOM 1746 O LYS A 218 14.469 -21.437 -67.239 1.00 95.58 O \nANISOU 1746 O LYS A 218 12107 10646 13564 -221 956 -325 O \nATOM 1747 CB LYS A 218 14.207 -22.180 -70.135 1.00 82.15 C \nANISOU 1747 CB LYS A 218 10370 9002 11839 -287 996 -347 C \nATOM 1748 CG LYS A 218 14.188 -22.022 -71.646 1.00 90.82 C \nANISOU 1748 CG LYS A 218 11437 10145 12926 -275 1014 -347 C \nATOM 1749 CD LYS A 218 14.615 -23.294 -72.372 1.00 97.53 C \nANISOU 1749 CD LYS A 218 12385 10954 13718 -363 1050 -355 C \nATOM 1750 CE LYS A 218 14.322 -23.249 -73.866 1.00101.99 C \nANISOU 1750 CE LYS A 218 12891 11575 14284 -373 1062 -364 C \nATOM 1751 NZ LYS A 218 15.258 -22.340 -74.569 1.00108.32 N \nANISOU 1751 NZ LYS A 218 13743 12375 15039 -262 1083 -321 N \nATOM 1752 N VAL A 219 12.260 -21.071 -67.471 1.00 81.49 N \nANISOU 1752 N VAL A 219 10072 8980 11912 -277 895 -380 N \nATOM 1753 CA VAL A 219 11.829 -21.502 -66.142 1.00 76.75 C \nANISOU 1753 CA VAL A 219 9465 8357 11339 -327 869 -395 C \nATOM 1754 C VAL A 219 11.020 -22.799 -66.278 1.00 81.85 C \nANISOU 1754 C VAL A 219 10078 9017 12005 -447 864 -438 C \nATOM 1755 O VAL A 219 9.959 -22.795 -66.897 1.00 81.97 O \nANISOU 1755 O VAL A 219 9975 9096 12073 -474 844 -468 O \nATOM 1756 CB VAL A 219 10.947 -20.409 -65.489 1.00 72.57 C \nANISOU 1756 CB VAL A 219 8815 7879 10880 -280 822 -398 C \nATOM 1757 CG1 VAL A 219 10.543 -20.787 -64.068 1.00 71.17 C \nANISOU 1757 CG1 VAL A 219 8633 7679 10728 -324 794 -410 C \nATOM 1758 CG2 VAL A 219 11.677 -19.088 -65.496 1.00 68.85 C \nANISOU 1758 CG2 VAL A 219 8358 7416 10385 -167 827 -358 C \nATOM 1759 N ASN A 220 11.488 -23.879 -65.641 1.00 98.59 N \nANISOU 1759 N ASN A 220 12298 11081 14081 -520 881 -441 N \nATOM 1760 CA ASN A 220 10.964 -25.261 -65.837 1.00103.14 C \nANISOU 1760 CA ASN A 220 12865 11671 14652 -646 886 -478 C \nATOM 1761 C ASN A 220 11.107 -25.734 -67.283 1.00100.26 C \nANISOU 1761 C ASN A 220 12512 11326 14255 -679 917 -486 C \nATOM 1762 O ASN A 220 10.211 -26.359 -67.841 1.00 99.18 O \nANISOU 1762 O ASN A 220 12289 11250 14146 -750 908 -523 O \nATOM 1763 CB ASN A 220 9.498 -25.385 -65.373 1.00112.72 C \nANISOU 1763 CB ASN A 220 13929 12954 15943 -688 839 -517 C \nATOM 1764 CG ASN A 220 9.339 -25.196 -63.875 1.00119.36 C \nANISOU 1764 CG ASN A 220 14769 13774 16808 -681 810 -511 C \nATOM 1765 OD1 ASN A 220 10.307 -25.330 -63.119 1.00124.55 O \nANISOU 1765 OD1 ASN A 220 15546 14363 17415 -677 828 -486 O \nATOM 1766 ND2 ASN A 220 8.116 -24.880 -63.434 1.00117.49 N \nANISOU 1766 ND2 ASN A 220 14402 13594 16645 -679 764 -534 N \nATOM 1767 N GLY A 221 12.236 -25.395 -67.891 1.00 98.07 N \nANISOU 1767 N GLY A 221 12342 11002 13920 -621 952 -452 N \nATOM 1768 CA GLY A 221 12.470 -25.675 -69.302 1.00 95.97 C \nANISOU 1768 CA GLY A 221 12094 10751 13620 -637 982 -453 C \nATOM 1769 C GLY A 221 11.481 -25.007 -70.239 1.00 93.61 C \nANISOU 1769 C GLY A 221 11641 10540 13385 -606 961 -473 C \nATOM 1770 O GLY A 221 11.296 -25.465 -71.362 1.00106.84 O \nANISOU 1770 O GLY A 221 13297 12249 15047 -649 978 -489 O \nATOM 1771 N GLN A 222 10.876 -23.902 -69.803 1.00 91.96 N \nANISOU 1771 N GLN A 222 11333 10369 13240 -531 925 -471 N \nATOM 1772 CA GLN A 222 9.873 -23.179 -70.611 1.00 90.14 C \nANISOU 1772 CA GLN A 222 10959 10218 13071 -500 902 -492 C \nATOM 1773 C GLN A 222 10.091 -21.646 -70.665 1.00 85.59 C \nANISOU 1773 C GLN A 222 10351 9658 12512 -383 890 -461 C \nATOM 1774 O GLN A 222 10.029 -20.934 -69.659 1.00 80.28 O \nANISOU 1774 O GLN A 222 9661 8976 11863 -336 865 -447 O \nATOM 1775 CB GLN A 222 8.473 -23.465 -70.094 1.00 86.34 C \nANISOU 1775 CB GLN A 222 10355 9788 12663 -551 861 -535 C \nATOM 1776 CG GLN A 222 7.376 -22.720 -70.863 1.00 89.90 C \nANISOU 1776 CG GLN A 222 10667 10314 13177 -518 835 -560 C \nATOM 1777 CD GLN A 222 7.489 -22.858 -72.388 1.00 89.03 C \nANISOU 1777 CD GLN A 222 10548 10238 13043 -527 864 -567 C \nATOM 1778 OE1 GLN A 222 7.535 -21.872 -73.123 1.00 85.21 O \nANISOU 1778 OE1 GLN A 222 10030 9779 12566 -460 865 -554 O \nATOM 1779 NE2 GLN A 222 7.537 -24.089 -72.859 1.00 93.89 N \nANISOU 1779 NE2 GLN A 222 11194 10857 13624 -615 888 -588 N \nATOM 1780 N SER A 223 10.343 -21.154 -71.867 1.00 79.44 N \nANISOU 1780 N SER A 223 9561 8909 11716 -342 908 -450 N \nATOM 1781 CA SER A 223 10.679 -19.753 -72.077 1.00 79.95 C \nANISOU 1781 CA SER A 223 9601 8998 11779 -237 903 -418 C \nATOM 1782 C SER A 223 9.438 -18.847 -72.105 1.00 78.27 C \nANISOU 1782 C SER A 223 9242 8855 11644 -219 861 -442 C \nATOM 1783 O SER A 223 9.545 -17.629 -72.015 1.00 86.57 O \nANISOU 1783 O SER A 223 10259 9932 12700 -144 848 -419 O \nATOM 1784 CB SER A 223 11.488 -19.621 -73.381 1.00 78.27 C \nANISOU 1784 CB SER A 223 9438 8793 11509 -203 941 -395 C \nATOM 1785 OG SER A 223 12.877 -19.488 -73.119 1.00 75.15 O \nANISOU 1785 OG SER A 223 9175 8340 11040 -141 970 -349 O \nATOM 1786 N GLY A 224 8.265 -19.449 -72.229 1.00 68.91 N \nANISOU 1786 N GLY A 224 7973 7699 10511 -288 840 -488 N \nATOM 1787 CA GLY A 224 7.002 -18.708 -72.277 1.00 53.20 C \nANISOU 1787 CA GLY A 224 5855 5765 8592 -276 800 -515 C \nATOM 1788 C GLY A 224 6.557 -18.328 -70.917 1.00 46.52 C \nANISOU 1788 C GLY A 224 4985 4905 7787 -264 762 -513 C \nATOM 1789 O GLY A 224 7.175 -18.730 -69.924 1.00 42.72 O \nANISOU 1789 O GLY A 224 4579 4373 7281 -272 767 -496 O \nATOM 1790 N ARG A 225 5.480 -17.546 -70.861 1.00 44.29 N \nANISOU 1790 N ARG A 225 4602 4664 7564 -246 724 -533 N \nATOM 1791 CA ARG A 225 4.900 -17.079 -69.594 1.00 41.24 C \nANISOU 1791 CA ARG A 225 4183 4268 7220 -236 682 -532 C \nATOM 1792 C ARG A 225 3.430 -17.071 -69.703 1.00 36.75 C \nANISOU 1792 C ARG A 225 3513 3735 6718 -260 645 -576 C \nATOM 1793 O ARG A 225 2.856 -17.023 -70.789 1.00 40.05 O \nANISOU 1793 O ARG A 225 3875 4193 7151 -266 648 -601 O \nATOM 1794 CB ARG A 225 5.388 -15.651 -69.217 1.00 49.95 C \nANISOU 1794 CB ARG A 225 5292 5378 8310 -162 672 -493 C \nATOM 1795 CG ARG A 225 6.365 -15.660 -68.081 1.00 67.45 C \nANISOU 1795 CG ARG A 225 7592 7548 10489 -139 680 -458 C \nATOM 1796 CD ARG A 225 7.775 -15.470 -68.536 1.00 77.28 C \nANISOU 1796 CD ARG A 225 8924 8779 11661 -89 723 -418 C \nATOM 1797 NE ARG A 225 8.747 -15.546 -67.432 1.00 82.06 N \nANISOU 1797 NE ARG A 225 9620 9334 12225 -63 733 -387 N \nATOM 1798 CZ ARG A 225 9.834 -16.315 -67.441 1.00 75.68 C \nANISOU 1798 CZ ARG A 225 8924 8474 11357 -64 771 -369 C \nATOM 1799 NH1 ARG A 225 10.136 -17.100 -68.471 1.00 66.84 N \nANISOU 1799 NH1 ARG A 225 7844 7344 10209 -95 804 -378 N \nATOM 1800 NH2 ARG A 225 10.641 -16.284 -66.424 1.00 80.53 N \nANISOU 1800 NH2 ARG A 225 9617 9044 11936 -35 778 -343 N \nATOM 1801 N MET A 226 2.775 -17.050 -68.561 1.00 40.22 N \nANISOU 1801 N MET A 226 3926 4160 7196 -269 607 -584 N \nATOM 1802 CA MET A 226 1.306 -17.099 -68.523 1.00 43.79 C \nANISOU 1802 CA MET A 226 4286 4640 7710 -286 567 -625 C \nATOM 1803 C MET A 226 0.826 -16.342 -67.304 1.00 45.61 C \nANISOU 1803 C MET A 226 4499 4854 7975 -262 523 -613 C \nATOM 1804 O MET A 226 1.106 -16.752 -66.186 1.00 54.95 O \nANISOU 1804 O MET A 226 5720 6005 9153 -278 515 -601 O \nATOM 1805 CB MET A 226 0.856 -18.559 -68.492 1.00 46.12 C \nANISOU 1805 CB MET A 226 4568 4942 8012 -350 572 -661 C \nATOM 1806 CG MET A 226 -0.598 -18.755 -68.809 1.00 52.90 C \nANISOU 1806 CG MET A 226 5332 5842 8925 -360 541 -709 C \nATOM 1807 SD MET A 226 -0.938 -20.486 -69.180 1.00 57.12 S \nANISOU 1807 SD MET A 226 5844 6411 9448 -435 559 -751 S \nATOM 1808 CE MET A 226 -0.361 -20.595 -70.865 1.00 44.87 C \nANISOU 1808 CE MET A 226 4306 4887 7857 -443 607 -756 C \nATOM 1809 N ASP A 227 0.124 -15.228 -67.497 1.00 46.53 N \nANISOU 1809 N ASP A 227 4564 4991 8122 -229 495 -617 N \nATOM 1810 CA ASP A 227 -0.370 -14.443 -66.379 1.00 47.22 C \nANISOU 1810 CA ASP A 227 4637 5064 8239 -211 451 -605 C \nATOM 1811 C ASP A 227 -1.860 -14.717 -66.157 1.00 46.52 C \nANISOU 1811 C ASP A 227 4483 4982 8209 -226 408 -646 C \nATOM 1812 O ASP A 227 -2.648 -14.934 -67.102 1.00 46.09 O \nANISOU 1812 O ASP A 227 4380 4955 8177 -230 407 -682 O \nATOM 1813 CB ASP A 227 -0.154 -12.957 -66.630 1.00 55.85 C \nANISOU 1813 CB ASP A 227 5724 6175 9319 -169 445 -578 C \nATOM 1814 CG ASP A 227 1.343 -12.574 -66.756 1.00 61.74 C \nANISOU 1814 CG ASP A 227 6534 6924 10002 -139 484 -533 C \nATOM 1815 OD1 ASP A 227 2.244 -13.412 -66.379 1.00 66.58 O \nANISOU 1815 OD1 ASP A 227 7209 7507 10582 -148 512 -519 O \nATOM 1816 OD2 ASP A 227 1.593 -11.426 -67.209 1.00 55.01 O \nANISOU 1816 OD2 ASP A 227 5668 6104 9128 -106 486 -513 O \nATOM 1817 N PHE A 228 -2.262 -14.702 -64.880 1.00 35.82 N \nANISOU 1817 N PHE A 228 3130 3602 6878 -230 372 -640 N \nATOM 1818 CA PHE A 228 -3.625 -14.914 -64.580 1.00 33.89 C \nANISOU 1818 CA PHE A 228 2831 3362 6685 -234 330 -674 C \nATOM 1819 C PHE A 228 -4.280 -13.754 -63.902 1.00 34.46 C \nANISOU 1819 C PHE A 228 2892 3418 6783 -209 284 -662 C \nATOM 1820 O PHE A 228 -3.611 -12.961 -63.284 1.00 46.57 O \nANISOU 1820 O PHE A 228 4462 4937 8295 -199 282 -624 O \nATOM 1821 CB PHE A 228 -3.763 -16.187 -63.747 1.00 33.96 C \nANISOU 1821 CB PHE A 228 2842 3363 6700 -270 324 -687 C \nATOM 1822 CG PHE A 228 -3.508 -17.414 -64.521 1.00 33.58 C \nANISOU 1822 CG PHE A 228 2789 3340 6631 -306 361 -711 C \nATOM 1823 CD1 PHE A 228 -4.484 -17.976 -65.293 1.00 34.04 C \nANISOU 1823 CD1 PHE A 228 2783 3437 6712 -312 355 -756 C \nATOM 1824 CD2 PHE A 228 -2.250 -17.960 -64.500 1.00 34.44 C \nANISOU 1824 CD2 PHE A 228 2962 3434 6690 -333 402 -688 C \nATOM 1825 CE1 PHE A 228 -4.195 -19.081 -66.070 1.00 38.03 C \nANISOU 1825 CE1 PHE A 228 3284 3975 7193 -351 391 -778 C \nATOM 1826 CE2 PHE A 228 -1.950 -19.056 -65.282 1.00 39.50 C \nANISOU 1826 CE2 PHE A 228 3607 4097 7304 -374 439 -708 C \nATOM 1827 CZ PHE A 228 -2.926 -19.631 -66.064 1.00 38.48 C \nANISOU 1827 CZ PHE A 228 3408 4015 7198 -387 433 -753 C \nATOM 1828 N PHE A 229 -5.619 -13.735 -63.922 1.00 34.85 N \nANISOU 1828 N PHE A 229 2896 3470 6878 -201 245 -695 N \nATOM 1829 CA PHE A 229 -6.352 -12.585 -63.412 1.00 38.39 C \nANISOU 1829 CA PHE A 229 3340 3898 7349 -181 201 -686 C \nATOM 1830 C PHE A 229 -7.655 -13.088 -62.817 1.00 36.13 C \nANISOU 1830 C PHE A 229 3021 3599 7107 -175 155 -716 C \nATOM 1831 O PHE A 229 -8.089 -14.151 -63.143 1.00 32.60 O \nANISOU 1831 O PHE A 229 2540 3172 6672 -180 162 -750 O \nATOM 1832 CB PHE A 229 -6.652 -11.616 -64.561 1.00 37.74 C \nANISOU 1832 CB PHE A 229 3242 3833 7263 -164 205 -696 C \nATOM 1833 CG PHE A 229 -5.456 -10.974 -65.114 1.00 38.94 C \nANISOU 1833 CG PHE A 229 3420 4005 7369 -162 244 -664 C \nATOM 1834 CD1 PHE A 229 -4.771 -11.534 -66.167 1.00 42.78 C \nANISOU 1834 CD1 PHE A 229 3906 4518 7830 -166 291 -671 C \nATOM 1835 CD2 PHE A 229 -5.012 -9.784 -64.584 1.00 41.12 C \nANISOU 1835 CD2 PHE A 229 3722 4278 7623 -156 232 -626 C \nATOM 1836 CE1 PHE A 229 -3.658 -10.886 -66.715 1.00 42.91 C \nANISOU 1836 CE1 PHE A 229 3948 4556 7799 -156 326 -639 C \nATOM 1837 CE2 PHE A 229 -3.903 -9.117 -65.104 1.00 36.75 C \nANISOU 1837 CE2 PHE A 229 3187 3755 7020 -147 267 -594 C \nATOM 1838 CZ PHE A 229 -3.236 -9.669 -66.174 1.00 39.67 C \nANISOU 1838 CZ PHE A 229 3557 4149 7366 -143 313 -601 C \nATOM 1839 N TRP A 230 -8.281 -12.267 -61.991 1.00 35.27 N \nANISOU 1839 N TRP A 230 2922 3461 7017 -163 110 -704 N \nATOM 1840 CA TRP A 230 -9.492 -12.662 -61.343 1.00 37.34 C \nANISOU 1840 CA TRP A 230 3162 3707 7317 -150 64 -727 C \nATOM 1841 C TRP A 230 -10.343 -11.436 -61.037 1.00 40.87 C \nANISOU 1841 C TRP A 230 3625 4121 7782 -131 18 -721 C \nATOM 1842 O TRP A 230 -9.774 -10.295 -60.865 1.00 37.01 O \nANISOU 1842 O TRP A 230 3170 3621 7269 -142 18 -686 O \nATOM 1843 CB TRP A 230 -9.171 -13.375 -60.070 1.00 34.42 C \nANISOU 1843 CB TRP A 230 2804 3328 6946 -169 53 -709 C \nATOM 1844 CG TRP A 230 -8.483 -12.560 -59.018 1.00 35.22 C \nANISOU 1844 CG TRP A 230 2951 3402 7029 -181 42 -662 C \nATOM 1845 CD1 TRP A 230 -7.137 -12.280 -58.945 1.00 35.60 C \nANISOU 1845 CD1 TRP A 230 3035 3453 7036 -196 79 -627 C \nATOM 1846 CD2 TRP A 230 -9.099 -11.912 -57.868 1.00 34.97 C \nANISOU 1846 CD2 TRP A 230 2936 3338 7015 -176 -9 -644 C \nATOM 1847 NE1 TRP A 230 -6.879 -11.498 -57.785 1.00 40.51 N \nANISOU 1847 NE1 TRP A 230 3690 4053 7650 -201 54 -590 N \nATOM 1848 CE2 TRP A 230 -8.059 -11.267 -57.123 1.00 34.46 C \nANISOU 1848 CE2 TRP A 230 2911 3263 6918 -194 0 -599 C \nATOM 1849 CE3 TRP A 230 -10.446 -11.742 -57.450 1.00 33.72 C \nANISOU 1849 CE3 TRP A 230 2764 3155 6892 -155 -63 -661 C \nATOM 1850 CZ2 TRP A 230 -8.307 -10.520 -56.014 1.00 30.11 C \nANISOU 1850 CZ2 TRP A 230 2384 2688 6370 -199 -40 -573 C \nATOM 1851 CZ3 TRP A 230 -10.720 -11.061 -56.263 1.00 29.67 C \nANISOU 1851 CZ3 TRP A 230 2281 2609 6384 -160 -106 -633 C \nATOM 1852 CH2 TRP A 230 -9.647 -10.430 -55.572 1.00 31.67 C \nANISOU 1852 CH2 TRP A 230 2570 2858 6604 -186 -94 -589 C \nATOM 1853 N THR A 231 -11.664 -11.664 -60.942 1.00 33.64 N \nANISOU 1853 N THR A 231 2689 3191 6901 -104 -22 -753 N \nATOM 1854 CA THR A 231 -12.571 -10.635 -60.453 1.00 37.51 C \nANISOU 1854 CA THR A 231 3207 3637 7406 -89 -72 -747 C \nATOM 1855 C THR A 231 -13.740 -11.268 -59.767 1.00 40.20 C \nANISOU 1855 C THR A 231 3533 3961 7781 -58 -117 -769 C \nATOM 1856 O THR A 231 -13.999 -12.473 -59.912 1.00 43.98 O \nANISOU 1856 O THR A 231 3968 4473 8272 -44 -108 -798 O \nATOM 1857 CB THR A 231 -13.059 -9.702 -61.563 1.00 38.54 C \nANISOU 1857 CB THR A 231 3347 3762 7535 -77 -71 -765 C \nATOM 1858 OG1 THR A 231 -13.908 -8.699 -61.023 1.00 52.41 O \nANISOU 1858 OG1 THR A 231 5143 5470 9300 -71 -120 -757 O \nATOM 1859 CG2 THR A 231 -13.832 -10.458 -62.593 1.00 38.26 C \nANISOU 1859 CG2 THR A 231 3271 3748 7519 -45 -61 -817 C \nATOM 1860 N ILE A 232 -14.441 -10.477 -58.977 1.00 41.75 N \nANISOU 1860 N ILE A 232 3765 4110 7988 -49 -166 -754 N \nATOM 1861 CA ILE A 232 -15.725 -10.929 -58.367 1.00 38.35 C \nANISOU 1861 CA ILE A 232 3328 3656 7588 -7 -216 -776 C \nATOM 1862 C ILE A 232 -16.851 -10.409 -59.237 1.00 39.17 C \nANISOU 1862 C ILE A 232 3443 3734 7704 34 -235 -811 C \nATOM 1863 O ILE A 232 -16.857 -9.227 -59.623 1.00 37.10 O \nANISOU 1863 O ILE A 232 3225 3442 7429 17 -238 -800 O \nATOM 1864 CB ILE A 232 -15.863 -10.407 -56.950 1.00 32.72 C \nANISOU 1864 CB ILE A 232 2656 2900 6876 -20 -261 -738 C \nATOM 1865 CG1 ILE A 232 -14.661 -10.869 -56.090 1.00 30.43 C \nANISOU 1865 CG1 ILE A 232 2360 2634 6568 -62 -238 -703 C \nATOM 1866 CG2 ILE A 232 -17.114 -10.840 -56.322 1.00 30.69 C \nANISOU 1866 CG2 ILE A 232 2396 2620 6645 27 -311 -755 C \nATOM 1867 CD1 ILE A 232 -14.343 -12.313 -56.129 1.00 30.00 C \nANISOU 1867 CD1 ILE A 232 2256 2628 6517 -63 -211 -722 C \nATOM 1868 N LEU A 233 -17.778 -11.281 -59.589 1.00 41.02 N \nANISOU 1868 N LEU A 233 3640 3986 7960 85 -245 -854 N \nATOM 1869 CA LEU A 233 -18.910 -10.883 -60.404 1.00 46.24 C \nANISOU 1869 CA LEU A 233 4316 4621 8633 133 -263 -892 C \nATOM 1870 C LEU A 233 -20.132 -10.842 -59.568 1.00 47.91 C \nANISOU 1870 C LEU A 233 4555 4785 8863 185 -323 -898 C \nATOM 1871 O LEU A 233 -20.598 -11.887 -59.125 1.00 58.04 O \nANISOU 1871 O LEU A 233 5794 6099 10160 223 -338 -914 O \nATOM 1872 CB LEU A 233 -19.095 -11.815 -61.548 1.00 51.00 C \nANISOU 1872 CB LEU A 233 4857 5282 9241 163 -229 -940 C \nATOM 1873 CG LEU A 233 -20.140 -11.421 -62.570 1.00 54.23 C \nANISOU 1873 CG LEU A 233 5279 5670 9656 213 -238 -984 C \nATOM 1874 CD1 LEU A 233 -19.752 -10.122 -63.262 1.00 58.68 C \nANISOU 1874 CD1 LEU A 233 5895 6200 10201 173 -223 -970 C \nATOM 1875 CD2 LEU A 233 -20.311 -12.536 -63.592 1.00 52.06 C \nANISOU 1875 CD2 LEU A 233 4930 5466 9384 243 -204 -1033 C \nATOM 1876 N LYS A 234 -20.647 -9.633 -59.322 1.00 50.07 N \nANISOU 1876 N LYS A 234 4904 4988 9132 182 -359 -882 N \nATOM 1877 CA LYS A 234 -21.809 -9.430 -58.434 1.00 51.88 C \nANISOU 1877 CA LYS A 234 5181 5156 9374 228 -421 -880 C \nATOM 1878 C LYS A 234 -23.078 -10.070 -59.033 1.00 52.72 C \nANISOU 1878 C LYS A 234 5267 5265 9497 318 -437 -934 C \nATOM 1879 O LYS A 234 -23.167 -10.273 -60.256 1.00 41.80 O \nANISOU 1879 O LYS A 234 3855 3912 8114 337 -404 -974 O \nATOM 1880 CB LYS A 234 -22.077 -7.952 -58.268 1.00 56.93 C \nANISOU 1880 CB LYS A 234 5914 5719 9998 198 -449 -857 C \nATOM 1881 CG LYS A 234 -20.945 -7.096 -57.739 1.00 57.51 C \nANISOU 1881 CG LYS A 234 6012 5793 10047 113 -437 -805 C \nATOM 1882 CD LYS A 234 -20.883 -7.120 -56.225 1.00 64.40 C \nANISOU 1882 CD LYS A 234 6905 6644 10922 99 -475 -764 C \nATOM 1883 CE LYS A 234 -19.921 -6.046 -55.719 1.00 71.43 C \nANISOU 1883 CE LYS A 234 7831 7528 11781 18 -469 -715 C \nATOM 1884 NZ LYS A 234 -19.554 -6.241 -54.281 1.00 86.13 N \nANISOU 1884 NZ LYS A 234 9695 9389 13642 -4 -492 -675 N \nATOM 1885 N PRO A 235 -24.067 -10.408 -58.169 1.00 65.80 N \nANISOU 1885 N PRO A 235 6939 6894 11168 379 -488 -937 N \nATOM 1886 CA PRO A 235 -25.315 -11.077 -58.534 1.00 62.23 C \nANISOU 1886 CA PRO A 235 6467 6450 10728 479 -510 -985 C \nATOM 1887 C PRO A 235 -25.839 -10.766 -59.916 1.00 65.71 C \nANISOU 1887 C PRO A 235 6921 6879 11165 514 -491 -1032 C \nATOM 1888 O PRO A 235 -25.680 -11.612 -60.791 1.00 66.57 O \nANISOU 1888 O PRO A 235 6954 7064 11277 532 -452 -1068 O \nATOM 1889 CB PRO A 235 -26.229 -10.622 -57.451 1.00 66.64 C \nANISOU 1889 CB PRO A 235 7098 6932 11290 518 -575 -965 C \nATOM 1890 CG PRO A 235 -25.333 -10.688 -56.228 1.00 68.25 C \nANISOU 1890 CG PRO A 235 7292 7149 11492 450 -580 -912 C \nATOM 1891 CD PRO A 235 -23.950 -10.342 -56.697 1.00 68.27 C \nANISOU 1891 CD PRO A 235 7275 7182 11481 358 -526 -892 C \nATOM 1892 N ASN A 236 -26.395 -9.587 -60.178 1.00 66.24 N \nANISOU 1892 N ASN A 236 7085 6860 11223 515 -513 -1032 N \nATOM 1893 CA ASN A 236 -26.961 -9.365 -61.533 1.00 70.64 C \nANISOU 1893 CA ASN A 236 7656 7408 11775 553 -494 -1082 C \nATOM 1894 C ASN A 236 -26.082 -8.634 -62.536 1.00 66.68 C \nANISOU 1894 C ASN A 236 7162 6918 11258 474 -447 -1079 C \nATOM 1895 O ASN A 236 -26.584 -7.970 -63.450 1.00 81.00 O \nANISOU 1895 O ASN A 236 9025 8692 13059 484 -442 -1108 O \nATOM 1896 CB ASN A 236 -28.363 -8.723 -61.451 1.00 78.46 C \nANISOU 1896 CB ASN A 236 8748 8302 12762 624 -546 -1102 C \nATOM 1897 CG ASN A 236 -29.442 -9.755 -61.196 1.00 79.28 C \nANISOU 1897 CG ASN A 236 8817 8428 12880 743 -575 -1136 C \nATOM 1898 OD1 ASN A 236 -30.139 -9.696 -60.189 1.00 86.90 O \nANISOU 1898 OD1 ASN A 236 9830 9341 13846 789 -627 -1118 O \nATOM 1899 ND2 ASN A 236 -29.542 -10.744 -62.078 1.00 76.88 N \nANISOU 1899 ND2 ASN A 236 8422 8209 12581 793 -541 -1183 N \nATOM 1900 N ASP A 237 -24.780 -8.787 -62.409 1.00 61.70 N \nANISOU 1900 N ASP A 237 6480 6342 10622 398 -410 -1047 N \nATOM 1901 CA ASP A 237 -23.848 -8.162 -63.356 1.00 55.44 C \nANISOU 1901 CA ASP A 237 5684 5572 9810 328 -362 -1041 C \nATOM 1902 C ASP A 237 -23.463 -9.216 -64.375 1.00 55.60 C \nANISOU 1902 C ASP A 237 5612 5680 9835 344 -312 -1077 C \nATOM 1903 O ASP A 237 -23.499 -10.407 -64.094 1.00 68.74 O \nANISOU 1903 O ASP A 237 7206 7398 11513 379 -307 -1090 O \nATOM 1904 CB ASP A 237 -22.632 -7.637 -62.594 1.00 55.39 C \nANISOU 1904 CB ASP A 237 5685 5572 9788 242 -353 -982 C \nATOM 1905 CG ASP A 237 -21.789 -6.636 -63.398 1.00 53.65 C \nANISOU 1905 CG ASP A 237 5485 5361 9539 171 -317 -966 C \nATOM 1906 OD1 ASP A 237 -21.890 -6.549 -64.633 1.00 51.68 O \nANISOU 1906 OD1 ASP A 237 5223 5131 9283 178 -288 -1001 O \nATOM 1907 OD2 ASP A 237 -20.919 -5.996 -62.757 1.00 51.65 O \nANISOU 1907 OD2 ASP A 237 5250 5107 9267 107 -315 -918 O \nATOM 1908 N ALA A 238 -23.098 -8.777 -65.561 1.00 54.10 N \nANISOU 1908 N ALA A 238 5420 5506 9629 315 -273 -1094 N \nATOM 1909 CA ALA A 238 -22.559 -9.654 -66.601 1.00 49.75 C \nANISOU 1909 CA ALA A 238 4786 5039 9077 313 -220 -1122 C \nATOM 1910 C ALA A 238 -21.081 -9.363 -66.885 1.00 51.02 C \nANISOU 1910 C ALA A 238 4929 5240 9217 230 -174 -1085 C \nATOM 1911 O ALA A 238 -20.622 -8.206 -66.714 1.00 45.36 O \nANISOU 1911 O ALA A 238 4267 4487 8481 178 -178 -1050 O \nATOM 1912 CB ALA A 238 -23.336 -9.458 -67.864 1.00 51.14 C \nANISOU 1912 CB ALA A 238 4972 5211 9249 353 -209 -1175 C \nATOM 1913 N ILE A 239 -20.330 -10.410 -67.296 1.00 45.63 N \nANISOU 1913 N ILE A 239 4171 4634 8534 218 -130 -1093 N \nATOM 1914 CA ILE A 239 -18.921 -10.253 -67.641 1.00 39.85 C \nANISOU 1914 CA ILE A 239 3423 3939 7777 151 -84 -1060 C \nATOM 1915 C ILE A 239 -18.750 -10.531 -69.089 1.00 43.78 C \nANISOU 1915 C ILE A 239 3882 4488 8264 150 -39 -1096 C \nATOM 1916 O ILE A 239 -19.319 -11.496 -69.550 1.00 46.63 O \nANISOU 1916 O ILE A 239 4193 4887 8637 192 -32 -1139 O \nATOM 1917 CB ILE A 239 -17.995 -11.114 -66.795 1.00 43.12 C \nANISOU 1917 CB ILE A 239 3803 4389 8192 124 -70 -1029 C \nATOM 1918 CG1 ILE A 239 -16.531 -10.986 -67.317 1.00 46.00 C \nANISOU 1918 CG1 ILE A 239 4158 4792 8527 65 -18 -999 C \nATOM 1919 CG2 ILE A 239 -18.414 -12.548 -66.830 1.00 44.21 C \nANISOU 1919 CG2 ILE A 239 3874 4579 8344 160 -65 -1065 C \nATOM 1920 CD1 ILE A 239 -15.506 -11.507 -66.367 1.00 44.54 C \nANISOU 1920 CD1 ILE A 239 3967 4622 8334 31 -6 -959 C \nATOM 1921 N ASN A 240 -17.985 -9.664 -69.819 1.00 45.25 N \nANISOU 1921 N ASN A 240 4089 4680 8424 103 -9 -1077 N \nATOM 1922 CA ASN A 240 -17.809 -9.804 -71.278 1.00 49.64 C \nANISOU 1922 CA ASN A 240 4613 5283 8966 99 34 -1109 C \nATOM 1923 C ASN A 240 -16.339 -10.095 -71.643 1.00 48.70 C \nANISOU 1923 C ASN A 240 4465 5219 8821 48 85 -1078 C \nATOM 1924 O ASN A 240 -15.433 -9.457 -71.161 1.00 50.16 O \nANISOU 1924 O ASN A 240 4678 5395 8987 10 90 -1030 O \nATOM 1925 CB ASN A 240 -18.237 -8.535 -72.008 1.00 58.76 C \nANISOU 1925 CB ASN A 240 5818 6404 10106 89 28 -1119 C \nATOM 1926 CG ASN A 240 -19.641 -8.064 -71.635 1.00 62.31 C \nANISOU 1926 CG ASN A 240 6319 6784 10573 134 -24 -1145 C \nATOM 1927 OD1 ASN A 240 -20.632 -8.406 -72.301 1.00 61.47 O \nANISOU 1927 OD1 ASN A 240 6204 6675 10477 186 -29 -1198 O \nATOM 1928 ND2 ASN A 240 -19.726 -7.281 -70.565 1.00 65.22 N \nANISOU 1928 ND2 ASN A 240 6746 7095 10941 117 -63 -1108 N \nATOM 1929 N PHE A 241 -16.109 -11.083 -72.475 1.00 46.56 N \nANISOU 1929 N PHE A 241 4140 5006 8546 51 123 -1106 N \nATOM 1930 CA PHE A 241 -14.771 -11.410 -72.916 1.00 38.07 C \nANISOU 1930 CA PHE A 241 3046 3977 7443 7 172 -1080 C \nATOM 1931 C PHE A 241 -14.710 -11.186 -74.400 1.00 41.17 C \nANISOU 1931 C PHE A 241 3421 4405 7816 0 207 -1106 C \nATOM 1932 O PHE A 241 -15.644 -11.575 -75.121 1.00 44.17 O \nANISOU 1932 O PHE A 241 3773 4801 8209 33 205 -1159 O \nATOM 1933 CB PHE A 241 -14.439 -12.895 -72.633 1.00 37.59 C \nANISOU 1933 CB PHE A 241 2939 3959 7385 3 190 -1087 C \nATOM 1934 CG PHE A 241 -14.320 -13.248 -71.167 1.00 37.37 C \nANISOU 1934 CG PHE A 241 2923 3905 7370 1 162 -1058 C \nATOM 1935 CD1 PHE A 241 -13.133 -12.995 -70.493 1.00 36.71 C \nANISOU 1935 CD1 PHE A 241 2873 3808 7267 -37 174 -1005 C \nATOM 1936 CD2 PHE A 241 -15.336 -13.825 -70.489 1.00 36.04 C \nANISOU 1936 CD2 PHE A 241 2735 3729 7229 39 125 -1083 C \nATOM 1937 CE1 PHE A 241 -13.020 -13.231 -69.165 1.00 35.93 C \nANISOU 1937 CE1 PHE A 241 2789 3684 7178 -41 149 -978 C \nATOM 1938 CE2 PHE A 241 -15.208 -14.152 -69.130 1.00 36.46 C \nANISOU 1938 CE2 PHE A 241 2799 3762 7293 33 99 -1055 C \nATOM 1939 CZ PHE A 241 -14.068 -13.834 -68.465 1.00 36.15 C \nANISOU 1939 CZ PHE A 241 2794 3704 7235 -9 110 -1003 C \nATOM 1940 N GLU A 242 -13.574 -10.669 -74.866 1.00 39.06 N \nANISOU 1940 N GLU A 242 3168 4158 7516 -38 240 -1071 N \nATOM 1941 CA GLU A 242 -13.317 -10.573 -76.259 1.00 42.07 C \nANISOU 1941 CA GLU A 242 3529 4582 7873 -51 279 -1090 C \nATOM 1942 C GLU A 242 -11.819 -10.776 -76.518 1.00 46.74 C \nANISOU 1942 C GLU A 242 4120 5210 8428 -87 323 -1048 C \nATOM 1943 O GLU A 242 -10.964 -10.143 -75.908 1.00 59.79 O \nANISOU 1943 O GLU A 242 5806 6849 10062 -104 323 -998 O \nATOM 1944 CB GLU A 242 -13.775 -9.185 -76.785 1.00 44.99 C \nANISOU 1944 CB GLU A 242 3932 4930 8232 -54 264 -1095 C \nATOM 1945 CG GLU A 242 -13.893 -9.135 -78.316 1.00 46.39 C \nANISOU 1945 CG GLU A 242 4085 5151 8392 -59 298 -1130 C \nATOM 1946 CD GLU A 242 -13.908 -7.759 -78.911 1.00 49.27 C \nANISOU 1946 CD GLU A 242 4482 5509 8730 -82 296 -1122 C \nATOM 1947 OE1 GLU A 242 -13.464 -7.649 -80.046 1.00 49.46 O \nANISOU 1947 OE1 GLU A 242 4486 5580 8726 -100 332 -1128 O \nATOM 1948 OE2 GLU A 242 -14.360 -6.808 -78.247 1.00 61.52 O \nANISOU 1948 OE2 GLU A 242 6078 7013 10285 -85 259 -1108 O \nATOM 1949 N SER A 243 -11.490 -11.605 -77.486 1.00 42.13 N \nANISOU 1949 N SER A 243 3502 4676 7830 -97 363 -1069 N \nATOM 1950 CA SER A 243 -10.104 -11.836 -77.807 1.00 38.21 C \nANISOU 1950 CA SER A 243 3014 4209 7295 -127 406 -1031 C \nATOM 1951 C SER A 243 -9.959 -12.519 -79.121 1.00 43.25 C \nANISOU 1951 C SER A 243 3617 4901 7915 -140 447 -1061 C \nATOM 1952 O SER A 243 -10.886 -13.286 -79.571 1.00 51.24 O \nANISOU 1952 O SER A 243 4587 5936 8947 -127 444 -1115 O \nATOM 1953 CB SER A 243 -9.460 -12.721 -76.769 1.00 35.93 C \nANISOU 1953 CB SER A 243 2737 3908 7007 -139 408 -1004 C \nATOM 1954 OG SER A 243 -8.095 -13.022 -77.110 1.00 32.44 O \nANISOU 1954 OG SER A 243 2315 3488 6522 -165 452 -969 O \nATOM 1955 N ASN A 244 -8.773 -12.283 -79.714 1.00 35.25 N \nANISOU 1955 N ASN A 244 2622 3911 6859 -162 484 -1026 N \nATOM 1956 CA ASN A 244 -8.436 -12.887 -80.976 1.00 38.02 C \nANISOU 1956 CA ASN A 244 2949 4313 7184 -180 527 -1045 C \nATOM 1957 C ASN A 244 -7.134 -13.576 -80.887 1.00 38.19 C \nANISOU 1957 C ASN A 244 2996 4344 7169 -206 562 -1006 C \nATOM 1958 O ASN A 244 -6.438 -13.821 -81.879 1.00 35.10 O \nANISOU 1958 O ASN A 244 2605 3988 6741 -224 601 -1000 O \nATOM 1959 CB ASN A 244 -8.443 -11.841 -82.064 1.00 38.34 C \nANISOU 1959 CB ASN A 244 2987 4378 7204 -180 538 -1048 C \nATOM 1960 CG ASN A 244 -7.328 -10.899 -81.932 1.00 32.83 C \nANISOU 1960 CG ASN A 244 2327 3678 6468 -185 549 -989 C \nATOM 1961 OD1 ASN A 244 -6.863 -10.605 -80.861 1.00 36.73 O \nANISOU 1961 OD1 ASN A 244 2853 4141 6962 -179 533 -949 O \nATOM 1962 ND2 ASN A 244 -6.856 -10.443 -83.050 1.00 33.11 N \nANISOU 1962 ND2 ASN A 244 2357 3755 6467 -195 578 -982 N \nATOM 1963 N GLY A 245 -6.794 -13.910 -79.660 1.00 41.56 N \nANISOU 1963 N GLY A 245 3451 4736 7605 -207 547 -980 N \nATOM 1964 CA GLY A 245 -5.561 -14.625 -79.450 1.00 53.88 C \nANISOU 1964 CA GLY A 245 5049 6295 9129 -231 580 -943 C \nATOM 1965 C GLY A 245 -5.043 -14.529 -78.032 1.00 53.82 C \nANISOU 1965 C GLY A 245 5086 6240 9124 -226 561 -902 C \nATOM 1966 O GLY A 245 -5.338 -13.620 -77.245 1.00 65.22 O \nANISOU 1966 O GLY A 245 6539 7655 10588 -203 527 -886 O \nATOM 1967 N ASN A 246 -4.223 -15.510 -77.752 1.00 50.95 N \nANISOU 1967 N ASN A 246 4754 5871 8735 -253 586 -886 N \nATOM 1968 CA ASN A 246 -3.601 -15.735 -76.467 1.00 43.44 C \nANISOU 1968 CA ASN A 246 3850 4877 7777 -257 578 -850 C \nATOM 1969 C ASN A 246 -4.447 -15.715 -75.260 1.00 38.67 C \nANISOU 1969 C ASN A 246 3229 4245 7218 -247 533 -861 C \nATOM 1970 O ASN A 246 -3.953 -15.451 -74.186 1.00 42.74 O \nANISOU 1970 O ASN A 246 3785 4724 7730 -240 520 -825 O \nATOM 1971 CB ASN A 246 -2.378 -14.837 -76.240 1.00 45.22 C \nANISOU 1971 CB ASN A 246 4136 5082 7964 -235 592 -792 C \nATOM 1972 CG ASN A 246 -1.609 -14.599 -77.490 1.00 47.18 C \nANISOU 1972 CG ASN A 246 4397 5361 8167 -232 632 -778 C \nATOM 1973 OD1 ASN A 246 -2.195 -14.492 -78.534 1.00 46.91 O \nANISOU 1973 OD1 ASN A 246 4319 5364 8141 -236 637 -809 O \nATOM 1974 ND2 ASN A 246 -0.289 -14.640 -77.403 1.00 49.47 N \nANISOU 1974 ND2 ASN A 246 4753 5637 8407 -226 662 -732 N \nATOM 1975 N PHE A 247 -5.707 -16.071 -75.399 1.00 42.85 N \nANISOU 1975 N PHE A 247 3701 4794 7787 -243 509 -910 N \nATOM 1976 CA PHE A 247 -6.674 -16.039 -74.322 1.00 44.25 C \nANISOU 1976 CA PHE A 247 3858 4947 8007 -226 462 -924 C \nATOM 1977 C PHE A 247 -6.724 -17.401 -73.626 1.00 49.11 C \nANISOU 1977 C PHE A 247 4464 5570 8624 -257 461 -937 C \nATOM 1978 O PHE A 247 -6.778 -18.466 -74.269 1.00 59.38 O \nANISOU 1978 O PHE A 247 5737 6915 9911 -288 486 -966 O \nATOM 1979 CB PHE A 247 -8.027 -15.785 -74.911 1.00 48.32 C \nANISOU 1979 CB PHE A 247 4320 5482 8558 -199 438 -974 C \nATOM 1980 CG PHE A 247 -9.135 -15.657 -73.882 1.00 52.93 C \nANISOU 1980 CG PHE A 247 4887 6038 9185 -171 386 -990 C \nATOM 1981 CD1 PHE A 247 -8.874 -15.211 -72.610 1.00 52.39 C \nANISOU 1981 CD1 PHE A 247 4857 5924 9126 -167 359 -952 C \nATOM 1982 CD2 PHE A 247 -10.436 -15.970 -74.208 1.00 49.30 C \nANISOU 1982 CD2 PHE A 247 4376 5600 8756 -144 364 -1042 C \nATOM 1983 CE1 PHE A 247 -9.893 -15.051 -71.705 1.00 53.39 C \nANISOU 1983 CE1 PHE A 247 4972 6024 9289 -140 311 -964 C \nATOM 1984 CE2 PHE A 247 -11.436 -15.845 -73.288 1.00 49.55 C \nANISOU 1984 CE2 PHE A 247 4399 5603 8823 -112 316 -1055 C \nATOM 1985 CZ PHE A 247 -11.173 -15.376 -72.039 1.00 50.46 C \nANISOU 1985 CZ PHE A 247 4555 5670 8947 -112 289 -1015 C \nATOM 1986 N ILE A 248 -6.679 -17.367 -72.311 1.00 41.62 N \nANISOU 1986 N ILE A 248 3540 4585 7689 -254 434 -914 N \nATOM 1987 CA ILE A 248 -6.776 -18.541 -71.522 1.00 39.00 C \nANISOU 1987 CA ILE A 248 3199 4261 7358 -285 429 -924 C \nATOM 1988 C ILE A 248 -8.146 -18.378 -70.881 1.00 39.66 C \nANISOU 1988 C ILE A 248 3237 4343 7491 -249 377 -952 C \nATOM 1989 O ILE A 248 -8.285 -17.807 -69.804 1.00 34.43 O \nANISOU 1989 O ILE A 248 2597 3638 6848 -231 343 -928 O \nATOM 1990 CB ILE A 248 -5.686 -18.644 -70.457 1.00 41.97 C \nANISOU 1990 CB ILE A 248 3642 4595 7709 -308 436 -876 C \nATOM 1991 CG1 ILE A 248 -4.289 -18.416 -71.016 1.00 48.08 C \nANISOU 1991 CG1 ILE A 248 4479 5355 8433 -321 482 -839 C \nATOM 1992 CG2 ILE A 248 -5.707 -20.005 -69.852 1.00 42.16 C \nANISOU 1992 CG2 ILE A 248 3658 4638 7724 -355 439 -890 C \nATOM 1993 CD1 ILE A 248 -3.914 -19.360 -72.144 1.00 52.08 C \nANISOU 1993 CD1 ILE A 248 4981 5901 8905 -361 525 -859 C \nATOM 1994 N ALA A 249 -9.176 -18.957 -71.549 1.00 41.78 N \nANISOU 1994 N ALA A 249 3439 4660 7776 -238 371 -1004 N \nATOM 1995 CA ALA A 249 -10.569 -18.780 -71.147 1.00 36.26 C \nANISOU 1995 CA ALA A 249 2697 3961 7120 -191 324 -1036 C \nATOM 1996 C ALA A 249 -10.965 -19.616 -69.948 1.00 41.65 C \nANISOU 1996 C ALA A 249 3361 4652 7814 -197 295 -1039 C \nATOM 1997 O ALA A 249 -10.430 -20.690 -69.725 1.00 42.35 O \nANISOU 1997 O ALA A 249 3444 4772 7875 -246 317 -1037 O \nATOM 1998 CB ALA A 249 -11.482 -19.134 -72.300 1.00 42.13 C \nANISOU 1998 CB ALA A 249 3378 4758 7869 -169 330 -1091 C \nATOM 1999 N PRO A 250 -11.932 -19.127 -69.174 1.00 39.14 N \nANISOU 1999 N PRO A 250 3035 4305 7532 -150 246 -1044 N \nATOM 2000 CA PRO A 250 -12.506 -19.848 -68.080 1.00 42.07 C \nANISOU 2000 CA PRO A 250 3379 4688 7916 -145 213 -1051 C \nATOM 2001 C PRO A 250 -13.527 -20.860 -68.522 1.00 49.15 C \nANISOU 2001 C PRO A 250 4197 5661 8818 -125 206 -1106 C \nATOM 2002 O PRO A 250 -14.063 -20.750 -69.597 1.00 46.91 O \nANISOU 2002 O PRO A 250 3881 5405 8537 -97 216 -1142 O \nATOM 2003 CB PRO A 250 -13.205 -18.762 -67.267 1.00 39.60 C \nANISOU 2003 CB PRO A 250 3095 4313 7639 -95 161 -1036 C \nATOM 2004 CG PRO A 250 -13.451 -17.663 -68.180 1.00 36.69 C \nANISOU 2004 CG PRO A 250 2744 3918 7279 -65 164 -1043 C \nATOM 2005 CD PRO A 250 -12.481 -17.778 -69.314 1.00 37.61 C \nANISOU 2005 CD PRO A 250 2865 4062 7364 -103 219 -1040 C \nATOM 2006 N GLU A 251 -13.689 -21.918 -67.727 1.00 62.69 N \nANISOU 2006 N GLU A 251 5877 7418 10524 -146 195 -1112 N \nATOM 2007 CA GLU A 251 -14.745 -22.903 -67.902 1.00 59.71 C \nANISOU 2007 CA GLU A 251 5415 7124 10148 -121 181 -1162 C \nATOM 2008 C GLU A 251 -15.501 -22.924 -66.620 1.00 56.47 C \nANISOU 2008 C GLU A 251 4996 6700 9762 -82 129 -1155 C \nATOM 2009 O GLU A 251 -16.708 -22.889 -66.627 1.00 60.79 O \nANISOU 2009 O GLU A 251 5500 7266 10330 -11 94 -1188 O \nATOM 2010 CB GLU A 251 -14.181 -24.285 -68.173 1.00 68.00 C \nANISOU 2010 CB GLU A 251 6425 8258 11153 -195 220 -1175 C \nATOM 2011 CG GLU A 251 -15.273 -25.335 -68.408 1.00 75.39 C \nANISOU 2011 CG GLU A 251 7261 9300 12082 -170 207 -1229 C \nATOM 2012 CD GLU A 251 -14.759 -26.679 -68.894 1.00 68.45 C \nANISOU 2012 CD GLU A 251 6338 8518 11151 -252 249 -1248 C \nATOM 2013 OE1 GLU A 251 -13.533 -26.851 -69.015 1.00 70.72 O \nANISOU 2013 OE1 GLU A 251 6682 8782 11408 -331 288 -1218 O \nATOM 2014 OE2 GLU A 251 -15.597 -27.539 -69.189 1.00 68.94 O \nANISOU 2014 OE2 GLU A 251 6313 8682 11201 -236 243 -1293 O \nATOM 2015 N TYR A 252 -14.780 -22.951 -65.508 1.00 51.10 N \nANISOU 2015 N TYR A 252 4358 5983 9074 -125 122 -1113 N \nATOM 2016 CA TYR A 252 -15.370 -23.029 -64.193 1.00 57.67 C \nANISOU 2016 CA TYR A 252 5185 6803 9924 -99 74 -1101 C \nATOM 2017 C TYR A 252 -15.126 -21.773 -63.343 1.00 59.95 C \nANISOU 2017 C TYR A 252 5551 6989 10237 -82 46 -1055 C \nATOM 2018 O TYR A 252 -14.056 -21.183 -63.379 1.00 66.96 O \nANISOU 2018 O TYR A 252 6501 7828 11115 -121 72 -1019 O \nATOM 2019 CB TYR A 252 -14.784 -24.219 -63.436 1.00 57.87 C \nANISOU 2019 CB TYR A 252 5191 6880 9916 -171 86 -1090 C \nATOM 2020 CG TYR A 252 -15.131 -25.533 -63.997 1.00 57.88 C \nANISOU 2020 CG TYR A 252 5110 6994 9887 -195 105 -1134 C \nATOM 2021 CD1 TYR A 252 -16.431 -26.057 -63.868 1.00 65.71 C \nANISOU 2021 CD1 TYR A 252 6020 8059 10890 -134 69 -1173 C \nATOM 2022 CD2 TYR A 252 -14.187 -26.283 -64.666 1.00 60.00 C \nANISOU 2022 CD2 TYR A 252 5381 7305 10113 -277 157 -1137 C \nATOM 2023 CE1 TYR A 252 -16.766 -27.288 -64.390 1.00 65.07 C \nANISOU 2023 CE1 TYR A 252 5851 8098 10774 -156 87 -1215 C \nATOM 2024 CE2 TYR A 252 -14.521 -27.510 -65.191 1.00 65.66 C \nANISOU 2024 CE2 TYR A 252 6018 8135 10796 -308 175 -1178 C \nATOM 2025 CZ TYR A 252 -15.805 -27.995 -65.051 1.00 68.28 C \nANISOU 2025 CZ TYR A 252 6259 8546 11137 -248 140 -1217 C \nATOM 2026 OH TYR A 252 -16.081 -29.221 -65.592 1.00 90.51 O \nANISOU 2026 OH TYR A 252 8990 11487 13912 -283 160 -1257 O \nATOM 2027 N ALA A 253 -16.143 -21.379 -62.595 1.00 58.13 N \nANISOU 2027 N ALA A 253 5317 6734 10037 -21 -7 -1056 N \nATOM 2028 CA ALA A 253 -16.053 -20.236 -61.712 1.00 57.79 C \nANISOU 2028 CA ALA A 253 5342 6601 10014 -7 -40 -1015 C \nATOM 2029 C ALA A 253 -16.433 -20.746 -60.361 1.00 52.62 C \nANISOU 2029 C ALA A 253 4673 5956 9364 -4 -79 -1002 C \nATOM 2030 O ALA A 253 -16.870 -21.849 -60.256 1.00 56.22 O \nANISOU 2030 O ALA A 253 5065 6487 9809 -2 -83 -1029 O \nATOM 2031 CB ALA A 253 -16.994 -19.125 -62.176 1.00 59.01 C \nANISOU 2031 CB ALA A 253 5519 6705 10197 63 -69 -1029 C \nATOM 2032 N TYR A 254 -16.319 -19.921 -59.352 1.00 51.59 N \nANISOU 2032 N TYR A 254 4600 5755 9247 -2 -110 -963 N \nATOM 2033 CA TYR A 254 -16.572 -20.311 -57.991 1.00 56.12 C \nANISOU 2033 CA TYR A 254 5169 6332 9823 -4 -148 -944 C \nATOM 2034 C TYR A 254 -17.611 -19.404 -57.354 1.00 62.18 C \nANISOU 2034 C TYR A 254 5965 7039 10621 62 -207 -935 C \nATOM 2035 O TYR A 254 -17.389 -18.210 -57.202 1.00 65.79 O \nANISOU 2035 O TYR A 254 6488 7421 11088 62 -217 -907 O \nATOM 2036 CB TYR A 254 -15.279 -20.214 -57.199 1.00 59.43 C \nANISOU 2036 CB TYR A 254 5639 6719 10222 -77 -127 -898 C \nATOM 2037 CG TYR A 254 -14.245 -21.218 -57.621 1.00 61.71 C \nANISOU 2037 CG TYR A 254 5912 7061 10474 -147 -73 -903 C \nATOM 2038 CD1 TYR A 254 -13.272 -20.891 -58.558 1.00 63.42 C \nANISOU 2038 CD1 TYR A 254 6163 7261 10674 -178 -23 -896 C \nATOM 2039 CD2 TYR A 254 -14.234 -22.497 -57.081 1.00 62.98 C \nANISOU 2039 CD2 TYR A 254 6029 7288 10613 -186 -71 -914 C \nATOM 2040 CE1 TYR A 254 -12.329 -21.814 -58.964 1.00 65.59 C \nANISOU 2040 CE1 TYR A 254 6435 7576 10911 -242 26 -900 C \nATOM 2041 CE2 TYR A 254 -13.296 -23.425 -57.466 1.00 63.16 C \nANISOU 2041 CE2 TYR A 254 6047 7354 10596 -259 -22 -918 C \nATOM 2042 CZ TYR A 254 -12.345 -23.083 -58.403 1.00 65.72 C \nANISOU 2042 CZ TYR A 254 6413 7653 10904 -286 27 -911 C \nATOM 2043 OH TYR A 254 -11.399 -23.987 -58.791 1.00 62.16 O \nANISOU 2043 OH TYR A 254 5971 7237 10410 -359 76 -914 O \nATOM 2044 N LYS A 255 -18.736 -19.982 -56.961 1.00 67.86 N \nANISOU 2044 N LYS A 255 6637 7795 11350 118 -247 -959 N \nATOM 2045 CA LYS A 255 -19.777 -19.262 -56.268 1.00 63.46 C \nANISOU 2045 CA LYS A 255 6113 7182 10818 184 -306 -950 C \nATOM 2046 C LYS A 255 -19.411 -19.134 -54.836 1.00 57.48 C \nANISOU 2046 C LYS A 255 5388 6393 10058 149 -333 -905 C \nATOM 2047 O LYS A 255 -19.010 -20.096 -54.240 1.00 61.55 O \nANISOU 2047 O LYS A 255 5866 6965 10557 109 -325 -900 O \nATOM 2048 CB LYS A 255 -21.026 -20.095 -56.297 1.00 68.69 C \nANISOU 2048 CB LYS A 255 6707 7908 11484 259 -337 -990 C \nATOM 2049 CG LYS A 255 -22.196 -19.441 -56.980 1.00 75.70 C \nANISOU 2049 CG LYS A 255 7613 8758 12392 351 -363 -1021 C \nATOM 2050 CD LYS A 255 -23.518 -20.052 -56.528 1.00 73.06 C \nANISOU 2050 CD LYS A 255 7233 8466 12062 442 -411 -1046 C \nATOM 2051 CE LYS A 255 -23.922 -21.251 -57.361 1.00 69.76 C \nANISOU 2051 CE LYS A 255 6715 8165 11627 473 -388 -1098 C \nATOM 2052 NZ LYS A 255 -25.139 -21.883 -56.789 1.00 67.71 N \nANISOU 2052 NZ LYS A 255 6405 7957 11364 564 -436 -1118 N \nATOM 2053 N ILE A 256 -19.587 -17.975 -54.247 1.00 57.07 N \nANISOU 2053 N ILE A 256 5407 6256 10021 162 -367 -874 N \nATOM 2054 CA ILE A 256 -19.239 -17.888 -52.850 1.00 61.63 C \nANISOU 2054 CA ILE A 256 6013 6809 10594 127 -393 -832 C \nATOM 2055 C ILE A 256 -20.413 -18.095 -51.872 1.00 71.73 C \nANISOU 2055 C ILE A 256 7282 8087 11886 187 -456 -831 C \nATOM 2056 O ILE A 256 -21.274 -17.237 -51.678 1.00 77.82 O \nANISOU 2056 O ILE A 256 8101 8794 12674 240 -500 -825 O \nATOM 2057 CB ILE A 256 -18.368 -16.668 -52.512 1.00 57.40 C \nANISOU 2057 CB ILE A 256 5556 6199 10056 79 -386 -787 C \nATOM 2058 CG1 ILE A 256 -18.972 -15.838 -51.404 1.00 57.83 C \nANISOU 2058 CG1 ILE A 256 5664 6189 10121 99 -444 -756 C \nATOM 2059 CG2 ILE A 256 -18.050 -15.871 -53.749 1.00 57.15 C \nANISOU 2059 CG2 ILE A 256 5549 6142 10023 76 -352 -798 C \nATOM 2060 CD1 ILE A 256 -18.569 -16.325 -50.044 1.00 57.48 C \nANISOU 2060 CD1 ILE A 256 5615 6158 10066 61 -460 -725 C \nATOM 2061 N VAL A 257 -20.372 -19.243 -51.222 1.00 80.33 N \nANISOU 2061 N VAL A 257 8314 9248 12962 171 -459 -834 N \nATOM 2062 CA VAL A 257 -21.277 -19.561 -50.130 1.00 83.26 C \nANISOU 2062 CA VAL A 257 8669 9629 13337 215 -516 -826 C \nATOM 2063 C VAL A 257 -20.553 -20.538 -49.221 1.00 88.38 C \nANISOU 2063 C VAL A 257 9280 10339 13961 146 -505 -808 C \nATOM 2064 O VAL A 257 -20.362 -21.694 -49.603 1.00104.19 O \nANISOU 2064 O VAL A 257 11211 12433 15944 123 -475 -836 O \nATOM 2065 CB VAL A 257 -22.623 -20.113 -50.648 1.00 80.34 C \nANISOU 2065 CB VAL A 257 8242 9310 12974 314 -543 -870 C \nATOM 2066 CG1 VAL A 257 -22.474 -21.407 -51.477 1.00 68.45 C \nANISOU 2066 CG1 VAL A 257 6641 7921 11448 303 -501 -913 C \nATOM 2067 CG2 VAL A 257 -23.592 -20.253 -49.477 1.00 79.74 C \nANISOU 2067 CG2 VAL A 257 8164 9233 12901 372 -607 -856 C \nATOM 2068 N LYS A 258 -20.120 -20.110 -48.038 1.00 87.02 N \nANISOU 2068 N LYS A 258 9156 10120 13786 106 -525 -765 N \nATOM 2069 CA LYS A 258 -20.544 -18.884 -47.395 1.00 86.21 C \nANISOU 2069 CA LYS A 258 9129 9925 13702 134 -571 -733 C \nATOM 2070 C LYS A 258 -19.381 -17.971 -47.013 1.00 81.73 C \nANISOU 2070 C LYS A 258 8632 9294 13129 61 -549 -691 C \nATOM 2071 O LYS A 258 -18.209 -18.327 -47.171 1.00 71.80 O \nANISOU 2071 O LYS A 258 7369 8061 11852 -7 -499 -686 O \nATOM 2072 CB LYS A 258 -21.289 -19.242 -46.127 1.00103.83 C \nANISOU 2072 CB LYS A 258 11347 12170 15933 163 -628 -716 C \nATOM 2073 CG LYS A 258 -20.374 -19.816 -45.058 1.00117.47 C \nANISOU 2073 CG LYS A 258 13065 13930 17638 81 -617 -687 C \nATOM 2074 CD LYS A 258 -21.139 -20.458 -43.920 1.00130.63 C \nANISOU 2074 CD LYS A 258 14696 15638 19298 109 -668 -678 C \nATOM 2075 CE LYS A 258 -21.647 -21.835 -44.323 1.00136.65 C \nANISOU 2075 CE LYS A 258 15358 16517 20046 137 -661 -719 C \nATOM 2076 NZ LYS A 258 -22.358 -22.529 -43.210 1.00137.33 N \nANISOU 2076 NZ LYS A 258 15400 16660 20119 163 -710 -710 N \nATOM 2077 N LYS A 259 -19.729 -16.778 -46.523 1.00 82.94 N \nANISOU 2077 N LYS A 259 8854 9366 13293 77 -588 -663 N \nATOM 2078 CA LYS A 259 -18.753 -15.806 -45.998 1.00 79.36 C \nANISOU 2078 CA LYS A 259 8466 8858 12829 14 -576 -620 C \nATOM 2079 C LYS A 259 -18.706 -15.786 -44.461 1.00 82.10 C \nANISOU 2079 C LYS A 259 8835 9193 13168 -13 -615 -582 C \nATOM 2080 O LYS A 259 -19.691 -15.423 -43.822 1.00 74.71 O \nANISOU 2080 O LYS A 259 7922 8222 12243 29 -672 -571 O \nATOM 2081 CB LYS A 259 -19.036 -14.393 -46.500 1.00 73.13 C \nANISOU 2081 CB LYS A 259 7743 7995 12049 31 -589 -611 C \nATOM 2082 CG LYS A 259 -18.521 -14.099 -47.880 1.00 75.57 C \nANISOU 2082 CG LYS A 259 8048 8308 12355 23 -538 -633 C \nATOM 2083 CD LYS A 259 -17.998 -12.677 -48.020 1.00 77.04 C \nANISOU 2083 CD LYS A 259 8302 8438 12532 -11 -531 -605 C \nATOM 2084 CE LYS A 259 -17.545 -12.356 -49.428 1.00 79.83 C \nANISOU 2084 CE LYS A 259 8650 8800 12880 -14 -483 -626 C \nATOM 2085 NZ LYS A 259 -18.702 -12.279 -50.377 1.00 89.80 N \nANISOU 2085 NZ LYS A 259 9907 10049 14162 49 -500 -665 N \nATOM 2086 N GLY A 260 -17.558 -16.163 -43.884 1.00 78.45 N \nANISOU 2086 N GLY A 260 8369 8754 12684 -83 -583 -562 N \nATOM 2087 CA GLY A 260 -17.359 -16.113 -42.431 1.00 78.02 C \nANISOU 2087 CA GLY A 260 8337 8688 12618 -117 -613 -525 C \nATOM 2088 C GLY A 260 -15.918 -15.835 -42.049 1.00 84.27 C \nANISOU 2088 C GLY A 260 9163 9471 13384 -192 -571 -497 C \nATOM 2089 O GLY A 260 -15.239 -15.060 -42.699 1.00 98.23 O \nANISOU 2089 O GLY A 260 10965 11213 15146 -207 -538 -491 O \nATOM 2090 N ASP A 261 -15.450 -16.462 -40.985 1.00 79.78 N \nANISOU 2090 N ASP A 261 8588 8928 12797 -235 -573 -480 N \nATOM 2091 CA ASP A 261 -14.109 -16.226 -40.519 1.00 79.06 C \nANISOU 2091 CA ASP A 261 8535 8827 12678 -299 -536 -454 C \nATOM 2092 C ASP A 261 -13.230 -17.330 -41.068 1.00 76.98 C \nANISOU 2092 C ASP A 261 8244 8612 12394 -336 -478 -477 C \nATOM 2093 O ASP A 261 -13.677 -18.460 -41.257 1.00 80.79 O \nANISOU 2093 O ASP A 261 8670 9148 12877 -331 -478 -505 O \nATOM 2094 CB ASP A 261 -14.050 -16.189 -38.981 1.00 83.16 C \nANISOU 2094 CB ASP A 261 9075 9338 13184 -331 -571 -420 C \nATOM 2095 CG ASP A 261 -14.497 -14.839 -38.382 1.00 87.72 C \nANISOU 2095 CG ASP A 261 9703 9857 13769 -318 -617 -387 C \nATOM 2096 OD1 ASP A 261 -14.271 -13.772 -39.013 1.00100.06 O \nANISOU 2096 OD1 ASP A 261 11302 11384 15333 -311 -605 -380 O \nATOM 2097 OD2 ASP A 261 -15.052 -14.837 -37.260 1.00 78.78 O \nANISOU 2097 OD2 ASP A 261 8578 8718 12638 -319 -666 -367 O \nATOM 2098 N SER A 262 -11.974 -16.996 -41.315 1.00 78.08 N \nANISOU 2098 N SER A 262 8423 8735 12509 -372 -428 -465 N \nATOM 2099 CA SER A 262 -10.982 -17.950 -41.746 1.00 76.25 C \nANISOU 2099 CA SER A 262 8186 8537 12250 -415 -370 -480 C \nATOM 2100 C SER A 262 -9.612 -17.259 -41.717 1.00 86.09 C \nANISOU 2100 C SER A 262 9495 9749 13465 -443 -327 -455 C \nATOM 2101 O SER A 262 -9.507 -16.039 -41.407 1.00 86.25 O \nANISOU 2101 O SER A 262 9551 9732 13487 -429 -343 -427 O \nATOM 2102 CB SER A 262 -11.305 -18.411 -43.179 1.00 75.29 C \nANISOU 2102 CB SER A 262 8023 8444 12140 -388 -344 -519 C \nATOM 2103 OG SER A 262 -10.160 -18.983 -43.798 1.00 92.70 O \nANISOU 2103 OG SER A 262 10244 10664 14314 -428 -281 -528 O \nATOM 2104 N ALA A 263 -8.565 -18.030 -42.028 1.00 76.62 N \nANISOU 2104 N ALA A 263 8313 8566 12234 -482 -272 -464 N \nATOM 2105 CA ALA A 263 -7.305 -17.440 -42.462 1.00 74.92 C \nANISOU 2105 CA ALA A 263 8152 8324 11990 -489 -222 -448 C \nATOM 2106 C ALA A 263 -6.552 -18.469 -43.245 1.00 65.56 C \nANISOU 2106 C ALA A 263 6972 7160 10777 -519 -166 -471 C \nATOM 2107 O ALA A 263 -7.095 -19.478 -43.614 1.00 57.73 O \nANISOU 2107 O ALA A 263 5934 6206 9793 -531 -167 -500 O \nATOM 2108 CB ALA A 263 -6.488 -16.906 -41.283 1.00 83.95 C \nANISOU 2108 CB ALA A 263 9350 9442 13105 -513 -223 -412 C \nATOM 2109 N ILE A 264 -5.289 -18.199 -43.512 1.00 70.16 N \nANISOU 2109 N ILE A 264 7613 7720 11325 -528 -117 -457 N \nATOM 2110 CA ILE A 264 -4.492 -19.112 -44.271 1.00 60.51 C \nANISOU 2110 CA ILE A 264 6412 6508 10071 -558 -62 -475 C \nATOM 2111 C ILE A 264 -3.210 -19.366 -43.475 1.00 63.34 C \nANISOU 2111 C ILE A 264 6847 6840 10379 -597 -28 -455 C \nATOM 2112 O ILE A 264 -2.294 -18.547 -43.444 1.00 80.47 O \nANISOU 2112 O ILE A 264 9071 8979 12524 -575 -4 -430 O \nATOM 2113 CB ILE A 264 -4.207 -18.557 -45.672 1.00 59.50 C \nANISOU 2113 CB ILE A 264 6286 6375 9946 -520 -29 -482 C \nATOM 2114 CG1 ILE A 264 -5.480 -18.595 -46.500 1.00 60.08 C \nANISOU 2114 CG1 ILE A 264 6286 6477 10064 -489 -57 -511 C \nATOM 2115 CG2 ILE A 264 -3.097 -19.360 -46.337 1.00 63.29 C \nANISOU 2115 CG2 ILE A 264 6812 6853 10381 -552 33 -491 C \nATOM 2116 CD1 ILE A 264 -5.396 -17.845 -47.808 1.00 56.13 C \nANISOU 2116 CD1 ILE A 264 5782 5973 9573 -448 -36 -516 C \nATOM 2117 N VAL A 265 -3.168 -20.528 -42.844 1.00 62.30 N \nANISOU 2117 N VAL A 265 6719 6726 10227 -655 -26 -466 N \nATOM 2118 CA VAL A 265 -2.062 -20.942 -42.000 1.00 57.68 C \nANISOU 2118 CA VAL A 265 6210 6116 9591 -702 3 -451 C \nATOM 2119 C VAL A 265 -0.969 -21.560 -42.842 1.00 55.21 C \nANISOU 2119 C VAL A 265 5959 5787 9232 -726 67 -461 C \nATOM 2120 O VAL A 265 -1.249 -22.319 -43.751 1.00 61.26 O \nANISOU 2120 O VAL A 265 6695 6581 10001 -746 83 -488 O \nATOM 2121 CB VAL A 265 -2.556 -21.941 -40.960 1.00 61.76 C \nANISOU 2121 CB VAL A 265 6703 6661 10102 -761 -25 -460 C \nATOM 2122 CG1 VAL A 265 -1.420 -22.400 -40.049 1.00 78.71 C \nANISOU 2122 CG1 VAL A 265 8936 8779 12193 -815 6 -447 C \nATOM 2123 CG2 VAL A 265 -3.658 -21.317 -40.128 1.00 46.03 C \nANISOU 2123 CG2 VAL A 265 4655 4682 8154 -732 -90 -448 C \nATOM 2124 N LYS A 266 0.270 -21.252 -42.501 1.00 58.51 N \nANISOU 2124 N LYS A 266 6466 6160 9605 -724 103 -440 N \nATOM 2125 CA LYS A 266 1.452 -21.787 -43.166 1.00 62.41 C \nANISOU 2125 CA LYS A 266 7041 6626 10046 -743 165 -444 C \nATOM 2126 C LYS A 266 2.050 -22.837 -42.282 1.00 67.29 C \nANISOU 2126 C LYS A 266 7725 7228 10615 -819 183 -447 C \nATOM 2127 O LYS A 266 3.161 -22.659 -41.777 1.00 80.18 O \nANISOU 2127 O LYS A 266 9451 8814 12200 -816 213 -429 O \nATOM 2128 CB LYS A 266 2.507 -20.682 -43.408 1.00 61.07 C \nANISOU 2128 CB LYS A 266 6937 6416 9851 -678 195 -416 C \nATOM 2129 CG LYS A 266 2.017 -19.484 -44.234 1.00 59.69 C \nANISOU 2129 CG LYS A 266 6703 6259 9717 -605 179 -409 C \nATOM 2130 CD LYS A 266 1.517 -19.920 -45.593 1.00 63.14 C \nANISOU 2130 CD LYS A 266 7094 6721 10176 -606 190 -435 C \nATOM 2131 CE LYS A 266 1.878 -18.947 -46.703 1.00 64.12 C \nANISOU 2131 CE LYS A 266 7219 6843 10301 -541 212 -425 C \nATOM 2132 NZ LYS A 266 2.112 -19.732 -47.983 1.00 72.18 N \nANISOU 2132 NZ LYS A 266 8249 7869 11306 -559 252 -448 N \nATOM 2133 N SER A 267 1.338 -23.955 -42.135 1.00 68.18 N \nANISOU 2133 N SER A 267 7790 7383 10733 -886 166 -472 N \nATOM 2134 CA SER A 267 1.812 -25.082 -41.307 1.00 70.62 C \nANISOU 2134 CA SER A 267 8156 7687 10990 -975 182 -480 C \nATOM 2135 C SER A 267 2.385 -26.205 -42.134 1.00 64.09 C \nANISOU 2135 C SER A 267 7379 6860 10114 -1040 231 -502 C \nATOM 2136 O SER A 267 1.987 -26.396 -43.259 1.00 62.87 O \nANISOU 2136 O SER A 267 7177 6735 9978 -1030 239 -519 O \nATOM 2137 CB SER A 267 0.666 -25.617 -40.446 1.00 77.06 C \nANISOU 2137 CB SER A 267 8886 8562 11833 -1017 129 -490 C \nATOM 2138 OG SER A 267 1.099 -26.724 -39.656 1.00 75.65 O \nANISOU 2138 OG SER A 267 8757 8387 11601 -1111 144 -498 O \nATOM 2139 N GLU A 268 3.317 -26.948 -41.554 1.00 76.69 N \nANISOU 2139 N GLU A 268 9075 8420 11645 -1108 264 -501 N \nATOM 2140 CA GLU A 268 3.776 -28.259 -42.102 1.00 78.90 C \nANISOU 2140 CA GLU A 268 9408 8704 11867 -1201 306 -524 C \nATOM 2141 C GLU A 268 3.167 -29.437 -41.313 1.00 65.46 C \nANISOU 2141 C GLU A 268 7663 7062 10146 -1306 283 -544 C \nATOM 2142 O GLU A 268 3.242 -30.575 -41.701 1.00 76.23 O \nANISOU 2142 O GLU A 268 9041 8457 11468 -1394 306 -567 O \nATOM 2143 CB GLU A 268 5.311 -28.337 -42.077 1.00 80.32 C \nANISOU 2143 CB GLU A 268 9747 8796 11974 -1213 364 -510 C \nATOM 2144 CG GLU A 268 5.884 -29.473 -42.923 1.00 93.52 C \nANISOU 2144 CG GLU A 268 11490 10458 13585 -1294 413 -530 C \nATOM 2145 CD GLU A 268 7.356 -29.787 -42.666 1.00104.33 C \nANISOU 2145 CD GLU A 268 13034 11736 14871 -1325 467 -519 C \nATOM 2146 OE1 GLU A 268 8.215 -29.196 -43.356 1.00115.65 O \nANISOU 2146 OE1 GLU A 268 14545 13110 16286 -1255 502 -503 O \nATOM 2147 OE2 GLU A 268 7.668 -30.656 -41.814 1.00101.80 O \nANISOU 2147 OE2 GLU A 268 12777 11403 14497 -1419 475 -526 O \nATOM 2148 N VAL A 269 2.573 -29.115 -40.188 1.00 58.68 N \nANISOU 2148 N VAL A 269 6754 6225 9317 -1295 237 -534 N \nATOM 2149 CA VAL A 269 2.003 -30.068 -39.267 1.00 52.79 C \nANISOU 2149 CA VAL A 269 5966 5539 8555 -1382 210 -547 C \nATOM 2150 C VAL A 269 0.796 -30.738 -39.906 1.00 58.31 C \nANISOU 2150 C VAL A 269 6536 6337 9282 -1404 183 -575 C \nATOM 2151 O VAL A 269 0.057 -30.151 -40.733 1.00 54.87 O \nANISOU 2151 O VAL A 269 6018 5926 8904 -1327 163 -579 O \nATOM 2152 CB VAL A 269 1.557 -29.346 -37.975 1.00 53.26 C \nANISOU 2152 CB VAL A 269 5991 5597 8648 -1344 161 -525 C \nATOM 2153 CG1 VAL A 269 0.755 -30.244 -37.069 1.00 53.55 C \nANISOU 2153 CG1 VAL A 269 5960 5710 8677 -1421 123 -537 C \nATOM 2154 CG2 VAL A 269 2.783 -28.791 -37.244 1.00 50.33 C \nANISOU 2154 CG2 VAL A 269 5747 5137 8238 -1330 189 -500 C \nATOM 2155 N GLU A 270 0.591 -31.992 -39.525 1.00 63.12 N \nANISOU 2155 N GLU A 270 7128 7010 9846 -1511 182 -595 N \nATOM 2156 CA GLU A 270 -0.495 -32.781 -40.080 1.00 64.78 C \nANISOU 2156 CA GLU A 270 7215 7329 10069 -1541 160 -624 C \nATOM 2157 C GLU A 270 -1.778 -32.662 -39.248 1.00 59.43 C \nANISOU 2157 C GLU A 270 6415 6726 9438 -1510 94 -623 C \nATOM 2158 O GLU A 270 -1.776 -32.179 -38.147 1.00 52.61 O \nANISOU 2158 O GLU A 270 5568 5834 8586 -1492 66 -601 O \nATOM 2159 CB GLU A 270 -0.069 -34.227 -40.197 1.00 78.85 C \nANISOU 2159 CB GLU A 270 9034 9155 11770 -1678 196 -648 C \nATOM 2160 CG GLU A 270 0.385 -34.853 -38.885 1.00 88.96 C \nANISOU 2160 CG GLU A 270 10377 10430 12993 -1774 196 -642 C \nATOM 2161 CD GLU A 270 0.715 -36.332 -39.032 1.00 96.21 C \nANISOU 2161 CD GLU A 270 11326 11404 13825 -1923 229 -668 C \nATOM 2162 OE1 GLU A 270 0.468 -36.889 -40.133 1.00 98.45 O \nANISOU 2162 OE1 GLU A 270 11566 11743 14097 -1950 246 -691 O \nATOM 2163 OE2 GLU A 270 1.206 -36.926 -38.043 1.00 97.59 O \nANISOU 2163 OE2 GLU A 270 11569 11570 13941 -2017 236 -665 O \nATOM 2164 N TYR A 271 -2.871 -33.121 -39.823 1.00 59.73 N \nANISOU 2164 N TYR A 271 6332 6862 9500 -1501 68 -648 N \nATOM 2165 CA TYR A 271 -4.164 -33.113 -39.163 1.00 64.96 C \nANISOU 2165 CA TYR A 271 6876 7605 10202 -1465 5 -650 C \nATOM 2166 C TYR A 271 -4.135 -34.170 -38.077 1.00 69.85 C \nANISOU 2166 C TYR A 271 7492 8286 10764 -1573 -4 -654 C \nATOM 2167 O TYR A 271 -3.299 -35.071 -38.108 1.00 84.65 O \nANISOU 2167 O TYR A 271 9436 10161 12566 -1684 40 -665 O \nATOM 2168 CB TYR A 271 -5.241 -33.428 -40.201 1.00 66.52 C \nANISOU 2168 CB TYR A 271 6953 7894 10428 -1425 -12 -679 C \nATOM 2169 CG TYR A 271 -6.650 -33.351 -39.708 1.00 68.43 C \nANISOU 2169 CG TYR A 271 7071 8216 10713 -1365 -77 -682 C \nATOM 2170 CD1 TYR A 271 -7.146 -32.203 -39.168 1.00 66.17 C \nANISOU 2170 CD1 TYR A 271 6776 7878 10488 -1267 -121 -657 C \nATOM 2171 CD2 TYR A 271 -7.501 -34.459 -39.801 1.00 81.40 C \nANISOU 2171 CD2 TYR A 271 8605 9993 12331 -1406 -95 -711 C \nATOM 2172 CE1 TYR A 271 -8.457 -32.129 -38.731 1.00 72.58 C \nANISOU 2172 CE1 TYR A 271 7484 8757 11337 -1206 -183 -659 C \nATOM 2173 CE2 TYR A 271 -8.821 -34.404 -39.353 1.00 81.95 C \nANISOU 2173 CE2 TYR A 271 8562 10140 12436 -1338 -157 -714 C \nATOM 2174 CZ TYR A 271 -9.297 -33.233 -38.826 1.00 78.09 C \nANISOU 2174 CZ TYR A 271 8076 9585 12010 -1236 -201 -687 C \nATOM 2175 OH TYR A 271 -10.598 -33.196 -38.384 1.00 79.93 O \nANISOU 2175 OH TYR A 271 8208 9887 12273 -1167 -262 -689 O \nATOM 2176 N GLY A 272 -5.032 -34.068 -37.114 1.00 73.80 N \nANISOU 2176 N GLY A 272 7915 8836 11289 -1547 -61 -645 N \nATOM 2177 CA GLY A 272 -5.002 -34.936 -35.928 1.00 69.27 C \nANISOU 2177 CA GLY A 272 7339 8318 10662 -1645 -74 -644 C \nATOM 2178 C GLY A 272 -6.353 -35.380 -35.412 1.00 70.02 C \nANISOU 2178 C GLY A 272 7296 8536 10773 -1628 -134 -653 C \nATOM 2179 O GLY A 272 -6.449 -35.877 -34.299 1.00 74.35 O \nANISOU 2179 O GLY A 272 7834 9129 11287 -1690 -156 -646 O \nATOM 2180 N ASN A 273 -7.408 -35.145 -36.187 1.00 70.57 N \nANISOU 2180 N ASN A 273 7262 8659 10892 -1538 -163 -666 N \nATOM 2181 CA ASN A 273 -8.790 -35.408 -35.748 1.00 75.95 C \nANISOU 2181 CA ASN A 273 7811 9451 11594 -1491 -225 -672 C \nATOM 2182 C ASN A 273 -9.156 -34.867 -34.350 1.00 84.47 C \nANISOU 2182 C ASN A 273 8891 10509 12697 -1459 -277 -640 C \nATOM 2183 O ASN A 273 -9.739 -35.581 -33.554 1.00 94.16 O \nANISOU 2183 O ASN A 273 10048 11833 13894 -1497 -311 -643 O \nATOM 2184 CB ASN A 273 -9.075 -36.889 -35.818 1.00 65.80 C \nANISOU 2184 CB ASN A 273 6448 8312 10241 -1592 -218 -703 C \nATOM 2185 CG ASN A 273 -8.754 -37.458 -37.182 1.00 69.52 C \nANISOU 2185 CG ASN A 273 6916 8814 10685 -1631 -168 -734 C \nATOM 2186 OD1 ASN A 273 -9.606 -37.531 -38.055 1.00 63.25 O \nANISOU 2186 OD1 ASN A 273 6026 8089 9917 -1565 -181 -756 O \nATOM 2187 ND2 ASN A 273 -7.498 -37.875 -37.373 1.00 73.34 N \nANISOU 2187 ND2 ASN A 273 7511 9243 11113 -1739 -109 -736 N \nATOM 2188 N CYS A 274 -8.852 -33.597 -34.095 1.00 95.11 N \nANISOU 2188 N CYS A 274 10309 11736 14093 -1387 -285 -611 N \nATOM 2189 CA CYS A 274 -9.098 -32.977 -32.787 1.00101.08 C \nANISOU 2189 CA CYS A 274 11078 12458 14869 -1360 -331 -578 C \nATOM 2190 C CYS A 274 -10.055 -31.799 -32.936 1.00100.52 C \nANISOU 2190 C CYS A 274 10968 12349 14875 -1224 -381 -563 C \nATOM 2191 O CYS A 274 -10.584 -31.574 -34.021 1.00 99.77 O \nANISOU 2191 O CYS A 274 10830 12264 14815 -1155 -380 -580 O \nATOM 2192 CB CYS A 274 -7.783 -32.544 -32.135 1.00 97.78 C \nANISOU 2192 CB CYS A 274 10791 11934 14426 -1413 -296 -555 C \nATOM 2193 SG CYS A 274 -6.427 -32.306 -33.293 1.00106.16 S \nANISOU 2193 SG CYS A 274 11964 12900 15472 -1433 -218 -564 S \nATOM 2194 N ASN A 275 -10.283 -31.085 -31.835 1.00105.51 N \nANISOU 2194 N ASN A 275 11619 12940 15529 -1192 -423 -530 N \nATOM 2195 CA ASN A 275 -11.075 -29.865 -31.834 1.00106.99 C \nANISOU 2195 CA ASN A 275 11794 13075 15782 -1076 -470 -510 C \nATOM 2196 C ASN A 275 -10.461 -28.800 -30.963 1.00110.59 C \nANISOU 2196 C ASN A 275 12338 13429 16250 -1071 -476 -473 C \nATOM 2197 O ASN A 275 -9.796 -29.117 -29.983 1.00115.54 O \nANISOU 2197 O ASN A 275 13011 14053 16838 -1147 -467 -460 O \nATOM 2198 CB ASN A 275 -12.469 -30.168 -31.285 1.00106.75 C \nANISOU 2198 CB ASN A 275 11664 13131 15766 -1026 -538 -509 C \nATOM 2199 CG ASN A 275 -13.392 -30.734 -32.332 1.00106.72 C \nANISOU 2199 CG ASN A 275 11563 13212 15773 -974 -545 -543 C \nATOM 2200 OD1 ASN A 275 -13.157 -30.588 -33.517 1.00114.55 O \nANISOU 2200 OD1 ASN A 275 12565 14181 16779 -953 -509 -563 O \nATOM 2201 ND2 ASN A 275 -14.448 -31.395 -31.895 1.00111.26 N \nANISOU 2201 ND2 ASN A 275 12044 13893 16337 -951 -592 -550 N \nATOM 2202 N THR A 276 -10.747 -27.547 -31.301 1.00106.71 N \nANISOU 2202 N THR A 276 11869 12865 15812 -982 -495 -457 N \nATOM 2203 CA THR A 276 -10.266 -26.395 -30.554 1.00110.92 C \nANISOU 2203 CA THR A 276 12477 13309 16358 -968 -504 -421 C \nATOM 2204 C THR A 276 -11.066 -25.157 -30.965 1.00119.45 C \nANISOU 2204 C THR A 276 13549 14341 17497 -865 -542 -407 C \nATOM 2205 O THR A 276 -11.732 -25.169 -31.991 1.00132.29 O \nANISOU 2205 O THR A 276 15128 15985 19151 -809 -546 -429 O \nATOM 2206 CB THR A 276 -8.763 -26.166 -30.790 1.00118.49 C \nANISOU 2206 CB THR A 276 13533 14202 17288 -1017 -438 -418 C \nATOM 2207 OG1 THR A 276 -8.327 -24.999 -30.086 1.00119.36 O \nANISOU 2207 OG1 THR A 276 13707 14237 17408 -996 -448 -384 O \nATOM 2208 CG2 THR A 276 -8.465 -25.968 -32.239 1.00121.37 C \nANISOU 2208 CG2 THR A 276 13906 14542 17667 -984 -396 -438 C \nATOM 2209 N LYS A 277 -11.031 -24.114 -30.146 1.00116.22 N \nANISOU 2209 N LYS A 277 13185 13872 17102 -846 -571 -373 N \nATOM 2210 CA LYS A 277 -11.515 -22.801 -30.548 1.00120.38 C \nANISOU 2210 CA LYS A 277 13728 14337 17674 -767 -596 -357 C \nATOM 2211 C LYS A 277 -10.305 -21.924 -30.814 1.00122.37 C \nANISOU 2211 C LYS A 277 14061 14518 17916 -780 -549 -344 C \nATOM 2212 O LYS A 277 -10.434 -20.765 -31.269 1.00141.67 O \nANISOU 2212 O LYS A 277 16529 16911 20389 -728 -557 -332 O \nATOM 2213 CB LYS A 277 -12.397 -22.181 -29.459 1.00131.30 C \nANISOU 2213 CB LYS A 277 15107 15708 19075 -735 -666 -326 C \nATOM 2214 CG LYS A 277 -13.143 -20.918 -29.894 1.00136.08 C \nANISOU 2214 CG LYS A 277 15725 16255 19723 -655 -701 -313 C \nATOM 2215 CD LYS A 277 -14.062 -20.289 -28.853 1.00134.46 C \nANISOU 2215 CD LYS A 277 15525 16032 19533 -625 -771 -281 C \nATOM 2216 CE LYS A 277 -14.674 -18.995 -29.362 1.00132.75 C \nANISOU 2216 CE LYS A 277 15339 15749 19350 -559 -799 -269 C \nATOM 2217 NZ LYS A 277 -15.210 -19.056 -30.756 1.00129.72 N \nANISOU 2217 NZ LYS A 277 14924 15369 18995 -499 -787 -301 N \nATOM 2218 N CYS A 278 -9.126 -22.474 -30.526 1.00102.99 N \nANISOU 2218 N CYS A 278 11650 12063 15417 -851 -500 -347 N \nATOM 2219 CA CYS A 278 -7.901 -21.769 -30.763 1.00110.57 C \nANISOU 2219 CA CYS A 278 12687 12965 16360 -859 -451 -336 C \nATOM 2220 C CYS A 278 -6.872 -22.678 -31.419 1.00106.15 C \nANISOU 2220 C CYS A 278 12158 12414 15762 -909 -384 -361 C \nATOM 2221 O CYS A 278 -6.509 -23.701 -30.845 1.00 96.51 O \nANISOU 2221 O CYS A 278 10943 11224 14501 -979 -370 -370 O \nATOM 2222 CB CYS A 278 -7.349 -21.221 -29.451 1.00112.60 C \nANISOU 2222 CB CYS A 278 12996 13192 16593 -889 -462 -304 C \nATOM 2223 SG CYS A 278 -5.847 -20.279 -29.757 1.00128.76 S \nANISOU 2223 SG CYS A 278 15133 15177 18613 -884 -403 -290 S \nATOM 2224 N GLN A 279 -6.375 -22.253 -32.590 1.00 90.49 N \nANISOU 2224 N GLN A 279 10197 10399 13785 -877 -343 -370 N \nATOM 2225 CA GLN A 279 -5.394 -23.014 -33.345 1.00 70.16 C \nANISOU 2225 CA GLN A 279 7660 7824 11173 -917 -279 -392 C \nATOM 2226 C GLN A 279 -4.196 -22.156 -33.716 1.00 70.50 C \nANISOU 2226 C GLN A 279 7784 7805 11198 -896 -232 -377 C \nATOM 2227 O GLN A 279 -4.352 -20.970 -34.005 1.00 70.87 O \nANISOU 2227 O GLN A 279 7831 7824 11274 -836 -246 -361 O \nATOM 2228 CB GLN A 279 -6.053 -23.547 -34.588 1.00 61.06 C \nANISOU 2228 CB GLN A 279 6446 6712 10044 -895 -274 -423 C \nATOM 2229 CG GLN A 279 -5.114 -24.275 -35.520 1.00 66.10 C \nANISOU 2229 CG GLN A 279 7122 7348 10645 -935 -208 -445 C \nATOM 2230 CD GLN A 279 -4.718 -25.662 -35.020 1.00 67.46 C \nANISOU 2230 CD GLN A 279 7307 7559 10765 -1030 -187 -461 C \nATOM 2231 OE1 GLN A 279 -5.573 -26.560 -34.897 1.00 57.52 O \nANISOU 2231 OE1 GLN A 279 5974 6374 9507 -1057 -214 -479 O \nATOM 2232 NE2 GLN A 279 -3.426 -25.861 -34.774 1.00 63.36 N \nANISOU 2232 NE2 GLN A 279 6883 6997 10195 -1080 -138 -455 N \nATOM 2233 N THR A 280 -3.005 -22.759 -33.708 1.00 67.94 N \nANISOU 2233 N THR A 280 7530 7461 10821 -947 -177 -384 N \nATOM 2234 CA THR A 280 -1.780 -22.059 -34.148 1.00 66.21 C \nANISOU 2234 CA THR A 280 7393 7188 10576 -920 -127 -372 C \nATOM 2235 C THR A 280 -1.168 -22.911 -35.223 1.00 65.95 C \nANISOU 2235 C THR A 280 7390 7153 10516 -946 -72 -397 C \nATOM 2236 O THR A 280 -1.597 -24.053 -35.410 1.00 68.56 O \nANISOU 2236 O THR A 280 7684 7527 10840 -998 -72 -422 O \nATOM 2237 CB THR A 280 -0.780 -21.773 -33.005 1.00 68.45 C \nANISOU 2237 CB THR A 280 7757 7435 10815 -942 -111 -349 C \nATOM 2238 OG1 THR A 280 0.358 -22.626 -33.103 1.00 78.64 O \nANISOU 2238 OG1 THR A 280 9130 8702 12047 -993 -54 -362 O \nATOM 2239 CG2 THR A 280 -1.418 -21.956 -31.644 1.00 67.25 C \nANISOU 2239 CG2 THR A 280 7575 7308 10668 -978 -162 -338 C \nATOM 2240 N PRO A 281 -0.176 -22.386 -35.946 1.00 67.43 N \nANISOU 2240 N PRO A 281 7641 7298 10682 -911 -24 -391 N \nATOM 2241 CA PRO A 281 0.483 -23.187 -36.982 1.00 76.31 C \nANISOU 2241 CA PRO A 281 8805 8413 11774 -937 30 -413 C \nATOM 2242 C PRO A 281 1.199 -24.448 -36.500 1.00 72.67 C \nANISOU 2242 C PRO A 281 8412 7946 11252 -1027 63 -426 C \nATOM 2243 O PRO A 281 1.245 -25.444 -37.230 1.00 77.93 O \nANISOU 2243 O PRO A 281 9080 8632 11899 -1076 90 -450 O \nATOM 2244 CB PRO A 281 1.531 -22.218 -37.555 1.00 79.36 C \nANISOU 2244 CB PRO A 281 9260 8750 12142 -875 71 -395 C \nATOM 2245 CG PRO A 281 0.960 -20.871 -37.314 1.00 75.33 C \nANISOU 2245 CG PRO A 281 8702 8246 11676 -807 29 -372 C \nATOM 2246 CD PRO A 281 0.320 -21.010 -35.953 1.00 72.37 C \nANISOU 2246 CD PRO A 281 8296 7888 11312 -843 -20 -364 C \nATOM 2247 N ILE A 282 1.743 -24.390 -35.290 1.00 62.42 N \nANISOU 2247 N ILE A 282 7172 6623 9922 -1053 62 -410 N \nATOM 2248 CA ILE A 282 2.472 -25.499 -34.740 1.00 59.39 C \nANISOU 2248 CA ILE A 282 6865 6225 9474 -1142 94 -421 C \nATOM 2249 C ILE A 282 1.639 -26.423 -33.816 1.00 66.02 C \nANISOU 2249 C ILE A 282 7647 7124 10315 -1221 54 -432 C \nATOM 2250 O ILE A 282 2.156 -27.429 -33.293 1.00 73.08 O \nANISOU 2250 O ILE A 282 8600 8016 11152 -1309 77 -443 O \nATOM 2251 CB ILE A 282 3.716 -25.019 -34.008 1.00 54.62 C \nANISOU 2251 CB ILE A 282 6375 5556 8821 -1129 126 -400 C \nATOM 2252 CG1 ILE A 282 3.369 -24.261 -32.753 1.00 58.19 C \nANISOU 2252 CG1 ILE A 282 6800 6016 9293 -1108 81 -378 C \nATOM 2253 CG2 ILE A 282 4.544 -24.171 -34.928 1.00 47.31 C \nANISOU 2253 CG2 ILE A 282 5503 4585 7888 -1048 165 -389 C \nATOM 2254 CD1 ILE A 282 4.570 -24.066 -31.842 1.00 59.57 C \nANISOU 2254 CD1 ILE A 282 7087 6138 9409 -1114 112 -363 C \nATOM 2255 N GLY A 283 0.370 -26.083 -33.615 1.00 59.19 N \nANISOU 2255 N GLY A 283 6671 6311 9508 -1189 -5 -429 N \nATOM 2256 CA GLY A 283 -0.527 -26.936 -32.861 1.00 63.79 C \nANISOU 2256 CA GLY A 283 7184 6960 10093 -1250 -46 -439 C \nATOM 2257 C GLY A 283 -1.716 -26.214 -32.271 1.00 60.97 C \nANISOU 2257 C GLY A 283 6737 6635 9795 -1197 -114 -423 C \nATOM 2258 O GLY A 283 -1.646 -25.043 -31.994 1.00 58.10 O \nANISOU 2258 O GLY A 283 6387 6232 9456 -1134 -130 -398 O \nATOM 2259 N ALA A 284 -2.793 -26.956 -32.044 1.00 58.75 N \nANISOU 2259 N ALA A 284 6367 6429 9528 -1225 -155 -437 N \nATOM 2260 CA ALA A 284 -3.955 -26.460 -31.356 1.00 62.80 C \nANISOU 2260 CA ALA A 284 6801 6974 10087 -1183 -222 -421 C \nATOM 2261 C ALA A 284 -3.724 -26.278 -29.840 1.00 68.65 C \nANISOU 2261 C ALA A 284 7576 7701 10806 -1216 -245 -397 C \nATOM 2262 O ALA A 284 -2.822 -26.869 -29.249 1.00 75.20 O \nANISOU 2262 O ALA A 284 8475 8516 11579 -1290 -213 -399 O \nATOM 2263 CB ALA A 284 -5.118 -27.398 -31.562 1.00 62.75 C \nANISOU 2263 CB ALA A 284 6691 7059 10094 -1199 -256 -444 C \nATOM 2264 N ILE A 285 -4.541 -25.435 -29.224 1.00 68.08 N \nANISOU 2264 N ILE A 285 7461 7630 10776 -1163 -302 -374 N \nATOM 2265 CA ILE A 285 -4.565 -25.346 -27.784 1.00 63.19 C \nANISOU 2265 CA ILE A 285 6856 7015 10141 -1196 -334 -352 C \nATOM 2266 C ILE A 285 -5.959 -25.299 -27.195 1.00 70.26 C \nANISOU 2266 C ILE A 285 7661 7962 11073 -1169 -406 -342 C \nATOM 2267 O ILE A 285 -6.659 -24.320 -27.334 1.00 75.74 O \nANISOU 2267 O ILE A 285 8327 8636 11813 -1095 -444 -326 O \nATOM 2268 CB ILE A 285 -3.649 -24.210 -27.213 1.00 61.11 C \nANISOU 2268 CB ILE A 285 6675 6678 9865 -1173 -318 -324 C \nATOM 2269 CG1 ILE A 285 -3.767 -24.190 -25.692 1.00 67.84 C \nANISOU 2269 CG1 ILE A 285 7533 7542 10700 -1212 -354 -303 C \nATOM 2270 CG2 ILE A 285 -3.913 -22.834 -27.756 1.00 53.13 C \nANISOU 2270 CG2 ILE A 285 5655 5630 8901 -1084 -334 -307 C \nATOM 2271 CD1 ILE A 285 -3.443 -25.539 -25.041 1.00 61.94 C \nANISOU 2271 CD1 ILE A 285 6802 6835 9899 -1311 -338 -320 C \nATOM 2272 N ASN A 286 -6.318 -26.376 -26.491 1.00 86.29 N \nANISOU 2272 N ASN A 286 9654 10059 13075 -1234 -425 -351 N \nATOM 2273 CA ASN A 286 -7.520 -26.457 -25.627 1.00 85.04 C \nANISOU 2273 CA ASN A 286 9420 9956 12936 -1219 -495 -337 C \nATOM 2274 C ASN A 286 -7.223 -26.058 -24.176 1.00 87.73 C \nANISOU 2274 C ASN A 286 9803 10274 13256 -1251 -518 -307 C \nATOM 2275 O ASN A 286 -6.992 -26.908 -23.334 1.00 85.43 O \nANISOU 2275 O ASN A 286 9515 10023 12920 -1330 -516 -310 O \nATOM 2276 CB ASN A 286 -8.086 -27.876 -25.654 1.00 87.31 C \nANISOU 2276 CB ASN A 286 9632 10344 13197 -1272 -504 -363 C \nATOM 2277 CG ASN A 286 -9.304 -28.043 -24.765 1.00 91.48 C \nANISOU 2277 CG ASN A 286 10082 10939 13739 -1253 -575 -349 C \nATOM 2278 OD1 ASN A 286 -9.930 -27.070 -24.337 1.00 99.33 O \nANISOU 2278 OD1 ASN A 286 11069 11899 14772 -1185 -623 -322 O \nATOM 2279 ND2 ASN A 286 -9.639 -29.289 -24.472 1.00 92.66 N \nANISOU 2279 ND2 ASN A 286 10171 11185 13849 -1314 -583 -366 N \nATOM 2280 N SER A 287 -7.228 -24.755 -23.899 1.00 97.61 N \nANISOU 2280 N SER A 287 11085 11464 14537 -1195 -538 -279 N \nATOM 2281 CA SER A 287 -6.993 -24.245 -22.542 1.00 98.51 C \nANISOU 2281 CA SER A 287 11237 11558 14633 -1219 -563 -249 C \nATOM 2282 C SER A 287 -7.959 -23.153 -22.147 1.00 93.21 C \nANISOU 2282 C SER A 287 10537 10870 14007 -1152 -627 -218 C \nATOM 2283 O SER A 287 -8.926 -22.883 -22.866 1.00 97.32 O \nANISOU 2283 O SER A 287 11007 11399 14573 -1086 -657 -222 O \nATOM 2284 CB SER A 287 -5.555 -23.759 -22.395 1.00100.23 C \nANISOU 2284 CB SER A 287 11554 11712 14816 -1244 -506 -243 C \nATOM 2285 OG SER A 287 -4.658 -24.861 -22.489 1.00102.60 O \nANISOU 2285 OG SER A 287 11895 12023 15064 -1320 -452 -268 O \nATOM 2286 N SER A 288 -7.726 -22.576 -20.970 1.00 90.86 N \nANISOU 2286 N SER A 288 10276 10553 13694 -1173 -648 -189 N \nATOM 2287 CA SER A 288 -8.536 -21.463 -20.477 1.00 90.14 C \nANISOU 2287 CA SER A 288 10173 10439 13636 -1121 -708 -157 C \nATOM 2288 C SER A 288 -7.709 -20.578 -19.569 1.00 86.64 C \nANISOU 2288 C SER A 288 9798 9955 13168 -1146 -699 -130 C \nATOM 2289 O SER A 288 -7.669 -20.805 -18.358 1.00 78.42 O \nANISOU 2289 O SER A 288 8765 8934 12099 -1194 -721 -114 O \nATOM 2290 CB SER A 288 -9.762 -21.970 -19.730 1.00 86.88 C \nANISOU 2290 CB SER A 288 9696 10081 13234 -1120 -775 -146 C \nATOM 2291 OG SER A 288 -10.593 -20.885 -19.380 1.00 90.75 O \nANISOU 2291 OG SER A 288 10185 10541 13756 -1066 -833 -115 O \nATOM 2292 N MET A 289 -7.062 -19.581 -20.178 1.00 84.63 N \nANISOU 2292 N MET A 289 9587 9649 12918 -1111 -667 -125 N \nATOM 2293 CA MET A 289 -6.124 -18.718 -19.488 1.00 92.29 C \nANISOU 2293 CA MET A 289 10621 10588 13857 -1127 -648 -105 C \nATOM 2294 C MET A 289 -5.928 -17.403 -20.245 1.00 88.04 C \nANISOU 2294 C MET A 289 10103 10010 13338 -1069 -637 -94 C \nATOM 2295 O MET A 289 -5.925 -17.365 -21.460 1.00 93.71 O \nANISOU 2295 O MET A 289 10810 10716 14078 -1029 -612 -111 O \nATOM 2296 CB MET A 289 -4.778 -19.448 -19.323 1.00 97.16 C \nANISOU 2296 CB MET A 289 11295 11201 14421 -1181 -581 -124 C \nATOM 2297 CG MET A 289 -4.666 -20.372 -18.111 1.00104.53 C \nANISOU 2297 CG MET A 289 12234 12167 15315 -1257 -591 -124 C \nATOM 2298 SD MET A 289 -2.963 -20.914 -17.759 1.00118.37 S \nANISOU 2298 SD MET A 289 14083 13896 16996 -1317 -513 -141 S \nATOM 2299 CE MET A 289 -3.299 -22.218 -16.592 1.00 84.04 C \nANISOU 2299 CE MET A 289 9715 9603 12615 -1410 -538 -147 C \nATOM 2300 N PRO A 290 -5.701 -16.314 -19.531 1.00 99.58 N \nANISOU 2300 N PRO A 290 11593 11457 14785 -1068 -653 -64 N \nATOM 2301 CA PRO A 290 -5.606 -15.011 -20.202 1.00101.79 C \nANISOU 2301 CA PRO A 290 11886 11712 15079 -1020 -648 -52 C \nATOM 2302 C PRO A 290 -4.386 -14.847 -21.091 1.00 93.72 C \nANISOU 2302 C PRO A 290 10902 10675 14034 -999 -576 -69 C \nATOM 2303 O PRO A 290 -4.354 -13.926 -21.936 1.00 90.07 O \nANISOU 2303 O PRO A 290 10439 10200 13585 -954 -567 -65 O \nATOM 2304 CB PRO A 290 -5.536 -14.015 -19.036 1.00 97.35 C \nANISOU 2304 CB PRO A 290 11347 11151 14493 -1040 -680 -17 C \nATOM 2305 CG PRO A 290 -4.977 -14.794 -17.914 1.00101.27 C \nANISOU 2305 CG PRO A 290 11864 11664 14949 -1097 -669 -18 C \nATOM 2306 CD PRO A 290 -5.469 -16.209 -18.085 1.00105.64 C \nANISOU 2306 CD PRO A 290 12383 12236 15518 -1117 -673 -42 C \nATOM 2307 N PHE A 291 -3.393 -15.714 -20.925 1.00 83.82 N \nANISOU 2307 N PHE A 291 9684 9422 12741 -1031 -525 -87 N \nATOM 2308 CA PHE A 291 -2.175 -15.582 -21.727 1.00 92.82 C \nANISOU 2308 CA PHE A 291 10872 10543 13853 -1006 -456 -101 C \nATOM 2309 C PHE A 291 -1.585 -16.905 -22.224 1.00 86.76 C \nANISOU 2309 C PHE A 291 10129 9770 13068 -1032 -406 -134 C \nATOM 2310 O PHE A 291 -1.903 -17.979 -21.712 1.00 79.72 O \nANISOU 2310 O PHE A 291 9225 8895 12171 -1084 -418 -145 O \nATOM 2311 CB PHE A 291 -1.129 -14.803 -20.945 1.00 95.55 C \nANISOU 2311 CB PHE A 291 11271 10886 14148 -1009 -432 -83 C \nATOM 2312 CG PHE A 291 -1.633 -13.485 -20.410 1.00100.24 C \nANISOU 2312 CG PHE A 291 11844 11494 14750 -996 -479 -51 C \nATOM 2313 CD1 PHE A 291 -2.119 -13.384 -19.120 1.00102.24 C \nANISOU 2313 CD1 PHE A 291 12088 11761 14996 -1037 -527 -30 C \nATOM 2314 CD2 PHE A 291 -1.639 -12.364 -21.203 1.00 98.70 C \nANISOU 2314 CD2 PHE A 291 11638 11299 14564 -948 -476 -41 C \nATOM 2315 CE1 PHE A 291 -2.573 -12.183 -18.611 1.00 99.30 C \nANISOU 2315 CE1 PHE A 291 11703 11401 14625 -1033 -571 1 C \nATOM 2316 CE2 PHE A 291 -2.092 -11.154 -20.709 1.00104.21 C \nANISOU 2316 CE2 PHE A 291 12321 12013 15262 -947 -519 -11 C \nATOM 2317 CZ PHE A 291 -2.560 -11.061 -19.411 1.00103.12 C \nANISOU 2317 CZ PHE A 291 12180 11886 15117 -991 -566 11 C \nATOM 2318 N HIS A 292 -0.760 -16.795 -23.269 1.00 85.13 N \nANISOU 2318 N HIS A 292 9955 9541 12848 -997 -350 -148 N \nATOM 2319 CA HIS A 292 0.023 -17.911 -23.794 1.00 74.70 C \nANISOU 2319 CA HIS A 292 8679 8206 11499 -1021 -293 -176 C \nATOM 2320 C HIS A 292 1.277 -17.376 -24.458 1.00 74.99 C \nANISOU 2320 C HIS A 292 8779 8213 11499 -975 -232 -178 C \nATOM 2321 O HIS A 292 1.379 -16.177 -24.731 1.00 92.07 O \nANISOU 2321 O HIS A 292 10933 10379 13669 -921 -235 -160 O \nATOM 2322 CB HIS A 292 -0.800 -18.772 -24.758 1.00 71.57 C \nANISOU 2322 CB HIS A 292 8227 7824 11141 -1026 -302 -200 C \nATOM 2323 CG HIS A 292 -0.938 -18.199 -26.137 1.00 80.33 C \nANISOU 2323 CG HIS A 292 9315 8925 12283 -963 -288 -206 C \nATOM 2324 ND1 HIS A 292 0.094 -18.181 -27.049 1.00 88.30 N \nANISOU 2324 ND1 HIS A 292 10376 9908 13266 -937 -227 -217 N \nATOM 2325 CD2 HIS A 292 -2.006 -17.674 -26.778 1.00 78.67 C \nANISOU 2325 CD2 HIS A 292 9040 8726 12126 -922 -328 -203 C \nATOM 2326 CE1 HIS A 292 -0.315 -17.638 -28.178 1.00 86.13 C \nANISOU 2326 CE1 HIS A 292 10063 9634 13027 -886 -229 -220 C \nATOM 2327 NE2 HIS A 292 -1.588 -17.320 -28.038 1.00 84.23 N \nANISOU 2327 NE2 HIS A 292 9753 9415 12835 -877 -289 -213 N \nATOM 2328 N ASN A 293 2.216 -18.272 -24.730 1.00 78.46 N \nANISOU 2328 N ASN A 293 9285 8629 11898 -999 -176 -199 N \nATOM 2329 CA ASN A 293 3.470 -17.935 -25.425 1.00 73.95 C \nANISOU 2329 CA ASN A 293 8786 8026 11287 -951 -113 -202 C \nATOM 2330 C ASN A 293 3.833 -18.940 -26.507 1.00 71.88 C \nANISOU 2330 C ASN A 293 8555 7741 11015 -963 -67 -230 C \nATOM 2331 O ASN A 293 5.004 -19.174 -26.781 1.00 76.37 O \nANISOU 2331 O ASN A 293 9211 8273 11532 -952 -10 -238 O \nATOM 2332 CB ASN A 293 4.600 -17.862 -24.431 1.00 78.74 C \nANISOU 2332 CB ASN A 293 9478 8613 11828 -961 -81 -196 C \nATOM 2333 CG ASN A 293 4.841 -19.180 -23.731 1.00 78.89 C \nANISOU 2333 CG ASN A 293 9546 8617 11812 -1043 -68 -214 C \nATOM 2334 OD1 ASN A 293 3.966 -20.053 -23.679 1.00 74.57 O \nANISOU 2334 OD1 ASN A 293 8950 8091 11293 -1101 -98 -226 O \nATOM 2335 ND2 ASN A 293 6.035 -19.323 -23.184 1.00 78.67 N \nANISOU 2335 ND2 ASN A 293 9617 8556 11718 -1049 -23 -217 N \nATOM 2336 N ILE A 294 2.810 -19.526 -27.115 1.00 66.79 N \nANISOU 2336 N ILE A 294 7841 7120 10418 -985 -94 -245 N \nATOM 2337 CA ILE A 294 2.960 -20.607 -28.065 1.00 67.29 C \nANISOU 2337 CA ILE A 294 7921 7174 10474 -1013 -59 -272 C \nATOM 2338 C ILE A 294 3.508 -20.122 -29.396 1.00 71.44 C \nANISOU 2338 C ILE A 294 8467 7678 11000 -948 -18 -275 C \nATOM 2339 O ILE A 294 4.574 -20.536 -29.835 1.00 75.26 O \nANISOU 2339 O ILE A 294 9034 8124 11436 -948 39 -285 O \nATOM 2340 CB ILE A 294 1.611 -21.292 -28.343 1.00 59.91 C \nANISOU 2340 CB ILE A 294 6890 6284 9589 -1045 -104 -287 C \nATOM 2341 CG1 ILE A 294 0.902 -21.715 -27.051 1.00 63.39 C \nANISOU 2341 CG1 ILE A 294 7295 6758 10034 -1102 -153 -281 C \nATOM 2342 CG2 ILE A 294 1.839 -22.500 -29.237 1.00 57.16 C \nANISOU 2342 CG2 ILE A 294 6560 5935 9222 -1088 -65 -317 C \nATOM 2343 CD1 ILE A 294 1.672 -22.713 -26.198 1.00 67.08 C \nANISOU 2343 CD1 ILE A 294 7835 7215 10439 -1183 -124 -291 C \nATOM 2344 N HIS A 295 2.748 -19.232 -30.023 1.00 75.43 N \nANISOU 2344 N HIS A 295 8899 8204 11557 -892 -49 -266 N \nATOM 2345 CA HIS A 295 3.066 -18.729 -31.358 1.00 75.63 C \nANISOU 2345 CA HIS A 295 8926 8219 11590 -832 -18 -269 C \nATOM 2346 C HIS A 295 2.308 -17.402 -31.618 1.00 65.51 C \nANISOU 2346 C HIS A 295 7573 6962 10355 -773 -59 -250 C \nATOM 2347 O HIS A 295 1.169 -17.265 -31.206 1.00 68.56 O \nANISOU 2347 O HIS A 295 7892 7372 10785 -787 -115 -245 O \nATOM 2348 CB HIS A 295 2.675 -19.795 -32.381 1.00 80.31 C \nANISOU 2348 CB HIS A 295 9495 8819 12200 -861 -4 -298 C \nATOM 2349 CG HIS A 295 3.227 -19.549 -33.753 1.00 81.22 C \nANISOU 2349 CG HIS A 295 9632 8917 12309 -812 40 -304 C \nATOM 2350 ND1 HIS A 295 2.532 -18.850 -34.715 1.00 79.21 N \nANISOU 2350 ND1 HIS A 295 9311 8684 12103 -761 21 -303 N \nATOM 2351 CD2 HIS A 295 4.412 -19.888 -34.310 1.00 83.84 C \nANISOU 2351 CD2 HIS A 295 10052 9212 12590 -804 101 -310 C \nATOM 2352 CE1 HIS A 295 3.269 -18.775 -35.808 1.00 85.33 C \nANISOU 2352 CE1 HIS A 295 10123 9440 12857 -726 69 -308 C \nATOM 2353 NE2 HIS A 295 4.417 -19.393 -35.588 1.00 83.03 N \nANISOU 2353 NE2 HIS A 295 9927 9113 12506 -749 118 -312 N \nATOM 2354 N PRO A 296 2.952 -16.429 -32.268 1.00 63.53 N \nANISOU 2354 N PRO A 296 7342 6706 10090 -710 -32 -237 N \nATOM 2355 CA PRO A 296 2.315 -15.135 -32.544 1.00 59.63 C \nANISOU 2355 CA PRO A 296 6789 6238 9631 -663 -67 -219 C \nATOM 2356 C PRO A 296 1.118 -15.270 -33.425 1.00 72.71 C \nANISOU 2356 C PRO A 296 8372 7907 11346 -661 -98 -234 C \nATOM 2357 O PRO A 296 0.039 -14.802 -33.079 1.00 63.59 O \nANISOU 2357 O PRO A 296 7161 6769 10232 -663 -153 -226 O \nATOM 2358 CB PRO A 296 3.406 -14.328 -33.263 1.00 59.87 C \nANISOU 2358 CB PRO A 296 6860 6267 9623 -600 -19 -209 C \nATOM 2359 CG PRO A 296 4.495 -15.303 -33.640 1.00 68.13 C \nANISOU 2359 CG PRO A 296 7985 7278 10623 -606 42 -225 C \nATOM 2360 CD PRO A 296 4.388 -16.449 -32.650 1.00 71.68 C \nANISOU 2360 CD PRO A 296 8462 7711 11064 -679 34 -237 C \nATOM 2361 N LEU A 297 1.329 -15.904 -34.577 1.00 93.56 N \nANISOU 2361 N LEU A 297 11019 10540 13989 -653 -62 -256 N \nATOM 2362 CA LEU A 297 0.274 -16.094 -35.584 1.00100.88 C \nANISOU 2362 CA LEU A 297 11880 11483 14969 -645 -83 -275 C \nATOM 2363 C LEU A 297 -0.768 -17.079 -35.115 1.00 95.42 C \nANISOU 2363 C LEU A 297 11142 10806 14308 -693 -123 -292 C \nATOM 2364 O LEU A 297 -0.686 -18.257 -35.391 1.00108.01 O \nANISOU 2364 O LEU A 297 12742 12404 15894 -730 -101 -315 O \nATOM 2365 CB LEU A 297 0.855 -16.568 -36.921 1.00106.16 C \nANISOU 2365 CB LEU A 297 12570 12143 15625 -629 -30 -294 C \nATOM 2366 CG LEU A 297 1.915 -15.664 -37.548 1.00104.81 C \nANISOU 2366 CG LEU A 297 12442 11962 15418 -573 12 -279 C \nATOM 2367 CD1 LEU A 297 2.692 -16.371 -38.656 1.00105.53 C \nANISOU 2367 CD1 LEU A 297 12577 12037 15484 -567 70 -297 C \nATOM 2368 CD2 LEU A 297 1.255 -14.404 -38.084 1.00105.71 C \nANISOU 2368 CD2 LEU A 297 12499 12100 15566 -527 -18 -267 C \nATOM 2369 N THR A 298 -1.755 -16.590 -34.399 1.00 88.42 N \nANISOU 2369 N THR A 298 10211 9932 13454 -692 -181 -279 N \nATOM 2370 CA THR A 298 -2.764 -17.453 -33.822 1.00 84.66 C \nANISOU 2370 CA THR A 298 9688 9476 13003 -729 -224 -291 C \nATOM 2371 C THR A 298 -4.057 -17.170 -34.520 1.00 76.19 C \nANISOU 2371 C THR A 298 8547 8418 11984 -694 -265 -300 C \nATOM 2372 O THR A 298 -4.187 -16.119 -35.129 1.00 92.79 O \nANISOU 2372 O THR A 298 10643 10509 14102 -649 -269 -291 O \nATOM 2373 CB THR A 298 -2.860 -17.145 -32.320 1.00 94.88 C \nANISOU 2373 CB THR A 298 10995 10770 14286 -755 -261 -266 C \nATOM 2374 OG1 THR A 298 -1.534 -17.192 -31.740 1.00 99.05 O \nANISOU 2374 OG1 THR A 298 11596 11280 14759 -776 -217 -256 O \nATOM 2375 CG2 THR A 298 -3.756 -18.125 -31.603 1.00 92.25 C \nANISOU 2375 CG2 THR A 298 10620 10463 13968 -796 -301 -275 C \nATOM 2376 N ILE A 299 -5.013 -18.090 -34.451 1.00 67.57 N \nANISOU 2376 N ILE A 299 7402 7354 10916 -711 -295 -319 N \nATOM 2377 CA ILE A 299 -6.295 -17.921 -35.125 1.00 67.16 C \nANISOU 2377 CA ILE A 299 7288 7316 10913 -670 -334 -332 C \nATOM 2378 C ILE A 299 -7.448 -18.445 -34.307 1.00 70.03 C \nANISOU 2378 C ILE A 299 7603 7708 11299 -679 -392 -334 C \nATOM 2379 O ILE A 299 -7.397 -19.545 -33.790 1.00 86.74 O \nANISOU 2379 O ILE A 299 9707 9856 13396 -724 -389 -345 O \nATOM 2380 CB ILE A 299 -6.310 -18.529 -36.571 1.00 79.67 C \nANISOU 2380 CB ILE A 299 8847 8918 12507 -655 -297 -366 C \nATOM 2381 CG1 ILE A 299 -6.969 -19.948 -36.656 1.00 80.81 C \nANISOU 2381 CG1 ILE A 299 8936 9111 12655 -683 -306 -396 C \nATOM 2382 CG2 ILE A 299 -4.904 -18.509 -37.209 1.00 80.12 C \nANISOU 2382 CG2 ILE A 299 8963 8954 12526 -665 -229 -367 C \nATOM 2383 CD1 ILE A 299 -8.342 -19.949 -37.288 1.00 79.81 C \nANISOU 2383 CD1 ILE A 299 8739 9011 12575 -634 -346 -415 C \nATOM 2384 N GLY A 300 -8.503 -17.660 -34.195 1.00 92.30 N \nANISOU 2384 N GLY A 300 10399 10518 14155 -636 -446 -322 N \nATOM 2385 CA GLY A 300 -9.695 -18.018 -33.409 1.00109.03 C \nANISOU 2385 CA GLY A 300 12474 12658 16293 -630 -508 -320 C \nATOM 2386 C GLY A 300 -9.876 -17.054 -32.240 1.00120.05 C \nANISOU 2386 C GLY A 300 13901 14024 17687 -634 -552 -282 C \nATOM 2387 O GLY A 300 -9.552 -15.866 -32.362 1.00112.54 O \nANISOU 2387 O GLY A 300 12986 13037 16735 -619 -548 -262 O \nATOM 2388 N GLU A 301 -10.412 -17.564 -31.126 1.00128.77 N \nANISOU 2388 N GLU A 301 14987 15151 18788 -655 -594 -272 N \nATOM 2389 CA GLU A 301 -10.445 -16.819 -29.854 1.00132.29 C \nANISOU 2389 CA GLU A 301 15466 15575 19224 -673 -632 -235 C \nATOM 2390 C GLU A 301 -9.419 -17.449 -28.911 1.00125.49 C \nANISOU 2390 C GLU A 301 14630 14731 18320 -739 -603 -229 C \nATOM 2391 O GLU A 301 -9.606 -18.528 -28.325 1.00 86.51 O \nANISOU 2391 O GLU A 301 9666 9834 13371 -773 -612 -237 O \nATOM 2392 CB GLU A 301 -11.833 -16.726 -29.202 1.00138.67 C \nANISOU 2392 CB GLU A 301 16245 16387 20057 -644 -706 -222 C \nATOM 2393 CG GLU A 301 -12.526 -15.380 -29.384 1.00129.17 C \nANISOU 2393 CG GLU A 301 15067 15135 18878 -601 -746 -202 C \nATOM 2394 CD GLU A 301 -13.875 -15.300 -28.681 1.00128.17 C \nANISOU 2394 CD GLU A 301 14926 15002 18770 -571 -821 -187 C \nATOM 2395 OE1 GLU A 301 -14.301 -16.286 -28.055 1.00126.39 O \nANISOU 2395 OE1 GLU A 301 14663 14818 18541 -578 -844 -192 O \nATOM 2396 OE2 GLU A 301 -14.526 -14.243 -28.755 1.00129.33 O \nANISOU 2396 OE2 GLU A 301 15104 15105 18932 -541 -858 -170 O \nATOM 2397 N CYS A 302 -8.323 -16.724 -28.783 1.00131.49 N \nANISOU 2397 N CYS A 302 15445 15463 19053 -755 -567 -213 N \nATOM 2398 CA CYS A 302 -7.128 -17.221 -28.159 1.00128.08 C \nANISOU 2398 CA CYS A 302 15053 15036 18575 -808 -524 -211 C \nATOM 2399 C CYS A 302 -6.589 -16.216 -27.158 1.00126.63 C \nANISOU 2399 C CYS A 302 14916 14832 18367 -822 -533 -178 C \nATOM 2400 O CYS A 302 -6.613 -14.999 -27.387 1.00138.89 O \nANISOU 2400 O CYS A 302 16483 16364 19927 -791 -542 -160 O \nATOM 2401 CB CYS A 302 -6.066 -17.458 -29.229 1.00123.06 C \nANISOU 2401 CB CYS A 302 14446 14391 17920 -805 -454 -232 C \nATOM 2402 SG CYS A 302 -6.661 -18.568 -30.492 1.00111.20 S \nANISOU 2402 SG CYS A 302 12889 12919 16444 -792 -440 -272 S \nATOM 2403 N PRO A 303 -6.084 -16.725 -26.041 1.00111.50 N \nANISOU 2403 N PRO A 303 13022 12926 16415 -873 -529 -170 N \nATOM 2404 CA PRO A 303 -5.336 -15.916 -25.102 1.00103.03 C \nANISOU 2404 CA PRO A 303 11997 11840 15308 -892 -525 -143 C \nATOM 2405 C PRO A 303 -4.352 -14.959 -25.754 1.00 91.01 C \nANISOU 2405 C PRO A 303 10515 10298 13766 -861 -479 -138 C \nATOM 2406 O PRO A 303 -3.849 -15.209 -26.846 1.00100.17 O \nANISOU 2406 O PRO A 303 11683 11451 14925 -839 -432 -158 O \nATOM 2407 CB PRO A 303 -4.566 -16.973 -24.280 1.00107.86 C \nANISOU 2407 CB PRO A 303 12639 12465 15877 -952 -497 -152 C \nATOM 2408 CG PRO A 303 -5.073 -18.317 -24.705 1.00101.31 C \nANISOU 2408 CG PRO A 303 11770 11663 15061 -972 -496 -180 C \nATOM 2409 CD PRO A 303 -6.284 -18.096 -25.548 1.00102.14 C \nANISOU 2409 CD PRO A 303 11815 11775 15220 -920 -534 -187 C \nATOM 2410 N LYS A 304 -4.035 -13.893 -25.055 1.00 95.49 N \nANISOU 2410 N LYS A 304 11108 10863 14312 -861 -491 -110 N \nATOM 2411 CA LYS A 304 -3.070 -12.950 -25.572 1.00101.37 C \nANISOU 2411 CA LYS A 304 11884 11602 15029 -830 -448 -102 C \nATOM 2412 C LYS A 304 -1.712 -13.603 -25.657 1.00 92.08 C \nANISOU 2412 C LYS A 304 10759 10420 13807 -838 -380 -118 C \nATOM 2413 O LYS A 304 -1.123 -13.955 -24.651 1.00 98.42 O \nANISOU 2413 O LYS A 304 11597 11224 14573 -873 -370 -113 O \nATOM 2414 CB LYS A 304 -2.969 -11.731 -24.655 1.00112.03 C \nANISOU 2414 CB LYS A 304 13247 12963 16355 -838 -475 -69 C \nATOM 2415 CG LYS A 304 -4.229 -10.895 -24.547 1.00119.17 C \nANISOU 2415 CG LYS A 304 14119 13867 17295 -833 -541 -49 C \nATOM 2416 CD LYS A 304 -3.872 -9.472 -24.157 1.00111.34 C \nANISOU 2416 CD LYS A 304 13142 12891 16269 -834 -548 -20 C \nATOM 2417 CE LYS A 304 -3.085 -8.787 -25.242 1.00108.28 C \nANISOU 2417 CE LYS A 304 12762 12515 15863 -793 -499 -26 C \nATOM 2418 NZ LYS A 304 -3.592 -8.995 -26.631 1.00103.98 N \nANISOU 2418 NZ LYS A 304 12193 11954 15361 -758 -492 -47 N \nATOM 2419 N TYR A 305 -1.213 -13.752 -26.865 1.00 89.80 N \nANISOU 2419 N TYR A 305 10480 10122 13519 -805 -334 -136 N \nATOM 2420 CA TYR A 305 0.165 -14.136 -27.036 1.00 90.75 C \nANISOU 2420 CA TYR A 305 10662 10229 13588 -801 -268 -146 C \nATOM 2421 C TYR A 305 1.089 -13.134 -26.317 1.00 88.28 C \nANISOU 2421 C TYR A 305 10391 9927 13226 -784 -252 -123 C \nATOM 2422 O TYR A 305 1.000 -11.911 -26.508 1.00 70.95 O \nANISOU 2422 O TYR A 305 8175 7751 11032 -751 -265 -103 O \nATOM 2423 CB TYR A 305 0.537 -14.232 -28.514 1.00 83.42 C \nANISOU 2423 CB TYR A 305 9739 9291 12667 -759 -224 -165 C \nATOM 2424 CG TYR A 305 1.994 -14.599 -28.743 1.00 94.26 C \nANISOU 2424 CG TYR A 305 11188 10644 13983 -747 -154 -173 C \nATOM 2425 CD1 TYR A 305 2.469 -15.862 -28.461 1.00 94.59 C \nANISOU 2425 CD1 TYR A 305 11276 10665 13999 -793 -125 -193 C \nATOM 2426 CD2 TYR A 305 2.904 -13.668 -29.221 1.00 93.00 C \nANISOU 2426 CD2 TYR A 305 11057 10488 13790 -691 -117 -162 C \nATOM 2427 CE1 TYR A 305 3.799 -16.186 -28.657 1.00 95.03 C \nANISOU 2427 CE1 TYR A 305 11416 10693 13998 -780 -62 -200 C \nATOM 2428 CE2 TYR A 305 4.230 -14.003 -29.424 1.00 93.58 C \nANISOU 2428 CE2 TYR A 305 11208 10540 13808 -670 -55 -169 C \nATOM 2429 CZ TYR A 305 4.671 -15.266 -29.135 1.00 91.25 C \nANISOU 2429 CZ TYR A 305 10969 10213 13489 -715 -27 -188 C \nATOM 2430 OH TYR A 305 5.990 -15.602 -29.328 1.00 98.63 O \nANISOU 2430 OH TYR A 305 11994 11116 14364 -693 35 -195 O \nATOM 2431 N VAL A 306 1.988 -13.666 -25.502 1.00 83.77 N \nANISOU 2431 N VAL A 306 9876 9344 12606 -809 -222 -125 N \nATOM 2432 CA VAL A 306 2.998 -12.830 -24.832 1.00 86.02 C \nANISOU 2432 CA VAL A 306 10205 9642 12835 -787 -199 -107 C \nATOM 2433 C VAL A 306 4.327 -13.523 -24.898 1.00 78.09 C \nANISOU 2433 C VAL A 306 9284 8610 11776 -778 -132 -123 C \nATOM 2434 O VAL A 306 4.339 -14.715 -25.029 1.00 70.10 O \nANISOU 2434 O VAL A 306 8298 7571 10767 -816 -117 -145 O \nATOM 2435 CB VAL A 306 2.620 -12.566 -23.373 1.00 82.01 C \nANISOU 2435 CB VAL A 306 9688 9153 12319 -831 -244 -87 C \nATOM 2436 CG1 VAL A 306 1.948 -11.210 -23.287 1.00 82.21 C \nANISOU 2436 CG1 VAL A 306 9661 9211 12362 -814 -290 -60 C \nATOM 2437 CG2 VAL A 306 1.700 -13.663 -22.857 1.00 74.92 C \nANISOU 2437 CG2 VAL A 306 8766 8244 11455 -893 -282 -98 C \nATOM 2438 N LYS A 307 5.429 -12.777 -24.826 1.00 85.48 N \nANISOU 2438 N LYS A 307 10265 9556 12658 -728 -94 -113 N \nATOM 2439 CA LYS A 307 6.756 -13.394 -24.882 1.00109.72 C \nANISOU 2439 CA LYS A 307 13429 12591 15668 -709 -28 -127 C \nATOM 2440 C LYS A 307 7.455 -13.578 -23.524 1.00115.46 C \nANISOU 2440 C LYS A 307 14217 13312 16339 -734 -17 -124 C \nATOM 2441 O LYS A 307 8.682 -13.614 -23.450 1.00128.40 O \nANISOU 2441 O LYS A 307 15938 14932 17916 -696 36 -129 O \nATOM 2442 CB LYS A 307 7.646 -12.663 -25.878 1.00119.75 C \nANISOU 2442 CB LYS A 307 14723 13870 16907 -624 18 -123 C \nATOM 2443 CG LYS A 307 8.104 -11.269 -25.491 1.00125.41 C \nANISOU 2443 CG LYS A 307 15424 14641 17587 -570 17 -98 C \nATOM 2444 CD LYS A 307 8.981 -10.688 -26.613 1.00128.83 C \nANISOU 2444 CD LYS A 307 15875 15087 17986 -483 65 -96 C \nATOM 2445 CE LYS A 307 8.657 -11.278 -27.993 1.00128.34 C \nANISOU 2445 CE LYS A 307 15804 14994 17966 -477 79 -113 C \nATOM 2446 NZ LYS A 307 9.478 -10.727 -29.097 1.00133.54 N \nANISOU 2446 NZ LYS A 307 16480 15667 18592 -393 124 -109 N \nATOM 2447 N SER A 308 6.661 -13.719 -22.466 1.00119.82 N \nANISOU 2447 N SER A 308 14733 13879 16913 -797 -68 -117 N \nATOM 2448 CA SER A 308 7.170 -14.063 -21.134 1.00118.98 C \nANISOU 2448 CA SER A 308 14681 13766 16760 -837 -63 -117 C \nATOM 2449 C SER A 308 7.286 -15.571 -21.012 1.00114.54 C \nANISOU 2449 C SER A 308 14173 13159 16190 -901 -43 -143 C \nATOM 2450 O SER A 308 6.573 -16.299 -21.699 1.00102.28 O \nANISOU 2450 O SER A 308 12584 11596 14681 -932 -56 -156 O \nATOM 2451 CB SER A 308 6.215 -13.577 -20.032 1.00116.36 C \nANISOU 2451 CB SER A 308 14284 13473 16453 -883 -129 -95 C \nATOM 2452 OG SER A 308 6.083 -12.163 -19.989 1.00113.72 O \nANISOU 2452 OG SER A 308 13905 13186 16119 -840 -151 -70 O \nATOM 2453 N ASN A 309 8.175 -16.027 -20.132 1.00111.05 N \nANISOU 2453 N ASN A 309 13815 12693 15686 -925 -12 -151 N \nATOM 2454 CA ASN A 309 8.284 -17.448 -19.804 1.00108.84 C \nANISOU 2454 CA ASN A 309 13591 12375 15387 -1004 4 -175 C \nATOM 2455 C ASN A 309 7.434 -17.839 -18.609 1.00106.84 C \nANISOU 2455 C ASN A 309 13293 12149 15152 -1086 -50 -169 C \nATOM 2456 O ASN A 309 7.103 -19.005 -18.442 1.00102.13 O \nANISOU 2456 O ASN A 309 12704 11542 14557 -1162 -55 -187 O \nATOM 2457 CB ASN A 309 9.735 -17.831 -19.538 1.00112.47 C \nANISOU 2457 CB ASN A 309 14182 12786 15766 -990 70 -189 C \nATOM 2458 CG ASN A 309 10.563 -17.856 -20.808 1.00117.97 C \nANISOU 2458 CG ASN A 309 14937 13444 16441 -922 126 -200 C \nATOM 2459 OD1 ASN A 309 10.080 -18.256 -21.868 1.00114.97 O \nANISOU 2459 OD1 ASN A 309 14524 13059 16103 -928 125 -209 O \nATOM 2460 ND2 ASN A 309 11.812 -17.425 -20.708 1.00119.27 N \nANISOU 2460 ND2 ASN A 309 15193 13585 16539 -854 176 -199 N \nATOM 2461 N LYS A 310 7.076 -16.850 -17.792 1.00106.86 N \nANISOU 2461 N LYS A 310 13248 12192 15163 -1073 -90 -144 N \nATOM 2462 CA LYS A 310 6.392 -17.094 -16.533 1.00 96.59 C \nANISOU 2462 CA LYS A 310 11914 10918 13868 -1144 -139 -135 C \nATOM 2463 C LYS A 310 5.407 -15.969 -16.201 1.00 92.84 C \nANISOU 2463 C LYS A 310 11347 10491 13438 -1127 -203 -104 C \nATOM 2464 O LYS A 310 5.783 -14.792 -16.123 1.00 99.10 O \nANISOU 2464 O LYS A 310 12136 11304 14214 -1073 -199 -86 O \nATOM 2465 CB LYS A 310 7.440 -17.224 -15.425 1.00 92.66 C \nANISOU 2465 CB LYS A 310 11506 10406 13297 -1164 -107 -139 C \nATOM 2466 CG LYS A 310 6.876 -17.598 -14.065 1.00 92.37 C \nANISOU 2466 CG LYS A 310 11447 10393 13255 -1246 -151 -132 C \nATOM 2467 CD LYS A 310 7.883 -17.328 -12.964 1.00 90.73 C \nANISOU 2467 CD LYS A 310 11315 10180 12976 -1247 -123 -132 C \nATOM 2468 CE LYS A 310 7.291 -17.636 -11.599 1.00 92.94 C \nANISOU 2468 CE LYS A 310 11569 10490 13252 -1330 -170 -122 C \nATOM 2469 NZ LYS A 310 8.365 -17.762 -10.577 1.00 99.72 N \nANISOU 2469 NZ LYS A 310 12521 11333 14033 -1347 -132 -132 N \nATOM 2470 N LEU A 311 4.146 -16.338 -16.008 1.00 82.10 N \nANISOU 2470 N LEU A 311 9914 9150 12129 -1174 -262 -98 N \nATOM 2471 CA LEU A 311 3.168 -15.436 -15.394 1.00 89.21 C \nANISOU 2471 CA LEU A 311 10745 10089 13063 -1176 -328 -68 C \nATOM 2472 C LEU A 311 2.412 -16.186 -14.318 1.00 83.57 C \nANISOU 2472 C LEU A 311 10006 9392 12356 -1253 -375 -64 C \nATOM 2473 O LEU A 311 1.434 -16.894 -14.621 1.00 80.67 O \nANISOU 2473 O LEU A 311 9586 9031 12032 -1278 -408 -70 O \nATOM 2474 CB LEU A 311 2.165 -14.865 -16.420 1.00 91.12 C \nANISOU 2474 CB LEU A 311 10913 10339 13369 -1134 -363 -58 C \nATOM 2475 CG LEU A 311 2.749 -13.921 -17.487 1.00 97.61 C \nANISOU 2475 CG LEU A 311 11744 11157 14188 -1058 -327 -56 C \nATOM 2476 CD1 LEU A 311 1.668 -13.494 -18.476 1.00 95.96 C \nANISOU 2476 CD1 LEU A 311 11466 10954 14043 -1029 -364 -50 C \nATOM 2477 CD2 LEU A 311 3.427 -12.695 -16.883 1.00 98.30 C \nANISOU 2477 CD2 LEU A 311 11849 11271 14229 -1029 -319 -35 C \nATOM 2478 N VAL A 312 2.837 -15.988 -13.066 1.00 77.68 N \nANISOU 2478 N VAL A 312 9291 8659 11565 -1286 -379 -53 N \nATOM 2479 CA VAL A 312 2.205 -16.662 -11.906 1.00 74.76 C \nANISOU 2479 CA VAL A 312 8902 8310 11193 -1362 -423 -47 C \nATOM 2480 C VAL A 312 1.733 -15.693 -10.799 1.00 73.97 C \nANISOU 2480 C VAL A 312 8771 8243 11090 -1374 -476 -13 C \nATOM 2481 O VAL A 312 2.517 -14.946 -10.218 1.00 75.48 O \nANISOU 2481 O VAL A 312 9000 8443 11237 -1361 -455 -4 O \nATOM 2482 CB VAL A 312 3.152 -17.706 -11.296 1.00 64.21 C \nANISOU 2482 CB VAL A 312 7644 6957 9796 -1418 -376 -71 C \nATOM 2483 CG1 VAL A 312 2.491 -18.404 -10.130 1.00 58.70 C \nANISOU 2483 CG1 VAL A 312 6920 6289 9094 -1500 -422 -65 C \nATOM 2484 CG2 VAL A 312 3.541 -18.723 -12.355 1.00 58.96 C \nANISOU 2484 CG2 VAL A 312 7013 6260 9130 -1420 -328 -104 C \nATOM 2485 N LEU A 313 0.447 -15.742 -10.505 1.00 69.16 N \nANISOU 2485 N LEU A 313 8095 7657 10526 -1397 -544 6 N \nATOM 2486 CA LEU A 313 -0.125 -14.851 -9.512 1.00 75.20 C \nANISOU 2486 CA LEU A 313 8833 8450 11291 -1412 -600 40 C \nATOM 2487 C LEU A 313 -0.113 -15.535 -8.155 1.00 82.79 C \nANISOU 2487 C LEU A 313 9808 9431 12217 -1486 -617 43 C \nATOM 2488 O LEU A 313 -0.660 -16.633 -7.992 1.00 82.38 O \nANISOU 2488 O LEU A 313 9734 9387 12178 -1530 -636 33 O \nATOM 2489 CB LEU A 313 -1.578 -14.474 -9.866 1.00 67.87 C \nANISOU 2489 CB LEU A 313 7833 7527 10425 -1394 -669 62 C \nATOM 2490 CG LEU A 313 -1.771 -13.612 -11.108 1.00 68.02 C \nANISOU 2490 CG LEU A 313 7833 7530 10480 -1327 -664 65 C \nATOM 2491 CD1 LEU A 313 -3.198 -13.759 -11.626 1.00 61.81 C \nANISOU 2491 CD1 LEU A 313 6988 6740 9756 -1311 -722 72 C \nATOM 2492 CD2 LEU A 313 -1.417 -12.149 -10.811 1.00 69.84 C \nANISOU 2492 CD2 LEU A 313 8075 7775 10684 -1307 -667 90 C \nATOM 2493 N ALA A 314 0.479 -14.878 -7.167 1.00 79.97 N \nANISOU 2493 N ALA A 314 9482 9088 11812 -1503 -613 57 N \nATOM 2494 CA ALA A 314 0.368 -15.357 -5.805 1.00 80.29 C \nANISOU 2494 CA ALA A 314 9530 9153 11822 -1574 -639 65 C \nATOM 2495 C ALA A 314 -1.072 -15.176 -5.364 1.00 73.20 C \nANISOU 2495 C ALA A 314 8565 8280 10968 -1594 -722 97 C \nATOM 2496 O ALA A 314 -1.655 -14.119 -5.557 1.00 78.31 O \nANISOU 2496 O ALA A 314 9183 8930 11642 -1560 -760 123 O \nATOM 2497 CB ALA A 314 1.289 -14.575 -4.898 1.00 87.59 C \nANISOU 2497 CB ALA A 314 10501 10093 12687 -1580 -616 74 C \nATOM 2498 N THR A 315 -1.635 -16.212 -4.767 1.00 65.04 N \nANISOU 2498 N THR A 315 7511 7266 9937 -1649 -752 94 N \nATOM 2499 CA THR A 315 -2.955 -16.139 -4.143 1.00 66.47 C \nANISOU 2499 CA THR A 315 7634 7473 10148 -1669 -833 126 C \nATOM 2500 C THR A 315 -2.868 -16.345 -2.617 1.00 75.21 C \nANISOU 2500 C THR A 315 8754 8613 11208 -1741 -857 141 C \nATOM 2501 O THR A 315 -3.563 -15.697 -1.844 1.00 81.53 O \nANISOU 2501 O THR A 315 9532 9432 12013 -1754 -915 176 O \nATOM 2502 CB THR A 315 -3.900 -17.198 -4.749 1.00 66.01 C \nANISOU 2502 CB THR A 315 7523 7424 10133 -1666 -859 114 C \nATOM 2503 OG1 THR A 315 -3.354 -18.539 -4.607 1.00 58.20 O \nANISOU 2503 OG1 THR A 315 6553 6449 9111 -1720 -819 82 O \nATOM 2504 CG2 THR A 315 -4.124 -16.884 -6.233 1.00 62.63 C \nANISOU 2504 CG2 THR A 315 7078 6965 9753 -1593 -844 103 C \nATOM 2505 N GLY A 316 -2.011 -17.259 -2.195 1.00 76.41 N \nANISOU 2505 N GLY A 316 8947 8770 11313 -1792 -810 114 N \nATOM 2506 CA GLY A 316 -1.841 -17.550 -0.792 1.00 75.02 C \nANISOU 2506 CA GLY A 316 8789 8626 11090 -1864 -826 123 C \nATOM 2507 C GLY A 316 -0.740 -16.727 -0.148 1.00 76.34 C \nANISOU 2507 C GLY A 316 9017 8788 11203 -1868 -788 124 C \nATOM 2508 O GLY A 316 -0.398 -15.638 -0.639 1.00 72.64 O \nANISOU 2508 O GLY A 316 8557 8302 10738 -1810 -772 132 O \nATOM 2509 N LEU A 317 -0.148 -17.302 0.909 1.00 71.69 N \nANISOU 2509 N LEU A 317 8467 8215 10556 -1935 -770 113 N \nATOM 2510 CA LEU A 317 0.766 -16.611 1.809 1.00 77.13 C \nANISOU 2510 CA LEU A 317 9208 8912 11186 -1949 -745 117 C \nATOM 2511 C LEU A 317 2.235 -16.975 1.629 1.00 73.94 C \nANISOU 2511 C LEU A 317 8891 8476 10726 -1943 -659 77 C \nATOM 2512 O LEU A 317 2.551 -18.056 1.209 1.00 84.65 O \nANISOU 2512 O LEU A 317 10277 9810 12074 -1966 -623 47 O \nATOM 2513 CB LEU A 317 0.380 -16.920 3.252 1.00 79.26 C \nANISOU 2513 CB LEU A 317 9466 9224 11425 -2030 -789 135 C \nATOM 2514 CG LEU A 317 -1.114 -16.790 3.554 1.00 86.56 C \nANISOU 2514 CG LEU A 317 10313 10180 12398 -2042 -878 175 C \nATOM 2515 CD1 LEU A 317 -1.802 -18.154 3.610 1.00 83.12 C \nANISOU 2515 CD1 LEU A 317 9841 9765 11976 -2089 -903 165 C \nATOM 2516 CD2 LEU A 317 -1.323 -16.028 4.853 1.00 87.19 C \nANISOU 2516 CD2 LEU A 317 10387 10294 12446 -2080 -922 209 C \nATOM 2517 N ARG A 318 3.123 -16.063 1.986 1.00 69.22 N \nANISOU 2517 N ARG A 318 8335 7881 10084 -1914 -627 78 N \nATOM 2518 CA ARG A 318 4.538 -16.375 2.092 1.00 72.83 C \nANISOU 2518 CA ARG A 318 8886 8310 10475 -1909 -549 43 C \nATOM 2519 C ARG A 318 4.712 -17.658 2.889 1.00 81.37 C \nANISOU 2519 C ARG A 318 10009 9391 11518 -2000 -540 22 C \nATOM 2520 O ARG A 318 4.239 -17.752 4.013 1.00 79.30 O \nANISOU 2520 O ARG A 318 9722 9168 11240 -2065 -584 40 O \nATOM 2521 CB ARG A 318 5.303 -15.247 2.787 1.00 65.19 C \nANISOU 2521 CB ARG A 318 7947 7369 9455 -1881 -531 52 C \nATOM 2522 CG ARG A 318 5.546 -14.033 1.915 1.00 62.76 C \nANISOU 2522 CG ARG A 318 7621 7064 9162 -1788 -516 63 C \nATOM 2523 CD ARG A 318 6.312 -12.971 2.686 1.00 69.89 C \nANISOU 2523 CD ARG A 318 8544 8007 10002 -1766 -498 71 C \nATOM 2524 NE ARG A 318 6.345 -11.671 2.031 1.00 74.20 N \nANISOU 2524 NE ARG A 318 9053 8581 10560 -1693 -499 89 N \nATOM 2525 CZ ARG A 318 7.290 -11.258 1.199 1.00 78.41 C \nANISOU 2525 CZ ARG A 318 9620 9102 11069 -1610 -440 71 C \nATOM 2526 NH1 ARG A 318 8.322 -12.025 0.909 1.00 86.92 N \nANISOU 2526 NH1 ARG A 318 10781 10134 12111 -1583 -372 34 N \nATOM 2527 NH2 ARG A 318 7.213 -10.057 0.670 1.00 84.42 N \nANISOU 2527 NH2 ARG A 318 10336 9901 11838 -1554 -448 91 N \nATOM 2528 N ASN A 319 5.409 -18.637 2.319 1.00 92.31 N \nANISOU 2528 N ASN A 319 11460 10732 12881 -2009 -482 -16 N \nATOM 2529 CA ASN A 319 5.553 -19.952 2.963 1.00 94.55 C \nANISOU 2529 CA ASN A 319 11785 11015 13124 -2106 -471 -39 C \nATOM 2530 C ASN A 319 6.994 -20.443 2.984 1.00 97.22 C \nANISOU 2530 C ASN A 319 12251 11301 13388 -2112 -388 -79 C \nATOM 2531 O ASN A 319 7.410 -21.243 2.152 1.00 92.62 O \nANISOU 2531 O ASN A 319 11720 10673 12799 -2114 -344 -108 O \nATOM 2532 CB ASN A 319 4.664 -20.958 2.248 1.00 92.53 C \nANISOU 2532 CB ASN A 319 11476 10765 12917 -2139 -497 -43 C \nATOM 2533 CG ASN A 319 4.809 -22.352 2.794 1.00 85.87 C \nANISOU 2533 CG ASN A 319 10671 9930 12027 -2245 -484 -68 C \nATOM 2534 OD1 ASN A 319 5.005 -22.547 3.987 1.00 96.72 O \nANISOU 2534 OD1 ASN A 319 12071 11328 13352 -2312 -491 -67 O \nATOM 2535 ND2 ASN A 319 4.740 -23.336 1.910 1.00 80.13 N \nANISOU 2535 ND2 ASN A 319 9949 9185 11311 -2266 -462 -92 N \nATOM 2536 N SER A 320 7.769 -19.903 3.914 1.00111.03 N \nANISOU 2536 N SER A 320 14055 13055 15077 -2109 -367 -81 N \nATOM 2537 CA SER A 320 9.104 -20.433 4.189 1.00120.46 C \nANISOU 2537 CA SER A 320 15380 14200 16190 -2123 -292 -120 C \nATOM 2538 C SER A 320 9.050 -21.324 5.439 1.00121.97 C \nANISOU 2538 C SER A 320 15600 14413 16331 -2242 -305 -130 C \nATOM 2539 O SER A 320 8.342 -20.993 6.405 1.00113.15 O \nANISOU 2539 O SER A 320 14414 13355 15222 -2284 -362 -102 O \nATOM 2540 CB SER A 320 10.123 -19.303 4.371 1.00119.85 C \nANISOU 2540 CB SER A 320 15355 14115 16067 -2034 -251 -122 C \nATOM 2541 OG SER A 320 11.328 -19.800 4.931 1.00122.59 O \nANISOU 2541 OG SER A 320 15831 14421 16328 -2055 -188 -158 O \nATOM 2542 N PRO A 321 9.757 -22.474 5.405 1.00123.58 N \nANISOU 2542 N PRO A 321 15906 14569 16480 -2302 -253 -168 N \nATOM 2543 CA PRO A 321 10.000 -23.281 6.617 1.00129.03 C \nANISOU 2543 CA PRO A 321 16652 15272 17103 -2414 -249 -184 C \nATOM 2544 C PRO A 321 11.194 -22.747 7.424 1.00120.80 C \nANISOU 2544 C PRO A 321 15713 14204 15981 -2386 -200 -201 C \nATOM 2545 O PRO A 321 12.075 -23.506 7.823 1.00121.71 O \nANISOU 2545 O PRO A 321 15948 14274 16020 -2439 -149 -237 O \nATOM 2546 CB PRO A 321 10.261 -24.702 6.065 1.00127.10 C \nANISOU 2546 CB PRO A 321 16476 14983 16831 -2489 -211 -220 C \nATOM 2547 CG PRO A 321 9.904 -24.644 4.611 1.00132.97 C \nANISOU 2547 CG PRO A 321 17175 15706 17642 -2421 -210 -216 C \nATOM 2548 CD PRO A 321 10.121 -23.219 4.191 1.00127.32 C \nANISOU 2548 CD PRO A 321 16434 14983 16960 -2289 -207 -196 C \nTER 2549 PRO A 321 \nATOM 2550 N ILE B 10 4.358 -14.450 12.775 1.00 98.50 N \nANISOU 2550 N ILE B 10 12185 11944 13298 -1318 -779 -14 N \nATOM 2551 CA ILE B 10 5.510 -13.491 12.661 1.00 96.54 C \nANISOU 2551 CA ILE B 10 11963 11743 12975 -1172 -805 -52 C \nATOM 2552 C ILE B 10 6.870 -14.214 12.671 1.00109.89 C \nANISOU 2552 C ILE B 10 13864 13327 14561 -1085 -863 -78 C \nATOM 2553 O ILE B 10 7.793 -13.838 11.945 1.00131.03 O \nANISOU 2553 O ILE B 10 16628 15995 17163 -964 -896 -111 O \nATOM 2554 CB ILE B 10 5.458 -12.358 13.718 1.00 86.39 C \nANISOU 2554 CB ILE B 10 10547 10605 11672 -1118 -796 -66 C \nATOM 2555 CG1 ILE B 10 6.852 -12.063 14.305 1.00 81.91 C \nANISOU 2555 CG1 ILE B 10 10043 10096 10984 -945 -840 -116 C \nATOM 2556 CG2 ILE B 10 4.462 -12.694 14.809 1.00 85.96 C \nANISOU 2556 CG2 ILE B 10 10433 10548 11681 -1221 -777 -37 C \nATOM 2557 CD1 ILE B 10 6.961 -10.758 15.069 1.00 79.19 C \nANISOU 2557 CD1 ILE B 10 9534 9975 10580 -884 -831 -139 C \nATOM 2558 N GLU B 11 6.988 -15.259 13.476 1.00107.55 N \nANISOU 2558 N GLU B 11 13676 12945 14246 -1145 -886 -66 N \nATOM 2559 CA GLU B 11 8.180 -16.102 13.460 1.00105.55 C \nANISOU 2559 CA GLU B 11 13687 12545 13872 -1103 -959 -81 C \nATOM 2560 C GLU B 11 8.141 -17.085 12.287 1.00101.41 C \nANISOU 2560 C GLU B 11 13298 11908 13326 -1248 -973 -50 C \nATOM 2561 O GLU B 11 9.082 -17.862 12.091 1.00110.87 O \nANISOU 2561 O GLU B 11 14765 12958 14403 -1261 -1046 -53 O \nATOM 2562 CB GLU B 11 8.304 -16.846 14.793 1.00112.40 C \nANISOU 2562 CB GLU B 11 14632 13365 14709 -1143 -984 -74 C \nATOM 2563 CG GLU B 11 8.406 -15.948 16.020 1.00119.89 C \nANISOU 2563 CG GLU B 11 15457 14435 15661 -1007 -975 -105 C \nATOM 2564 CD GLU B 11 9.574 -14.969 15.979 1.00121.49 C \nANISOU 2564 CD GLU B 11 15705 14707 15749 -756 -1022 -170 C \nATOM 2565 OE1 GLU B 11 10.701 -15.373 16.363 1.00120.68 O \nANISOU 2565 OE1 GLU B 11 15834 14507 15512 -621 -1103 -207 O \nATOM 2566 OE2 GLU B 11 9.366 -13.787 15.595 1.00120.50 O \nANISOU 2566 OE2 GLU B 11 15391 14749 15644 -689 -985 -187 O \nATOM 2567 N GLY B 12 7.064 -17.031 11.500 1.00 97.18 N \nANISOU 2567 N GLY B 12 12595 11444 12886 -1357 -912 -23 N \nATOM 2568 CA GLY B 12 6.806 -17.975 10.420 1.00 99.41 C \nANISOU 2568 CA GLY B 12 12943 11679 13147 -1518 -912 9 C \nATOM 2569 C GLY B 12 5.369 -18.468 10.483 1.00103.90 C \nANISOU 2569 C GLY B 12 13316 12364 13799 -1663 -851 39 C \nATOM 2570 O GLY B 12 4.634 -18.143 11.421 1.00 99.47 O \nANISOU 2570 O GLY B 12 12609 11878 13306 -1637 -820 38 O \nATOM 2571 N GLY B 13 4.975 -19.255 9.483 1.00102.21 N \nANISOU 2571 N GLY B 13 13101 12177 13557 -1803 -842 62 N \nATOM 2572 CA GLY B 13 3.611 -19.799 9.397 1.00100.43 C \nANISOU 2572 CA GLY B 13 12684 12103 13371 -1906 -793 78 C \nATOM 2573 C GLY B 13 3.390 -21.087 10.187 1.00 94.76 C \nANISOU 2573 C GLY B 13 11978 11448 12580 -2069 -802 100 C \nATOM 2574 O GLY B 13 4.338 -21.762 10.572 1.00 90.46 O \nANISOU 2574 O GLY B 13 11632 10804 11936 -2161 -852 116 O \nATOM 2575 N TRP B 14 2.124 -21.414 10.437 1.00 97.22 N \nANISOU 2575 N TRP B 14 12091 11928 12921 -2096 -762 99 N \nATOM 2576 CA TRP B 14 1.749 -22.609 11.225 1.00 87.73 C \nANISOU 2576 CA TRP B 14 10848 10846 11641 -2243 -763 115 C \nATOM 2577 C TRP B 14 1.546 -23.792 10.289 1.00 87.49 C \nANISOU 2577 C TRP B 14 10791 10971 11479 -2447 -763 135 C \nATOM 2578 O TRP B 14 0.446 -23.979 9.735 1.00 80.42 O \nANISOU 2578 O TRP B 14 9697 10281 10577 -2430 -728 118 O \nATOM 2579 CB TRP B 14 0.416 -22.449 11.988 1.00 81.86 C \nANISOU 2579 CB TRP B 14 9895 10246 10961 -2150 -727 93 C \nATOM 2580 CG TRP B 14 0.228 -21.430 13.070 1.00 79.70 C \nANISOU 2580 CG TRP B 14 9600 9887 10794 -1993 -724 78 C \nATOM 2581 CD1 TRP B 14 -0.989 -20.858 13.474 1.00 78.23 C \nANISOU 2581 CD1 TRP B 14 9278 9772 10674 -1870 -706 56 C \nATOM 2582 CD2 TRP B 14 1.227 -20.871 13.919 1.00 81.77 C \nANISOU 2582 CD2 TRP B 14 9989 9994 11085 -1943 -746 81 C \nATOM 2583 NE1 TRP B 14 -0.774 -19.988 14.511 1.00 80.69 N \nANISOU 2583 NE1 TRP B 14 9625 9981 11055 -1787 -713 54 N \nATOM 2584 CE2 TRP B 14 0.571 -19.957 14.792 1.00 85.22 C \nANISOU 2584 CE2 TRP B 14 10334 10436 11608 -1820 -732 66 C \nATOM 2585 CE3 TRP B 14 2.619 -21.015 14.010 1.00 79.31 C \nANISOU 2585 CE3 TRP B 14 9877 9541 10714 -1975 -787 89 C \nATOM 2586 CZ2 TRP B 14 1.266 -19.206 15.739 1.00 83.85 C \nANISOU 2586 CZ2 TRP B 14 10221 10173 11464 -1746 -746 61 C \nATOM 2587 CZ3 TRP B 14 3.304 -20.264 14.949 1.00 81.65 C \nANISOU 2587 CZ3 TRP B 14 10241 9743 11038 -1857 -807 75 C \nATOM 2588 CH2 TRP B 14 2.632 -19.378 15.809 1.00 82.52 C \nANISOU 2588 CH2 TRP B 14 10216 9902 11237 -1753 -781 62 C \nATOM 2589 N GLN B 15 2.581 -24.610 10.134 1.00 88.03 N \nANISOU 2589 N GLN B 15 11071 10959 11417 -2642 -811 168 N \nATOM 2590 CA GLN B 15 2.447 -25.850 9.387 1.00 90.13 C \nANISOU 2590 CA GLN B 15 11323 11404 11517 -2903 -818 197 C \nATOM 2591 C GLN B 15 1.205 -26.628 9.849 1.00 89.56 C \nANISOU 2591 C GLN B 15 10983 11654 11393 -2968 -777 187 C \nATOM 2592 O GLN B 15 0.597 -27.381 9.069 1.00 83.33 O \nANISOU 2592 O GLN B 15 10044 11131 10485 -3100 -758 189 O \nATOM 2593 CB GLN B 15 3.697 -26.700 9.556 1.00 98.24 C \nANISOU 2593 CB GLN B 15 12663 12281 12381 -3140 -894 242 C \nATOM 2594 CG GLN B 15 3.749 -27.907 8.617 1.00101.74 C \nANISOU 2594 CG GLN B 15 13147 12892 12620 -3465 -915 284 C \nATOM 2595 CD GLN B 15 3.821 -27.567 7.119 1.00108.69 C \nANISOU 2595 CD GLN B 15 14031 13764 13501 -3450 -908 281 C \nATOM 2596 OE1 GLN B 15 4.231 -26.472 6.701 1.00100.38 O \nANISOU 2596 OE1 GLN B 15 13057 12505 12577 -3225 -910 256 O \nATOM 2597 NE2 GLN B 15 3.401 -28.523 6.298 1.00115.48 N \nANISOU 2597 NE2 GLN B 15 14788 14886 14201 -3699 -898 305 N \nATOM 2598 N GLY B 16 0.838 -26.429 11.118 1.00 86.77 N \nANISOU 2598 N GLY B 16 10563 11294 11110 -2860 -766 172 N \nATOM 2599 CA GLY B 16 -0.250 -27.140 11.746 1.00 85.33 C \nANISOU 2599 CA GLY B 16 10153 11398 10869 -2889 -737 155 C \nATOM 2600 C GLY B 16 -1.637 -26.569 11.534 1.00 93.01 C \nANISOU 2600 C GLY B 16 10879 12538 11923 -2648 -696 102 C \nATOM 2601 O GLY B 16 -2.608 -27.209 11.924 1.00 94.95 O \nANISOU 2601 O GLY B 16 10929 13059 12089 -2638 -681 76 O \nATOM 2602 N MET B 17 -1.765 -25.385 10.931 1.00 96.92 N \nANISOU 2602 N MET B 17 11393 12880 12553 -2447 -688 81 N \nATOM 2603 CA MET B 17 -3.093 -24.817 10.731 1.00 91.64 C \nANISOU 2603 CA MET B 17 10551 12332 11938 -2218 -669 30 C \nATOM 2604 C MET B 17 -3.630 -25.135 9.353 1.00 89.71 C \nANISOU 2604 C MET B 17 10190 12290 11608 -2222 -657 10 C \nATOM 2605 O MET B 17 -3.318 -24.467 8.374 1.00 95.64 O \nANISOU 2605 O MET B 17 11010 12910 12418 -2179 -656 14 O \nATOM 2606 CB MET B 17 -3.147 -23.316 10.959 1.00 94.86 C \nANISOU 2606 CB MET B 17 11038 12489 12515 -2008 -673 18 C \nATOM 2607 CG MET B 17 -4.587 -22.814 10.827 1.00 94.43 C \nANISOU 2607 CG MET B 17 10862 12537 12479 -1789 -676 -31 C \nATOM 2608 SD MET B 17 -4.898 -21.225 11.545 1.00 83.59 S \nANISOU 2608 SD MET B 17 9588 10917 11254 -1601 -696 -39 S \nATOM 2609 CE MET B 17 -3.685 -20.281 10.611 1.00 93.12 C \nANISOU 2609 CE MET B 17 10926 11911 12545 -1650 -688 -7 C \nATOM 2610 N VAL B 18 -4.460 -26.156 9.302 1.00 97.10 N \nANISOU 2610 N VAL B 18 10932 13572 12390 -2262 -649 -16 N \nATOM 2611 CA VAL B 18 -5.032 -26.669 8.063 1.00106.11 C \nANISOU 2611 CA VAL B 18 11920 14997 13402 -2276 -639 -43 C \nATOM 2612 C VAL B 18 -6.437 -26.097 7.841 1.00111.64 C \nANISOU 2612 C VAL B 18 12485 15813 14118 -1952 -645 -117 C \nATOM 2613 O VAL B 18 -7.006 -26.231 6.761 1.00127.41 O \nANISOU 2613 O VAL B 18 14372 18007 16033 -1879 -643 -152 O \nATOM 2614 CB VAL B 18 -5.106 -28.226 8.102 1.00108.80 C \nANISOU 2614 CB VAL B 18 12103 15731 13505 -2530 -632 -34 C \nATOM 2615 CG1 VAL B 18 -3.741 -28.815 8.462 1.00106.16 C \nANISOU 2615 CG1 VAL B 18 11966 15242 13126 -2865 -647 43 C \nATOM 2616 CG2 VAL B 18 -6.170 -28.719 9.085 1.00105.72 C \nANISOU 2616 CG2 VAL B 18 11517 15620 13030 -2402 -632 -85 C \nATOM 2617 N ASP B 19 -6.985 -25.470 8.874 1.00110.47 N \nANISOU 2617 N ASP B 19 12373 15538 14062 -1757 -663 -141 N \nATOM 2618 CA ASP B 19 -8.379 -25.013 8.898 1.00114.42 C \nANISOU 2618 CA ASP B 19 12803 16131 14542 -1443 -693 -215 C \nATOM 2619 C ASP B 19 -8.641 -23.722 8.078 1.00119.32 C \nANISOU 2619 C ASP B 19 13552 16509 15276 -1263 -715 -227 C \nATOM 2620 O ASP B 19 -9.786 -23.413 7.719 1.00110.14 O \nANISOU 2620 O ASP B 19 12363 15431 14057 -1011 -754 -290 O \nATOM 2621 CB ASP B 19 -8.801 -24.769 10.361 1.00121.88 C \nANISOU 2621 CB ASP B 19 13789 16984 15534 -1331 -716 -227 C \nATOM 2622 CG ASP B 19 -8.740 -26.033 11.213 1.00123.38 C \nANISOU 2622 CG ASP B 19 13839 17442 15596 -1476 -700 -225 C \nATOM 2623 OD1 ASP B 19 -8.645 -27.140 10.636 1.00130.80 O \nANISOU 2623 OD1 ASP B 19 14620 18708 16371 -1638 -679 -226 O \nATOM 2624 OD2 ASP B 19 -8.796 -25.908 12.458 1.00120.99 O \nANISOU 2624 OD2 ASP B 19 13585 17038 15346 -1445 -711 -220 O \nATOM 2625 N GLY B 20 -7.588 -22.954 7.799 1.00112.74 N \nANISOU 2625 N GLY B 20 12872 15379 14584 -1381 -699 -171 N \nATOM 2626 CA GLY B 20 -7.747 -21.660 7.132 1.00101.22 C \nANISOU 2626 CA GLY B 20 11538 13690 13230 -1246 -719 -174 C \nATOM 2627 C GLY B 20 -6.444 -20.947 6.824 1.00 94.23 C \nANISOU 2627 C GLY B 20 10789 12545 12471 -1390 -697 -116 C \nATOM 2628 O GLY B 20 -5.362 -21.531 6.932 1.00 93.10 O \nANISOU 2628 O GLY B 20 10665 12389 12322 -1586 -673 -75 O \nATOM 2629 N TRP B 21 -6.553 -19.670 6.469 1.00 85.18 N \nANISOU 2629 N TRP B 21 9754 11194 11418 -1287 -716 -114 N \nATOM 2630 CA TRP B 21 -5.372 -18.864 6.121 1.00 88.66 C \nANISOU 2630 CA TRP B 21 10304 11423 11959 -1383 -700 -70 C \nATOM 2631 C TRP B 21 -4.789 -18.140 7.309 1.00 77.47 C \nANISOU 2631 C TRP B 21 8977 9832 10625 -1408 -704 -44 C \nATOM 2632 O TRP B 21 -3.578 -18.072 7.458 1.00 69.48 O \nANISOU 2632 O TRP B 21 8023 8728 9648 -1510 -689 -14 O \nATOM 2633 CB TRP B 21 -5.708 -17.848 5.027 1.00100.63 C \nANISOU 2633 CB TRP B 21 11875 12850 13511 -1288 -714 -80 C \nATOM 2634 CG TRP B 21 -5.663 -18.407 3.627 1.00111.53 C \nANISOU 2634 CG TRP B 21 13189 14353 14832 -1316 -698 -90 C \nATOM 2635 CD1 TRP B 21 -5.417 -19.695 3.259 1.00116.05 C \nANISOU 2635 CD1 TRP B 21 13660 15126 15309 -1432 -674 -90 C \nATOM 2636 CD2 TRP B 21 -5.903 -17.688 2.421 1.00114.58 C \nANISOU 2636 CD2 TRP B 21 13612 14687 15237 -1244 -707 -100 C \nATOM 2637 NE1 TRP B 21 -5.468 -19.817 1.902 1.00118.04 N \nANISOU 2637 NE1 TRP B 21 13874 15456 15519 -1436 -666 -99 N \nATOM 2638 CE2 TRP B 21 -5.773 -18.598 1.361 1.00114.79 C \nANISOU 2638 CE2 TRP B 21 13546 14885 15185 -1307 -685 -108 C \nATOM 2639 CE3 TRP B 21 -6.216 -16.354 2.132 1.00119.86 C \nANISOU 2639 CE3 TRP B 21 14388 15188 15967 -1153 -735 -99 C \nATOM 2640 CZ2 TRP B 21 -5.945 -18.223 0.029 1.00123.21 C \nANISOU 2640 CZ2 TRP B 21 14616 15951 16247 -1257 -686 -119 C \nATOM 2641 CZ3 TRP B 21 -6.385 -15.978 0.801 1.00123.94 C \nANISOU 2641 CZ3 TRP B 21 14918 15698 16476 -1110 -739 -109 C \nATOM 2642 CH2 TRP B 21 -6.245 -16.911 -0.232 1.00120.36 C \nANISOU 2642 CH2 TRP B 21 14364 15408 15959 -1149 -713 -121 C \nATOM 2643 N TYR B 22 -5.664 -17.581 8.133 1.00 75.47 N \nANISOU 2643 N TYR B 22 8751 9539 10385 -1302 -735 -59 N \nATOM 2644 CA TYR B 22 -5.240 -16.951 9.368 1.00 74.67 C \nANISOU 2644 CA TYR B 22 8714 9315 10341 -1333 -740 -36 C \nATOM 2645 C TYR B 22 -5.980 -17.555 10.537 1.00 73.58 C \nANISOU 2645 C TYR B 22 8540 9254 10165 -1290 -757 -53 C \nATOM 2646 O TYR B 22 -7.097 -18.064 10.380 1.00 77.57 O \nANISOU 2646 O TYR B 22 8996 9882 10595 -1179 -781 -92 O \nATOM 2647 CB TYR B 22 -5.535 -15.464 9.346 1.00 80.65 C \nANISOU 2647 CB TYR B 22 9571 9932 11140 -1286 -771 -27 C \nATOM 2648 CG TYR B 22 -5.420 -14.815 7.993 1.00 78.65 C \nANISOU 2648 CG TYR B 22 9348 9639 10897 -1276 -770 -25 C \nATOM 2649 CD1 TYR B 22 -6.541 -14.315 7.348 1.00 72.31 C \nANISOU 2649 CD1 TYR B 22 8605 8812 10056 -1176 -814 -45 C \nATOM 2650 CD2 TYR B 22 -4.175 -14.670 7.378 1.00 72.99 C \nANISOU 2650 CD2 TYR B 22 8623 8896 10215 -1354 -736 -5 C \nATOM 2651 CE1 TYR B 22 -6.433 -13.696 6.122 1.00 71.02 C \nANISOU 2651 CE1 TYR B 22 8475 8607 9902 -1174 -815 -42 C \nATOM 2652 CE2 TYR B 22 -4.056 -14.039 6.157 1.00 69.17 C \nANISOU 2652 CE2 TYR B 22 8163 8378 9740 -1343 -736 -4 C \nATOM 2653 CZ TYR B 22 -5.189 -13.560 5.526 1.00 68.58 C \nANISOU 2653 CZ TYR B 22 8129 8288 9639 -1263 -770 -20 C \nATOM 2654 OH TYR B 22 -5.065 -12.969 4.287 1.00 58.31 O \nANISOU 2654 OH TYR B 22 6854 6956 8346 -1259 -770 -18 O \nATOM 2655 N GLY B 23 -5.358 -17.491 11.710 1.00 67.41 N \nANISOU 2655 N GLY B 23 7780 8411 9421 -1357 -749 -30 N \nATOM 2656 CA GLY B 23 -5.993 -18.001 12.916 1.00 67.35 C \nANISOU 2656 CA GLY B 23 7745 8463 9383 -1322 -764 -43 C \nATOM 2657 C GLY B 23 -5.143 -17.956 14.149 1.00 65.58 C \nANISOU 2657 C GLY B 23 7545 8172 9202 -1407 -751 -16 C \nATOM 2658 O GLY B 23 -4.189 -17.176 14.238 1.00 57.40 O \nANISOU 2658 O GLY B 23 6565 7026 8217 -1456 -742 8 O \nATOM 2659 N TYR B 24 -5.460 -18.832 15.095 1.00 72.70 N \nANISOU 2659 N TYR B 24 8394 9163 10065 -1413 -751 -25 N \nATOM 2660 CA TYR B 24 -4.852 -18.767 16.436 1.00 73.56 C \nANISOU 2660 CA TYR B 24 8533 9208 10209 -1471 -747 -5 C \nATOM 2661 C TYR B 24 -4.198 -20.067 16.846 1.00 71.66 C \nANISOU 2661 C TYR B 24 8249 9057 9923 -1583 -726 5 C \nATOM 2662 O TYR B 24 -4.421 -21.112 16.234 1.00 85.61 O \nANISOU 2662 O TYR B 24 9940 10976 11612 -1631 -717 -6 O \nATOM 2663 CB TYR B 24 -5.912 -18.422 17.464 1.00 73.51 C \nANISOU 2663 CB TYR B 24 8543 9190 10196 -1381 -781 -19 C \nATOM 2664 CG TYR B 24 -6.800 -17.255 17.077 1.00 78.55 C \nANISOU 2664 CG TYR B 24 9273 9737 10835 -1286 -825 -28 C \nATOM 2665 CD1 TYR B 24 -7.976 -17.459 16.349 1.00 77.93 C \nANISOU 2665 CD1 TYR B 24 9201 9721 10689 -1155 -860 -66 C \nATOM 2666 CD2 TYR B 24 -6.469 -15.947 17.443 1.00 78.26 C \nANISOU 2666 CD2 TYR B 24 9326 9569 10840 -1333 -839 1 C \nATOM 2667 CE1 TYR B 24 -8.808 -16.399 16.014 1.00 75.74 C \nANISOU 2667 CE1 TYR B 24 9061 9327 10389 -1072 -919 -73 C \nATOM 2668 CE2 TYR B 24 -7.287 -14.883 17.113 1.00 80.81 C \nANISOU 2668 CE2 TYR B 24 9765 9802 11136 -1292 -890 2 C \nATOM 2669 CZ TYR B 24 -8.462 -15.116 16.397 1.00 84.60 C \nANISOU 2669 CZ TYR B 24 10295 10298 11553 -1161 -935 -34 C \nATOM 2670 OH TYR B 24 -9.297 -14.080 16.046 1.00 95.24 O \nANISOU 2670 OH TYR B 24 11810 11527 12851 -1121 -1004 -33 O \nATOM 2671 N HIS B 25 -3.368 -19.985 17.870 1.00 64.47 N \nANISOU 2671 N HIS B 25 7391 8063 9041 -1638 -725 25 N \nATOM 2672 CA HIS B 25 -2.875 -21.141 18.552 1.00 62.42 C \nANISOU 2672 CA HIS B 25 7125 7863 8727 -1747 -720 36 C \nATOM 2673 C HIS B 25 -2.822 -20.836 20.019 1.00 64.92 C \nANISOU 2673 C HIS B 25 7464 8121 9081 -1722 -728 40 C \nATOM 2674 O HIS B 25 -2.073 -19.954 20.446 1.00 67.87 O \nANISOU 2674 O HIS B 25 7910 8374 9504 -1700 -734 51 O \nATOM 2675 CB HIS B 25 -1.487 -21.559 18.103 1.00 66.88 C \nANISOU 2675 CB HIS B 25 7797 8357 9259 -1867 -722 60 C \nATOM 2676 CG HIS B 25 -0.971 -22.753 18.854 1.00 79.24 C \nANISOU 2676 CG HIS B 25 9403 9961 10744 -2008 -732 77 C \nATOM 2677 ND1 HIS B 25 -1.612 -23.976 18.851 1.00 89.42 N \nANISOU 2677 ND1 HIS B 25 10590 11448 11935 -2114 -724 76 N \nATOM 2678 CD2 HIS B 25 0.102 -22.894 19.667 1.00 82.86 C \nANISOU 2678 CD2 HIS B 25 9997 10300 11186 -2060 -755 93 C \nATOM 2679 CE1 HIS B 25 -0.939 -24.825 19.605 1.00 93.90 C \nANISOU 2679 CE1 HIS B 25 11237 12008 12433 -2259 -741 100 C \nATOM 2680 NE2 HIS B 25 0.110 -24.193 20.106 1.00 91.00 N \nANISOU 2680 NE2 HIS B 25 11031 11428 12116 -2220 -763 110 N \nATOM 2681 N HIS B 26 -3.602 -21.577 20.799 1.00 65.45 N \nANISOU 2681 N HIS B 26 7457 8302 9108 -1721 -731 29 N \nATOM 2682 CA HIS B 26 -3.591 -21.428 22.247 1.00 67.88 C \nANISOU 2682 CA HIS B 26 7783 8565 9444 -1708 -739 34 C \nATOM 2683 C HIS B 26 -2.845 -22.574 22.938 1.00 71.61 C \nANISOU 2683 C HIS B 26 8273 9077 9860 -1841 -736 51 C \nATOM 2684 O HIS B 26 -2.710 -23.675 22.421 1.00 72.38 O \nANISOU 2684 O HIS B 26 8344 9289 9869 -1957 -731 56 O \nATOM 2685 CB HIS B 26 -5.031 -21.318 22.777 1.00 71.12 C \nANISOU 2685 CB HIS B 26 8130 9049 9843 -1591 -757 6 C \nATOM 2686 CG HIS B 26 -5.763 -22.621 22.834 1.00 77.58 C \nANISOU 2686 CG HIS B 26 8833 10081 10562 -1597 -755 -19 C \nATOM 2687 ND1 HIS B 26 -6.356 -23.187 21.730 1.00 78.30 N \nANISOU 2687 ND1 HIS B 26 8836 10342 10574 -1567 -752 -45 N \nATOM 2688 CD2 HIS B 26 -5.999 -23.472 23.865 1.00 82.42 C \nANISOU 2688 CD2 HIS B 26 9386 10805 11124 -1628 -755 -24 C \nATOM 2689 CE1 HIS B 26 -6.915 -24.338 22.071 1.00 85.02 C \nANISOU 2689 CE1 HIS B 26 9563 11427 11315 -1581 -750 -69 C \nATOM 2690 NE2 HIS B 26 -6.721 -24.530 23.364 1.00 80.88 N \nANISOU 2690 NE2 HIS B 26 9056 10867 10809 -1621 -752 -56 N \nATOM 2691 N SER B 27 -2.368 -22.291 24.127 1.00 73.46 N \nANISOU 2691 N SER B 27 8561 9222 10128 -1837 -743 60 N \nATOM 2692 CA SER B 27 -1.873 -23.323 24.991 1.00 74.30 C \nANISOU 2692 CA SER B 27 8696 9359 10176 -1949 -749 74 C \nATOM 2693 C SER B 27 -2.248 -22.944 26.426 1.00 71.58 C \nANISOU 2693 C SER B 27 8329 8990 9878 -1882 -754 69 C \nATOM 2694 O SER B 27 -2.044 -21.808 26.849 1.00 68.20 O \nANISOU 2694 O SER B 27 7938 8458 9517 -1799 -759 68 O \nATOM 2695 CB SER B 27 -0.365 -23.515 24.815 1.00 71.04 C \nANISOU 2695 CB SER B 27 8449 8816 9727 -2036 -770 95 C \nATOM 2696 OG SER B 27 0.353 -22.421 25.348 1.00 78.57 O \nANISOU 2696 OG SER B 27 9479 9633 10740 -1929 -782 89 O \nATOM 2697 N ASN B 28 -2.820 -23.904 27.151 1.00 70.71 N \nANISOU 2697 N ASN B 28 8148 9004 9715 -1928 -752 65 N \nATOM 2698 CA ASN B 28 -3.231 -23.700 28.539 1.00 69.33 C \nANISOU 2698 CA ASN B 28 7953 8817 9573 -1874 -759 60 C \nATOM 2699 C ASN B 28 -3.214 -25.018 29.317 1.00 67.05 C \nANISOU 2699 C ASN B 28 7628 8647 9202 -1989 -759 66 C \nATOM 2700 O ASN B 28 -2.754 -26.020 28.795 1.00 68.41 O \nANISOU 2700 O ASN B 28 7811 8898 9282 -2137 -758 81 O \nATOM 2701 CB ASN B 28 -4.612 -23.032 28.601 1.00 71.75 C \nANISOU 2701 CB ASN B 28 8192 9161 9907 -1726 -768 33 C \nATOM 2702 CG ASN B 28 -5.705 -23.876 27.966 1.00 72.41 C \nANISOU 2702 CG ASN B 28 8162 9447 9905 -1684 -770 1 C \nATOM 2703 OD1 ASN B 28 -5.445 -24.942 27.414 1.00 72.76 O \nANISOU 2703 OD1 ASN B 28 8144 9635 9865 -1794 -754 4 O \nATOM 2704 ND2 ASN B 28 -6.936 -23.390 28.028 1.00 67.60 N \nANISOU 2704 ND2 ASN B 28 7535 8860 9288 -1524 -797 -32 N \nATOM 2705 N GLU B 29 -3.677 -24.995 30.570 1.00 62.94 N \nANISOU 2705 N GLU B 29 7075 8139 8701 -1941 -764 59 N \nATOM 2706 CA GLU B 29 -3.741 -26.192 31.435 1.00 69.03 C \nANISOU 2706 CA GLU B 29 7800 9037 9392 -2046 -764 64 C \nATOM 2707 C GLU B 29 -4.578 -27.344 30.793 1.00 69.58 C \nANISOU 2707 C GLU B 29 7718 9385 9333 -2101 -755 44 C \nATOM 2708 O GLU B 29 -4.225 -28.501 30.936 1.00 70.89 O \nANISOU 2708 O GLU B 29 7863 9683 9388 -2281 -754 61 O \nATOM 2709 CB GLU B 29 -4.238 -25.831 32.862 1.00 67.89 C \nANISOU 2709 CB GLU B 29 7639 8861 9296 -1956 -772 54 C \nATOM 2710 CG GLU B 29 -5.603 -25.111 32.875 1.00 80.65 C \nANISOU 2710 CG GLU B 29 9193 10510 10942 -1773 -784 20 C \nATOM 2711 CD GLU B 29 -5.582 -23.562 32.601 1.00 84.08 C \nANISOU 2711 CD GLU B 29 9717 10759 11470 -1679 -796 25 C \nATOM 2712 OE1 GLU B 29 -4.556 -22.851 32.757 1.00 70.69 O \nANISOU 2712 OE1 GLU B 29 8101 8927 9831 -1720 -791 49 O \nATOM 2713 OE2 GLU B 29 -6.638 -23.023 32.220 1.00 90.59 O \nANISOU 2713 OE2 GLU B 29 10539 11592 12288 -1558 -819 2 O \nATOM 2714 N GLN B 30 -5.615 -26.997 30.030 1.00 70.60 N \nANISOU 2714 N GLN B 30 7755 9612 9459 -1954 -755 8 N \nATOM 2715 CA GLN B 30 -6.437 -27.963 29.304 1.00 71.80 C \nANISOU 2715 CA GLN B 30 7742 10069 9470 -1960 -749 -25 C \nATOM 2716 C GLN B 30 -5.744 -28.489 28.023 1.00 82.63 C \nANISOU 2716 C GLN B 30 9119 11506 10772 -2133 -736 -1 C \nATOM 2717 O GLN B 30 -6.326 -29.313 27.290 1.00 79.12 O \nANISOU 2717 O GLN B 30 8522 11352 10189 -2168 -728 -25 O \nATOM 2718 CB GLN B 30 -7.817 -27.381 28.952 1.00 74.22 C \nANISOU 2718 CB GLN B 30 7979 10448 9773 -1699 -770 -82 C \nATOM 2719 CG GLN B 30 -8.695 -27.058 30.154 1.00 88.27 C \nANISOU 2719 CG GLN B 30 9765 12205 11570 -1530 -800 -112 C \nATOM 2720 CD GLN B 30 -8.492 -25.647 30.704 1.00101.23 C \nANISOU 2720 CD GLN B 30 11579 13524 13360 -1460 -819 -90 C \nATOM 2721 OE1 GLN B 30 -7.553 -24.935 30.329 1.00113.12 O \nANISOU 2721 OE1 GLN B 30 13183 14838 14959 -1543 -804 -51 O \nATOM 2722 NE2 GLN B 30 -9.377 -25.236 31.599 1.00106.08 N \nANISOU 2722 NE2 GLN B 30 12232 14098 13974 -1310 -857 -115 N \nATOM 2723 N GLY B 31 -4.494 -28.079 27.774 1.00 88.84 N \nANISOU 2723 N GLY B 31 10080 12048 11627 -2241 -738 43 N \nATOM 2724 CA GLY B 31 -3.763 -28.482 26.557 1.00 88.40 C \nANISOU 2724 CA GLY B 31 10080 12004 11504 -2403 -737 68 C \nATOM 2725 C GLY B 31 -3.649 -27.352 25.534 1.00 85.79 C \nANISOU 2725 C GLY B 31 9810 11508 11278 -2272 -733 61 C \nATOM 2726 O GLY B 31 -3.537 -26.197 25.891 1.00 87.55 O \nANISOU 2726 O GLY B 31 10107 11527 11629 -2129 -738 57 O \nATOM 2727 N SER B 32 -3.667 -27.711 24.255 1.00 84.37 N \nANISOU 2727 N SER B 32 9591 11441 11026 -2342 -727 61 N \nATOM 2728 CA SER B 32 -3.348 -26.801 23.181 1.00 75.56 C \nANISOU 2728 CA SER B 32 8550 10170 9989 -2266 -725 62 C \nATOM 2729 C SER B 32 -4.193 -27.076 21.943 1.00 79.42 C \nANISOU 2729 C SER B 32 8895 10876 10404 -2228 -712 33 C \nATOM 2730 O SER B 32 -4.942 -28.054 21.893 1.00 73.28 O \nANISOU 2730 O SER B 32 7951 10400 9492 -2271 -706 11 O \nATOM 2731 CB SER B 32 -1.865 -26.903 22.833 1.00 70.82 C \nANISOU 2731 CB SER B 32 8154 9381 9372 -2427 -744 105 C \nATOM 2732 OG SER B 32 -1.586 -28.025 22.062 1.00 71.92 O \nANISOU 2732 OG SER B 32 8297 9670 9359 -2650 -751 127 O \nATOM 2733 N GLY B 33 -4.097 -26.179 20.962 1.00 81.60 N \nANISOU 2733 N GLY B 33 9224 11023 10759 -2134 -710 29 N \nATOM 2734 CA GLY B 33 -4.844 -26.332 19.716 1.00 82.94 C \nANISOU 2734 CA GLY B 33 9275 11376 10865 -2079 -702 -1 C \nATOM 2735 C GLY B 33 -4.778 -25.158 18.750 1.00 81.83 C \nANISOU 2735 C GLY B 33 9208 11055 10828 -1955 -703 -5 C \nATOM 2736 O GLY B 33 -4.510 -24.034 19.150 1.00 82.18 O \nANISOU 2736 O GLY B 33 9359 10869 10997 -1860 -711 2 O \nATOM 2737 N TYR B 34 -5.014 -25.438 17.468 1.00 83.49 N \nANISOU 2737 N TYR B 34 9352 11400 10971 -1972 -695 -17 N \nATOM 2738 CA TYR B 34 -5.136 -24.407 16.433 1.00 82.30 C \nANISOU 2738 CA TYR B 34 9248 11121 10900 -1847 -697 -28 C \nATOM 2739 C TYR B 34 -6.598 -24.063 16.168 1.00 82.13 C \nANISOU 2739 C TYR B 34 9130 11222 10855 -1617 -715 -85 C \nATOM 2740 O TYR B 34 -7.493 -24.837 16.462 1.00 80.65 O \nANISOU 2740 O TYR B 34 8806 11283 10553 -1552 -723 -125 O \nATOM 2741 CB TYR B 34 -4.505 -24.860 15.125 1.00 80.80 C \nANISOU 2741 CB TYR B 34 9068 10984 10647 -1992 -685 -8 C \nATOM 2742 CG TYR B 34 -3.014 -25.142 15.189 1.00 80.54 C \nANISOU 2742 CG TYR B 34 9202 10790 10611 -2200 -691 44 C \nATOM 2743 CD1 TYR B 34 -2.536 -26.440 15.395 1.00 71.48 C \nANISOU 2743 CD1 TYR B 34 8061 9777 9319 -2441 -697 73 C \nATOM 2744 CD2 TYR B 34 -2.075 -24.116 15.025 1.00 74.21 C \nANISOU 2744 CD2 TYR B 34 8567 9710 9918 -2155 -701 62 C \nATOM 2745 CE1 TYR B 34 -1.175 -26.697 15.465 1.00 71.56 C \nANISOU 2745 CE1 TYR B 34 8289 9602 9300 -2621 -725 119 C \nATOM 2746 CE2 TYR B 34 -0.712 -24.379 15.090 1.00 73.18 C \nANISOU 2746 CE2 TYR B 34 8624 9426 9756 -2297 -724 98 C \nATOM 2747 CZ TYR B 34 -0.271 -25.665 15.315 1.00 74.34 C \nANISOU 2747 CZ TYR B 34 8821 9662 9762 -2525 -742 126 C \nATOM 2748 OH TYR B 34 1.075 -25.911 15.374 1.00 80.30 O \nANISOU 2748 OH TYR B 34 9823 10227 10461 -2654 -786 160 O \nATOM 2749 N ALA B 35 -6.824 -22.879 15.619 1.00 86.51 N \nANISOU 2749 N ALA B 35 9772 11600 11498 -1485 -730 -92 N \nATOM 2750 CA ALA B 35 -8.170 -22.395 15.350 1.00 91.39 C \nANISOU 2750 CA ALA B 35 10376 12266 12084 -1253 -768 -145 C \nATOM 2751 C ALA B 35 -8.115 -21.244 14.355 1.00 90.70 C \nANISOU 2751 C ALA B 35 10397 11995 12070 -1193 -781 -138 C \nATOM 2752 O ALA B 35 -7.568 -20.199 14.651 1.00 88.12 O \nANISOU 2752 O ALA B 35 10194 11438 11850 -1226 -783 -104 O \nATOM 2753 CB ALA B 35 -8.833 -21.947 16.643 1.00 93.20 C \nANISOU 2753 CB ALA B 35 10669 12408 12336 -1134 -805 -159 C \nATOM 2754 N ALA B 36 -8.661 -21.457 13.166 1.00100.81 N \nANISOU 2754 N ALA B 36 11617 13408 13277 -1112 -787 -171 N \nATOM 2755 CA ALA B 36 -8.621 -20.446 12.109 1.00104.68 C \nANISOU 2755 CA ALA B 36 12204 13743 13825 -1064 -799 -165 C \nATOM 2756 C ALA B 36 -9.735 -19.423 12.271 1.00104.40 C \nANISOU 2756 C ALA B 36 12305 13577 13787 -863 -867 -196 C \nATOM 2757 O ALA B 36 -10.811 -19.748 12.773 1.00106.63 O \nANISOU 2757 O ALA B 36 12581 13959 13973 -695 -914 -245 O \nATOM 2758 CB ALA B 36 -8.713 -21.110 10.744 1.00109.00 C \nANISOU 2758 CB ALA B 36 12640 14486 14288 -1069 -781 -187 C \nATOM 2759 N ASP B 37 -9.475 -18.188 11.850 1.00101.55 N \nANISOU 2759 N ASP B 37 12085 12995 13506 -884 -881 -167 N \nATOM 2760 CA ASP B 37 -10.506 -17.166 11.858 1.00105.12 C \nANISOU 2760 CA ASP B 37 12714 13300 13925 -736 -960 -186 C \nATOM 2761 C ASP B 37 -11.355 -17.306 10.594 1.00111.68 C \nANISOU 2761 C ASP B 37 13549 14222 14663 -567 -997 -238 C \nATOM 2762 O ASP B 37 -10.842 -17.242 9.479 1.00120.49 O \nANISOU 2762 O ASP B 37 14617 15354 15809 -629 -961 -225 O \nATOM 2763 CB ASP B 37 -9.882 -15.786 11.942 1.00104.54 C \nANISOU 2763 CB ASP B 37 12779 12995 13945 -863 -964 -130 C \nATOM 2764 CG ASP B 37 -10.867 -14.731 12.347 1.00107.99 C \nANISOU 2764 CG ASP B 37 13439 13262 14330 -786 -1056 -134 C \nATOM 2765 OD1 ASP B 37 -12.073 -14.872 12.056 1.00113.31 O \nANISOU 2765 OD1 ASP B 37 14211 13949 14894 -590 -1131 -186 O \nATOM 2766 OD2 ASP B 37 -10.428 -13.747 12.959 1.00114.80 O \nANISOU 2766 OD2 ASP B 37 14393 13988 15238 -922 -1061 -86 O \nATOM 2767 N LYS B 38 -12.658 -17.483 10.779 1.00104.59 N \nANISOU 2767 N LYS B 38 12720 13381 13637 -335 -1076 -302 N \nATOM 2768 CA LYS B 38 -13.565 -17.738 9.671 1.00102.36 C \nANISOU 2768 CA LYS B 38 12436 13227 13230 -119 -1123 -369 C \nATOM 2769 C LYS B 38 -13.757 -16.514 8.811 1.00100.41 C \nANISOU 2769 C LYS B 38 12400 12746 13003 -100 -1174 -352 C \nATOM 2770 O LYS B 38 -13.686 -16.591 7.585 1.00 92.28 O \nANISOU 2770 O LYS B 38 11315 11788 11960 -74 -1157 -366 O \nATOM 2771 CB LYS B 38 -14.925 -18.183 10.204 1.00108.44 C \nANISOU 2771 CB LYS B 38 13260 14113 13829 172 -1214 -453 C \nATOM 2772 CG LYS B 38 -15.947 -18.527 9.133 1.00112.09 C \nANISOU 2772 CG LYS B 38 13716 14754 14121 457 -1277 -542 C \nATOM 2773 CD LYS B 38 -17.191 -19.158 9.711 1.00110.79 C \nANISOU 2773 CD LYS B 38 13564 14775 13757 778 -1364 -640 C \nATOM 2774 CE LYS B 38 -18.011 -19.812 8.629 1.00112.25 C \nANISOU 2774 CE LYS B 38 13636 15264 13748 1061 -1403 -740 C \nATOM 2775 NZ LYS B 38 -19.293 -20.363 9.134 1.00115.45 N \nANISOU 2775 NZ LYS B 38 14070 15874 13922 1440 -1506 -853 N \nATOM 2776 N GLU B 39 -14.022 -15.389 9.470 1.00100.43 N \nANISOU 2776 N GLU B 39 12654 12482 13025 -131 -1241 -321 N \nATOM 2777 CA GLU B 39 -14.301 -14.140 8.775 1.00 97.99 C \nANISOU 2777 CA GLU B 39 12586 11941 12703 -142 -1308 -299 C \nATOM 2778 C GLU B 39 -13.066 -13.685 8.009 1.00 98.02 C \nANISOU 2778 C GLU B 39 12485 11915 12843 -371 -1218 -237 C \nATOM 2779 O GLU B 39 -13.136 -13.410 6.815 1.00 96.72 O \nANISOU 2779 O GLU B 39 12346 11738 12664 -337 -1225 -246 O \nATOM 2780 CB GLU B 39 -14.754 -13.046 9.755 1.00 96.52 C \nANISOU 2780 CB GLU B 39 12692 11497 12484 -197 -1399 -266 C \nATOM 2781 CG GLU B 39 -15.047 -11.710 9.079 1.00103.45 C \nANISOU 2781 CG GLU B 39 13848 12140 13319 -261 -1479 -234 C \nATOM 2782 CD GLU B 39 -15.671 -10.668 9.993 1.00105.10 C \nANISOU 2782 CD GLU B 39 14394 12102 13438 -330 -1595 -202 C \nATOM 2783 OE1 GLU B 39 -16.128 -11.025 11.099 1.00112.11 O \nANISOU 2783 OE1 GLU B 39 15335 12984 14276 -254 -1634 -221 O \nATOM 2784 OE2 GLU B 39 -15.705 -9.475 9.602 1.00101.29 O \nANISOU 2784 OE2 GLU B 39 14132 11435 12919 -481 -1651 -153 O \nATOM 2785 N SER B 40 -11.936 -13.635 8.706 1.00 96.83 N \nANISOU 2785 N SER B 40 12220 11760 12810 -583 -1139 -181 N \nATOM 2786 CA SER B 40 -10.700 -13.111 8.148 1.00 93.02 C \nANISOU 2786 CA SER B 40 11664 11243 12438 -777 -1066 -127 C \nATOM 2787 C SER B 40 -10.239 -13.929 6.932 1.00 87.78 C \nANISOU 2787 C SER B 40 10828 10733 11793 -758 -1004 -147 C \nATOM 2788 O SER B 40 -9.909 -13.372 5.884 1.00 97.28 O \nANISOU 2788 O SER B 40 12054 11887 13022 -800 -993 -132 O \nATOM 2789 CB SER B 40 -9.611 -13.088 9.230 1.00 91.12 C \nANISOU 2789 CB SER B 40 11333 11002 12285 -949 -1005 -82 C \nATOM 2790 OG SER B 40 -8.957 -11.832 9.249 1.00 90.50 O \nANISOU 2790 OG SER B 40 11327 10810 12248 -1102 -1002 -32 O \nATOM 2791 N THR B 41 -10.218 -15.244 7.075 1.00 90.53 N \nANISOU 2791 N THR B 41 11006 11280 12112 -714 -966 -177 N \nATOM 2792 CA THR B 41 -9.842 -16.147 5.980 1.00 87.82 C \nANISOU 2792 CA THR B 41 10499 11118 11751 -727 -913 -194 C \nATOM 2793 C THR B 41 -10.780 -15.945 4.785 1.00 93.01 C \nANISOU 2793 C THR B 41 11210 11804 12324 -555 -963 -240 C \nATOM 2794 O THR B 41 -10.336 -15.895 3.640 1.00102.18 O \nANISOU 2794 O THR B 41 12327 12988 13509 -602 -931 -231 O \nATOM 2795 CB THR B 41 -9.866 -17.620 6.444 1.00 86.57 C \nANISOU 2795 CB THR B 41 10157 11211 11526 -728 -879 -220 C \nATOM 2796 OG1 THR B 41 -8.873 -17.823 7.459 1.00 85.62 O \nANISOU 2796 OG1 THR B 41 10007 11043 11481 -900 -835 -174 O \nATOM 2797 CG2 THR B 41 -9.571 -18.564 5.286 1.00 92.59 C \nANISOU 2797 CG2 THR B 41 10760 12191 12231 -774 -835 -234 C \nATOM 2798 N GLN B 42 -12.074 -15.816 5.053 1.00 93.97 N \nANISOU 2798 N GLN B 42 11450 11917 12337 -340 -1050 -293 N \nATOM 2799 CA GLN B 42 -13.064 -15.595 3.997 1.00 89.64 C \nANISOU 2799 CA GLN B 42 10996 11384 11681 -131 -1120 -348 C \nATOM 2800 C GLN B 42 -12.818 -14.308 3.227 1.00 86.90 C \nANISOU 2800 C GLN B 42 10825 10798 11396 -213 -1141 -306 C \nATOM 2801 O GLN B 42 -12.738 -14.317 2.001 1.00 92.46 O \nANISOU 2801 O GLN B 42 11486 11551 12092 -189 -1126 -317 O \nATOM 2802 CB GLN B 42 -14.484 -15.581 4.571 1.00 85.13 C \nANISOU 2802 CB GLN B 42 10590 10799 10958 141 -1235 -416 C \nATOM 2803 CG GLN B 42 -15.566 -15.674 3.515 1.00 86.34 C \nANISOU 2803 CG GLN B 42 10816 11036 10954 423 -1315 -496 C \nATOM 2804 CD GLN B 42 -15.358 -16.873 2.597 1.00 87.32 C \nANISOU 2804 CD GLN B 42 10634 11520 11025 460 -1242 -538 C \nATOM 2805 OE1 GLN B 42 -15.069 -17.982 3.058 1.00 88.50 O \nANISOU 2805 OE1 GLN B 42 10540 11936 11150 408 -1179 -549 O \nATOM 2806 NE2 GLN B 42 -15.513 -16.659 1.292 1.00 88.52 N \nANISOU 2806 NE2 GLN B 42 10799 11691 11142 531 -1253 -559 N \nATOM 2807 N LYS B 43 -12.717 -13.206 3.965 1.00 86.52 N \nANISOU 2807 N LYS B 43 10966 10513 11393 -322 -1178 -257 N \nATOM 2808 CA LYS B 43 -12.446 -11.875 3.393 1.00 81.92 C \nANISOU 2808 CA LYS B 43 10550 9725 10850 -448 -1202 -208 C \nATOM 2809 C LYS B 43 -11.223 -11.887 2.456 1.00 84.55 C \nANISOU 2809 C LYS B 43 10710 10121 11293 -601 -1103 -173 C \nATOM 2810 O LYS B 43 -11.214 -11.242 1.417 1.00 89.98 O \nANISOU 2810 O LYS B 43 11468 10741 11979 -614 -1117 -165 O \nATOM 2811 CB LYS B 43 -12.228 -10.863 4.510 1.00 85.23 C \nANISOU 2811 CB LYS B 43 11118 9970 11295 -615 -1230 -151 C \nATOM 2812 CG LYS B 43 -13.477 -10.175 5.015 1.00102.70 C \nANISOU 2812 CG LYS B 43 13648 12000 13372 -521 -1366 -164 C \nATOM 2813 CD LYS B 43 -14.553 -11.157 5.468 1.00114.88 C \nANISOU 2813 CD LYS B 43 15218 13626 14804 -248 -1428 -242 C \nATOM 2814 CE LYS B 43 -15.863 -10.460 5.838 1.00124.34 C \nANISOU 2814 CE LYS B 43 16802 14608 15835 -112 -1591 -265 C \nATOM 2815 NZ LYS B 43 -16.958 -11.339 6.355 1.00129.14 N \nANISOU 2815 NZ LYS B 43 17466 15298 16305 197 -1669 -351 N \nATOM 2816 N ALA B 44 -10.209 -12.654 2.825 1.00 85.66 N \nANISOU 2816 N ALA B 44 10646 10385 11514 -709 -1012 -155 N \nATOM 2817 CA ALA B 44 -8.996 -12.750 2.039 1.00 82.73 C \nANISOU 2817 CA ALA B 44 10148 10059 11228 -841 -932 -125 C \nATOM 2818 C ALA B 44 -9.204 -13.500 0.746 1.00 82.88 C \nANISOU 2818 C ALA B 44 10070 10217 11204 -756 -915 -162 C \nATOM 2819 O ALA B 44 -8.603 -13.170 -0.261 1.00 92.30 O \nANISOU 2819 O ALA B 44 11247 11385 12438 -821 -886 -143 O \nATOM 2820 CB ALA B 44 -7.886 -13.391 2.852 1.00 75.78 C \nANISOU 2820 CB ALA B 44 9137 9243 10413 -970 -864 -99 C \nATOM 2821 N ILE B 45 -10.044 -14.516 0.777 1.00 86.15 N \nANISOU 2821 N ILE B 45 10407 10805 11520 -608 -934 -216 N \nATOM 2822 CA ILE B 45 -10.318 -15.335 -0.402 1.00 86.75 C \nANISOU 2822 CA ILE B 45 10359 11082 11522 -525 -919 -258 C \nATOM 2823 C ILE B 45 -11.212 -14.562 -1.359 1.00 81.51 C \nANISOU 2823 C ILE B 45 9842 10328 10799 -362 -989 -290 C \nATOM 2824 O ILE B 45 -10.970 -14.554 -2.558 1.00 83.89 O \nANISOU 2824 O ILE B 45 10098 10670 11105 -375 -966 -292 O \nATOM 2825 CB ILE B 45 -11.024 -16.665 -0.001 1.00 92.42 C \nANISOU 2825 CB ILE B 45 10922 12084 12111 -402 -924 -317 C \nATOM 2826 CG1 ILE B 45 -10.137 -17.526 0.898 1.00 93.92 C \nANISOU 2826 CG1 ILE B 45 10975 12371 12338 -589 -859 -282 C \nATOM 2827 CG2 ILE B 45 -11.435 -17.476 -1.221 1.00 94.88 C \nANISOU 2827 CG2 ILE B 45 11085 12660 12303 -304 -916 -369 C \nATOM 2828 CD1 ILE B 45 -10.924 -18.517 1.738 1.00100.16 C \nANISOU 2828 CD1 ILE B 45 11656 13393 13007 -474 -879 -333 C \nATOM 2829 N ASP B 46 -12.267 -13.957 -0.828 1.00 84.25 N \nANISOU 2829 N ASP B 46 10387 10549 11075 -206 -1084 -318 N \nATOM 2830 CA ASP B 46 -13.129 -13.067 -1.608 1.00 84.76 C \nANISOU 2830 CA ASP B 46 10672 10464 11067 -65 -1175 -342 C \nATOM 2831 C ASP B 46 -12.312 -11.991 -2.308 1.00 90.05 C \nANISOU 2831 C ASP B 46 11414 10959 11844 -257 -1146 -277 C \nATOM 2832 O ASP B 46 -12.482 -11.759 -3.510 1.00 95.59 O \nANISOU 2832 O ASP B 46 12144 11657 12520 -201 -1159 -292 O \nATOM 2833 CB ASP B 46 -14.198 -12.442 -0.719 1.00 85.98 C \nANISOU 2833 CB ASP B 46 11100 10441 11125 69 -1295 -362 C \nATOM 2834 CG ASP B 46 -15.323 -13.425 -0.394 1.00101.62 C \nANISOU 2834 CG ASP B 46 13054 12611 12944 367 -1357 -455 C \nATOM 2835 OD1 ASP B 46 -15.387 -14.501 -1.033 1.00108.06 O \nANISOU 2835 OD1 ASP B 46 13634 13722 13701 477 -1312 -508 O \nATOM 2836 OD2 ASP B 46 -16.135 -13.150 0.520 1.00108.95 O \nANISOU 2836 OD2 ASP B 46 14190 13421 13784 489 -1453 -477 O \nATOM 2837 N GLY B 47 -11.392 -11.369 -1.572 1.00 85.08 N \nANISOU 2837 N GLY B 47 10791 10216 11321 -475 -1104 -210 N \nATOM 2838 CA GLY B 47 -10.540 -10.344 -2.135 1.00 78.88 C \nANISOU 2838 CA GLY B 47 10040 9314 10615 -653 -1074 -155 C \nATOM 2839 C GLY B 47 -9.591 -10.892 -3.186 1.00 80.48 C \nANISOU 2839 C GLY B 47 10052 9640 10887 -710 -987 -150 C \nATOM 2840 O GLY B 47 -9.538 -10.404 -4.331 1.00 86.49 O \nANISOU 2840 O GLY B 47 10850 10362 11649 -711 -991 -147 O \nATOM 2841 N VAL B 48 -8.823 -11.901 -2.810 1.00 77.15 N \nANISOU 2841 N VAL B 48 9448 9354 10510 -772 -915 -146 N \nATOM 2842 CA VAL B 48 -7.763 -12.417 -3.695 1.00 83.17 C \nANISOU 2842 CA VAL B 48 10073 10204 11323 -867 -841 -132 C \nATOM 2843 C VAL B 48 -8.326 -13.031 -4.973 1.00 86.50 C \nANISOU 2843 C VAL B 48 10433 10757 11676 -757 -845 -174 C \nATOM 2844 O VAL B 48 -7.745 -12.891 -6.046 1.00 95.56 O \nANISOU 2844 O VAL B 48 11553 11902 12854 -814 -815 -160 O \nATOM 2845 CB VAL B 48 -6.837 -13.410 -2.947 1.00 80.95 C \nANISOU 2845 CB VAL B 48 9665 10019 11073 -977 -783 -115 C \nATOM 2846 CG1 VAL B 48 -6.335 -14.513 -3.860 1.00 81.04 C \nANISOU 2846 CG1 VAL B 48 9551 10188 11054 -1030 -737 -122 C \nATOM 2847 CG2 VAL B 48 -5.662 -12.655 -2.308 1.00 76.62 C \nANISOU 2847 CG2 VAL B 48 9157 9346 10608 -1109 -758 -69 C \nATOM 2848 N THR B 49 -9.465 -13.696 -4.871 1.00 91.80 N \nANISOU 2848 N THR B 49 11080 11560 12239 -585 -888 -230 N \nATOM 2849 CA THR B 49 -10.019 -14.393 -6.035 1.00 91.64 C \nANISOU 2849 CA THR B 49 10965 11731 12122 -463 -891 -280 C \nATOM 2850 C THR B 49 -10.522 -13.409 -7.087 1.00 96.99 C \nANISOU 2850 C THR B 49 11791 12273 12787 -366 -942 -291 C \nATOM 2851 O THR B 49 -10.279 -13.600 -8.274 1.00105.14 O \nANISOU 2851 O THR B 49 12752 13384 13813 -377 -914 -297 O \nATOM 2852 CB THR B 49 -11.163 -15.353 -5.678 1.00 91.32 C \nANISOU 2852 CB THR B 49 10843 11924 11930 -258 -932 -354 C \nATOM 2853 OG1 THR B 49 -11.940 -14.769 -4.637 1.00 99.60 O \nANISOU 2853 OG1 THR B 49 12064 12823 12955 -138 -1007 -368 O \nATOM 2854 CG2 THR B 49 -10.626 -16.705 -5.205 1.00 94.73 C \nANISOU 2854 CG2 THR B 49 11051 12611 12329 -382 -866 -350 C \nATOM 2855 N ASN B 50 -11.206 -12.351 -6.665 1.00 88.19 N \nANISOU 2855 N ASN B 50 10902 10950 11657 -291 -1023 -290 N \nATOM 2856 CA ASN B 50 -11.724 -11.368 -7.620 1.00 84.54 C \nANISOU 2856 CA ASN B 50 10622 10337 11161 -220 -1086 -296 C \nATOM 2857 C ASN B 50 -10.606 -10.533 -8.224 1.00 79.00 C \nANISOU 2857 C ASN B 50 9919 9519 10578 -431 -1031 -232 C \nATOM 2858 O ASN B 50 -10.728 -10.043 -9.347 1.00 83.21 O \nANISOU 2858 O ASN B 50 10514 10005 11099 -405 -1048 -235 O \nATOM 2859 CB ASN B 50 -12.726 -10.442 -6.936 1.00 87.27 C \nANISOU 2859 CB ASN B 50 11258 10472 11428 -128 -1203 -303 C \nATOM 2860 CG ASN B 50 -13.729 -11.186 -6.082 1.00 90.02 C \nANISOU 2860 CG ASN B 50 11632 10915 11658 85 -1265 -366 C \nATOM 2861 OD1 ASN B 50 -13.797 -12.416 -6.103 1.00 91.61 O \nANISOU 2861 OD1 ASN B 50 11610 11379 11817 185 -1221 -413 O \nATOM 2862 ND2 ASN B 50 -14.516 -10.440 -5.317 1.00 89.21 N \nANISOU 2862 ND2 ASN B 50 11808 10608 11480 145 -1372 -367 N \nATOM 2863 N LYS B 51 -9.521 -10.389 -7.482 1.00 72.37 N \nANISOU 2863 N LYS B 51 9008 8649 9839 -619 -970 -179 N \nATOM 2864 CA LYS B 51 -8.312 -9.825 -8.035 1.00 71.25 C \nANISOU 2864 CA LYS B 51 8820 8461 9791 -786 -910 -132 C \nATOM 2865 C LYS B 51 -7.855 -10.619 -9.236 1.00 80.68 C \nANISOU 2865 C LYS B 51 9874 9786 10995 -777 -857 -147 C \nATOM 2866 O LYS B 51 -7.647 -10.063 -10.323 1.00 89.43 O \nANISOU 2866 O LYS B 51 11013 10848 12118 -794 -854 -139 O \nATOM 2867 CB LYS B 51 -7.211 -9.841 -7.009 1.00 70.19 C \nANISOU 2867 CB LYS B 51 8612 8325 9732 -932 -858 -93 C \nATOM 2868 CG LYS B 51 -5.932 -9.197 -7.486 1.00 69.38 C \nANISOU 2868 CG LYS B 51 8475 8189 9697 -1062 -810 -56 C \nATOM 2869 CD LYS B 51 -4.779 -9.427 -6.523 1.00 67.45 C \nANISOU 2869 CD LYS B 51 8156 7970 9502 -1157 -764 -33 C \nATOM 2870 CE LYS B 51 -4.558 -8.198 -5.684 1.00 68.71 C \nANISOU 2870 CE LYS B 51 8380 8066 9663 -1236 -785 -5 C \nATOM 2871 NZ LYS B 51 -3.542 -8.300 -4.619 1.00 76.38 N \nANISOU 2871 NZ LYS B 51 9288 9071 10660 -1296 -753 9 N \nATOM 2872 N VAL B 52 -7.725 -11.925 -9.047 1.00 83.77 N \nANISOU 2872 N VAL B 52 10116 10352 11361 -768 -818 -168 N \nATOM 2873 CA VAL B 52 -7.406 -12.824 -10.148 1.00 83.34 C \nANISOU 2873 CA VAL B 52 9932 10458 11277 -785 -776 -182 C \nATOM 2874 C VAL B 52 -8.404 -12.678 -11.319 1.00 82.64 C \nANISOU 2874 C VAL B 52 9871 10418 11111 -623 -818 -227 C \nATOM 2875 O VAL B 52 -8.004 -12.610 -12.485 1.00 93.75 O \nANISOU 2875 O VAL B 52 11250 11840 12532 -661 -793 -220 O \nATOM 2876 CB VAL B 52 -7.380 -14.300 -9.670 1.00 81.08 C \nANISOU 2876 CB VAL B 52 9487 10397 10922 -816 -745 -199 C \nATOM 2877 CG1 VAL B 52 -7.384 -15.265 -10.852 1.00 74.10 C \nANISOU 2877 CG1 VAL B 52 8467 9736 9953 -831 -718 -222 C \nATOM 2878 CG2 VAL B 52 -6.155 -14.544 -8.801 1.00 82.69 C \nANISOU 2878 CG2 VAL B 52 9680 10542 11195 -999 -702 -151 C \nATOM 2879 N ASN B 53 -9.696 -12.688 -11.019 1.00 70.87 N \nANISOU 2879 N ASN B 53 8447 8958 9523 -426 -889 -278 N \nATOM 2880 CA ASN B 53 -10.694 -12.649 -12.078 1.00 74.63 C \nANISOU 2880 CA ASN B 53 8964 9497 9895 -228 -943 -335 C \nATOM 2881 C ASN B 53 -10.651 -11.300 -12.785 1.00 83.81 C \nANISOU 2881 C ASN B 53 10316 10420 11109 -253 -978 -306 C \nATOM 2882 O ASN B 53 -10.706 -11.223 -14.008 1.00 85.93 O \nANISOU 2882 O ASN B 53 10571 10721 11357 -212 -976 -320 O \nATOM 2883 CB ASN B 53 -12.106 -12.951 -11.548 1.00 75.56 C \nANISOU 2883 CB ASN B 53 9149 9695 9865 36 -1031 -408 C \nATOM 2884 CG ASN B 53 -12.198 -14.307 -10.862 1.00 82.70 C \nANISOU 2884 CG ASN B 53 9840 10888 10695 63 -996 -442 C \nATOM 2885 OD1 ASN B 53 -11.480 -15.248 -11.209 1.00 82.39 O \nANISOU 2885 OD1 ASN B 53 9585 11062 10659 -79 -916 -428 O \nATOM 2886 ND2 ASN B 53 -13.074 -14.405 -9.869 1.00 84.10 N \nANISOU 2886 ND2 ASN B 53 10093 11074 10789 229 -1062 -484 N \nATOM 2887 N SER B 54 -10.558 -10.226 -12.014 1.00 89.55 N \nANISOU 2887 N SER B 54 11215 10924 11887 -337 -1012 -264 N \nATOM 2888 CA SER B 54 -10.504 -8.898 -12.609 1.00 89.20 C \nANISOU 2888 CA SER B 54 11347 10678 11865 -404 -1049 -230 C \nATOM 2889 C SER B 54 -9.376 -8.813 -13.632 1.00 91.64 C \nANISOU 2889 C SER B 54 11531 11023 12265 -540 -968 -198 C \nATOM 2890 O SER B 54 -9.564 -8.303 -14.731 1.00 99.67 O \nANISOU 2890 O SER B 54 12614 11991 13264 -510 -990 -203 O \nATOM 2891 CB SER B 54 -10.336 -7.839 -11.524 1.00 93.46 C \nANISOU 2891 CB SER B 54 12038 11039 12433 -545 -1081 -179 C \nATOM 2892 OG SER B 54 -11.526 -7.734 -10.742 1.00 86.50 O \nANISOU 2892 OG SER B 54 11349 10075 11443 -412 -1182 -209 O \nATOM 2893 N ILE B 55 -8.202 -9.331 -13.277 1.00 92.37 N \nANISOU 2893 N ILE B 55 11463 11192 12442 -680 -885 -168 N \nATOM 2894 CA ILE B 55 -7.070 -9.395 -14.212 1.00 86.80 C \nANISOU 2894 CA ILE B 55 10659 10518 11802 -789 -818 -143 C \nATOM 2895 C ILE B 55 -7.431 -10.200 -15.451 1.00 95.11 C \nANISOU 2895 C ILE B 55 11627 11712 12800 -699 -808 -181 C \nATOM 2896 O ILE B 55 -7.175 -9.764 -16.565 1.00108.47 O \nANISOU 2896 O ILE B 55 13336 13368 14509 -716 -799 -174 O \nATOM 2897 CB ILE B 55 -5.830 -10.039 -13.538 1.00 82.84 C \nANISOU 2897 CB ILE B 55 10045 10070 11360 -922 -752 -115 C \nATOM 2898 CG1 ILE B 55 -5.214 -9.077 -12.511 1.00 82.60 C \nANISOU 2898 CG1 ILE B 55 10078 9923 11383 -1015 -754 -78 C \nATOM 2899 CG2 ILE B 55 -4.764 -10.479 -14.538 1.00 80.28 C \nANISOU 2899 CG2 ILE B 55 9646 9794 11062 -1006 -699 -102 C \nATOM 2900 CD1 ILE B 55 -4.336 -9.752 -11.481 1.00 75.84 C \nANISOU 2900 CD1 ILE B 55 9151 9108 10556 -1090 -716 -64 C \nATOM 2901 N ILE B 56 -8.027 -11.371 -15.234 1.00100.49 N \nANISOU 2901 N ILE B 56 12202 12579 13400 -608 -808 -223 N \nATOM 2902 CA ILE B 56 -8.437 -12.263 -16.321 1.00 99.19 C \nANISOU 2902 CA ILE B 56 11917 12624 13145 -524 -799 -266 C \nATOM 2903 C ILE B 56 -9.598 -11.704 -17.151 1.00 97.85 C \nANISOU 2903 C ILE B 56 11857 12424 12896 -316 -871 -315 C \nATOM 2904 O ILE B 56 -9.554 -11.766 -18.376 1.00102.20 O \nANISOU 2904 O ILE B 56 12368 13037 13427 -296 -859 -327 O \nATOM 2905 CB ILE B 56 -8.843 -13.664 -15.791 1.00100.04 C \nANISOU 2905 CB ILE B 56 11858 13007 13146 -481 -786 -305 C \nATOM 2906 CG1 ILE B 56 -7.626 -14.385 -15.221 1.00 98.42 C \nANISOU 2906 CG1 ILE B 56 11559 12845 12992 -713 -719 -255 C \nATOM 2907 CG2 ILE B 56 -9.462 -14.523 -16.897 1.00 95.87 C \nANISOU 2907 CG2 ILE B 56 11186 12759 12479 -371 -787 -361 C \nATOM 2908 CD1 ILE B 56 -7.956 -15.623 -14.419 1.00 99.84 C \nANISOU 2908 CD1 ILE B 56 11595 13270 13069 -718 -710 -280 C \nATOM 2909 N ASP B 57 -10.640 -11.215 -16.488 1.00 98.22 N \nANISOU 2909 N ASP B 57 12062 12375 12883 -157 -955 -345 N \nATOM 2910 CA ASP B 57 -11.876 -10.778 -17.170 1.00106.07 C \nANISOU 2910 CA ASP B 57 13215 13327 13759 81 -1051 -402 C \nATOM 2911 C ASP B 57 -11.721 -9.479 -17.970 1.00101.96 C \nANISOU 2911 C ASP B 57 12882 12568 13291 15 -1081 -365 C \nATOM 2912 O ASP B 57 -12.235 -9.368 -19.081 1.00104.31 O \nANISOU 2912 O ASP B 57 13225 12887 13520 144 -1117 -402 O \nATOM 2913 CB ASP B 57 -13.033 -10.622 -16.170 1.00113.19 C \nANISOU 2913 CB ASP B 57 14293 14160 14553 275 -1154 -446 C \nATOM 2914 CG ASP B 57 -13.377 -11.914 -15.466 1.00114.08 C \nANISOU 2914 CG ASP B 57 14216 14548 14579 386 -1136 -498 C \nATOM 2915 OD1 ASP B 57 -13.235 -12.988 -16.088 1.00119.04 O \nANISOU 2915 OD1 ASP B 57 14601 15477 15152 408 -1080 -531 O \nATOM 2916 OD2 ASP B 57 -13.767 -11.843 -14.282 1.00113.72 O \nANISOU 2916 OD2 ASP B 57 14264 14432 14511 430 -1180 -503 O \nATOM 2917 N LYS B 58 -11.022 -8.500 -17.407 1.00100.64 N \nANISOU 2917 N LYS B 58 12812 12201 13227 -185 -1067 -296 N \nATOM 2918 CA LYS B 58 -10.719 -7.251 -18.135 1.00102.71 C \nANISOU 2918 CA LYS B 58 13216 12282 13529 -296 -1085 -254 C \nATOM 2919 C LYS B 58 -10.039 -7.494 -19.474 1.00111.24 C \nANISOU 2919 C LYS B 58 14153 13455 14659 -336 -1017 -251 C \nATOM 2920 O LYS B 58 -10.129 -6.674 -20.387 1.00115.64 O \nANISOU 2920 O LYS B 58 14821 13908 15209 -348 -1046 -240 O \nATOM 2921 CB LYS B 58 -9.846 -6.329 -17.295 1.00 99.74 C \nANISOU 2921 CB LYS B 58 12878 11779 13240 -527 -1058 -183 C \nATOM 2922 CG LYS B 58 -10.587 -5.721 -16.121 1.00102.72 C \nANISOU 2922 CG LYS B 58 13462 12017 13550 -528 -1144 -174 C \nATOM 2923 CD LYS B 58 -11.403 -4.505 -16.559 1.00108.12 C \nANISOU 2923 CD LYS B 58 14448 12501 14132 -532 -1256 -163 C \nATOM 2924 CE LYS B 58 -12.615 -4.270 -15.663 1.00104.24 C \nANISOU 2924 CE LYS B 58 14232 11867 13505 -429 -1383 -183 C \nATOM 2925 NZ LYS B 58 -13.799 -5.061 -16.112 1.00102.02 N \nANISOU 2925 NZ LYS B 58 14033 11625 13102 -106 -1459 -270 N \nATOM 2926 N MET B 59 -9.400 -8.647 -19.600 1.00111.88 N \nANISOU 2926 N MET B 59 14005 13733 14773 -367 -936 -259 N \nATOM 2927 CA MET B 59 -8.761 -9.017 -20.836 1.00117.65 C \nANISOU 2927 CA MET B 59 14610 14561 15532 -417 -877 -256 C \nATOM 2928 C MET B 59 -9.755 -9.302 -21.971 1.00119.25 C \nANISOU 2928 C MET B 59 14821 14864 15624 -220 -922 -316 C \nATOM 2929 O MET B 59 -9.322 -9.523 -23.095 1.00118.27 O \nANISOU 2929 O MET B 59 14608 14816 15513 -257 -881 -315 O \nATOM 2930 CB MET B 59 -7.838 -10.225 -20.622 1.00126.47 C \nANISOU 2930 CB MET B 59 15522 15853 16676 -535 -795 -243 C \nATOM 2931 CG MET B 59 -6.656 -10.245 -21.571 1.00134.19 C \nANISOU 2931 CG MET B 59 16440 16828 17718 -682 -734 -208 C \nATOM 2932 SD MET B 59 -5.574 -8.820 -21.303 1.00148.53 S \nANISOU 2932 SD MET B 59 18371 18410 19652 -818 -723 -149 S \nATOM 2933 CE MET B 59 -6.106 -7.776 -22.668 1.00152.07 C \nANISOU 2933 CE MET B 59 18924 18770 20087 -749 -761 -158 C \nATOM 2934 N ASN B 60 -11.062 -9.255 -21.695 1.00124.29 N \nANISOU 2934 N ASN B 60 15585 15498 16142 1 -1014 -373 N \nATOM 2935 CA ASN B 60 -12.135 -9.478 -22.708 1.00137.08 C \nANISOU 2935 CA ASN B 60 17243 17219 17622 250 -1078 -447 C \nATOM 2936 C ASN B 60 -11.918 -8.893 -24.131 1.00141.67 C \nANISOU 2936 C ASN B 60 17867 17732 18227 226 -1073 -435 C \nATOM 2937 O ASN B 60 -12.744 -9.115 -25.040 1.00133.99 O \nANISOU 2937 O ASN B 60 16914 16860 17135 438 -1124 -499 O \nATOM 2938 CB ASN B 60 -13.465 -8.907 -22.162 1.00144.94 C \nANISOU 2938 CB ASN B 60 18516 18064 18490 478 -1214 -494 C \nATOM 2939 CG ASN B 60 -14.319 -9.940 -21.449 1.00148.59 C \nANISOU 2939 CG ASN B 60 18898 18746 18814 708 -1252 -571 C \nATOM 2940 OD1 ASN B 60 -14.333 -11.125 -21.802 1.00151.06 O \nANISOU 2940 OD1 ASN B 60 18948 19390 19058 784 -1200 -618 O \nATOM 2941 ND2 ASN B 60 -15.076 -9.485 -20.456 1.00150.01 N \nANISOU 2941 ND2 ASN B 60 19312 18759 18927 817 -1349 -586 N \nATOM 2942 N THR B 61 -10.815 -8.161 -24.312 1.00142.65 N \nANISOU 2942 N THR B 61 18000 17707 18492 -13 -1016 -361 N \nATOM 2943 CA THR B 61 -10.544 -7.397 -25.537 1.00149.85 C \nANISOU 2943 CA THR B 61 18979 18520 19439 -60 -1015 -341 C \nATOM 2944 C THR B 61 -10.450 -8.210 -26.842 1.00162.71 C \nANISOU 2944 C THR B 61 20436 20355 21032 1 -971 -375 C \nATOM 2945 O THR B 61 -11.188 -7.930 -27.791 1.00175.62 O \nANISOU 2945 O THR B 61 22161 21978 22586 156 -1028 -415 O \nATOM 2946 CB THR B 61 -9.269 -6.542 -25.384 1.00141.18 C \nANISOU 2946 CB THR B 61 17883 17281 18480 -317 -957 -262 C \nATOM 2947 OG1 THR B 61 -8.149 -7.381 -25.083 1.00134.67 O \nANISOU 2947 OG1 THR B 61 16854 16582 17732 -448 -863 -238 O \nATOM 2948 CG2 THR B 61 -9.436 -5.516 -24.282 1.00132.67 C \nANISOU 2948 CG2 THR B 61 16986 16015 17406 -396 -1010 -226 C \nATOM 2949 N GLN B 62 -9.531 -9.179 -26.893 1.00166.71 N \nANISOU 2949 N GLN B 62 20718 21040 21583 -134 -879 -357 N \nATOM 2950 CA GLN B 62 -9.295 -10.005 -28.101 1.00160.50 C \nANISOU 2950 CA GLN B 62 19762 20467 20752 -140 -832 -377 C \nATOM 2951 C GLN B 62 -10.540 -10.760 -28.637 1.00149.69 C \nANISOU 2951 C GLN B 62 18317 19354 19205 116 -880 -465 C \nATOM 2952 O GLN B 62 -11.333 -11.309 -27.859 1.00143.95 O \nANISOU 2952 O GLN B 62 17558 18762 18373 267 -919 -515 O \nATOM 2953 CB GLN B 62 -8.108 -10.979 -27.900 1.00162.16 C \nANISOU 2953 CB GLN B 62 19794 20814 21005 -364 -743 -336 C \nATOM 2954 CG GLN B 62 -8.343 -12.174 -26.981 1.00164.99 C \nANISOU 2954 CG GLN B 62 20009 21401 21277 -366 -729 -358 C \nATOM 2955 CD GLN B 62 -8.502 -11.785 -25.523 1.00176.48 C \nANISOU 2955 CD GLN B 62 21559 22712 22781 -349 -756 -346 C \nATOM 2956 OE1 GLN B 62 -8.387 -10.615 -25.163 1.00176.66 O \nANISOU 2956 OE1 GLN B 62 21753 22472 22896 -359 -784 -316 O \nATOM 2957 NE2 GLN B 62 -8.780 -12.765 -24.674 1.00195.70 N \nANISOU 2957 NE2 GLN B 62 23876 25342 25138 -335 -750 -369 N \nATOM 2958 N PHE B 63 -10.717 -10.730 -29.963 1.00141.25 N \nANISOU 2958 N PHE B 63 17223 18357 18090 183 -883 -489 N \nATOM 2959 CA PHE B 63 -11.701 -11.572 -30.672 1.00148.24 C \nANISOU 2959 CA PHE B 63 17979 19559 18786 415 -915 -578 C \nATOM 2960 C PHE B 63 -11.173 -12.147 -32.008 1.00140.16 C \nANISOU 2960 C PHE B 63 16778 18739 17736 311 -852 -573 C \nATOM 2961 O PHE B 63 -11.117 -13.362 -32.201 1.00126.47 O \nANISOU 2961 O PHE B 63 14805 17363 15886 264 -808 -597 O \nATOM 2962 CB PHE B 63 -12.986 -10.789 -30.986 1.00153.49 C \nANISOU 2962 CB PHE B 63 18871 20098 19349 728 -1034 -645 C \nATOM 2963 CG PHE B 63 -13.624 -10.111 -29.800 1.00156.68 C \nANISOU 2963 CG PHE B 63 19517 20267 19748 835 -1121 -650 C \nATOM 2964 CD1 PHE B 63 -14.451 -10.819 -28.925 1.00151.18 C \nANISOU 2964 CD1 PHE B 63 18777 19751 18912 1038 -1169 -717 C \nATOM 2965 CD2 PHE B 63 -13.437 -8.752 -29.586 1.00156.27 C \nANISOU 2965 CD2 PHE B 63 19738 19833 19803 731 -1163 -591 C \nATOM 2966 CE1 PHE B 63 -15.052 -10.193 -27.843 1.00147.02 C \nANISOU 2966 CE1 PHE B 63 18500 18992 18368 1135 -1258 -722 C \nATOM 2967 CE2 PHE B 63 -14.035 -8.120 -28.503 1.00159.63 C \nANISOU 2967 CE2 PHE B 63 20406 20047 20200 795 -1250 -590 C \nATOM 2968 CZ PHE B 63 -14.843 -8.842 -27.631 1.00151.50 C \nANISOU 2968 CZ PHE B 63 19355 19163 19043 1001 -1300 -655 C \nATOM 2969 N GLU B 64 -10.791 -11.251 -32.921 1.00141.10 N \nANISOU 2969 N GLU B 64 17020 18642 17951 258 -851 -539 N \nATOM 2970 CA GLU B 64 -10.365 -11.619 -34.281 1.00136.96 C \nANISOU 2970 CA GLU B 64 16371 18266 17403 180 -804 -536 C \nATOM 2971 C GLU B 64 -8.898 -11.990 -34.256 1.00130.56 C \nANISOU 2971 C GLU B 64 15477 17428 16701 -151 -714 -454 C \nATOM 2972 O GLU B 64 -8.199 -11.595 -33.334 1.00145.37 O \nANISOU 2972 O GLU B 64 17441 19097 18698 -287 -697 -400 O \nATOM 2973 CB GLU B 64 -10.531 -10.442 -35.257 1.00136.37 C \nANISOU 2973 CB GLU B 64 16482 17947 17385 259 -845 -532 C \nATOM 2974 CG GLU B 64 -11.968 -10.123 -35.659 1.00142.33 C \nANISOU 2974 CG GLU B 64 17358 18728 17993 600 -949 -619 C \nATOM 2975 CD GLU B 64 -12.616 -11.183 -36.560 1.00143.58 C \nANISOU 2975 CD GLU B 64 17303 19295 17957 779 -951 -703 C \nATOM 2976 OE1 GLU B 64 -12.266 -11.305 -37.765 1.00138.82 O \nANISOU 2976 OE1 GLU B 64 16611 18783 17350 715 -913 -696 O \nATOM 2977 OE2 GLU B 64 -13.506 -11.905 -36.057 1.00146.01 O \nANISOU 2977 OE2 GLU B 64 17521 19860 18095 996 -994 -780 O \nATOM 2978 N ALA B 65 -8.423 -12.697 -35.282 1.00112.18 N \nANISOU 2978 N ALA B 65 13009 15297 14317 -275 -667 -446 N \nATOM 2979 CA ALA B 65 -7.001 -13.023 -35.393 1.00102.36 C \nANISOU 2979 CA ALA B 65 11751 13991 13151 -583 -603 -369 C \nATOM 2980 C ALA B 65 -6.577 -13.090 -36.860 1.00 99.78 C \nANISOU 2980 C ALA B 65 11393 13716 12803 -664 -579 -358 C \nATOM 2981 O ALA B 65 -7.388 -13.465 -37.712 1.00105.79 O \nANISOU 2981 O ALA B 65 12038 14721 13434 -530 -593 -414 O \nATOM 2982 CB ALA B 65 -6.697 -14.326 -34.666 1.00 93.85 C \nANISOU 2982 CB ALA B 65 10526 13163 11972 -754 -572 -357 C \nATOM 2983 N VAL B 66 -5.340 -12.677 -37.172 1.00 91.56 N \nANISOU 2983 N VAL B 66 10462 12448 11878 -855 -550 -293 N \nATOM 2984 CA VAL B 66 -4.856 -12.671 -38.579 1.00 92.46 C \nANISOU 2984 CA VAL B 66 10573 12577 11980 -937 -531 -278 C \nATOM 2985 C VAL B 66 -3.317 -12.588 -38.626 1.00 90.61 C \nANISOU 2985 C VAL B 66 10464 12136 11828 -1174 -505 -207 C \nATOM 2986 O VAL B 66 -2.702 -12.096 -37.681 1.00 87.82 O \nANISOU 2986 O VAL B 66 10224 11567 11575 -1206 -509 -177 O \nATOM 2987 CB VAL B 66 -5.588 -11.586 -39.478 1.00 85.72 C \nANISOU 2987 CB VAL B 66 9787 11611 11171 -716 -563 -315 C \nATOM 2988 CG1 VAL B 66 -6.238 -10.469 -38.635 1.00 81.17 C \nANISOU 2988 CG1 VAL B 66 9351 10812 10680 -536 -612 -331 C \nATOM 2989 CG2 VAL B 66 -4.635 -10.977 -40.508 1.00 82.59 C \nANISOU 2989 CG2 VAL B 66 9485 11032 10863 -824 -543 -273 C \nATOM 2990 N GLY B 67 -2.725 -13.148 -39.693 1.00 93.25 N \nANISOU 2990 N GLY B 67 10781 12558 12093 -1332 -487 -185 N \nATOM 2991 CA GLY B 67 -1.316 -12.927 -40.065 1.00 89.04 C \nANISOU 2991 CA GLY B 67 10414 11802 11617 -1503 -482 -129 C \nATOM 2992 C GLY B 67 -1.216 -11.770 -41.042 1.00 85.97 C \nANISOU 2992 C GLY B 67 10102 11234 11330 -1382 -486 -135 C \nATOM 2993 O GLY B 67 -1.440 -10.645 -40.627 1.00 85.11 O \nANISOU 2993 O GLY B 67 10053 10948 11337 -1231 -498 -146 O \nATOM 2994 N ARG B 68 -0.869 -12.064 -42.314 1.00 83.64 N \nANISOU 2994 N ARG B 68 9805 10997 10976 -1472 -478 -125 N \nATOM 2995 CA ARG B 68 -1.009 -11.167 -43.526 1.00 71.04 C \nANISOU 2995 CA ARG B 68 8236 9314 9441 -1357 -479 -140 C \nATOM 2996 C ARG B 68 0.109 -11.388 -44.556 1.00 70.84 C \nANISOU 2996 C ARG B 68 8313 9219 9385 -1522 -475 -103 C \nATOM 2997 O ARG B 68 1.235 -11.738 -44.195 1.00 80.30 O \nANISOU 2997 O ARG B 68 9648 10298 10562 -1681 -487 -63 O \nATOM 2998 CB ARG B 68 -1.097 -9.701 -43.183 1.00 73.05 C \nANISOU 2998 CB ARG B 68 8584 9329 9844 -1189 -493 -147 C \nATOM 2999 CG ARG B 68 -1.689 -8.817 -44.284 1.00 77.98 C \nANISOU 2999 CG ARG B 68 9208 9917 10504 -1047 -501 -173 C \nATOM 3000 CD ARG B 68 -2.781 -7.878 -43.754 1.00 74.19 C \nANISOU 3000 CD ARG B 68 8749 9371 10071 -856 -533 -204 C \nATOM 3001 NE ARG B 68 -2.449 -7.412 -42.416 1.00 80.30 N \nANISOU 3001 NE ARG B 68 9589 10008 10913 -873 -541 -184 N \nATOM 3002 CZ ARG B 68 -3.300 -7.381 -41.392 1.00 93.23 C \nANISOU 3002 CZ ARG B 68 11218 11666 12538 -784 -566 -205 C \nATOM 3003 NH1 ARG B 68 -4.561 -7.767 -41.562 1.00102.62 N \nANISOU 3003 NH1 ARG B 68 12347 13004 13640 -640 -594 -253 N \nATOM 3004 NH2 ARG B 68 -2.881 -6.967 -40.207 1.00 84.68 N \nANISOU 3004 NH2 ARG B 68 10193 10466 11516 -823 -568 -182 N \nATOM 3005 N GLU B 69 -0.205 -11.194 -45.840 1.00 64.11 N \nANISOU 3005 N GLU B 69 7415 8430 8514 -1477 -469 -118 N \nATOM 3006 CA GLU B 69 0.660 -11.651 -46.928 1.00 63.27 C \nANISOU 3006 CA GLU B 69 7382 8321 8337 -1652 -468 -87 C \nATOM 3007 C GLU B 69 0.994 -10.557 -47.935 1.00 59.87 C \nANISOU 3007 C GLU B 69 7038 7706 8004 -1547 -471 -90 C \nATOM 3008 O GLU B 69 0.114 -9.857 -48.397 1.00 62.48 O \nANISOU 3008 O GLU B 69 7290 8064 8387 -1372 -466 -125 O \nATOM 3009 CB GLU B 69 -0.015 -12.819 -47.633 1.00 72.77 C \nANISOU 3009 CB GLU B 69 8410 9874 9366 -1759 -455 -100 C \nATOM 3010 CG GLU B 69 0.913 -13.775 -48.385 1.00 79.80 C \nANISOU 3010 CG GLU B 69 9382 10826 10113 -2054 -463 -52 C \nATOM 3011 CD GLU B 69 0.515 -15.253 -48.241 1.00 85.01 C \nANISOU 3011 CD GLU B 69 9883 11863 10553 -2275 -456 -45 C \nATOM 3012 OE1 GLU B 69 -0.491 -15.568 -47.546 1.00 80.19 O \nANISOU 3012 OE1 GLU B 69 9078 11487 9902 -2168 -442 -86 O \nATOM 3013 OE2 GLU B 69 1.208 -16.114 -48.842 1.00 93.98 O \nANISOU 3013 OE2 GLU B 69 11094 13080 11533 -2566 -470 2 O \nATOM 3014 N PHE B 70 2.267 -10.462 -48.324 1.00 59.85 N \nANISOU 3014 N PHE B 70 7213 7524 8003 -1655 -487 -55 N \nATOM 3015 CA PHE B 70 2.790 -9.364 -49.151 1.00 53.11 C \nANISOU 3015 CA PHE B 70 6455 6486 7237 -1553 -493 -58 C \nATOM 3016 C PHE B 70 3.776 -9.852 -50.168 1.00 50.44 C \nANISOU 3016 C PHE B 70 6256 6098 6812 -1706 -512 -30 C \nATOM 3017 O PHE B 70 4.473 -10.788 -49.911 1.00 64.43 O \nANISOU 3017 O PHE B 70 8144 7864 8473 -1894 -537 2 O \nATOM 3018 CB PHE B 70 3.503 -8.344 -48.279 1.00 53.80 C \nANISOU 3018 CB PHE B 70 6659 6355 7427 -1447 -509 -58 C \nATOM 3019 CG PHE B 70 2.617 -7.706 -47.229 1.00 50.17 C \nANISOU 3019 CG PHE B 70 6099 5911 7051 -1314 -498 -79 C \nATOM 3020 CD1 PHE B 70 2.697 -8.099 -45.945 1.00 46.68 C \nANISOU 3020 CD1 PHE B 70 5665 5469 6602 -1348 -504 -72 C \nATOM 3021 CD2 PHE B 70 1.672 -6.762 -47.589 1.00 45.99 C \nANISOU 3021 CD2 PHE B 70 5492 5394 6590 -1170 -492 -105 C \nATOM 3022 CE1 PHE B 70 1.882 -7.531 -44.999 1.00 46.28 C \nANISOU 3022 CE1 PHE B 70 5540 5427 6616 -1237 -501 -90 C \nATOM 3023 CE2 PHE B 70 0.820 -6.223 -46.685 1.00 43.67 C \nANISOU 3023 CE2 PHE B 70 5150 5101 6343 -1071 -498 -121 C \nATOM 3024 CZ PHE B 70 0.929 -6.601 -45.363 1.00 45.50 C \nANISOU 3024 CZ PHE B 70 5384 5332 6573 -1103 -501 -113 C \nATOM 3025 N ASN B 71 3.867 -9.190 -51.311 1.00 47.65 N \nANISOU 3025 N ASN B 71 5917 5690 6498 -1633 -507 -39 N \nATOM 3026 CA ASN B 71 4.766 -9.606 -52.354 1.00 48.28 C \nANISOU 3026 CA ASN B 71 6142 5713 6489 -1769 -531 -14 C \nATOM 3027 C ASN B 71 6.169 -8.982 -52.200 1.00 47.27 C \nANISOU 3027 C ASN B 71 6262 5316 6384 -1719 -576 -5 C \nATOM 3028 O ASN B 71 6.532 -8.533 -51.144 1.00 54.32 O \nANISOU 3028 O ASN B 71 7207 6105 7327 -1628 -589 -13 O \nATOM 3029 CB ASN B 71 4.147 -9.358 -53.745 1.00 49.15 C \nANISOU 3029 CB ASN B 71 6141 5929 6605 -1724 -506 -30 C \nATOM 3030 CG ASN B 71 4.232 -7.935 -54.186 1.00 50.04 C \nANISOU 3030 CG ASN B 71 6274 5890 6851 -1523 -502 -53 C \nATOM 3031 OD1 ASN B 71 4.877 -7.104 -53.557 1.00 66.48 O \nANISOU 3031 OD1 ASN B 71 8452 7804 9005 -1425 -518 -57 O \nATOM 3032 ND2 ASN B 71 3.559 -7.628 -55.242 1.00 52.51 N \nANISOU 3032 ND2 ASN B 71 6486 6286 7180 -1461 -482 -71 N \nATOM 3033 N ASN B 72 6.974 -9.040 -53.227 1.00 48.16 N \nANISOU 3033 N ASN B 72 6532 5334 6433 -1774 -606 7 N \nATOM 3034 CA ASN B 72 8.349 -8.651 -53.126 1.00 51.60 C \nANISOU 3034 CA ASN B 72 7232 5536 6838 -1715 -667 7 C \nATOM 3035 C ASN B 72 8.523 -7.133 -53.267 1.00 51.80 C \nANISOU 3035 C ASN B 72 7211 5482 6987 -1457 -655 -33 C \nATOM 3036 O ASN B 72 9.509 -6.601 -52.785 1.00 53.02 O \nANISOU 3036 O ASN B 72 7518 5499 7127 -1334 -698 -51 O \nATOM 3037 CB ASN B 72 9.146 -9.347 -54.210 1.00 55.67 C \nANISOU 3037 CB ASN B 72 7968 5975 7208 -1879 -718 35 C \nATOM 3038 CG ASN B 72 10.611 -9.389 -53.909 1.00 60.21 C \nANISOU 3038 CG ASN B 72 8897 6302 7679 -1856 -811 37 C \nATOM 3039 OD1 ASN B 72 11.015 -9.526 -52.742 1.00 68.46 O \nANISOU 3039 OD1 ASN B 72 10042 7269 8702 -1829 -844 35 O \nATOM 3040 ND2 ASN B 72 11.434 -9.342 -54.955 1.00 59.49 N \nANISOU 3040 ND2 ASN B 72 9023 6079 7503 -1862 -865 40 N \nATOM 3041 N LEU B 73 7.605 -6.462 -53.975 1.00 49.39 N \nANISOU 3041 N LEU B 73 6709 5280 6776 -1380 -604 -48 N \nATOM 3042 CA LEU B 73 7.593 -5.033 -54.084 1.00 44.71 C \nANISOU 3042 CA LEU B 73 6048 4656 6285 -1185 -589 -79 C \nATOM 3043 C LEU B 73 6.673 -4.358 -53.093 1.00 42.70 C \nANISOU 3043 C LEU B 73 5623 4475 6127 -1102 -556 -92 C \nATOM 3044 O LEU B 73 6.287 -3.215 -53.313 1.00 47.11 O \nANISOU 3044 O LEU B 73 6092 5053 6756 -995 -539 -108 O \nATOM 3045 CB LEU B 73 7.264 -4.608 -55.499 1.00 42.88 C \nANISOU 3045 CB LEU B 73 5758 4457 6076 -1162 -570 -84 C \nATOM 3046 CG LEU B 73 8.338 -4.995 -56.448 1.00 44.95 C \nANISOU 3046 CG LEU B 73 6219 4617 6243 -1213 -612 -75 C \nATOM 3047 CD1 LEU B 73 7.962 -4.567 -57.862 1.00 43.26 C \nANISOU 3047 CD1 LEU B 73 5933 4446 6060 -1190 -588 -81 C \nATOM 3048 CD2 LEU B 73 9.724 -4.430 -56.020 1.00 47.87 C \nANISOU 3048 CD2 LEU B 73 6786 4836 6566 -1077 -670 -98 C \nATOM 3049 N GLU B 74 6.398 -5.055 -51.994 1.00 45.15 N \nANISOU 3049 N GLU B 74 5914 4818 6422 -1167 -556 -81 N \nATOM 3050 CA GLU B 74 5.619 -4.502 -50.862 1.00 42.72 C \nANISOU 3050 CA GLU B 74 5483 4558 6190 -1097 -536 -91 C \nATOM 3051 C GLU B 74 6.352 -4.733 -49.555 1.00 43.41 C \nANISOU 3051 C GLU B 74 5657 4586 6250 -1099 -560 -89 C \nATOM 3052 O GLU B 74 5.743 -5.027 -48.550 1.00 42.94 O \nANISOU 3052 O GLU B 74 5526 4577 6212 -1123 -549 -85 O \nATOM 3053 CB GLU B 74 4.236 -5.147 -50.800 1.00 42.75 C \nANISOU 3053 CB GLU B 74 5344 4698 6200 -1147 -510 -90 C \nATOM 3054 CG GLU B 74 3.387 -4.912 -52.071 1.00 42.78 C \nANISOU 3054 CG GLU B 74 5263 4776 6217 -1112 -493 -102 C \nATOM 3055 CD GLU B 74 2.044 -5.627 -51.982 1.00 44.59 C \nANISOU 3055 CD GLU B 74 5358 5172 6414 -1115 -480 -115 C \nATOM 3056 OE1 GLU B 74 2.055 -6.840 -51.688 1.00 46.47 O \nANISOU 3056 OE1 GLU B 74 5568 5520 6569 -1230 -477 -106 O \nATOM 3057 OE2 GLU B 74 0.988 -4.984 -52.241 1.00 40.17 O \nANISOU 3057 OE2 GLU B 74 4732 4643 5887 -999 -482 -139 O \nATOM 3058 N ARG B 75 7.659 -4.491 -49.546 1.00 43.13 N \nANISOU 3058 N ARG B 75 5782 4443 6162 -1041 -601 -98 N \nATOM 3059 CA ARG B 75 8.462 -4.645 -48.346 1.00 42.90 C \nANISOU 3059 CA ARG B 75 5862 4349 6088 -1007 -636 -105 C \nATOM 3060 C ARG B 75 8.241 -3.527 -47.301 1.00 40.36 C \nANISOU 3060 C ARG B 75 5416 4086 5831 -884 -620 -126 C \nATOM 3061 O ARG B 75 8.376 -3.747 -46.104 1.00 39.02 O \nANISOU 3061 O ARG B 75 5262 3912 5653 -881 -630 -127 O \nATOM 3062 CB ARG B 75 9.937 -4.750 -48.737 1.00 46.85 C \nANISOU 3062 CB ARG B 75 6609 4715 6475 -946 -703 -119 C \nATOM 3063 CG ARG B 75 10.250 -5.919 -49.654 1.00 48.10 C \nANISOU 3063 CG ARG B 75 6942 4798 6537 -1112 -735 -89 C \nATOM 3064 CD ARG B 75 9.722 -7.172 -49.016 1.00 56.81 C \nANISOU 3064 CD ARG B 75 8037 5944 7604 -1315 -728 -52 C \nATOM 3065 NE ARG B 75 10.160 -8.392 -49.664 1.00 69.04 N \nANISOU 3065 NE ARG B 75 9783 7437 9011 -1527 -773 -16 N \nATOM 3066 CZ ARG B 75 9.639 -9.599 -49.394 1.00 80.78 C \nANISOU 3066 CZ ARG B 75 11241 9022 10431 -1760 -764 22 C \nATOM 3067 NH1 ARG B 75 8.648 -9.719 -48.508 1.00 85.19 N \nANISOU 3067 NH1 ARG B 75 11578 9728 11063 -1769 -711 21 N \nATOM 3068 NH2 ARG B 75 10.089 -10.689 -50.020 1.00 77.42 N \nANISOU 3068 NH2 ARG B 75 11008 8565 9843 -1996 -811 62 N \nATOM 3069 N ARG B 76 7.884 -2.333 -47.748 1.00 40.97 N \nANISOU 3069 N ARG B 76 5375 4230 5961 -805 -597 -141 N \nATOM 3070 CA ARG B 76 7.596 -1.232 -46.749 1.00 40.00 C \nANISOU 3070 CA ARG B 76 5132 4193 5873 -739 -585 -153 C \nATOM 3071 C ARG B 76 6.375 -1.522 -45.962 1.00 36.20 C \nANISOU 3071 C ARG B 76 4558 3744 5454 -821 -560 -132 C \nATOM 3072 O ARG B 76 6.406 -1.592 -44.737 1.00 32.64 O \nANISOU 3072 O ARG B 76 4094 3305 5001 -819 -565 -132 O \nATOM 3073 CB ARG B 76 7.428 0.084 -47.470 1.00 37.81 C \nANISOU 3073 CB ARG B 76 4763 3995 5609 -688 -572 -164 C \nATOM 3074 CG ARG B 76 8.697 0.590 -48.148 1.00 37.48 C \nANISOU 3074 CG ARG B 76 4791 3964 5488 -565 -600 -198 C \nATOM 3075 CD ARG B 76 8.395 1.764 -49.032 1.00 36.11 C \nANISOU 3075 CD ARG B 76 4514 3883 5324 -550 -583 -203 C \nATOM 3076 NE ARG B 76 7.508 1.335 -50.094 1.00 38.47 N \nANISOU 3076 NE ARG B 76 4813 4117 5687 -639 -562 -177 N \nATOM 3077 CZ ARG B 76 6.709 2.164 -50.737 1.00 42.96 C \nANISOU 3077 CZ ARG B 76 5298 4735 6288 -676 -545 -167 C \nATOM 3078 NH1 ARG B 76 6.657 3.467 -50.397 1.00 47.66 N \nANISOU 3078 NH1 ARG B 76 5805 5452 6853 -673 -546 -173 N \nATOM 3079 NH2 ARG B 76 5.979 1.727 -51.708 1.00 43.40 N \nANISOU 3079 NH2 ARG B 76 5365 4737 6386 -725 -533 -153 N \nATOM 3080 N ILE B 77 5.309 -1.874 -46.689 1.00 37.08 N \nANISOU 3080 N ILE B 77 4618 3868 5604 -882 -540 -118 N \nATOM 3081 CA ILE B 77 4.059 -2.308 -46.031 1.00 39.07 C \nANISOU 3081 CA ILE B 77 4798 4157 5890 -928 -529 -108 C \nATOM 3082 C ILE B 77 4.265 -3.510 -45.154 1.00 37.94 C \nANISOU 3082 C ILE B 77 4686 4010 5718 -987 -532 -100 C \nATOM 3083 O ILE B 77 3.715 -3.601 -44.042 1.00 47.77 O \nANISOU 3083 O ILE B 77 5888 5281 6981 -992 -530 -98 O \nATOM 3084 CB ILE B 77 2.997 -2.652 -47.104 1.00 46.75 C \nANISOU 3084 CB ILE B 77 5725 5167 6870 -943 -518 -109 C \nATOM 3085 CG1 ILE B 77 2.623 -1.438 -47.921 1.00 47.63 C \nANISOU 3085 CG1 ILE B 77 5822 5269 7006 -895 -522 -114 C \nATOM 3086 CG2 ILE B 77 1.705 -3.121 -46.440 1.00 56.98 C \nANISOU 3086 CG2 ILE B 77 6959 6522 8171 -940 -519 -113 C \nATOM 3087 CD1 ILE B 77 2.228 -0.251 -47.054 1.00 48.16 C \nANISOU 3087 CD1 ILE B 77 5875 5334 7087 -882 -537 -110 C \nATOM 3088 N GLU B 78 5.025 -4.478 -45.624 1.00 38.79 N \nANISOU 3088 N GLU B 78 4886 4087 5766 -1051 -542 -92 N \nATOM 3089 CA GLU B 78 5.227 -5.714 -44.846 1.00 43.94 C \nANISOU 3089 CA GLU B 78 5588 4742 6363 -1151 -552 -77 C \nATOM 3090 C GLU B 78 5.936 -5.441 -43.557 1.00 42.56 C \nANISOU 3090 C GLU B 78 5476 4508 6186 -1103 -573 -82 C \nATOM 3091 O GLU B 78 5.595 -5.963 -42.521 1.00 55.79 O \nANISOU 3091 O GLU B 78 7123 6212 7862 -1146 -570 -75 O \nATOM 3092 CB GLU B 78 6.021 -6.693 -45.714 1.00 53.36 C \nANISOU 3092 CB GLU B 78 6919 5895 7461 -1263 -575 -61 C \nATOM 3093 CG GLU B 78 6.302 -8.038 -45.054 1.00 65.60 C \nANISOU 3093 CG GLU B 78 8554 7453 8916 -1422 -596 -36 C \nATOM 3094 CD GLU B 78 7.121 -8.947 -45.952 1.00 76.54 C \nANISOU 3094 CD GLU B 78 10121 8785 10175 -1574 -634 -12 C \nATOM 3095 OE1 GLU B 78 6.715 -10.110 -46.167 1.00 96.28 O \nANISOU 3095 OE1 GLU B 78 12591 11406 12586 -1766 -628 14 O \nATOM 3096 OE2 GLU B 78 8.175 -8.504 -46.467 1.00 79.47 O \nANISOU 3096 OE2 GLU B 78 10670 9009 10514 -1507 -675 -20 O \nATOM 3097 N ASN B 79 6.914 -4.571 -43.620 1.00 46.13 N \nANISOU 3097 N ASN B 79 6000 4900 6625 -996 -595 -101 N \nATOM 3098 CA ASN B 79 7.707 -4.209 -42.458 1.00 52.11 C \nANISOU 3098 CA ASN B 79 6813 5630 7355 -914 -621 -117 C \nATOM 3099 C ASN B 79 6.812 -3.431 -41.515 1.00 48.89 C \nANISOU 3099 C ASN B 79 6246 5310 7020 -890 -592 -118 C \nATOM 3100 O ASN B 79 6.913 -3.581 -40.292 1.00 41.92 O \nANISOU 3100 O ASN B 79 5364 4432 6132 -886 -599 -119 O \nATOM 3101 CB ASN B 79 8.912 -3.348 -42.876 1.00 55.19 C \nANISOU 3101 CB ASN B 79 7289 5994 7685 -764 -655 -151 C \nATOM 3102 CG ASN B 79 9.911 -3.180 -41.764 1.00 62.44 C \nANISOU 3102 CG ASN B 79 8297 6897 8531 -649 -698 -179 C \nATOM 3103 OD1 ASN B 79 10.112 -2.092 -41.292 1.00 63.10 O \nANISOU 3103 OD1 ASN B 79 8280 7086 8607 -532 -694 -208 O \nATOM 3104 ND2 ASN B 79 10.545 -4.278 -41.339 1.00 70.89 N \nANISOU 3104 ND2 ASN B 79 9562 7847 9525 -691 -744 -172 N \nATOM 3105 N LEU B 80 5.978 -2.560 -42.099 1.00 44.48 N \nANISOU 3105 N LEU B 80 5576 4809 6514 -881 -568 -117 N \nATOM 3106 CA LEU B 80 4.984 -1.801 -41.322 1.00 44.89 C \nANISOU 3106 CA LEU B 80 5521 4922 6613 -890 -555 -112 C \nATOM 3107 C LEU B 80 4.062 -2.742 -40.576 1.00 42.77 C \nANISOU 3107 C LEU B 80 5230 4652 6369 -951 -548 -98 C \nATOM 3108 O LEU B 80 3.839 -2.600 -39.370 1.00 40.42 O \nANISOU 3108 O LEU B 80 4907 4371 6081 -954 -552 -96 O \nATOM 3109 CB LEU B 80 4.183 -0.884 -42.271 1.00 46.13 C \nANISOU 3109 CB LEU B 80 5624 5107 6795 -894 -548 -108 C \nATOM 3110 CG LEU B 80 3.008 -0.112 -41.713 1.00 48.20 C \nANISOU 3110 CG LEU B 80 5841 5395 7077 -928 -555 -97 C \nATOM 3111 CD1 LEU B 80 3.319 0.507 -40.383 1.00 56.08 C \nANISOU 3111 CD1 LEU B 80 6811 6445 8052 -939 -564 -95 C \nATOM 3112 CD2 LEU B 80 2.605 0.974 -42.631 1.00 49.46 C \nANISOU 3112 CD2 LEU B 80 5995 5571 7227 -940 -564 -93 C \nATOM 3113 N ASN B 81 3.516 -3.728 -41.297 1.00 44.52 N \nANISOU 3113 N ASN B 81 5449 4881 6587 -998 -539 -93 N \nATOM 3114 CA ASN B 81 2.741 -4.790 -40.636 1.00 50.36 C \nANISOU 3114 CA ASN B 81 6149 5669 7317 -1048 -534 -88 C \nATOM 3115 C ASN B 81 3.554 -5.502 -39.534 1.00 53.38 C \nANISOU 3115 C ASN B 81 6589 6024 7668 -1095 -543 -79 C \nATOM 3116 O ASN B 81 3.073 -5.702 -38.435 1.00 51.79 O \nANISOU 3116 O ASN B 81 6349 5850 7479 -1101 -542 -78 O \nATOM 3117 CB ASN B 81 2.336 -5.851 -41.651 1.00 55.20 C \nANISOU 3117 CB ASN B 81 6736 6352 7886 -1105 -524 -87 C \nATOM 3118 CG ASN B 81 1.268 -6.782 -41.124 1.00 59.04 C \nANISOU 3118 CG ASN B 81 7134 6960 8340 -1126 -518 -95 C \nATOM 3119 OD1 ASN B 81 0.107 -6.403 -41.027 1.00 61.43 O \nANISOU 3119 OD1 ASN B 81 7377 7305 8657 -1039 -525 -114 O \nATOM 3120 ND2 ASN B 81 1.661 -7.966 -40.729 1.00 58.60 N \nANISOU 3120 ND2 ASN B 81 7085 6961 8218 -1237 -515 -82 N \nATOM 3121 N LYS B 82 4.775 -5.921 -39.849 1.00 51.21 N \nANISOU 3121 N LYS B 82 6433 5684 7339 -1125 -561 -75 N \nATOM 3122 CA LYS B 82 5.582 -6.599 -38.851 1.00 64.17 C \nANISOU 3122 CA LYS B 82 8177 7275 8929 -1166 -585 -68 C \nATOM 3123 C LYS B 82 5.769 -5.746 -37.591 1.00 72.57 C \nANISOU 3123 C LYS B 82 9213 8332 10027 -1073 -590 -81 C \nATOM 3124 O LYS B 82 5.684 -6.255 -36.474 1.00 73.38 O \nANISOU 3124 O LYS B 82 9318 8438 10123 -1107 -594 -75 O \nATOM 3125 CB LYS B 82 6.929 -6.939 -39.431 1.00 75.20 C \nANISOU 3125 CB LYS B 82 9767 8566 10240 -1177 -626 -68 C \nATOM 3126 CG LYS B 82 7.894 -7.554 -38.445 1.00 81.84 C \nANISOU 3126 CG LYS B 82 10777 9318 11001 -1198 -673 -65 C \nATOM 3127 CD LYS B 82 7.482 -8.969 -38.076 1.00 93.67 C \nANISOU 3127 CD LYS B 82 12293 10853 12444 -1390 -673 -32 C \nATOM 3128 CE LYS B 82 8.623 -9.699 -37.380 1.00100.12 C \nANISOU 3128 CE LYS B 82 13357 11539 13145 -1446 -739 -22 C \nATOM 3129 NZ LYS B 82 9.242 -8.952 -36.240 1.00101.87 N \nANISOU 3129 NZ LYS B 82 13621 11699 13384 -1274 -763 -52 N \nATOM 3130 N LYS B 83 6.039 -4.448 -37.756 1.00 76.67 N \nANISOU 3130 N LYS B 83 9697 8865 10568 -968 -590 -99 N \nATOM 3131 CA LYS B 83 6.316 -3.575 -36.602 1.00 71.27 C \nANISOU 3131 CA LYS B 83 8973 8222 9886 -896 -597 -113 C \nATOM 3132 C LYS B 83 5.099 -3.260 -35.767 1.00 60.54 C \nANISOU 3132 C LYS B 83 7501 6918 8584 -939 -577 -100 C \nATOM 3133 O LYS B 83 5.189 -3.134 -34.526 1.00 57.23 O \nANISOU 3133 O LYS B 83 7064 6520 8160 -930 -582 -101 O \nATOM 3134 CB LYS B 83 6.952 -2.275 -37.034 1.00 82.26 C \nANISOU 3134 CB LYS B 83 10335 9675 11246 -794 -604 -138 C \nATOM 3135 CG LYS B 83 8.385 -2.436 -37.564 1.00 94.74 C \nANISOU 3135 CG LYS B 83 12057 11204 12737 -688 -643 -167 C \nATOM 3136 CD LYS B 83 9.086 -3.736 -37.114 1.00 97.08 C \nANISOU 3136 CD LYS B 83 12536 11374 12974 -709 -682 -163 C \nATOM 3137 CE LYS B 83 10.558 -3.849 -37.518 1.00 95.45 C \nANISOU 3137 CE LYS B 83 12540 11083 12645 -579 -747 -198 C \nATOM 3138 NZ LYS B 83 10.965 -5.252 -37.811 1.00 91.38 N \nANISOU 3138 NZ LYS B 83 12253 10403 12064 -688 -791 -174 N \nATOM 3139 N MET B 84 3.954 -3.179 -36.416 1.00 53.44 N \nANISOU 3139 N MET B 84 6547 6033 7726 -976 -562 -90 N \nATOM 3140 CA MET B 84 2.684 -3.149 -35.680 1.00 50.19 C \nANISOU 3140 CA MET B 84 6081 5642 7345 -1004 -562 -81 C \nATOM 3141 C MET B 84 2.521 -4.326 -34.747 1.00 51.61 C \nANISOU 3141 C MET B 84 6263 5825 7521 -1038 -559 -77 C \nATOM 3142 O MET B 84 2.131 -4.168 -33.579 1.00 55.99 O \nANISOU 3142 O MET B 84 6797 6391 8087 -1040 -565 -74 O \nATOM 3143 CB MET B 84 1.489 -3.138 -36.618 1.00 52.10 C \nANISOU 3143 CB MET B 84 6305 5890 7602 -1000 -563 -82 C \nATOM 3144 CG MET B 84 0.221 -2.761 -35.880 1.00 54.89 C \nANISOU 3144 CG MET B 84 6656 6242 7959 -992 -586 -80 C \nATOM 3145 SD MET B 84 -1.169 -2.761 -36.917 1.00 68.56 S \nANISOU 3145 SD MET B 84 8410 7968 9673 -936 -610 -95 S \nATOM 3146 CE MET B 84 -1.428 -4.547 -37.023 1.00 49.19 C \nANISOU 3146 CE MET B 84 5884 5615 7192 -917 -588 -114 C \nATOM 3147 N GLU B 85 2.817 -5.529 -35.229 1.00 56.11 N \nANISOU 3147 N GLU B 85 6862 6397 8059 -1085 -553 -74 N \nATOM 3148 CA GLU B 85 2.705 -6.743 -34.358 1.00 58.78 C \nANISOU 3148 CA GLU B 85 7199 6767 8368 -1151 -553 -67 C \nATOM 3149 C GLU B 85 3.724 -6.801 -33.264 1.00 56.66 C \nANISOU 3149 C GLU B 85 7006 6442 8082 -1155 -568 -63 C \nATOM 3150 O GLU B 85 3.375 -7.035 -32.118 1.00 65.16 O \nANISOU 3150 O GLU B 85 8051 7539 9168 -1166 -568 -61 O \nATOM 3151 CB GLU B 85 2.755 -8.030 -35.166 1.00 71.20 C \nANISOU 3151 CB GLU B 85 8784 8393 9874 -1250 -548 -59 C \nATOM 3152 CG GLU B 85 1.726 -8.133 -36.297 1.00 78.95 C \nANISOU 3152 CG GLU B 85 9675 9471 10849 -1231 -534 -70 C \nATOM 3153 CD GLU B 85 0.281 -7.900 -35.856 1.00 86.77 C \nANISOU 3153 CD GLU B 85 10568 10539 11860 -1143 -535 -92 C \nATOM 3154 OE1 GLU B 85 -0.020 -7.849 -34.635 1.00 91.61 O \nANISOU 3154 OE1 GLU B 85 11171 11146 12490 -1123 -543 -93 O \nATOM 3155 OE2 GLU B 85 -0.575 -7.781 -36.763 1.00 96.31 O \nANISOU 3155 OE2 GLU B 85 11728 11810 13054 -1080 -537 -111 O \nATOM 3156 N ASP B 86 4.979 -6.563 -33.577 1.00 63.95 N \nANISOU 3156 N ASP B 86 8036 7293 8967 -1123 -589 -69 N \nATOM 3157 CA ASP B 86 6.008 -6.438 -32.517 1.00 69.94 C \nANISOU 3157 CA ASP B 86 8882 8004 9690 -1073 -616 -78 C \nATOM 3158 C ASP B 86 5.639 -5.307 -31.568 1.00 73.52 C \nANISOU 3158 C ASP B 86 9228 8519 10188 -1003 -605 -89 C \nATOM 3159 O ASP B 86 5.827 -5.425 -30.373 1.00 80.98 O \nANISOU 3159 O ASP B 86 10178 9467 11123 -994 -614 -90 O \nATOM 3160 CB ASP B 86 7.395 -6.140 -33.104 1.00 78.80 C \nANISOU 3160 CB ASP B 86 10148 9053 10738 -986 -655 -99 C \nATOM 3161 CG ASP B 86 7.902 -7.251 -34.002 1.00 91.79 C \nANISOU 3161 CG ASP B 86 11955 10611 12310 -1080 -682 -83 C \nATOM 3162 OD1 ASP B 86 7.440 -8.405 -33.853 1.00105.51 O \nANISOU 3162 OD1 ASP B 86 13704 12359 14026 -1232 -677 -55 O \nATOM 3163 OD2 ASP B 86 8.770 -6.982 -34.867 1.00 99.79 O \nANISOU 3163 OD2 ASP B 86 13089 11560 13267 -1013 -714 -99 O \nATOM 3164 N GLY B 87 5.130 -4.208 -32.120 1.00 71.49 N \nANISOU 3164 N GLY B 87 8885 8313 9964 -973 -591 -92 N \nATOM 3165 CA GLY B 87 4.732 -3.054 -31.319 1.00 70.78 C \nANISOU 3165 CA GLY B 87 8708 8298 9888 -956 -588 -94 C \nATOM 3166 C GLY B 87 3.738 -3.419 -30.229 1.00 64.61 C \nANISOU 3166 C GLY B 87 7890 7516 9141 -1011 -584 -78 C \nATOM 3167 O GLY B 87 4.010 -3.168 -29.055 1.00 74.70 O \nANISOU 3167 O GLY B 87 9152 8827 10405 -1002 -591 -80 O \nATOM 3168 N PHE B 88 2.605 -4.008 -30.607 1.00 46.50 N \nANISOU 3168 N PHE B 88 5584 5204 6880 -1050 -578 -68 N \nATOM 3169 CA PHE B 88 1.580 -4.382 -29.638 1.00 49.54 C \nANISOU 3169 CA PHE B 88 5943 5597 7281 -1072 -583 -62 C \nATOM 3170 C PHE B 88 1.965 -5.518 -28.733 1.00 55.89 C \nANISOU 3170 C PHE B 88 6759 6403 8074 -1098 -578 -61 C \nATOM 3171 O PHE B 88 1.563 -5.574 -27.555 1.00 60.19 O \nANISOU 3171 O PHE B 88 7284 6958 8626 -1105 -583 -58 O \nATOM 3172 CB PHE B 88 0.274 -4.742 -30.334 1.00 47.37 C \nANISOU 3172 CB PHE B 88 5655 5332 7010 -1058 -588 -68 C \nATOM 3173 CG PHE B 88 -0.460 -3.565 -30.876 1.00 40.60 C \nANISOU 3173 CG PHE B 88 4826 4450 6152 -1041 -612 -66 C \nATOM 3174 CD1 PHE B 88 -0.866 -2.532 -30.037 1.00 43.85 C \nANISOU 3174 CD1 PHE B 88 5270 4841 6549 -1071 -640 -53 C \nATOM 3175 CD2 PHE B 88 -0.774 -3.507 -32.161 1.00 40.44 C \nANISOU 3175 CD2 PHE B 88 4815 4425 6127 -1015 -613 -73 C \nATOM 3176 CE1 PHE B 88 -1.575 -1.428 -30.513 1.00 44.49 C \nANISOU 3176 CE1 PHE B 88 5418 4887 6600 -1095 -676 -44 C \nATOM 3177 CE2 PHE B 88 -1.496 -2.407 -32.660 1.00 44.54 C \nANISOU 3177 CE2 PHE B 88 5392 4903 6629 -1010 -646 -69 C \nATOM 3178 CZ PHE B 88 -1.865 -1.362 -31.843 1.00 42.13 C \nANISOU 3178 CZ PHE B 88 5142 4568 6298 -1061 -680 -52 C \nATOM 3179 N LEU B 89 2.818 -6.385 -29.245 1.00 68.36 N \nANISOU 3179 N LEU B 89 8390 7962 9621 -1125 -575 -61 N \nATOM 3180 CA LEU B 89 3.330 -7.507 -28.456 1.00 76.68 C \nANISOU 3180 CA LEU B 89 9493 9004 10638 -1182 -581 -54 C \nATOM 3181 C LEU B 89 4.188 -7.001 -27.308 1.00 77.95 C \nANISOU 3181 C LEU B 89 9697 9130 10790 -1133 -598 -60 C \nATOM 3182 O LEU B 89 4.045 -7.453 -26.171 1.00 88.60 O \nANISOU 3182 O LEU B 89 11040 10487 12139 -1159 -600 -55 O \nATOM 3183 CB LEU B 89 4.142 -8.422 -29.360 1.00 89.00 C \nANISOU 3183 CB LEU B 89 11154 10529 12133 -1250 -592 -46 C \nATOM 3184 CG LEU B 89 4.868 -9.604 -28.717 1.00 99.12 C \nANISOU 3184 CG LEU B 89 12550 11773 13338 -1347 -616 -32 C \nATOM 3185 CD1 LEU B 89 5.061 -10.748 -29.697 1.00 93.64 C \nANISOU 3185 CD1 LEU B 89 11928 11096 12557 -1491 -626 -12 C \nATOM 3186 CD2 LEU B 89 6.222 -9.130 -28.218 1.00104.81 C \nANISOU 3186 CD2 LEU B 89 13420 12382 14022 -1263 -656 -45 C \nATOM 3187 N ASP B 90 5.086 -6.066 -27.615 1.00 78.85 N \nANISOU 3187 N ASP B 90 9845 9230 10884 -1051 -610 -76 N \nATOM 3188 CA ASP B 90 5.950 -5.442 -26.607 1.00 83.84 C \nANISOU 3188 CA ASP B 90 10495 9882 11479 -969 -629 -95 C \nATOM 3189 C ASP B 90 5.096 -4.828 -25.500 1.00 79.05 C \nANISOU 3189 C ASP B 90 9777 9346 10913 -992 -615 -86 C \nATOM 3190 O ASP B 90 5.309 -5.100 -24.332 1.00 85.98 O \nANISOU 3190 O ASP B 90 10664 10226 11777 -987 -623 -88 O \nATOM 3191 CB ASP B 90 6.852 -4.378 -27.234 1.00 95.93 C \nANISOU 3191 CB ASP B 90 12030 11458 12959 -858 -644 -123 C \nATOM 3192 CG ASP B 90 8.027 -4.975 -28.014 1.00111.70 C \nANISOU 3192 CG ASP B 90 14198 13363 14882 -796 -681 -141 C \nATOM 3193 OD1 ASP B 90 8.061 -6.213 -28.258 1.00115.01 O \nANISOU 3193 OD1 ASP B 90 14736 13676 15287 -886 -694 -121 O \nATOM 3194 OD2 ASP B 90 8.926 -4.179 -28.390 1.00135.78 O \nANISOU 3194 OD2 ASP B 90 17269 16458 17862 -662 -704 -176 O \nATOM 3195 N VAL B 91 4.113 -4.022 -25.888 1.00 71.83 N \nANISOU 3195 N VAL B 91 8784 8474 10035 -1024 -602 -76 N \nATOM 3196 CA VAL B 91 3.235 -3.324 -24.957 1.00 64.95 C \nANISOU 3196 CA VAL B 91 7852 7649 9178 -1067 -604 -63 C \nATOM 3197 C VAL B 91 2.481 -4.311 -24.099 1.00 69.51 C \nANISOU 3197 C VAL B 91 8439 8186 9788 -1102 -603 -53 C \nATOM 3198 O VAL B 91 2.512 -4.221 -22.873 1.00 74.62 O \nANISOU 3198 O VAL B 91 9070 8855 10428 -1111 -609 -50 O \nATOM 3199 CB VAL B 91 2.235 -2.475 -25.715 1.00 62.75 C \nANISOU 3199 CB VAL B 91 7557 7376 8909 -1110 -609 -50 C \nATOM 3200 CG1 VAL B 91 1.176 -1.915 -24.783 1.00 67.71 C \nANISOU 3200 CG1 VAL B 91 8188 8009 9531 -1175 -631 -31 C \nATOM 3201 CG2 VAL B 91 2.955 -1.339 -26.414 1.00 64.07 C \nANISOU 3201 CG2 VAL B 91 7692 7624 9028 -1096 -610 -58 C \nATOM 3202 N TRP B 92 1.839 -5.289 -24.732 1.00 69.44 N \nANISOU 3202 N TRP B 92 8442 8144 9798 -1117 -596 -51 N \nATOM 3203 CA TRP B 92 1.080 -6.328 -23.978 1.00 69.01 C \nANISOU 3203 CA TRP B 92 8372 8098 9750 -1141 -596 -48 C \nATOM 3204 C TRP B 92 1.907 -7.250 -23.109 1.00 74.33 C \nANISOU 3204 C TRP B 92 9074 8765 10404 -1170 -593 -46 C \nATOM 3205 O TRP B 92 1.485 -7.639 -22.022 1.00 85.43 O \nANISOU 3205 O TRP B 92 10459 10188 11814 -1186 -596 -43 O \nATOM 3206 CB TRP B 92 0.221 -7.182 -24.918 1.00 64.65 C \nANISOU 3206 CB TRP B 92 7795 7581 9186 -1141 -591 -56 C \nATOM 3207 CG TRP B 92 -0.995 -6.432 -25.370 1.00 60.85 C \nANISOU 3207 CG TRP B 92 7314 7095 8710 -1087 -612 -64 C \nATOM 3208 CD1 TRP B 92 -1.306 -6.037 -26.638 1.00 58.73 C \nANISOU 3208 CD1 TRP B 92 7058 6819 8438 -1058 -616 -70 C \nATOM 3209 CD2 TRP B 92 -2.040 -5.944 -24.531 1.00 53.48 C \nANISOU 3209 CD2 TRP B 92 6409 6142 7770 -1056 -644 -66 C \nATOM 3210 NE1 TRP B 92 -2.504 -5.349 -26.638 1.00 58.47 N \nANISOU 3210 NE1 TRP B 92 7074 6755 8388 -1008 -656 -77 N \nATOM 3211 CE2 TRP B 92 -2.969 -5.276 -25.352 1.00 57.97 C \nANISOU 3211 CE2 TRP B 92 7034 6676 8317 -1008 -678 -74 C \nATOM 3212 CE3 TRP B 92 -2.286 -6.021 -23.173 1.00 58.23 C \nANISOU 3212 CE3 TRP B 92 7016 6739 8371 -1066 -656 -62 C \nATOM 3213 CZ2 TRP B 92 -4.137 -4.684 -24.850 1.00 64.52 C \nANISOU 3213 CZ2 TRP B 92 7959 7447 9107 -969 -735 -78 C \nATOM 3214 CZ3 TRP B 92 -3.448 -5.411 -22.651 1.00 66.74 C \nANISOU 3214 CZ3 TRP B 92 8167 7771 9420 -1031 -706 -64 C \nATOM 3215 CH2 TRP B 92 -4.360 -4.761 -23.496 1.00 66.79 C \nANISOU 3215 CH2 TRP B 92 8262 7725 9389 -984 -750 -73 C \nATOM 3216 N THR B 93 3.102 -7.581 -23.562 1.00 80.46 N \nANISOU 3216 N THR B 93 9922 9504 11145 -1174 -598 -48 N \nATOM 3217 CA THR B 93 4.049 -8.335 -22.720 1.00 78.03 C \nANISOU 3217 CA THR B 93 9699 9156 10791 -1197 -615 -46 C \nATOM 3218 C THR B 93 4.376 -7.485 -21.496 1.00 72.93 C \nANISOU 3218 C THR B 93 9032 8524 10153 -1131 -623 -56 C \nATOM 3219 O THR B 93 4.216 -7.916 -20.368 1.00 74.98 O \nANISOU 3219 O THR B 93 9285 8788 10414 -1156 -625 -51 O \nATOM 3220 CB THR B 93 5.347 -8.699 -23.498 1.00 83.06 C \nANISOU 3220 CB THR B 93 10484 9716 11359 -1192 -642 -51 C \nATOM 3221 OG1 THR B 93 5.080 -9.750 -24.428 1.00 76.17 O \nANISOU 3221 OG1 THR B 93 9641 8847 10455 -1303 -638 -34 O \nATOM 3222 CG2 THR B 93 6.472 -9.132 -22.554 1.00 82.89 C \nANISOU 3222 CG2 THR B 93 10605 9623 11267 -1170 -682 -58 C \nATOM 3223 N TYR B 94 4.841 -6.269 -21.740 1.00 73.71 N \nANISOU 3223 N TYR B 94 9107 8657 10241 -1054 -627 -72 N \nATOM 3224 CA TYR B 94 5.176 -5.329 -20.679 1.00 72.02 C \nANISOU 3224 CA TYR B 94 8842 8517 10004 -1001 -634 -84 C \nATOM 3225 C TYR B 94 4.078 -5.173 -19.640 1.00 68.40 C \nANISOU 3225 C TYR B 94 8310 8090 9588 -1067 -624 -65 C \nATOM 3226 O TYR B 94 4.360 -5.168 -18.445 1.00 58.01 O \nANISOU 3226 O TYR B 94 6986 6802 8254 -1055 -631 -69 O \nATOM 3227 CB TYR B 94 5.470 -3.965 -21.274 1.00 75.37 C \nANISOU 3227 CB TYR B 94 9202 9040 10394 -951 -634 -99 C \nATOM 3228 CG TYR B 94 5.738 -2.905 -20.243 1.00 82.19 C \nANISOU 3228 CG TYR B 94 9978 10048 11203 -925 -639 -111 C \nATOM 3229 CD1 TYR B 94 7.040 -2.620 -19.843 1.00 80.71 C \nANISOU 3229 CD1 TYR B 94 9799 9950 10919 -790 -662 -153 C \nATOM 3230 CD2 TYR B 94 4.683 -2.187 -19.674 1.00 76.99 C \nANISOU 3230 CD2 TYR B 94 9240 9448 10563 -1033 -632 -84 C \nATOM 3231 CE1 TYR B 94 7.278 -1.649 -18.912 1.00 86.45 C \nANISOU 3231 CE1 TYR B 94 10414 10863 11571 -768 -665 -168 C \nATOM 3232 CE2 TYR B 94 4.917 -1.218 -18.750 1.00 84.83 C \nANISOU 3232 CE2 TYR B 94 10147 10602 11483 -1048 -638 -90 C \nATOM 3233 CZ TYR B 94 6.214 -0.957 -18.381 1.00 90.36 C \nANISOU 3233 CZ TYR B 94 10812 11430 12089 -917 -649 -133 C \nATOM 3234 OH TYR B 94 6.442 0.032 -17.463 1.00132.97 O \nANISOU 3234 OH TYR B 94 16091 17043 17389 -934 -654 -143 O \nATOM 3235 N ASN B 95 2.839 -5.001 -20.089 1.00 66.19 N \nANISOU 3235 N ASN B 95 7997 7802 9352 -1122 -616 -48 N \nATOM 3236 CA ASN B 95 1.746 -4.799 -19.151 1.00 63.99 C \nANISOU 3236 CA ASN B 95 7692 7530 9091 -1168 -624 -34 C \nATOM 3237 C ASN B 95 1.575 -6.016 -18.268 1.00 69.69 C \nANISOU 3237 C ASN B 95 8426 8224 9829 -1176 -620 -33 C \nATOM 3238 O ASN B 95 1.653 -5.919 -17.022 1.00 74.23 O \nANISOU 3238 O ASN B 95 8988 8817 10398 -1185 -626 -30 O \nATOM 3239 CB ASN B 95 0.428 -4.501 -19.872 1.00 65.51 C \nANISOU 3239 CB ASN B 95 7900 7691 9298 -1190 -637 -25 C \nATOM 3240 CG ASN B 95 0.389 -3.098 -20.481 1.00 66.87 C \nANISOU 3240 CG ASN B 95 8076 7895 9439 -1224 -650 -16 C \nATOM 3241 OD1 ASN B 95 1.062 -2.154 -20.019 1.00 73.12 O \nANISOU 3241 OD1 ASN B 95 8825 8772 10184 -1255 -651 -13 O \nATOM 3242 ND2 ASN B 95 -0.403 -2.954 -21.511 1.00 67.53 N \nANISOU 3242 ND2 ASN B 95 8199 7932 9526 -1222 -663 -14 N \nATOM 3243 N ALA B 96 1.377 -7.168 -18.890 1.00 64.41 N \nANISOU 3243 N ALA B 96 7771 7536 9165 -1187 -612 -35 N \nATOM 3244 CA ALA B 96 1.112 -8.386 -18.119 1.00 75.22 C \nANISOU 3244 CA ALA B 96 9134 8918 10526 -1221 -609 -33 C \nATOM 3245 C ALA B 96 2.183 -8.662 -17.036 1.00 84.92 C \nANISOU 3245 C ALA B 96 10407 10123 11734 -1230 -615 -32 C \nATOM 3246 O ALA B 96 1.865 -9.002 -15.893 1.00 82.79 O \nANISOU 3246 O ALA B 96 10120 9867 11470 -1247 -617 -28 O \nATOM 3247 CB ALA B 96 1.009 -9.563 -19.057 1.00 79.77 C \nANISOU 3247 CB ALA B 96 9710 9528 11073 -1264 -599 -34 C \nATOM 3248 N GLU B 97 3.455 -8.472 -17.385 1.00 92.75 N \nANISOU 3248 N GLU B 97 11472 11077 12691 -1198 -626 -40 N \nATOM 3249 CA GLU B 97 4.544 -8.692 -16.430 1.00 92.19 C \nANISOU 3249 CA GLU B 97 11479 10974 12574 -1168 -648 -48 C \nATOM 3250 C GLU B 97 4.541 -7.698 -15.275 1.00 88.97 C \nANISOU 3250 C GLU B 97 11003 10626 12174 -1115 -649 -57 C \nATOM 3251 O GLU B 97 4.758 -8.084 -14.136 1.00 79.21 O \nANISOU 3251 O GLU B 97 9787 9385 10924 -1117 -658 -58 O \nATOM 3252 CB GLU B 97 5.893 -8.655 -17.123 1.00 97.24 C \nANISOU 3252 CB GLU B 97 12246 11556 13144 -1102 -678 -67 C \nATOM 3253 CG GLU B 97 6.034 -9.687 -18.227 1.00 98.95 C \nANISOU 3253 CG GLU B 97 12562 11706 13327 -1186 -687 -52 C \nATOM 3254 CD GLU B 97 7.362 -10.397 -18.180 1.00 98.95 C \nANISOU 3254 CD GLU B 97 12785 11592 13220 -1179 -743 -59 C \nATOM 3255 OE1 GLU B 97 7.840 -10.687 -17.070 1.00107.38 O \nANISOU 3255 OE1 GLU B 97 13927 12625 14247 -1158 -771 -64 O \nATOM 3256 OE2 GLU B 97 7.909 -10.687 -19.246 1.00 97.81 O \nANISOU 3256 OE2 GLU B 97 12763 11381 13020 -1196 -768 -58 O \nATOM 3257 N LEU B 98 4.319 -6.417 -15.562 1.00 85.26 N \nANISOU 3257 N LEU B 98 10457 10229 11709 -1087 -642 -62 N \nATOM 3258 CA LEU B 98 4.261 -5.410 -14.475 1.00 80.87 C \nANISOU 3258 CA LEU B 98 9825 9771 11132 -1080 -645 -64 C \nATOM 3259 C LEU B 98 2.963 -5.440 -13.721 1.00 66.03 C \nANISOU 3259 C LEU B 98 7908 7881 9299 -1164 -640 -39 C \nATOM 3260 O LEU B 98 2.925 -5.123 -12.541 1.00 62.69 O \nANISOU 3260 O LEU B 98 7454 7506 8859 -1180 -646 -36 O \nATOM 3261 CB LEU B 98 4.521 -3.995 -14.974 1.00 89.12 C \nANISOU 3261 CB LEU B 98 10798 10937 12126 -1060 -646 -74 C \nATOM 3262 CG LEU B 98 5.979 -3.700 -15.377 1.00 96.70 C \nANISOU 3262 CG LEU B 98 11776 11964 13000 -923 -661 -115 C \nATOM 3263 CD1 LEU B 98 6.182 -2.198 -15.399 1.00104.89 C \nANISOU 3263 CD1 LEU B 98 12687 13211 13954 -917 -661 -128 C \nATOM 3264 CD2 LEU B 98 7.016 -4.310 -14.451 1.00 97.24 C \nANISOU 3264 CD2 LEU B 98 11918 12017 13013 -816 -687 -145 C \nATOM 3265 N LEU B 99 1.927 -5.915 -14.367 1.00 63.60 N \nANISOU 3265 N LEU B 99 7617 7515 9035 -1202 -636 -27 N \nATOM 3266 CA LEU B 99 0.699 -6.160 -13.640 1.00 65.42 C \nANISOU 3266 CA LEU B 99 7845 7724 9288 -1239 -646 -14 C \nATOM 3267 C LEU B 99 0.900 -7.218 -12.573 1.00 74.28 C \nANISOU 3267 C LEU B 99 8968 8837 10417 -1240 -641 -16 C \nATOM 3268 O LEU B 99 0.442 -7.057 -11.459 1.00 91.07 O \nANISOU 3268 O LEU B 99 11084 10974 12545 -1258 -651 -10 O \nATOM 3269 CB LEU B 99 -0.409 -6.606 -14.578 1.00 62.35 C \nANISOU 3269 CB LEU B 99 7474 7301 8916 -1229 -652 -16 C \nATOM 3270 CG LEU B 99 -1.744 -6.862 -13.870 1.00 70.61 C \nANISOU 3270 CG LEU B 99 8541 8331 9958 -1219 -678 -16 C \nATOM 3271 CD1 LEU B 99 -2.198 -5.631 -13.105 1.00 65.83 C \nANISOU 3271 CD1 LEU B 99 7984 7704 9326 -1266 -712 1 C \nATOM 3272 CD2 LEU B 99 -2.832 -7.283 -14.860 1.00 75.56 C \nANISOU 3272 CD2 LEU B 99 9187 8953 10569 -1159 -694 -33 C \nATOM 3273 N VAL B 100 1.586 -8.306 -12.916 1.00 81.29 N \nANISOU 3273 N VAL B 100 9887 9704 11297 -1237 -631 -22 N \nATOM 3274 CA VAL B 100 1.791 -9.423 -11.980 1.00 71.14 C \nANISOU 3274 CA VAL B 100 8620 8410 9998 -1268 -632 -20 C \nATOM 3275 C VAL B 100 2.692 -9.033 -10.817 1.00 71.93 C \nANISOU 3275 C VAL B 100 8744 8509 10079 -1238 -643 -25 C \nATOM 3276 O VAL B 100 2.333 -9.238 -9.663 1.00 84.90 O \nANISOU 3276 O VAL B 100 10363 10164 11730 -1256 -645 -20 O \nATOM 3277 CB VAL B 100 2.360 -10.646 -12.702 1.00 67.44 C \nANISOU 3277 CB VAL B 100 8213 7921 9490 -1319 -631 -17 C \nATOM 3278 CG1 VAL B 100 2.969 -11.633 -11.731 1.00 67.42 C \nANISOU 3278 CG1 VAL B 100 8277 7896 9445 -1372 -645 -11 C \nATOM 3279 CG2 VAL B 100 1.253 -11.333 -13.493 1.00 70.56 C \nANISOU 3279 CG2 VAL B 100 8544 8383 9884 -1358 -618 -16 C \nATOM 3280 N LEU B 101 3.852 -8.473 -11.117 1.00 68.89 N \nANISOU 3280 N LEU B 101 8400 8122 9652 -1174 -655 -41 N \nATOM 3281 CA LEU B 101 4.802 -8.054 -10.067 1.00 73.38 C \nANISOU 3281 CA LEU B 101 8986 8726 10171 -1103 -673 -60 C \nATOM 3282 C LEU B 101 4.142 -7.122 -9.069 1.00 75.13 C \nANISOU 3282 C LEU B 101 9100 9038 10407 -1125 -664 -53 C \nATOM 3283 O LEU B 101 4.187 -7.355 -7.880 1.00 77.99 O \nANISOU 3283 O LEU B 101 9458 9412 10764 -1129 -670 -52 O \nATOM 3284 CB LEU B 101 6.048 -7.358 -10.670 1.00 73.24 C \nANISOU 3284 CB LEU B 101 9007 8742 10077 -983 -695 -93 C \nATOM 3285 CG LEU B 101 6.920 -8.184 -11.640 1.00 75.17 C \nANISOU 3285 CG LEU B 101 9413 8874 10275 -949 -723 -104 C \nATOM 3286 CD1 LEU B 101 8.069 -7.374 -12.210 1.00 70.03 C \nANISOU 3286 CD1 LEU B 101 8804 8270 9535 -792 -752 -146 C \nATOM 3287 CD2 LEU B 101 7.449 -9.423 -10.943 1.00 80.59 C \nANISOU 3287 CD2 LEU B 101 10252 9451 10916 -976 -756 -100 C \nATOM 3288 N MET B 102 3.517 -6.067 -9.574 1.00 78.16 N \nANISOU 3288 N MET B 102 9417 9482 10798 -1159 -657 -43 N \nATOM 3289 CA MET B 102 2.892 -5.063 -8.720 1.00 75.38 C \nANISOU 3289 CA MET B 102 8997 9218 10428 -1223 -662 -29 C \nATOM 3290 C MET B 102 1.833 -5.711 -7.864 1.00 79.94 C \nANISOU 3290 C MET B 102 9597 9723 11054 -1280 -665 -9 C \nATOM 3291 O MET B 102 1.787 -5.507 -6.659 1.00 77.43 O \nANISOU 3291 O MET B 102 9255 9448 10718 -1305 -672 -4 O \nATOM 3292 CB MET B 102 2.276 -3.952 -9.577 1.00 73.44 C \nANISOU 3292 CB MET B 102 8725 9016 10163 -1290 -666 -13 C \nATOM 3293 CG MET B 102 3.294 -2.926 -10.079 1.00 76.01 C \nANISOU 3293 CG MET B 102 8982 9494 10404 -1249 -665 -34 C \nATOM 3294 SD MET B 102 2.649 -1.869 -11.373 1.00 79.55 S \nANISOU 3294 SD MET B 102 9423 9971 10830 -1339 -670 -14 S \nATOM 3295 CE MET B 102 0.935 -1.713 -10.917 1.00 72.27 C \nANISOU 3295 CE MET B 102 8586 8939 9934 -1484 -699 30 C \nATOM 3296 N GLU B 103 0.997 -6.526 -8.497 1.00 81.30 N \nANISOU 3296 N GLU B 103 9808 9807 11274 -1289 -663 -3 N \nATOM 3297 CA GLU B 103 -0.180 -7.068 -7.838 1.00 71.14 C \nANISOU 3297 CA GLU B 103 8539 8479 10011 -1312 -675 7 C \nATOM 3298 C GLU B 103 0.165 -8.210 -6.905 1.00 66.51 C \nANISOU 3298 C GLU B 103 7947 7887 9436 -1302 -665 1 C \nATOM 3299 O GLU B 103 -0.518 -8.440 -5.896 1.00 60.55 O \nANISOU 3299 O GLU B 103 7191 7130 8687 -1317 -675 6 O \nATOM 3300 CB GLU B 103 -1.193 -7.525 -8.887 1.00 69.09 C \nANISOU 3300 CB GLU B 103 8306 8180 9767 -1290 -682 2 C \nATOM 3301 CG GLU B 103 -2.618 -7.142 -8.534 1.00 81.75 C \nANISOU 3301 CG GLU B 103 9966 9744 11349 -1289 -723 6 C \nATOM 3302 CD GLU B 103 -2.850 -5.640 -8.449 1.00 87.92 C \nANISOU 3302 CD GLU B 103 10807 10511 12089 -1362 -756 29 C \nATOM 3303 OE1 GLU B 103 -3.890 -5.244 -7.887 1.00 89.68 O \nANISOU 3303 OE1 GLU B 103 11125 10678 12270 -1386 -806 38 O \nATOM 3304 OE2 GLU B 103 -1.999 -4.857 -8.916 1.00 99.70 O \nANISOU 3304 OE2 GLU B 103 12260 12056 13567 -1404 -740 36 O \nATOM 3305 N ASN B 104 1.211 -8.954 -7.243 1.00 66.22 N \nANISOU 3305 N ASN B 104 7932 7839 9390 -1284 -653 -8 N \nATOM 3306 CA ASN B 104 1.669 -10.012 -6.357 1.00 70.64 C \nANISOU 3306 CA ASN B 104 8519 8385 9938 -1300 -653 -9 C \nATOM 3307 C ASN B 104 2.183 -9.402 -5.068 1.00 73.75 C \nANISOU 3307 C ASN B 104 8903 8804 10316 -1276 -662 -12 C \nATOM 3308 O ASN B 104 1.877 -9.894 -3.982 1.00 84.87 O \nANISOU 3308 O ASN B 104 10304 10212 11732 -1299 -664 -7 O \nATOM 3309 CB ASN B 104 2.787 -10.820 -7.006 1.00 75.47 C \nANISOU 3309 CB ASN B 104 9217 8950 10507 -1304 -659 -14 C \nATOM 3310 CG ASN B 104 2.270 -11.962 -7.853 1.00 66.80 C \nANISOU 3310 CG ASN B 104 8122 7861 9398 -1379 -650 -5 C \nATOM 3311 OD1 ASN B 104 1.074 -12.286 -7.842 1.00 68.59 O \nANISOU 3311 OD1 ASN B 104 8269 8149 9643 -1397 -639 -4 O \nATOM 3312 ND2 ASN B 104 3.185 -12.620 -8.534 1.00 59.22 N \nANISOU 3312 ND2 ASN B 104 7264 6853 8383 -1419 -664 -2 N \nATOM 3313 N GLU B 105 2.964 -8.331 -5.167 1.00 70.10 N \nANISOU 3313 N GLU B 105 8425 8393 9816 -1225 -668 -25 N \nATOM 3314 CA GLU B 105 3.366 -7.602 -3.976 1.00 76.73 C \nANISOU 3314 CA GLU B 105 9220 9316 10616 -1202 -676 -33 C \nATOM 3315 C GLU B 105 2.180 -7.145 -3.101 1.00 82.84 C \nANISOU 3315 C GLU B 105 9945 10115 11414 -1286 -677 -9 C \nATOM 3316 O GLU B 105 2.178 -7.337 -1.881 1.00 82.66 O \nANISOU 3316 O GLU B 105 9912 10108 11386 -1295 -681 -7 O \nATOM 3317 CB GLU B 105 4.176 -6.379 -4.329 1.00 77.80 C \nANISOU 3317 CB GLU B 105 9304 9576 10680 -1142 -682 -54 C \nATOM 3318 CG GLU B 105 4.828 -5.804 -3.085 1.00 94.57 C \nANISOU 3318 CG GLU B 105 11370 11833 12729 -1095 -693 -74 C \nATOM 3319 CD GLU B 105 5.007 -4.315 -3.143 1.00108.23 C \nANISOU 3319 CD GLU B 105 12979 13773 14370 -1109 -693 -82 C \nATOM 3320 OE1 GLU B 105 6.175 -3.903 -3.056 1.00115.97 O \nANISOU 3320 OE1 GLU B 105 13920 14896 15247 -975 -706 -127 O \nATOM 3321 OE2 GLU B 105 4.012 -3.540 -3.277 1.00115.31 O \nANISOU 3321 OE2 GLU B 105 13830 14708 15272 -1251 -688 -47 O \nATOM 3322 N ARG B 106 1.161 -6.566 -3.722 1.00 79.35 N \nANISOU 3322 N ARG B 106 9502 9661 10987 -1344 -682 9 N \nATOM 3323 CA ARG B 106 0.024 -6.079 -2.956 1.00 75.48 C \nANISOU 3323 CA ARG B 106 9026 9163 10490 -1422 -704 32 C \nATOM 3324 C ARG B 106 -0.639 -7.258 -2.287 1.00 75.50 C \nANISOU 3324 C ARG B 106 9059 9092 10536 -1401 -706 30 C \nATOM 3325 O ARG B 106 -1.049 -7.184 -1.125 1.00 82.26 O \nANISOU 3325 O ARG B 106 9922 9952 11383 -1433 -721 40 O \nATOM 3326 CB ARG B 106 -0.954 -5.318 -3.846 1.00 77.60 C \nANISOU 3326 CB ARG B 106 9348 9396 10742 -1477 -729 48 C \nATOM 3327 CG ARG B 106 -0.368 -3.995 -4.393 1.00 83.28 C \nANISOU 3327 CG ARG B 106 10024 10226 11393 -1535 -730 55 C \nATOM 3328 CD ARG B 106 -1.208 -3.395 -5.507 1.00101.31 C \nANISOU 3328 CD ARG B 106 12383 12452 13660 -1587 -756 71 C \nATOM 3329 NE ARG B 106 -2.575 -3.186 -5.041 1.00120.35 N \nANISOU 3329 NE ARG B 106 14923 14762 16042 -1657 -810 94 N \nATOM 3330 CZ ARG B 106 -3.563 -4.086 -5.097 1.00133.79 C \nANISOU 3330 CZ ARG B 106 16711 16339 17784 -1574 -832 82 C \nATOM 3331 NH1 ARG B 106 -3.375 -5.298 -5.612 1.00128.56 N \nANISOU 3331 NH1 ARG B 106 15996 15661 17192 -1454 -797 53 N \nATOM 3332 NH2 ARG B 106 -4.757 -3.763 -4.630 1.00139.22 N \nANISOU 3332 NH2 ARG B 106 17549 16932 18415 -1614 -898 96 N \nATOM 3333 N THR B 107 -0.726 -8.376 -2.997 1.00 77.05 N \nANISOU 3333 N THR B 107 9264 9245 10765 -1357 -693 19 N \nATOM 3334 CA THR B 107 -1.343 -9.593 -2.418 1.00 71.91 C \nANISOU 3334 CA THR B 107 8613 8580 10130 -1344 -692 13 C \nATOM 3335 C THR B 107 -0.603 -10.025 -1.156 1.00 69.47 C \nANISOU 3335 C THR B 107 8290 8286 9819 -1358 -684 14 C \nATOM 3336 O THR B 107 -1.212 -10.371 -0.147 1.00 69.33 O \nANISOU 3336 O THR B 107 8268 8270 9804 -1365 -693 17 O \nATOM 3337 CB THR B 107 -1.350 -10.744 -3.423 1.00 73.80 C \nANISOU 3337 CB THR B 107 8839 8832 10370 -1329 -676 1 C \nATOM 3338 OG1 THR B 107 -2.207 -10.424 -4.523 1.00 74.69 O \nANISOU 3338 OG1 THR B 107 8962 8940 10478 -1295 -688 -6 O \nATOM 3339 CG2 THR B 107 -1.839 -12.027 -2.785 1.00 77.42 C \nANISOU 3339 CG2 THR B 107 9266 9338 10812 -1336 -673 -6 C \nATOM 3340 N LEU B 108 0.722 -10.005 -1.208 1.00 67.63 N \nANISOU 3340 N LEU B 108 8067 8060 9569 -1343 -675 8 N \nATOM 3341 CA LEU B 108 1.525 -10.508 -0.088 1.00 66.39 C \nANISOU 3341 CA LEU B 108 7929 7904 9393 -1335 -678 3 C \nATOM 3342 C LEU B 108 1.406 -9.641 1.152 1.00 69.65 C \nANISOU 3342 C LEU B 108 8301 8368 9796 -1339 -685 7 C \nATOM 3343 O LEU B 108 1.219 -10.163 2.254 1.00 86.09 O \nANISOU 3343 O LEU B 108 10383 10444 11885 -1354 -688 10 O \nATOM 3344 CB LEU B 108 2.993 -10.698 -0.483 1.00 62.18 C \nANISOU 3344 CB LEU B 108 7467 7347 8812 -1283 -687 -14 C \nATOM 3345 CG LEU B 108 3.277 -11.816 -1.519 1.00 62.88 C \nANISOU 3345 CG LEU B 108 7637 7371 8885 -1319 -690 -11 C \nATOM 3346 CD1 LEU B 108 4.791 -12.067 -1.646 1.00 61.34 C \nANISOU 3346 CD1 LEU B 108 7583 7111 8612 -1262 -724 -28 C \nATOM 3347 CD2 LEU B 108 2.557 -13.121 -1.193 1.00 57.55 C \nANISOU 3347 CD2 LEU B 108 6954 6698 8214 -1413 -682 5 C \nATOM 3348 N ASP B 109 1.494 -8.326 1.017 1.00 65.40 N \nANISOU 3348 N ASP B 109 7723 7900 9226 -1344 -690 8 N \nATOM 3349 CA ASP B 109 1.301 -7.522 2.208 1.00 72.19 C \nANISOU 3349 CA ASP B 109 8540 8837 10052 -1388 -701 17 C \nATOM 3350 C ASP B 109 -0.178 -7.218 2.533 1.00 64.65 C \nANISOU 3350 C ASP B 109 7617 7837 9111 -1474 -721 44 C \nATOM 3351 O ASP B 109 -0.492 -6.741 3.606 1.00 68.75 O \nANISOU 3351 O ASP B 109 8130 8393 9599 -1533 -737 58 O \nATOM 3352 CB ASP B 109 2.241 -6.318 2.241 1.00 80.62 C \nANISOU 3352 CB ASP B 109 9536 10062 11033 -1369 -702 3 C \nATOM 3353 CG ASP B 109 2.041 -5.411 1.137 1.00 84.28 C \nANISOU 3353 CG ASP B 109 9980 10572 11470 -1410 -704 10 C \nATOM 3354 OD1 ASP B 109 0.891 -5.358 0.651 1.00 99.27 O \nANISOU 3354 OD1 ASP B 109 11933 12379 13405 -1485 -714 36 O \nATOM 3355 OD2 ASP B 109 3.039 -4.738 0.773 1.00 84.63 O \nANISOU 3355 OD2 ASP B 109 9962 10754 11440 -1351 -701 -15 O \nATOM 3356 N PHE B 110 -1.084 -7.578 1.649 1.00 60.01 N \nANISOU 3356 N PHE B 110 7081 7165 8555 -1468 -730 48 N \nATOM 3357 CA PHE B 110 -2.479 -7.712 2.018 1.00 62.32 C \nANISOU 3357 CA PHE B 110 7445 7388 8848 -1485 -765 58 C \nATOM 3358 C PHE B 110 -2.585 -8.749 3.159 1.00 67.56 C \nANISOU 3358 C PHE B 110 8091 8044 9535 -1455 -758 50 C \nATOM 3359 O PHE B 110 -3.193 -8.476 4.184 1.00 81.07 O \nANISOU 3359 O PHE B 110 9839 9740 11224 -1488 -785 61 O \nATOM 3360 CB PHE B 110 -3.298 -8.182 0.828 1.00 61.36 C \nANISOU 3360 CB PHE B 110 7369 7206 8739 -1427 -776 45 C \nATOM 3361 CG PHE B 110 -4.751 -8.427 1.130 1.00 58.97 C \nANISOU 3361 CG PHE B 110 7159 6839 8408 -1383 -826 38 C \nATOM 3362 CD1 PHE B 110 -5.533 -7.426 1.687 1.00 60.32 C \nANISOU 3362 CD1 PHE B 110 7455 6948 8518 -1444 -886 59 C \nATOM 3363 CD2 PHE B 110 -5.356 -9.625 0.795 1.00 57.98 C \nANISOU 3363 CD2 PHE B 110 7013 6731 8288 -1278 -824 8 C \nATOM 3364 CE1 PHE B 110 -6.901 -7.604 1.916 1.00 60.95 C \nANISOU 3364 CE1 PHE B 110 7674 6941 8544 -1372 -953 45 C \nATOM 3365 CE2 PHE B 110 -6.730 -9.831 1.036 1.00 61.27 C \nANISOU 3365 CE2 PHE B 110 7521 7110 8648 -1185 -883 -14 C \nATOM 3366 CZ PHE B 110 -7.509 -8.814 1.583 1.00 61.46 C \nANISOU 3366 CZ PHE B 110 7708 7030 8614 -1215 -953 2 C \nATOM 3367 N HIS B 111 -1.972 -9.910 2.977 1.00 57.29 N \nANISOU 3367 N HIS B 111 6747 6754 8265 -1411 -727 34 N \nATOM 3368 CA HIS B 111 -1.944 -10.961 4.001 1.00 57.57 C \nANISOU 3368 CA HIS B 111 6764 6799 8311 -1404 -719 29 C \nATOM 3369 C HIS B 111 -1.281 -10.514 5.297 1.00 59.52 C \nANISOU 3369 C HIS B 111 6997 7070 8548 -1431 -719 37 C \nATOM 3370 O HIS B 111 -1.805 -10.746 6.408 1.00 56.98 O \nANISOU 3370 O HIS B 111 6678 6745 8226 -1443 -731 41 O \nATOM 3371 CB HIS B 111 -1.179 -12.198 3.496 1.00 54.22 C \nANISOU 3371 CB HIS B 111 6325 6388 7888 -1403 -694 20 C \nATOM 3372 CG HIS B 111 -1.866 -12.930 2.394 1.00 51.68 C \nANISOU 3372 CG HIS B 111 5986 6093 7556 -1390 -690 10 C \nATOM 3373 ND1 HIS B 111 -3.202 -13.260 2.448 1.00 57.23 N \nANISOU 3373 ND1 HIS B 111 6668 6836 8240 -1342 -708 -5 N \nATOM 3374 CD2 HIS B 111 -1.416 -13.402 1.212 1.00 54.50 C \nANISOU 3374 CD2 HIS B 111 6344 6463 7900 -1406 -676 7 C \nATOM 3375 CE1 HIS B 111 -3.546 -13.918 1.360 1.00 55.74 C \nANISOU 3375 CE1 HIS B 111 6445 6711 8024 -1323 -701 -20 C \nATOM 3376 NE2 HIS B 111 -2.481 -14.011 0.586 1.00 57.25 N \nANISOU 3376 NE2 HIS B 111 6646 6883 8222 -1379 -679 -8 N \nATOM 3377 N ASP B 112 -0.137 -9.844 5.169 1.00 58.12 N \nANISOU 3377 N ASP B 112 6801 6935 8348 -1425 -710 33 N \nATOM 3378 CA ASP B 112 0.520 -9.267 6.367 1.00 58.01 C \nANISOU 3378 CA ASP B 112 6754 6992 8297 -1430 -714 32 C \nATOM 3379 C ASP B 112 -0.400 -8.298 7.104 1.00 60.11 C \nANISOU 3379 C ASP B 112 7015 7290 8536 -1513 -736 54 C \nATOM 3380 O ASP B 112 -0.487 -8.319 8.333 1.00 65.11 O \nANISOU 3380 O ASP B 112 7638 7946 9157 -1538 -742 60 O \nATOM 3381 CB ASP B 112 1.839 -8.588 6.016 1.00 56.16 C \nANISOU 3381 CB ASP B 112 6487 6846 8005 -1373 -709 11 C \nATOM 3382 CG ASP B 112 2.911 -9.587 5.535 1.00 61.08 C \nANISOU 3382 CG ASP B 112 7177 7406 8623 -1286 -709 -13 C \nATOM 3383 OD1 ASP B 112 2.638 -10.803 5.592 1.00 67.04 O \nANISOU 3383 OD1 ASP B 112 7987 8069 9415 -1312 -707 -5 O \nATOM 3384 OD2 ASP B 112 3.999 -9.163 5.049 1.00 66.53 O \nANISOU 3384 OD2 ASP B 112 7878 8146 9254 -1199 -718 -40 O \nATOM 3385 N SER B 113 -1.106 -7.468 6.353 1.00 63.23 N \nANISOU 3385 N SER B 113 7441 7674 8908 -1569 -754 70 N \nATOM 3386 CA SER B 113 -2.013 -6.488 6.964 1.00 69.33 C \nANISOU 3386 CA SER B 113 8267 8453 9622 -1684 -795 99 C \nATOM 3387 C SER B 113 -3.155 -7.211 7.691 1.00 66.29 C \nANISOU 3387 C SER B 113 7970 7955 9263 -1667 -824 103 C \nATOM 3388 O SER B 113 -3.535 -6.840 8.793 1.00 70.94 O \nANISOU 3388 O SER B 113 8593 8550 9811 -1737 -851 120 O \nATOM 3389 CB SER B 113 -2.572 -5.505 5.922 1.00 73.91 C \nANISOU 3389 CB SER B 113 8913 9017 10153 -1761 -824 118 C \nATOM 3390 OG SER B 113 -3.991 -5.609 5.878 1.00 87.60 O \nANISOU 3390 OG SER B 113 10801 10608 11877 -1775 -878 130 O \nATOM 3391 N ASN B 114 -3.712 -8.232 7.071 1.00 60.31 N \nANISOU 3391 N ASN B 114 7242 7119 8554 -1572 -822 83 N \nATOM 3392 CA ASN B 114 -4.823 -8.972 7.691 1.00 60.84 C \nANISOU 3392 CA ASN B 114 7376 7120 8621 -1517 -855 74 C \nATOM 3393 C ASN B 114 -4.402 -9.716 8.945 1.00 61.02 C \nANISOU 3393 C ASN B 114 7332 7181 8670 -1508 -831 69 C \nATOM 3394 O ASN B 114 -5.138 -9.775 9.917 1.00 61.43 O \nANISOU 3394 O ASN B 114 7441 7201 8700 -1511 -864 73 O \nATOM 3395 CB ASN B 114 -5.415 -9.979 6.693 1.00 67.65 C \nANISOU 3395 CB ASN B 114 8239 7965 9502 -1402 -853 44 C \nATOM 3396 CG ASN B 114 -6.277 -9.325 5.623 1.00 67.86 C \nANISOU 3396 CG ASN B 114 8377 7925 9484 -1377 -900 41 C \nATOM 3397 OD1 ASN B 114 -6.902 -8.301 5.845 1.00 69.81 O \nANISOU 3397 OD1 ASN B 114 8761 8097 9669 -1438 -959 62 O \nATOM 3398 ND2 ASN B 114 -6.285 -9.914 4.449 1.00 74.13 N \nANISOU 3398 ND2 ASN B 114 9127 8745 10295 -1303 -880 19 N \nATOM 3399 N VAL B 115 -3.208 -10.309 8.920 1.00 63.50 N \nANISOU 3399 N VAL B 115 7553 7551 9022 -1494 -782 60 N \nATOM 3400 CA VAL B 115 -2.664 -10.972 10.116 1.00 57.32 C \nANISOU 3400 CA VAL B 115 6728 6797 8253 -1493 -765 57 C \nATOM 3401 C VAL B 115 -2.526 -9.944 11.232 1.00 58.84 C \nANISOU 3401 C VAL B 115 6921 7025 8409 -1560 -781 75 C \nATOM 3402 O VAL B 115 -2.973 -10.177 12.350 1.00 58.17 O \nANISOU 3402 O VAL B 115 6852 6929 8321 -1573 -795 80 O \nATOM 3403 CB VAL B 115 -1.286 -11.638 9.839 1.00 52.25 C \nANISOU 3403 CB VAL B 115 6047 6181 7625 -1470 -730 45 C \nATOM 3404 CG1 VAL B 115 -0.544 -11.972 11.127 1.00 53.75 C \nANISOU 3404 CG1 VAL B 115 6224 6393 7806 -1470 -726 43 C \nATOM 3405 CG2 VAL B 115 -1.465 -12.908 9.047 1.00 44.97 C \nANISOU 3405 CG2 VAL B 115 5126 5246 6716 -1452 -718 35 C \nATOM 3406 N LYS B 116 -1.884 -8.816 10.927 1.00 63.28 N \nANISOU 3406 N LYS B 116 7455 7660 8929 -1607 -778 83 N \nATOM 3407 CA LYS B 116 -1.757 -7.700 11.897 1.00 69.04 C \nANISOU 3407 CA LYS B 116 8161 8485 9587 -1703 -795 102 C \nATOM 3408 C LYS B 116 -3.100 -7.273 12.504 1.00 66.59 C \nANISOU 3408 C LYS B 116 7962 8101 9239 -1797 -846 131 C \nATOM 3409 O LYS B 116 -3.163 -6.882 13.658 1.00 70.46 O \nANISOU 3409 O LYS B 116 8450 8639 9684 -1873 -862 146 O \nATOM 3410 CB LYS B 116 -1.115 -6.462 11.246 1.00 78.25 C \nANISOU 3410 CB LYS B 116 9268 9784 10677 -1760 -791 106 C \nATOM 3411 CG LYS B 116 0.389 -6.342 11.386 1.00 85.08 C \nANISOU 3411 CG LYS B 116 10016 10805 11505 -1676 -761 75 C \nATOM 3412 CD LYS B 116 0.725 -5.968 12.809 1.00102.49 C \nANISOU 3412 CD LYS B 116 12156 13142 13645 -1712 -765 75 C \nATOM 3413 CE LYS B 116 2.218 -5.951 13.037 1.00114.46 C \nANISOU 3413 CE LYS B 116 13574 14813 15101 -1573 -749 28 C \nATOM 3414 NZ LYS B 116 2.500 -5.776 14.488 1.00122.45 N \nANISOU 3414 NZ LYS B 116 14524 15948 16054 -1584 -754 23 N \nATOM 3415 N ASN B 117 -4.168 -7.327 11.721 1.00 60.76 N \nANISOU 3415 N ASN B 117 7340 7244 8501 -1785 -883 135 N \nATOM 3416 CA ASN B 117 -5.487 -6.967 12.229 1.00 71.08 C \nANISOU 3416 CA ASN B 117 8816 8444 9747 -1842 -955 154 C \nATOM 3417 C ASN B 117 -6.007 -7.930 13.268 1.00 80.89 C \nANISOU 3417 C ASN B 117 10080 9634 11020 -1763 -965 139 C \nATOM 3418 O ASN B 117 -6.599 -7.512 14.273 1.00 98.56 O \nANISOU 3418 O ASN B 117 12418 11833 13197 -1837 -1014 159 O \nATOM 3419 CB ASN B 117 -6.496 -6.825 11.096 1.00 76.93 C \nANISOU 3419 CB ASN B 117 9706 9065 10459 -1803 -1007 151 C \nATOM 3420 CG ASN B 117 -6.498 -5.419 10.511 1.00 84.33 C \nANISOU 3420 CG ASN B 117 10719 10018 11303 -1967 -1041 186 C \nATOM 3421 OD1 ASN B 117 -6.436 -4.440 11.255 1.00 93.67 O \nANISOU 3421 OD1 ASN B 117 11937 11259 12393 -2145 -1070 224 O \nATOM 3422 ND2 ASN B 117 -6.584 -5.312 9.190 1.00 84.57 N \nANISOU 3422 ND2 ASN B 117 10774 10016 11343 -1925 -1042 178 N \nATOM 3423 N LEU B 118 -5.781 -9.217 13.048 1.00 75.45 N \nANISOU 3423 N LEU B 118 9303 8956 10409 -1630 -922 106 N \nATOM 3424 CA LEU B 118 -6.082 -10.204 14.070 1.00 66.83 C \nANISOU 3424 CA LEU B 118 8192 7861 9340 -1565 -920 90 C \nATOM 3425 C LEU B 118 -5.316 -9.955 15.355 1.00 67.58 C \nANISOU 3425 C LEU B 118 8222 8018 9438 -1645 -898 108 C \nATOM 3426 O LEU B 118 -5.901 -9.938 16.460 1.00 64.79 O \nANISOU 3426 O LEU B 118 7928 7634 9056 -1667 -932 116 O \nATOM 3427 CB LEU B 118 -5.796 -11.585 13.564 1.00 71.52 C \nANISOU 3427 CB LEU B 118 8684 8500 9988 -1463 -875 59 C \nATOM 3428 CG LEU B 118 -7.031 -12.409 13.227 1.00 72.78 C \nANISOU 3428 CG LEU B 118 8889 8649 10116 -1337 -910 26 C \nATOM 3429 CD1 LEU B 118 -8.004 -11.577 12.419 1.00 75.40 C \nANISOU 3429 CD1 LEU B 118 9370 8891 10387 -1300 -975 23 C \nATOM 3430 CD2 LEU B 118 -6.626 -13.671 12.475 1.00 69.08 C \nANISOU 3430 CD2 LEU B 118 8295 8280 9672 -1287 -860 1 C \nATOM 3431 N TYR B 119 -4.005 -9.750 15.218 1.00 66.47 N \nANISOU 3431 N TYR B 119 7970 7970 9317 -1670 -850 108 N \nATOM 3432 CA TYR B 119 -3.132 -9.448 16.390 1.00 65.15 C \nANISOU 3432 CA TYR B 119 7728 7895 9130 -1717 -832 115 C \nATOM 3433 C TYR B 119 -3.616 -8.263 17.172 1.00 70.15 C \nANISOU 3433 C TYR B 119 8413 8563 9680 -1851 -873 146 C \nATOM 3434 O TYR B 119 -3.559 -8.287 18.390 1.00 77.26 O \nANISOU 3434 O TYR B 119 9295 9498 10563 -1884 -877 152 O \nATOM 3435 CB TYR B 119 -1.693 -9.227 15.944 1.00 59.13 C \nANISOU 3435 CB TYR B 119 6867 7238 8361 -1684 -793 99 C \nATOM 3436 CG TYR B 119 -0.704 -9.068 17.072 1.00 64.54 C \nANISOU 3436 CG TYR B 119 7476 8037 9010 -1674 -780 89 C \nATOM 3437 CD1 TYR B 119 -0.096 -10.184 17.671 1.00 64.31 C \nANISOU 3437 CD1 TYR B 119 7442 7975 9020 -1590 -764 68 C \nATOM 3438 CD2 TYR B 119 -0.349 -7.796 17.537 1.00 70.52 C \nANISOU 3438 CD2 TYR B 119 8166 8958 9669 -1754 -788 98 C \nATOM 3439 CE1 TYR B 119 0.826 -10.032 18.703 1.00 69.64 C \nANISOU 3439 CE1 TYR B 119 8065 8747 9647 -1554 -761 53 C \nATOM 3440 CE2 TYR B 119 0.567 -7.630 18.572 1.00 68.71 C \nANISOU 3440 CE2 TYR B 119 7850 8871 9384 -1719 -779 79 C \nATOM 3441 CZ TYR B 119 1.149 -8.736 19.154 1.00 72.32 C \nANISOU 3441 CZ TYR B 119 8321 9266 9891 -1604 -768 54 C \nATOM 3442 OH TYR B 119 2.046 -8.547 20.174 1.00 70.44 O \nANISOU 3442 OH TYR B 119 8015 9164 9584 -1547 -768 30 O \nATOM 3443 N ASP B 120 -4.116 -7.239 16.469 1.00 79.40 N \nANISOU 3443 N ASP B 120 9661 9724 10785 -1948 -908 169 N \nATOM 3444 CA ASP B 120 -4.593 -5.995 17.119 1.00 86.98 C \nANISOU 3444 CA ASP B 120 10699 10725 11623 -2138 -961 210 C \nATOM 3445 C ASP B 120 -5.988 -6.152 17.779 1.00 87.02 C \nANISOU 3445 C ASP B 120 10909 10559 11595 -2165 -1035 227 C \nATOM 3446 O ASP B 120 -6.189 -5.700 18.884 1.00 84.60 O \nANISOU 3446 O ASP B 120 10645 10279 11219 -2282 -1065 252 O \nATOM 3447 CB ASP B 120 -4.606 -4.828 16.131 1.00 95.83 C \nANISOU 3447 CB ASP B 120 11854 11902 12655 -2266 -983 234 C \nATOM 3448 CG ASP B 120 -3.242 -4.166 15.971 1.00111.09 C \nANISOU 3448 CG ASP B 120 13583 14085 14541 -2298 -930 224 C \nATOM 3449 OD1 ASP B 120 -2.227 -4.690 16.497 1.00115.31 O \nANISOU 3449 OD1 ASP B 120 13970 14724 15117 -2183 -880 192 O \nATOM 3450 OD2 ASP B 120 -3.180 -3.107 15.294 1.00125.79 O \nANISOU 3450 OD2 ASP B 120 15441 16049 16305 -2430 -946 246 O \nATOM 3451 N LYS B 121 -6.939 -6.794 17.104 1.00 83.10 N \nANISOU 3451 N LYS B 121 10543 9901 11131 -2041 -1070 207 N \nATOM 3452 CA LYS B 121 -8.210 -7.164 17.732 1.00 89.35 C \nANISOU 3452 CA LYS B 121 11527 10539 11883 -1987 -1146 202 C \nATOM 3453 C LYS B 121 -8.025 -7.828 19.113 1.00 90.23 C \nANISOU 3453 C LYS B 121 11561 10689 12032 -1955 -1122 194 C \nATOM 3454 O LYS B 121 -8.779 -7.562 20.047 1.00 91.10 O \nANISOU 3454 O LYS B 121 11823 10722 12069 -2012 -1188 211 O \nATOM 3455 CB LYS B 121 -8.979 -8.128 16.846 1.00 96.92 C \nANISOU 3455 CB LYS B 121 12543 11401 12879 -1776 -1163 157 C \nATOM 3456 CG LYS B 121 -9.652 -7.530 15.619 1.00107.82 C \nANISOU 3456 CG LYS B 121 14091 12682 14193 -1772 -1224 159 C \nATOM 3457 CD LYS B 121 -10.311 -8.621 14.761 1.00110.20 C \nANISOU 3457 CD LYS B 121 14399 12948 14525 -1530 -1231 102 C \nATOM 3458 CE LYS B 121 -11.268 -9.516 15.559 1.00108.61 C \nANISOU 3458 CE LYS B 121 14273 12704 14288 -1359 -1280 61 C \nATOM 3459 NZ LYS B 121 -12.643 -8.986 15.624 1.00116.69 N \nANISOU 3459 NZ LYS B 121 15627 13548 15164 -1299 -1418 53 N \nATOM 3460 N VAL B 122 -7.033 -8.705 19.224 1.00 90.68 N \nANISOU 3460 N VAL B 122 11410 10851 12194 -1869 -1037 169 N \nATOM 3461 CA VAL B 122 -6.726 -9.383 20.482 1.00 90.34 C \nANISOU 3461 CA VAL B 122 11285 10851 12188 -1841 -1010 162 C \nATOM 3462 C VAL B 122 -6.064 -8.440 21.473 1.00 89.26 C \nANISOU 3462 C VAL B 122 11097 10821 11996 -1999 -1004 193 C \nATOM 3463 O VAL B 122 -6.542 -8.295 22.596 1.00 86.62 O \nANISOU 3463 O VAL B 122 10834 10461 11618 -2059 -1040 210 O \nATOM 3464 CB VAL B 122 -5.815 -10.603 20.267 1.00 91.94 C \nANISOU 3464 CB VAL B 122 11322 11121 12491 -1725 -935 129 C \nATOM 3465 CG1 VAL B 122 -5.507 -11.299 21.576 1.00 96.34 C \nANISOU 3465 CG1 VAL B 122 11817 11714 13076 -1708 -915 124 C \nATOM 3466 CG2 VAL B 122 -6.488 -11.589 19.334 1.00 93.18 C \nANISOU 3466 CG2 VAL B 122 11499 11229 12676 -1592 -939 98 C \nATOM 3467 N ARG B 123 -5.007 -7.760 21.037 1.00 87.28 N \nANISOU 3467 N ARG B 123 10723 10710 11727 -2061 -964 199 N \nATOM 3468 CA ARG B 123 -4.262 -6.829 21.901 1.00 84.14 C \nANISOU 3468 CA ARG B 123 10230 10493 11245 -2195 -953 219 C \nATOM 3469 C ARG B 123 -5.137 -5.791 22.563 1.00 82.14 C \nANISOU 3469 C ARG B 123 10120 10228 10863 -2402 -1024 266 C \nATOM 3470 O ARG B 123 -4.853 -5.397 23.685 1.00 92.49 O \nANISOU 3470 O ARG B 123 11374 11658 12109 -2502 -1025 282 O \nATOM 3471 CB ARG B 123 -3.179 -6.092 21.132 1.00 80.85 C \nANISOU 3471 CB ARG B 123 9676 10260 10785 -2217 -917 211 C \nATOM 3472 CG ARG B 123 -2.327 -5.191 21.995 1.00 81.75 C \nANISOU 3472 CG ARG B 123 9647 10631 10783 -2318 -903 216 C \nATOM 3473 CD ARG B 123 -1.126 -4.692 21.208 1.00 93.44 C \nANISOU 3473 CD ARG B 123 10969 12320 12216 -2260 -865 187 C \nATOM 3474 NE ARG B 123 -0.332 -3.708 21.963 1.00108.57 N \nANISOU 3474 NE ARG B 123 12720 14554 13977 -2344 -858 182 N \nATOM 3475 CZ ARG B 123 0.360 -2.707 21.412 1.00118.48 C \nANISOU 3475 CZ ARG B 123 13839 16076 15101 -2391 -848 171 C \nATOM 3476 NH1 ARG B 123 0.369 -2.521 20.092 1.00113.29 N \nANISOU 3476 NH1 ARG B 123 13206 15378 14463 -2371 -845 168 N \nATOM 3477 NH2 ARG B 123 1.051 -1.878 22.189 1.00120.83 N \nANISOU 3477 NH2 ARG B 123 13962 16715 15232 -2454 -843 159 N \nATOM 3478 N LEU B 124 -6.189 -5.347 21.885 1.00 81.03 N \nANISOU 3478 N LEU B 124 10181 9941 10665 -2474 -1093 290 N \nATOM 3479 CA LEU B 124 -7.099 -4.357 22.475 1.00 90.37 C \nANISOU 3479 CA LEU B 124 11574 11069 11692 -2699 -1185 342 C \nATOM 3480 C LEU B 124 -7.970 -4.936 23.573 1.00 88.70 C \nANISOU 3480 C LEU B 124 11514 10704 11484 -2654 -1236 342 C \nATOM 3481 O LEU B 124 -8.270 -4.239 24.546 1.00 83.10 O \nANISOU 3481 O LEU B 124 10903 10018 10654 -2848 -1288 382 O \nATOM 3482 CB LEU B 124 -7.995 -3.710 21.426 1.00 91.49 C \nANISOU 3482 CB LEU B 124 11951 11065 11747 -2784 -1264 366 C \nATOM 3483 CG LEU B 124 -7.286 -2.654 20.589 1.00100.15 C \nANISOU 3483 CG LEU B 124 12940 12347 12763 -2946 -1240 389 C \nATOM 3484 CD1 LEU B 124 -8.300 -1.868 19.759 1.00100.47 C \nANISOU 3484 CD1 LEU B 124 13270 12225 12678 -3090 -1341 427 C \nATOM 3485 CD2 LEU B 124 -6.427 -1.726 21.446 1.00 98.01 C \nANISOU 3485 CD2 LEU B 124 12492 12377 12372 -3163 -1212 418 C \nATOM 3486 N GLN B 125 -8.332 -6.212 23.439 1.00 89.81 N \nANISOU 3486 N GLN B 125 11660 10718 11747 -2409 -1221 295 N \nATOM 3487 CA GLN B 125 -9.195 -6.863 24.424 1.00 93.02 C \nANISOU 3487 CA GLN B 125 12198 10995 12152 -2327 -1270 284 C \nATOM 3488 C GLN B 125 -8.537 -7.205 25.754 1.00 85.48 C \nANISOU 3488 C GLN B 125 11083 10157 11237 -2345 -1219 284 C \nATOM 3489 O GLN B 125 -9.240 -7.358 26.733 1.00 98.96 O \nANISOU 3489 O GLN B 125 12921 11776 12903 -2353 -1272 291 O \nATOM 3490 CB GLN B 125 -9.840 -8.124 23.869 1.00 92.08 C \nANISOU 3490 CB GLN B 125 12109 10762 12115 -2059 -1274 229 C \nATOM 3491 CG GLN B 125 -10.966 -7.861 22.887 1.00 89.94 C \nANISOU 3491 CG GLN B 125 12090 10323 11760 -1996 -1367 220 C \nATOM 3492 CD GLN B 125 -11.579 -9.143 22.406 1.00 91.42 C \nANISOU 3492 CD GLN B 125 12265 10470 12002 -1713 -1368 154 C \nATOM 3493 OE1 GLN B 125 -12.717 -9.450 22.720 1.00 94.66 O \nANISOU 3493 OE1 GLN B 125 12876 10758 12330 -1579 -1458 126 O \nATOM 3494 NE2 GLN B 125 -10.805 -9.926 21.672 1.00 97.00 N \nANISOU 3494 NE2 GLN B 125 12732 11300 12825 -1619 -1271 127 N \nATOM 3495 N LEU B 126 -7.215 -7.250 25.833 1.00 86.21 N \nANISOU 3495 N LEU B 126 10923 10442 11391 -2350 -1128 275 N \nATOM 3496 CA LEU B 126 -6.585 -7.734 27.059 1.00 85.13 C \nANISOU 3496 CA LEU B 126 10648 10401 11296 -2323 -1084 265 C \nATOM 3497 C LEU B 126 -5.349 -6.965 27.506 1.00 83.40 C \nANISOU 3497 C LEU B 126 10239 10426 11022 -2433 -1036 276 C \nATOM 3498 O LEU B 126 -4.454 -7.506 28.125 1.00 93.36 O \nANISOU 3498 O LEU B 126 11347 11789 12338 -2342 -983 249 O \nATOM 3499 CB LEU B 126 -6.312 -9.235 26.914 1.00 87.49 C \nANISOU 3499 CB LEU B 126 10850 10657 11734 -2101 -1030 218 C \nATOM 3500 CG LEU B 126 -5.773 -9.782 25.596 1.00 80.90 C \nANISOU 3500 CG LEU B 126 9929 9832 10976 -1985 -982 189 C \nATOM 3501 CD1 LEU B 126 -4.286 -9.517 25.464 1.00 85.92 C \nANISOU 3501 CD1 LEU B 126 10392 10631 11622 -1991 -921 181 C \nATOM 3502 CD2 LEU B 126 -6.046 -11.254 25.491 1.00 74.43 C \nANISOU 3502 CD2 LEU B 126 9089 8949 10241 -1821 -962 154 C \nATOM 3503 N ARG B 127 -5.364 -5.673 27.250 1.00 93.37 N \nANISOU 3503 N ARG B 127 11528 11798 12151 -2635 -1067 312 N \nATOM 3504 CA ARG B 127 -4.250 -4.731 27.537 1.00 96.98 C \nANISOU 3504 CA ARG B 127 11783 12562 12501 -2752 -1030 317 C \nATOM 3505 C ARG B 127 -3.203 -5.240 28.534 1.00 95.72 C \nANISOU 3505 C ARG B 127 11431 12559 12380 -2631 -974 281 C \nATOM 3506 O ARG B 127 -2.102 -5.642 28.141 1.00 95.85 O \nANISOU 3506 O ARG B 127 11294 12675 12449 -2460 -919 235 O \nATOM 3507 CB ARG B 127 -4.775 -3.335 27.982 1.00 97.52 C \nANISOU 3507 CB ARG B 127 11944 12744 12365 -3073 -1096 379 C \nATOM 3508 CG ARG B 127 -6.181 -2.981 27.487 1.00 99.35 C \nANISOU 3508 CG ARG B 127 12493 12720 12535 -3209 -1193 424 C \nATOM 3509 CD ARG B 127 -7.198 -3.038 28.628 1.00103.58 C \nANISOU 3509 CD ARG B 127 13252 13092 13012 -3308 -1271 456 C \nATOM 3510 NE ARG B 127 -8.487 -3.571 28.223 1.00109.25 N \nANISOU 3510 NE ARG B 127 14272 13473 13765 -3204 -1352 453 N \nATOM 3511 CZ ARG B 127 -9.405 -2.926 27.517 1.00117.68 C \nANISOU 3511 CZ ARG B 127 15619 14377 14716 -3327 -1448 487 C \nATOM 3512 NH1 ARG B 127 -9.176 -1.694 27.088 1.00127.54 N \nANISOU 3512 NH1 ARG B 127 16879 15771 15808 -3602 -1472 535 N \nATOM 3513 NH2 ARG B 127 -10.554 -3.525 27.219 1.00120.91 N \nANISOU 3513 NH2 ARG B 127 16301 14491 15147 -3164 -1527 466 N \nATOM 3514 N ASP B 128 -3.547 -5.192 29.814 1.00 96.99 N \nANISOU 3514 N ASP B 128 11625 12730 12497 -2720 -997 301 N \nATOM 3515 CA ASP B 128 -2.618 -5.560 30.881 1.00101.05 C \nANISOU 3515 CA ASP B 128 11972 13400 13021 -2624 -954 270 C \nATOM 3516 C ASP B 128 -2.957 -6.932 31.498 1.00 99.41 C \nANISOU 3516 C ASP B 128 11837 12972 12962 -2464 -947 250 C \nATOM 3517 O ASP B 128 -2.278 -7.386 32.417 1.00105.10 O \nANISOU 3517 O ASP B 128 12457 13773 13702 -2377 -918 225 O \nATOM 3518 CB ASP B 128 -2.527 -4.463 31.958 1.00100.40 C \nANISOU 3518 CB ASP B 128 11819 13569 12758 -2847 -977 301 C \nATOM 3519 CG ASP B 128 -3.900 -3.989 32.460 1.00104.97 C \nANISOU 3519 CG ASP B 128 12630 13994 13258 -3091 -1056 367 C \nATOM 3520 OD1 ASP B 128 -4.935 -4.599 32.120 1.00 97.53 O \nANISOU 3520 OD1 ASP B 128 11907 12743 12407 -3036 -1097 376 O \nATOM 3521 OD2 ASP B 128 -3.927 -2.975 33.189 1.00108.64 O \nANISOU 3521 OD2 ASP B 128 13067 14667 13544 -3337 -1085 405 O \nATOM 3522 N ASN B 129 -3.979 -7.589 30.960 1.00 85.98 N \nANISOU 3522 N ASN B 129 10302 11019 11347 -2415 -975 257 N \nATOM 3523 CA ASN B 129 -4.250 -8.959 31.299 1.00 85.19 C \nANISOU 3523 CA ASN B 129 10237 10760 11372 -2252 -962 231 C \nATOM 3524 C ASN B 129 -3.263 -9.964 30.657 1.00 85.14 C \nANISOU 3524 C ASN B 129 10122 10760 11468 -2067 -903 187 C \nATOM 3525 O ASN B 129 -3.236 -11.123 31.056 1.00 76.91 O \nANISOU 3525 O ASN B 129 9079 9639 10505 -1961 -886 167 O \nATOM 3526 CB ASN B 129 -5.685 -9.299 30.919 1.00 87.76 C \nANISOU 3526 CB ASN B 129 10763 10867 11715 -2238 -1019 242 C \nATOM 3527 CG ASN B 129 -6.682 -8.730 31.917 1.00 96.60 C \nANISOU 3527 CG ASN B 129 12047 11918 12737 -2377 -1093 278 C \nATOM 3528 OD1 ASN B 129 -6.328 -7.885 32.750 1.00101.98 O \nANISOU 3528 OD1 ASN B 129 12687 12737 13326 -2540 -1099 307 O \nATOM 3529 ND2 ASN B 129 -7.923 -9.209 31.864 1.00 92.63 N \nANISOU 3529 ND2 ASN B 129 11739 11219 12236 -2304 -1156 273 N \nATOM 3530 N ALA B 130 -2.462 -9.512 29.686 1.00 78.13 N \nANISOU 3530 N ALA B 130 9160 9968 10560 -2044 -879 174 N \nATOM 3531 CA ALA B 130 -1.421 -10.321 29.052 1.00 73.69 C \nANISOU 3531 CA ALA B 130 8534 9407 10060 -1887 -838 135 C \nATOM 3532 C ALA B 130 -0.140 -9.556 28.715 1.00 74.59 C \nANISOU 3532 C ALA B 130 8532 9717 10091 -1846 -820 110 C \nATOM 3533 O ALA B 130 -0.166 -8.336 28.531 1.00 73.33 O \nANISOU 3533 O ALA B 130 8320 9711 9831 -1956 -830 125 O \nATOM 3534 CB ALA B 130 -1.966 -10.958 27.772 1.00 76.88 C \nANISOU 3534 CB ALA B 130 9011 9664 10537 -1837 -837 132 C \nATOM 3535 N LYS B 131 0.958 -10.311 28.577 1.00 77.01 N \nANISOU 3535 N LYS B 131 8818 10020 10421 -1687 -802 69 N \nATOM 3536 CA LYS B 131 2.282 -9.793 28.175 1.00 82.90 C \nANISOU 3536 CA LYS B 131 9486 10936 11077 -1573 -796 27 C \nATOM 3537 C LYS B 131 2.451 -9.998 26.670 1.00 85.56 C \nANISOU 3537 C LYS B 131 9870 11186 11453 -1520 -790 18 C \nATOM 3538 O LYS B 131 2.313 -11.104 26.193 1.00 67.77 O \nANISOU 3538 O LYS B 131 7713 8747 9288 -1479 -787 19 O \nATOM 3539 CB LYS B 131 3.459 -10.535 28.845 1.00 91.50 C \nANISOU 3539 CB LYS B 131 10594 12033 12141 -1400 -804 -20 C \nATOM 3540 CG LYS B 131 3.879 -10.075 30.234 1.00102.40 C \nANISOU 3540 CG LYS B 131 11885 13595 13429 -1380 -812 -37 C \nATOM 3541 CD LYS B 131 5.144 -10.799 30.735 1.00103.18 C \nANISOU 3541 CD LYS B 131 12042 13683 13479 -1169 -834 -93 C \nATOM 3542 CE LYS B 131 5.474 -10.524 32.232 1.00104.49 C \nANISOU 3542 CE LYS B 131 12130 14010 13561 -1136 -844 -112 C \nATOM 3543 NZ LYS B 131 5.171 -9.128 32.681 1.00103.77 N \nANISOU 3543 NZ LYS B 131 11853 14215 13361 -1257 -832 -99 N \nATOM 3544 N GLU B 132 2.761 -8.923 25.935 1.00 96.43 N \nANISOU 3544 N GLU B 132 11169 12723 12746 -1534 -789 11 N \nATOM 3545 CA GLU B 132 3.172 -9.034 24.534 1.00 93.28 C \nANISOU 3545 CA GLU B 132 10804 12273 12365 -1456 -784 -7 C \nATOM 3546 C GLU B 132 4.599 -9.558 24.462 1.00 93.86 C \nANISOU 3546 C GLU B 132 10910 12364 12387 -1243 -797 -65 C \nATOM 3547 O GLU B 132 5.548 -8.827 24.765 1.00 96.34 O \nANISOU 3547 O GLU B 132 11134 12902 12568 -1131 -810 -110 O \nATOM 3548 CB GLU B 132 3.099 -7.683 23.829 1.00 93.00 C \nANISOU 3548 CB GLU B 132 10673 12426 12238 -1539 -783 1 C \nATOM 3549 CG GLU B 132 1.706 -7.097 23.720 1.00 93.84 C \nANISOU 3549 CG GLU B 132 10811 12480 12363 -1759 -791 60 C \nATOM 3550 CD GLU B 132 1.682 -5.817 22.904 1.00 96.89 C \nANISOU 3550 CD GLU B 132 11129 13041 12644 -1867 -796 73 C \nATOM 3551 OE1 GLU B 132 1.867 -5.882 21.678 1.00 91.07 O \nANISOU 3551 OE1 GLU B 132 10414 12250 11938 -1807 -789 62 O \nATOM 3552 OE2 GLU B 132 1.477 -4.738 23.495 1.00102.08 O \nANISOU 3552 OE2 GLU B 132 11710 13904 13173 -2032 -810 97 O \nATOM 3553 N LEU B 133 4.743 -10.813 24.055 1.00 88.37 N \nANISOU 3553 N LEU B 133 10358 11448 11772 -1187 -804 -68 N \nATOM 3554 CA LEU B 133 6.056 -11.469 24.013 1.00 90.50 C \nANISOU 3554 CA LEU B 133 10741 11667 11977 -1002 -838 -117 C \nATOM 3555 C LEU B 133 6.933 -10.901 22.902 1.00 93.14 C \nANISOU 3555 C LEU B 133 11081 12083 12225 -869 -855 -158 C \nATOM 3556 O LEU B 133 8.168 -11.131 22.889 1.00 88.93 O \nANISOU 3556 O LEU B 133 10653 11552 11586 -669 -902 -214 O \nATOM 3557 CB LEU B 133 5.926 -12.988 23.851 1.00 82.07 C \nANISOU 3557 CB LEU B 133 9846 10348 10989 -1038 -848 -97 C \nATOM 3558 CG LEU B 133 5.578 -13.848 25.036 1.00 79.92 C \nANISOU 3558 CG LEU B 133 9614 9996 10758 -1099 -850 -79 C \nATOM 3559 CD1 LEU B 133 4.885 -13.033 26.083 1.00 81.43 C \nANISOU 3559 CD1 LEU B 133 9655 10327 10959 -1165 -828 -63 C \nATOM 3560 CD2 LEU B 133 4.728 -15.029 24.600 1.00 81.16 C \nANISOU 3560 CD2 LEU B 133 9838 9990 11010 -1234 -835 -38 C \nATOM 3561 N GLY B 134 6.301 -10.158 21.987 1.00 82.52 N \nANISOU 3561 N GLY B 134 9645 10799 10910 -968 -827 -133 N \nATOM 3562 CA GLY B 134 7.004 -9.559 20.854 1.00 81.29 C \nANISOU 3562 CA GLY B 134 9474 10734 10678 -860 -837 -168 C \nATOM 3563 C GLY B 134 7.292 -10.576 19.785 1.00 82.46 C \nANISOU 3563 C GLY B 134 9803 10648 10880 -816 -854 -169 C \nATOM 3564 O GLY B 134 8.292 -10.476 19.077 1.00 90.47 O \nANISOU 3564 O GLY B 134 10890 11679 11805 -655 -887 -214 O \nATOM 3565 N ASN B 135 6.397 -11.554 19.667 1.00 86.16 N \nANISOU 3565 N ASN B 135 10345 10919 11475 -961 -835 -120 N \nATOM 3566 CA ASN B 135 6.624 -12.741 18.829 1.00 84.07 C \nANISOU 3566 CA ASN B 135 10255 10445 11242 -968 -853 -113 C \nATOM 3567 C ASN B 135 5.340 -13.198 18.109 1.00 82.76 C \nANISOU 3567 C ASN B 135 10059 10191 11196 -1139 -815 -62 C \nATOM 3568 O ASN B 135 5.350 -14.182 17.368 1.00 76.32 O \nANISOU 3568 O ASN B 135 9352 9246 10399 -1184 -822 -50 O \nATOM 3569 CB ASN B 135 7.195 -13.884 19.670 1.00 83.17 C \nANISOU 3569 CB ASN B 135 10304 10202 11093 -939 -892 -120 C \nATOM 3570 CG ASN B 135 6.155 -14.533 20.531 1.00 85.67 C \nANISOU 3570 CG ASN B 135 10572 10477 11501 -1091 -863 -77 C \nATOM 3571 OD1 ASN B 135 5.165 -13.893 20.931 1.00 95.67 O \nANISOU 3571 OD1 ASN B 135 11683 11837 12830 -1167 -825 -55 O \nATOM 3572 ND2 ASN B 135 6.348 -15.816 20.807 1.00 78.52 N \nANISOU 3572 ND2 ASN B 135 9816 9432 10586 -1146 -888 -65 N \nATOM 3573 N GLY B 136 4.239 -12.485 18.332 1.00 77.23 N \nANISOU 3573 N GLY B 136 9224 9569 10550 -1231 -783 -36 N \nATOM 3574 CA GLY B 136 2.977 -12.857 17.749 1.00 67.41 C \nANISOU 3574 CA GLY B 136 7966 8255 9394 -1345 -761 -1 C \nATOM 3575 C GLY B 136 2.065 -13.396 18.800 1.00 68.87 C \nANISOU 3575 C GLY B 136 8132 8413 9623 -1417 -756 20 C \nATOM 3576 O GLY B 136 0.862 -13.508 18.570 1.00 58.83 O \nANISOU 3576 O GLY B 136 6838 7116 8399 -1480 -748 40 O \nATOM 3577 N CYS B 137 2.642 -13.713 19.961 1.00 78.61 N \nANISOU 3577 N CYS B 137 9386 9656 10827 -1385 -767 9 N \nATOM 3578 CA CYS B 137 1.922 -14.368 21.046 1.00 79.96 C \nANISOU 3578 CA CYS B 137 9548 9800 11033 -1444 -764 26 C \nATOM 3579 C CYS B 137 1.803 -13.489 22.240 1.00 78.43 C \nANISOU 3579 C CYS B 137 9287 9697 10818 -1447 -768 27 C \nATOM 3580 O CYS B 137 2.680 -12.673 22.494 1.00 83.35 O \nANISOU 3580 O CYS B 137 9874 10423 11372 -1383 -775 6 O \nATOM 3581 CB CYS B 137 2.667 -15.613 21.497 1.00 73.98 C \nANISOU 3581 CB CYS B 137 8889 8971 10250 -1434 -780 18 C \nATOM 3582 SG CYS B 137 2.993 -16.750 20.168 1.00 81.40 S \nANISOU 3582 SG CYS B 137 9938 9819 11171 -1478 -788 23 S \nATOM 3583 N PHE B 138 0.727 -13.686 22.989 1.00 74.17 N \nANISOU 3583 N PHE B 138 8728 9138 10316 -1515 -766 48 N \nATOM 3584 CA PHE B 138 0.567 -13.038 24.257 1.00 73.67 C \nANISOU 3584 CA PHE B 138 8620 9146 10226 -1543 -773 55 C \nATOM 3585 C PHE B 138 0.672 -14.101 25.358 1.00 75.73 C \nANISOU 3585 C PHE B 138 8909 9361 10505 -1532 -775 52 C \nATOM 3586 O PHE B 138 0.014 -15.139 25.295 1.00 64.93 O \nANISOU 3586 O PHE B 138 7570 7921 9179 -1558 -772 60 O \nATOM 3587 CB PHE B 138 -0.800 -12.363 24.359 1.00 83.44 C \nANISOU 3587 CB PHE B 138 9857 10376 11472 -1635 -787 83 C \nATOM 3588 CG PHE B 138 -1.105 -11.379 23.256 1.00 81.92 C \nANISOU 3588 CG PHE B 138 9667 10205 11254 -1677 -794 94 C \nATOM 3589 CD1 PHE B 138 -0.727 -10.058 23.367 1.00 78.11 C \nANISOU 3589 CD1 PHE B 138 9129 9860 10689 -1738 -800 101 C \nATOM 3590 CD2 PHE B 138 -1.820 -11.780 22.132 1.00 80.21 C \nANISOU 3590 CD2 PHE B 138 9501 9896 11078 -1663 -797 96 C \nATOM 3591 CE1 PHE B 138 -1.031 -9.157 22.375 1.00 83.79 C \nANISOU 3591 CE1 PHE B 138 9858 10608 11372 -1801 -810 115 C \nATOM 3592 CE2 PHE B 138 -2.125 -10.885 21.134 1.00 78.56 C \nANISOU 3592 CE2 PHE B 138 9312 9696 10843 -1703 -809 106 C \nATOM 3593 CZ PHE B 138 -1.733 -9.571 21.258 1.00 86.03 C \nANISOU 3593 CZ PHE B 138 10216 10760 11710 -1781 -816 118 C \nATOM 3594 N GLU B 139 1.500 -13.839 26.368 1.00 75.49 N \nANISOU 3594 N GLU B 139 8859 9398 10425 -1489 -783 37 N \nATOM 3595 CA GLU B 139 1.472 -14.626 27.590 1.00 78.03 C \nANISOU 3595 CA GLU B 139 9202 9686 10758 -1495 -787 39 C \nATOM 3596 C GLU B 139 0.461 -13.979 28.510 1.00 76.81 C \nANISOU 3596 C GLU B 139 8993 9578 10612 -1572 -789 61 C \nATOM 3597 O GLU B 139 0.687 -12.882 29.046 1.00 64.44 O \nANISOU 3597 O GLU B 139 7365 8133 8986 -1591 -794 61 O \nATOM 3598 CB GLU B 139 2.846 -14.709 28.275 1.00 86.26 C \nANISOU 3598 CB GLU B 139 10278 10767 11730 -1393 -806 7 C \nATOM 3599 CG GLU B 139 2.827 -15.570 29.533 1.00 86.14 C \nANISOU 3599 CG GLU B 139 10300 10706 11724 -1407 -814 10 C \nATOM 3600 CD GLU B 139 4.198 -15.990 30.042 1.00 89.00 C \nANISOU 3600 CD GLU B 139 10763 11048 12005 -1292 -848 -24 C \nATOM 3601 OE1 GLU B 139 5.213 -15.873 29.327 1.00 89.94 O \nANISOU 3601 OE1 GLU B 139 10961 11157 12055 -1186 -874 -55 O \nATOM 3602 OE2 GLU B 139 4.259 -16.470 31.186 1.00 96.17 O \nANISOU 3602 OE2 GLU B 139 11694 11940 12907 -1297 -858 -23 O \nATOM 3603 N PHE B 140 -0.657 -14.674 28.702 1.00 81.16 N \nANISOU 3603 N PHE B 140 9571 10051 11214 -1617 -791 78 N \nATOM 3604 CA PHE B 140 -1.714 -14.201 29.566 1.00 77.99 C \nANISOU 3604 CA PHE B 140 9169 9653 10809 -1679 -809 98 C \nATOM 3605 C PHE B 140 -1.124 -14.070 30.940 1.00 85.81 C \nANISOU 3605 C PHE B 140 10125 10708 11770 -1681 -809 95 C \nATOM 3606 O PHE B 140 -0.277 -14.858 31.370 1.00 91.72 O \nANISOU 3606 O PHE B 140 10878 11449 12522 -1623 -801 77 O \nATOM 3607 CB PHE B 140 -2.842 -15.200 29.680 1.00 74.18 C \nANISOU 3607 CB PHE B 140 8725 9095 10365 -1670 -819 99 C \nATOM 3608 CG PHE B 140 -3.730 -15.237 28.502 1.00 80.26 C \nANISOU 3608 CG PHE B 140 9531 9823 11142 -1652 -830 97 C \nATOM 3609 CD1 PHE B 140 -3.348 -15.897 27.347 1.00 74.42 C \nANISOU 3609 CD1 PHE B 140 8774 9082 10421 -1619 -809 84 C \nATOM 3610 CD2 PHE B 140 -4.971 -14.630 28.551 1.00 79.78 C \nANISOU 3610 CD2 PHE B 140 9545 9715 11051 -1665 -874 107 C \nATOM 3611 CE1 PHE B 140 -4.181 -15.915 26.257 1.00 80.62 C \nANISOU 3611 CE1 PHE B 140 9582 9847 11203 -1590 -821 78 C \nATOM 3612 CE2 PHE B 140 -5.816 -14.666 27.460 1.00 81.52 C \nANISOU 3612 CE2 PHE B 140 9820 9893 11262 -1617 -896 97 C \nATOM 3613 CZ PHE B 140 -5.420 -15.304 26.307 1.00 78.03 C \nANISOU 3613 CZ PHE B 140 9325 9475 10846 -1575 -865 81 C \nATOM 3614 N TYR B 141 -1.563 -13.064 31.660 1.00 96.01 N \nANISOU 3614 N TYR B 141 11401 12063 13016 -1759 -826 114 N \nATOM 3615 CA TYR B 141 -1.150 -12.984 33.032 1.00 97.97 C \nANISOU 3615 CA TYR B 141 11608 12384 13231 -1766 -827 111 C \nATOM 3616 C TYR B 141 -1.947 -14.096 33.670 1.00106.16 C \nANISOU 3616 C TYR B 141 12699 13307 14330 -1757 -833 116 C \nATOM 3617 O TYR B 141 -1.386 -15.098 34.134 1.00124.83 O \nANISOU 3617 O TYR B 141 15060 15649 16720 -1700 -820 100 O \nATOM 3618 CB TYR B 141 -1.412 -11.598 33.619 1.00 93.55 C \nANISOU 3618 CB TYR B 141 11013 11953 12580 -1888 -847 135 C \nATOM 3619 CG TYR B 141 -0.297 -10.636 33.276 1.00 86.89 C \nANISOU 3619 CG TYR B 141 10061 11310 11643 -1871 -834 116 C \nATOM 3620 CD1 TYR B 141 1.021 -10.978 33.543 1.00 82.08 C \nANISOU 3620 CD1 TYR B 141 9391 10789 11008 -1725 -819 72 C \nATOM 3621 CD2 TYR B 141 -0.544 -9.403 32.681 1.00 92.74 C \nANISOU 3621 CD2 TYR B 141 10774 12163 12299 -1991 -847 137 C \nATOM 3622 CE1 TYR B 141 2.052 -10.137 33.224 1.00 82.56 C \nANISOU 3622 CE1 TYR B 141 9350 11059 10958 -1660 -817 40 C \nATOM 3623 CE2 TYR B 141 0.492 -8.536 32.373 1.00 91.87 C \nANISOU 3623 CE2 TYR B 141 10536 12290 12080 -1964 -835 112 C \nATOM 3624 CZ TYR B 141 1.784 -8.919 32.652 1.00 92.52 C \nANISOU 3624 CZ TYR B 141 10545 12473 12137 -1779 -819 59 C \nATOM 3625 OH TYR B 141 2.833 -8.077 32.363 1.00115.92 O \nANISOU 3625 OH TYR B 141 13378 15700 14966 -1703 -816 19 O \nATOM 3626 N HIS B 142 -3.263 -13.983 33.565 1.00 96.95 N \nANISOU 3626 N HIS B 142 11600 12066 13170 -1803 -861 134 N \nATOM 3627 CA HIS B 142 -4.157 -14.984 34.153 1.00 89.34 C \nANISOU 3627 CA HIS B 142 10678 11028 12239 -1769 -874 130 C \nATOM 3628 C HIS B 142 -4.238 -16.379 33.515 1.00 90.55 C \nANISOU 3628 C HIS B 142 10815 11152 12436 -1692 -855 108 C \nATOM 3629 O HIS B 142 -3.634 -16.696 32.486 1.00 99.44 O \nANISOU 3629 O HIS B 142 11920 12286 13577 -1671 -832 98 O \nATOM 3630 CB HIS B 142 -5.565 -14.404 34.343 1.00 83.69 C \nANISOU 3630 CB HIS B 142 10077 10242 11481 -1808 -931 147 C \nATOM 3631 CG HIS B 142 -6.250 -13.982 33.095 1.00 80.13 C \nANISOU 3631 CG HIS B 142 9706 9733 11009 -1798 -959 148 C \nATOM 3632 ND1 HIS B 142 -6.053 -12.732 32.545 1.00 89.83 N \nANISOU 3632 ND1 HIS B 142 10962 10983 12186 -1897 -972 171 N \nATOM 3633 CD2 HIS B 142 -7.199 -14.585 32.344 1.00 75.66 C \nANISOU 3633 CD2 HIS B 142 9202 9102 10443 -1701 -984 126 C \nATOM 3634 CE1 HIS B 142 -6.817 -12.603 31.476 1.00 92.07 C \nANISOU 3634 CE1 HIS B 142 11341 11188 12454 -1865 -1005 168 C \nATOM 3635 NE2 HIS B 142 -7.517 -13.715 31.329 1.00 88.59 N \nANISOU 3635 NE2 HIS B 142 10921 10695 12043 -1733 -1013 137 N \nATOM 3636 N LYS B 143 -4.965 -17.222 34.227 1.00 88.60 N \nANISOU 3636 N LYS B 143 10576 10897 12193 -1664 -866 100 N \nATOM 3637 CA LYS B 143 -5.390 -18.510 33.752 1.00 86.41 C \nANISOU 3637 CA LYS B 143 10266 10648 11917 -1611 -857 78 C \nATOM 3638 C LYS B 143 -6.521 -18.273 32.791 1.00 85.78 C \nANISOU 3638 C LYS B 143 10233 10550 11809 -1546 -889 64 C \nATOM 3639 O LYS B 143 -7.496 -17.591 33.136 1.00 89.76 O \nANISOU 3639 O LYS B 143 10832 10994 12278 -1519 -940 66 O \nATOM 3640 CB LYS B 143 -5.917 -19.320 34.926 1.00 88.04 C \nANISOU 3640 CB LYS B 143 10454 10886 12109 -1592 -867 69 C \nATOM 3641 CG LYS B 143 -6.516 -20.666 34.552 1.00 96.26 C \nANISOU 3641 CG LYS B 143 11433 12025 13115 -1542 -862 41 C \nATOM 3642 CD LYS B 143 -7.297 -21.267 35.708 1.00104.21 C \nANISOU 3642 CD LYS B 143 12423 13083 14088 -1498 -882 26 C \nATOM 3643 CE LYS B 143 -6.383 -21.556 36.893 1.00106.43 C \nANISOU 3643 CE LYS B 143 12685 13354 14398 -1582 -859 46 C \nATOM 3644 NZ LYS B 143 -7.095 -22.237 37.999 1.00102.39 N \nANISOU 3644 NZ LYS B 143 12145 12905 13853 -1546 -875 31 N \nATOM 3645 N CYS B 144 -6.405 -18.865 31.608 1.00 82.12 N \nANISOU 3645 N CYS B 144 9726 10132 11345 -1521 -869 50 N \nATOM 3646 CA CYS B 144 -7.378 -18.668 30.554 1.00 74.82 C \nANISOU 3646 CA CYS B 144 8841 9202 10386 -1440 -899 30 C \nATOM 3647 C CYS B 144 -7.850 -20.011 30.040 1.00 76.00 C \nANISOU 3647 C CYS B 144 8900 9489 10489 -1372 -889 -5 C \nATOM 3648 O CYS B 144 -7.255 -20.591 29.122 1.00 65.00 O \nANISOU 3648 O CYS B 144 7438 8162 9096 -1416 -853 -5 O \nATOM 3649 CB CYS B 144 -6.793 -17.829 29.421 1.00 70.38 C \nANISOU 3649 CB CYS B 144 8302 8591 9848 -1481 -886 46 C \nATOM 3650 SG CYS B 144 -7.972 -17.069 28.253 1.00 77.47 S \nANISOU 3650 SG CYS B 144 9308 9427 10698 -1399 -941 32 S \nATOM 3651 N ASP B 145 -8.937 -20.502 30.641 1.00 87.83 N \nANISOU 3651 N ASP B 145 10398 11050 11924 -1266 -925 -37 N \nATOM 3652 CA ASP B 145 -9.545 -21.784 30.226 1.00 91.70 C \nANISOU 3652 CA ASP B 145 10768 11744 12328 -1182 -921 -81 C \nATOM 3653 C ASP B 145 -10.017 -21.731 28.774 1.00 87.20 C \nANISOU 3653 C ASP B 145 10192 11228 11713 -1096 -934 -109 C \nATOM 3654 O ASP B 145 -10.046 -20.677 28.155 1.00 88.85 O \nANISOU 3654 O ASP B 145 10512 11290 11956 -1084 -955 -95 O \nATOM 3655 CB ASP B 145 -10.685 -22.229 31.178 1.00 99.75 C \nANISOU 3655 CB ASP B 145 11791 12845 13265 -1040 -969 -123 C \nATOM 3656 CG ASP B 145 -11.785 -21.173 31.354 1.00102.08 C \nANISOU 3656 CG ASP B 145 12282 12982 13522 -893 -1055 -140 C \nATOM 3657 OD1 ASP B 145 -12.052 -20.391 30.432 1.00107.40 O \nANISOU 3657 OD1 ASP B 145 13062 13555 14189 -853 -1087 -140 O \nATOM 3658 OD2 ASP B 145 -12.409 -21.140 32.433 1.00106.54 O \nANISOU 3658 OD2 ASP B 145 12919 13513 14047 -822 -1101 -154 O \nATOM 3659 N ASN B 146 -10.372 -22.881 28.230 1.00 90.67 N \nANISOU 3659 N ASN B 146 10489 11902 12059 -1047 -920 -147 N \nATOM 3660 CA ASN B 146 -10.813 -22.958 26.847 1.00 89.98 C \nANISOU 3660 CA ASN B 146 10369 11908 11912 -959 -929 -179 C \nATOM 3661 C ASN B 146 -11.893 -21.941 26.500 1.00 89.65 C \nANISOU 3661 C ASN B 146 10495 11730 11839 -762 -1007 -210 C \nATOM 3662 O ASN B 146 -11.862 -21.362 25.425 1.00 87.69 O \nANISOU 3662 O ASN B 146 10303 11408 11606 -749 -1014 -206 O \nATOM 3663 CB ASN B 146 -11.289 -24.377 26.516 1.00 90.44 C \nANISOU 3663 CB ASN B 146 10229 12310 11826 -909 -916 -229 C \nATOM 3664 CG ASN B 146 -10.175 -25.386 26.583 1.00 98.98 C \nANISOU 3664 CG ASN B 146 11182 13519 12907 -1156 -850 -189 C \nATOM 3665 OD1 ASN B 146 -10.332 -26.461 27.161 1.00116.04 O \nANISOU 3665 OD1 ASN B 146 13209 15911 14970 -1198 -839 -205 O \nATOM 3666 ND2 ASN B 146 -9.025 -25.040 26.019 1.00105.22 N \nANISOU 3666 ND2 ASN B 146 12033 14157 13790 -1325 -815 -136 N \nATOM 3667 N GLU B 147 -12.843 -21.730 27.405 1.00 96.57 N \nANISOU 3667 N GLU B 147 11477 12560 12656 -615 -1075 -240 N \nATOM 3668 CA GLU B 147 -13.921 -20.772 27.157 1.00102.26 C \nANISOU 3668 CA GLU B 147 12426 13116 13311 -433 -1174 -269 C \nATOM 3669 C GLU B 147 -13.412 -19.339 27.183 1.00100.66 C \nANISOU 3669 C GLU B 147 12411 12627 13210 -588 -1186 -202 C \nATOM 3670 O GLU B 147 -13.898 -18.503 26.430 1.00102.73 O \nANISOU 3670 O GLU B 147 12841 12758 13435 -529 -1245 -206 O \nATOM 3671 CB GLU B 147 -15.093 -20.974 28.126 1.00106.22 C \nANISOU 3671 CB GLU B 147 13031 13636 13692 -223 -1261 -323 C \nATOM 3672 CG GLU B 147 -15.865 -22.253 27.846 1.00115.37 C \nANISOU 3672 CG GLU B 147 14012 15129 14693 0 -1273 -411 C \nATOM 3673 CD GLU B 147 -17.122 -22.396 28.687 1.00126.22 C \nANISOU 3673 CD GLU B 147 15514 16528 15916 273 -1378 -481 C \nATOM 3674 OE1 GLU B 147 -17.034 -22.998 29.778 1.00128.24 O \nANISOU 3674 OE1 GLU B 147 15672 16883 16169 241 -1356 -482 O \nATOM 3675 OE2 GLU B 147 -18.196 -21.901 28.272 1.00134.93 O \nANISOU 3675 OE2 GLU B 147 16838 17539 16891 527 -1492 -538 O \nATOM 3676 N CYS B 148 -12.440 -19.057 28.047 1.00 98.79 N \nANISOU 3676 N CYS B 148 12141 12316 13077 -786 -1134 -144 N \nATOM 3677 CA CYS B 148 -11.773 -17.754 28.066 1.00 91.41 C \nANISOU 3677 CA CYS B 148 11320 11193 12218 -955 -1130 -83 C \nATOM 3678 C CYS B 148 -11.041 -17.528 26.743 1.00 96.00 C \nANISOU 3678 C CYS B 148 11834 11788 12852 -1025 -1082 -67 C \nATOM 3679 O CYS B 148 -11.034 -16.424 26.210 1.00107.10 O \nANISOU 3679 O CYS B 148 13365 13068 14261 -1079 -1110 -41 O \nATOM 3680 CB CYS B 148 -10.788 -17.661 29.250 1.00 93.48 C \nANISOU 3680 CB CYS B 148 11516 11441 12563 -1120 -1080 -38 C \nATOM 3681 SG CYS B 148 -9.582 -16.307 29.285 1.00 96.93 S \nANISOU 3681 SG CYS B 148 11980 11774 13074 -1332 -1046 27 S \nATOM 3682 N MET B 149 -10.458 -18.588 26.199 1.00 90.10 N \nANISOU 3682 N MET B 149 10903 11201 12129 -1036 -1015 -81 N \nATOM 3683 CA MET B 149 -9.778 -18.520 24.928 1.00 83.48 C \nANISOU 3683 CA MET B 149 10007 10383 11329 -1094 -973 -69 C \nATOM 3684 C MET B 149 -10.771 -18.336 23.792 1.00 82.94 C \nANISOU 3684 C MET B 149 10006 10320 11186 -945 -1023 -108 C \nATOM 3685 O MET B 149 -10.561 -17.496 22.907 1.00 84.45 O \nANISOU 3685 O MET B 149 10270 10414 11403 -984 -1028 -89 O \nATOM 3686 CB MET B 149 -8.945 -19.787 24.684 1.00 87.12 C \nANISOU 3686 CB MET B 149 10290 11010 11802 -1170 -903 -71 C \nATOM 3687 CG MET B 149 -7.462 -19.531 24.520 1.00 87.79 C \nANISOU 3687 CG MET B 149 10358 11028 11969 -1331 -851 -26 C \nATOM 3688 SD MET B 149 -6.650 -19.579 26.100 1.00104.44 S \nANISOU 3688 SD MET B 149 12469 13090 14122 -1426 -833 2 S \nATOM 3689 CE MET B 149 -4.971 -19.138 25.699 1.00 76.04 C \nANISOU 3689 CE MET B 149 8891 9420 10582 -1538 -795 35 C \nATOM 3690 N GLU B 150 -11.839 -19.129 23.772 1.00 85.41 N \nANISOU 3690 N GLU B 150 10294 10768 11391 -761 -1064 -168 N \nATOM 3691 CA GLU B 150 -12.857 -18.954 22.731 1.00 93.42 C \nANISOU 3691 CA GLU B 150 11393 11794 12308 -572 -1128 -217 C \nATOM 3692 C GLU B 150 -13.313 -17.502 22.745 1.00 92.55 C \nANISOU 3692 C GLU B 150 11556 11418 12191 -571 -1208 -193 C \nATOM 3693 O GLU B 150 -13.560 -16.921 21.680 1.00 99.66 O \nANISOU 3693 O GLU B 150 12554 12246 13067 -533 -1239 -197 O \nATOM 3694 CB GLU B 150 -14.043 -19.905 22.903 1.00 99.77 C \nANISOU 3694 CB GLU B 150 12152 12798 12959 -323 -1181 -299 C \nATOM 3695 CG GLU B 150 -15.111 -19.822 21.805 1.00109.41 C \nANISOU 3695 CG GLU B 150 13458 14065 14047 -77 -1256 -367 C \nATOM 3696 CD GLU B 150 -14.584 -20.167 20.412 1.00116.33 C \nANISOU 3696 CD GLU B 150 14177 15078 14945 -133 -1193 -366 C \nATOM 3697 OE1 GLU B 150 -13.960 -21.244 20.257 1.00128.78 O \nANISOU 3697 OE1 GLU B 150 15505 16900 16527 -237 -1111 -364 O \nATOM 3698 OE2 GLU B 150 -14.798 -19.378 19.469 1.00109.97 O \nANISOU 3698 OE2 GLU B 150 13509 14137 14138 -90 -1230 -365 O \nATOM 3699 N SER B 151 -13.394 -16.938 23.953 1.00 88.47 N \nANISOU 3699 N SER B 151 11165 10766 11683 -638 -1243 -163 N \nATOM 3700 CA SER B 151 -13.940 -15.602 24.162 1.00 91.95 C \nANISOU 3700 CA SER B 151 11895 10968 12074 -675 -1336 -135 C \nATOM 3701 C SER B 151 -13.063 -14.537 23.526 1.00 95.03 C \nANISOU 3701 C SER B 151 12303 11264 12539 -886 -1299 -73 C \nATOM 3702 O SER B 151 -13.585 -13.580 22.950 1.00106.14 O \nANISOU 3702 O SER B 151 13924 12526 13878 -896 -1374 -62 O \nATOM 3703 CB SER B 151 -14.159 -15.273 25.649 1.00 93.74 C \nANISOU 3703 CB SER B 151 12240 11097 12279 -735 -1378 -112 C \nATOM 3704 OG SER B 151 -13.011 -14.717 26.241 1.00100.11 O \nANISOU 3704 OG SER B 151 12962 11884 13193 -983 -1308 -44 O \nATOM 3705 N VAL B 152 -11.746 -14.709 23.607 1.00 90.07 N \nANISOU 3705 N VAL B 152 11465 10725 12031 -1044 -1194 -38 N \nATOM 3706 CA VAL B 152 -10.832 -13.742 22.990 1.00 93.14 C \nANISOU 3706 CA VAL B 152 11841 11072 12476 -1215 -1156 10 C \nATOM 3707 C VAL B 152 -10.804 -13.852 21.458 1.00 93.11 C \nANISOU 3707 C VAL B 152 11801 11098 12478 -1153 -1141 -9 C \nATOM 3708 O VAL B 152 -10.457 -12.895 20.773 1.00104.73 O \nANISOU 3708 O VAL B 152 13327 12508 13956 -1254 -1142 22 O \nATOM 3709 CB VAL B 152 -9.383 -13.818 23.537 1.00 94.23 C \nANISOU 3709 CB VAL B 152 11798 11293 12713 -1362 -1065 44 C \nATOM 3710 CG1 VAL B 152 -9.365 -13.727 25.048 1.00 93.55 C \nANISOU 3710 CG1 VAL B 152 11731 11193 12620 -1421 -1076 61 C \nATOM 3711 CG2 VAL B 152 -8.667 -15.067 23.077 1.00 97.72 C \nANISOU 3711 CG2 VAL B 152 12048 11865 13216 -1317 -989 21 C \nATOM 3712 N ARG B 153 -11.171 -15.015 20.932 1.00 91.08 N \nANISOU 3712 N ARG B 153 11441 10961 12203 -996 -1125 -60 N \nATOM 3713 CA ARG B 153 -11.210 -15.222 19.484 1.00 90.87 C \nANISOU 3713 CA ARG B 153 11369 10988 12169 -929 -1112 -83 C \nATOM 3714 C ARG B 153 -12.406 -14.552 18.838 1.00 98.16 C \nANISOU 3714 C ARG B 153 12517 11794 12987 -797 -1214 -108 C \nATOM 3715 O ARG B 153 -12.278 -13.965 17.775 1.00 89.39 O \nANISOU 3715 O ARG B 153 11452 10631 11881 -828 -1217 -97 O \nATOM 3716 CB ARG B 153 -11.243 -16.717 19.133 1.00 85.91 C \nANISOU 3716 CB ARG B 153 10542 10578 11521 -825 -1066 -130 C \nATOM 3717 CG ARG B 153 -9.978 -17.482 19.506 1.00 78.37 C \nANISOU 3717 CG ARG B 153 9401 9727 10649 -977 -974 -102 C \nATOM 3718 CD ARG B 153 -9.933 -18.821 18.802 1.00 79.98 C \nANISOU 3718 CD ARG B 153 9430 10154 10805 -941 -933 -135 C \nATOM 3719 NE ARG B 153 -9.436 -19.905 19.647 1.00 83.23 N \nANISOU 3719 NE ARG B 153 9710 10699 11213 -1025 -890 -130 N \nATOM 3720 CZ ARG B 153 -10.199 -20.843 20.207 1.00 89.55 C \nANISOU 3720 CZ ARG B 153 10427 11678 11919 -928 -907 -172 C \nATOM 3721 NH1 ARG B 153 -11.511 -20.870 20.003 1.00 90.36 N \nANISOU 3721 NH1 ARG B 153 10563 11855 11914 -707 -971 -232 N \nATOM 3722 NH2 ARG B 153 -9.646 -21.780 20.959 1.00 95.05 N \nANISOU 3722 NH2 ARG B 153 11013 12491 12610 -1043 -867 -159 N \nATOM 3723 N ASN B 154 -13.568 -14.659 19.480 1.00111.76 N \nANISOU 3723 N ASN B 154 14397 13467 14598 -639 -1306 -146 N \nATOM 3724 CA ASN B 154 -14.827 -14.126 18.920 1.00116.70 C \nANISOU 3724 CA ASN B 154 15297 13960 15083 -465 -1432 -184 C \nATOM 3725 C ASN B 154 -15.148 -12.699 19.371 1.00111.68 C \nANISOU 3725 C ASN B 154 14977 13065 14390 -607 -1526 -131 C \nATOM 3726 O ASN B 154 -16.257 -12.226 19.152 1.00113.71 O \nANISOU 3726 O ASN B 154 15538 13164 14500 -476 -1657 -157 O \nATOM 3727 CB ASN B 154 -16.003 -15.056 19.264 1.00123.89 C \nANISOU 3727 CB ASN B 154 16247 14970 15857 -164 -1505 -270 C \nATOM 3728 CG ASN B 154 -16.075 -15.375 20.742 1.00131.45 C \nANISOU 3728 CG ASN B 154 17196 15935 16814 -181 -1510 -265 C \nATOM 3729 OD1 ASN B 154 -15.293 -14.833 21.515 1.00131.56 O \nANISOU 3729 OD1 ASN B 154 17196 15863 16926 -419 -1465 -196 O \nATOM 3730 ND2 ASN B 154 -16.972 -16.287 21.150 1.00146.28 N \nANISOU 3730 ND2 ASN B 154 19058 17947 18574 78 -1561 -342 N \nATOM 3731 N GLY B 155 -14.193 -12.036 20.025 1.00107.30 N \nANISOU 3731 N GLY B 155 14364 12480 13924 -874 -1468 -59 N \nATOM 3732 CA GLY B 155 -14.387 -10.670 20.500 1.00102.99 C \nANISOU 3732 CA GLY B 155 14081 11747 13304 -1072 -1548 1 C \nATOM 3733 C GLY B 155 -15.168 -10.567 21.804 1.00107.43 C \nANISOU 3733 C GLY B 155 14855 12197 13766 -1052 -1641 1 C \nATOM 3734 O GLY B 155 -15.118 -9.548 22.491 1.00110.30 O \nANISOU 3734 O GLY B 155 15385 12450 14074 -1277 -1687 62 O \nATOM 3735 N THR B 156 -15.878 -11.625 22.167 1.00106.71 N \nANISOU 3735 N THR B 156 14749 12158 13637 -792 -1669 -67 N \nATOM 3736 CA THR B 156 -16.738 -11.608 23.326 1.00113.84 C \nANISOU 3736 CA THR B 156 15878 12948 14429 -720 -1771 -81 C \nATOM 3737 C THR B 156 -15.977 -11.963 24.591 1.00104.06 C \nANISOU 3737 C THR B 156 14428 11815 13296 -853 -1683 -50 C \nATOM 3738 O THR B 156 -16.392 -12.842 25.329 1.00 99.47 O \nANISOU 3738 O THR B 156 13797 11303 12694 -685 -1692 -96 O \nATOM 3739 CB THR B 156 -17.878 -12.615 23.142 1.00125.14 C \nANISOU 3739 CB THR B 156 17375 14428 15744 -338 -1848 -182 C \nATOM 3740 OG1 THR B 156 -17.337 -13.938 23.126 1.00126.62 O \nANISOU 3740 OG1 THR B 156 17173 14898 16038 -235 -1723 -223 O \nATOM 3741 CG2 THR B 156 -18.621 -12.359 21.840 1.00125.91 C \nANISOU 3741 CG2 THR B 156 17669 14444 15727 -161 -1936 -225 C \nATOM 3742 N TYR B 157 -14.883 -11.252 24.850 1.00105.53 N \nANISOU 3742 N TYR B 157 14494 12027 13574 -1142 -1605 23 N \nATOM 3743 CA TYR B 157 -14.033 -11.510 26.017 1.00103.47 C \nANISOU 3743 CA TYR B 157 14032 11874 13409 -1270 -1520 52 C \nATOM 3744 C TYR B 157 -14.259 -10.462 27.081 1.00109.24 C \nANISOU 3744 C TYR B 157 14981 12478 14048 -1475 -1595 108 C \nATOM 3745 O TYR B 157 -14.176 -9.266 26.805 1.00126.83 O \nANISOU 3745 O TYR B 157 17357 14629 16205 -1689 -1636 163 O \nATOM 3746 CB TYR B 157 -12.555 -11.513 25.614 1.00102.57 C \nANISOU 3746 CB TYR B 157 13617 11918 13439 -1416 -1385 82 C \nATOM 3747 CG TYR B 157 -11.555 -11.363 26.766 1.00 93.08 C \nANISOU 3747 CG TYR B 157 12259 10804 12302 -1585 -1316 121 C \nATOM 3748 CD1 TYR B 157 -11.199 -12.449 27.571 1.00 94.40 C \nANISOU 3748 CD1 TYR B 157 12252 11072 12545 -1504 -1256 97 C \nATOM 3749 CD2 TYR B 157 -10.957 -10.146 27.030 1.00 87.90 C \nANISOU 3749 CD2 TYR B 157 11622 10160 11614 -1824 -1313 179 C \nATOM 3750 CE1 TYR B 157 -10.279 -12.320 28.605 1.00 89.91 C \nANISOU 3750 CE1 TYR B 157 11556 10579 12026 -1636 -1201 127 C \nATOM 3751 CE2 TYR B 157 -10.036 -9.999 28.063 1.00 88.90 C \nANISOU 3751 CE2 TYR B 157 11595 10402 11780 -1949 -1254 205 C \nATOM 3752 CZ TYR B 157 -9.700 -11.094 28.848 1.00 92.77 C \nANISOU 3752 CZ TYR B 157 11935 10958 12354 -1843 -1200 177 C \nATOM 3753 OH TYR B 157 -8.795 -10.946 29.868 1.00 82.10 O \nANISOU 3753 OH TYR B 157 10451 9715 11031 -1947 -1150 198 O \nATOM 3754 N ASP B 158 -14.524 -10.911 28.305 1.00115.78 N \nANISOU 3754 N ASP B 158 15822 13305 14866 -1433 -1611 99 N \nATOM 3755 CA ASP B 158 -14.772 -10.011 29.440 1.00117.31 C \nANISOU 3755 CA ASP B 158 16223 13389 14960 -1635 -1684 152 C \nATOM 3756 C ASP B 158 -13.471 -9.674 30.170 1.00111.28 C \nANISOU 3756 C ASP B 158 15201 12788 14291 -1872 -1575 204 C \nATOM 3757 O ASP B 158 -12.932 -10.494 30.904 1.00104.85 O \nANISOU 3757 O ASP B 158 14168 12092 13578 -1809 -1496 186 O \nATOM 3758 CB ASP B 158 -15.766 -10.642 30.425 1.00120.05 C \nANISOU 3758 CB ASP B 158 16735 13647 15231 -1452 -1768 111 C \nATOM 3759 CG ASP B 158 -16.128 -9.712 31.563 1.00121.57 C \nANISOU 3759 CG ASP B 158 17192 13702 15298 -1667 -1862 168 C \nATOM 3760 OD1 ASP B 158 -16.609 -8.595 31.271 1.00131.89 O \nANISOU 3760 OD1 ASP B 158 18813 14844 16456 -1837 -1970 213 O \nATOM 3761 OD2 ASP B 158 -15.932 -10.100 32.733 1.00104.31 O \nANISOU 3761 OD2 ASP B 158 14909 11574 13151 -1682 -1830 171 O \nATOM 3762 N TYR B 159 -12.984 -8.453 29.970 1.00115.67 N \nANISOU 3762 N TYR B 159 15790 13368 14791 -2138 -1577 265 N \nATOM 3763 CA TYR B 159 -11.761 -7.979 30.631 1.00110.72 C \nANISOU 3763 CA TYR B 159 14923 12937 14210 -2348 -1487 306 C \nATOM 3764 C TYR B 159 -11.863 -7.907 32.153 1.00114.36 C \nANISOU 3764 C TYR B 159 15421 13406 14626 -2445 -1510 329 C \nATOM 3765 O TYR B 159 -10.959 -8.385 32.841 1.00109.13 O \nANISOU 3765 O TYR B 159 14501 12900 14062 -2427 -1416 319 O \nATOM 3766 CB TYR B 159 -11.330 -6.610 30.061 1.00107.82 C \nANISOU 3766 CB TYR B 159 14581 12642 13743 -2618 -1497 362 C \nATOM 3767 CG TYR B 159 -10.154 -5.979 30.795 1.00102.70 C \nANISOU 3767 CG TYR B 159 13693 12244 13084 -2826 -1422 397 C \nATOM 3768 CD1 TYR B 159 -8.832 -6.264 30.413 1.00104.73 C \nANISOU 3768 CD1 TYR B 159 13623 12713 13458 -2755 -1302 371 C \nATOM 3769 CD2 TYR B 159 -10.356 -5.122 31.868 1.00 99.74 C \nANISOU 3769 CD2 TYR B 159 13429 11905 12562 -3078 -1479 449 C \nATOM 3770 CE1 TYR B 159 -7.750 -5.707 31.075 1.00100.82 C \nANISOU 3770 CE1 TYR B 159 12909 12471 12927 -2891 -1243 387 C \nATOM 3771 CE2 TYR B 159 -9.288 -4.557 32.541 1.00100.39 C \nANISOU 3771 CE2 TYR B 159 13267 12267 12611 -3247 -1412 472 C \nATOM 3772 CZ TYR B 159 -7.989 -4.851 32.145 1.00108.22 C \nANISOU 3772 CZ TYR B 159 13926 13478 13714 -3133 -1295 436 C \nATOM 3773 OH TYR B 159 -6.927 -4.306 32.828 1.00102.80 O \nANISOU 3773 OH TYR B 159 13000 13090 12969 -3249 -1238 443 O \nATOM 3774 N PRO B 160 -12.947 -7.290 32.687 1.00125.57 N \nANISOU 3774 N PRO B 160 17185 14646 15880 -2551 -1643 359 N \nATOM 3775 CA PRO B 160 -12.971 -7.035 34.137 1.00123.16 C \nANISOU 3775 CA PRO B 160 16920 14362 15511 -2699 -1667 392 C \nATOM 3776 C PRO B 160 -12.977 -8.260 35.031 1.00114.62 C \nANISOU 3776 C PRO B 160 15708 13296 14545 -2479 -1622 344 C \nATOM 3777 O PRO B 160 -12.574 -8.153 36.192 1.00124.45 O \nANISOU 3777 O PRO B 160 16865 14631 15788 -2595 -1596 367 O \nATOM 3778 CB PRO B 160 -14.254 -6.213 34.345 1.00135.26 C \nANISOU 3778 CB PRO B 160 18920 15650 16824 -2838 -1841 430 C \nATOM 3779 CG PRO B 160 -15.079 -6.443 33.128 1.00135.33 C \nANISOU 3779 CG PRO B 160 19140 15474 16804 -2637 -1914 391 C \nATOM 3780 CD PRO B 160 -14.108 -6.680 32.010 1.00126.46 C \nANISOU 3780 CD PRO B 160 17689 14527 15832 -2575 -1786 371 C \nATOM 3781 N GLN B 161 -13.398 -9.408 34.511 1.00108.02 N \nANISOU 3781 N GLN B 161 14843 12405 13795 -2179 -1611 278 N \nATOM 3782 CA GLN B 161 -13.377 -10.647 35.312 1.00100.95 C \nANISOU 3782 CA GLN B 161 13797 11563 12995 -1983 -1564 231 C \nATOM 3783 C GLN B 161 -11.996 -10.925 35.854 1.00 88.80 C \nANISOU 3783 C GLN B 161 11922 10232 11586 -2064 -1432 243 C \nATOM 3784 O GLN B 161 -11.841 -11.227 37.017 1.00 81.01 O \nANISOU 3784 O GLN B 161 10877 9284 10617 -2080 -1416 246 O \nATOM 3785 CB GLN B 161 -13.825 -11.859 34.490 1.00103.56 C \nANISOU 3785 CB GLN B 161 14066 11898 13385 -1678 -1550 158 C \nATOM 3786 CG GLN B 161 -14.863 -12.720 35.172 1.00113.51 C \nANISOU 3786 CG GLN B 161 15445 13095 14589 -1452 -1619 105 C \nATOM 3787 CD GLN B 161 -15.104 -13.996 34.410 1.00124.40 C \nANISOU 3787 CD GLN B 161 16669 14584 16014 -1173 -1583 29 C \nATOM 3788 OE1 GLN B 161 -14.505 -14.223 33.363 1.00126.26 O \nANISOU 3788 OE1 GLN B 161 16730 14915 16326 -1166 -1509 22 O \nATOM 3789 NE2 GLN B 161 -15.986 -14.843 34.932 1.00138.44 N \nANISOU 3789 NE2 GLN B 161 18504 16372 17725 -944 -1637 -30 N \nATOM 3790 N TYR B 162 -10.996 -10.812 34.983 1.00 90.04 N \nANISOU 3790 N TYR B 162 11878 10513 11821 -2098 -1348 246 N \nATOM 3791 CA TYR B 162 -9.626 -11.212 35.317 1.00 92.00 C \nANISOU 3791 CA TYR B 162 11833 10945 12180 -2111 -1234 241 C \nATOM 3792 C TYR B 162 -8.787 -10.019 35.713 1.00 91.93 C \nANISOU 3792 C TYR B 162 11750 11071 12107 -2338 -1214 287 C \nATOM 3793 O TYR B 162 -7.573 -10.148 35.887 1.00 91.05 O \nANISOU 3793 O TYR B 162 11416 11125 12055 -2335 -1133 277 O \nATOM 3794 CB TYR B 162 -8.968 -11.947 34.127 1.00 87.66 C \nANISOU 3794 CB TYR B 162 11117 10456 11734 -1979 -1160 206 C \nATOM 3795 CG TYR B 162 -9.874 -12.965 33.482 1.00 82.13 C \nANISOU 3795 CG TYR B 162 10478 9674 11053 -1778 -1186 161 C \nATOM 3796 CD1 TYR B 162 -10.665 -12.605 32.394 1.00 79.70 C \nANISOU 3796 CD1 TYR B 162 10325 9272 10687 -1730 -1245 153 C \nATOM 3797 CD2 TYR B 162 -9.984 -14.272 33.975 1.00 76.02 C \nANISOU 3797 CD2 TYR B 162 9609 8944 10330 -1636 -1157 123 C \nATOM 3798 CE1 TYR B 162 -11.515 -13.510 31.803 1.00 81.70 C \nANISOU 3798 CE1 TYR B 162 10620 9493 10929 -1520 -1274 102 C \nATOM 3799 CE2 TYR B 162 -10.848 -15.182 33.388 1.00 71.71 C \nANISOU 3799 CE2 TYR B 162 9090 8390 9765 -1450 -1184 75 C \nATOM 3800 CZ TYR B 162 -11.599 -14.791 32.306 1.00 77.27 C \nANISOU 3800 CZ TYR B 162 9933 9017 10407 -1380 -1241 61 C \nATOM 3801 OH TYR B 162 -12.452 -15.658 31.686 1.00 87.56 O \nANISOU 3801 OH TYR B 162 11249 10352 11667 -1170 -1271 4 O \nATOM 3802 N SER B 163 -9.448 -8.875 35.882 1.00 97.10 N \nANISOU 3802 N SER B 163 12607 11670 12616 -2535 -1299 333 N \nATOM 3803 CA SER B 163 -8.765 -7.613 36.146 1.00101.40 C \nANISOU 3803 CA SER B 163 13079 12396 13052 -2791 -1290 379 C \nATOM 3804 C SER B 163 -7.748 -7.657 37.270 1.00 98.66 C \nANISOU 3804 C SER B 163 12504 12259 12722 -2826 -1223 377 C \nATOM 3805 O SER B 163 -6.553 -7.490 37.015 1.00 96.90 O \nANISOU 3805 O SER B 163 12049 12246 12523 -2810 -1148 360 O \nATOM 3806 CB SER B 163 -9.776 -6.522 36.405 1.00114.14 C \nANISOU 3806 CB SER B 163 14989 13903 14476 -3034 -1408 437 C \nATOM 3807 OG SER B 163 -10.524 -6.313 35.232 1.00124.34 O \nANISOU 3807 OG SER B 163 16488 15026 15729 -3008 -1472 438 O \nATOM 3808 N GLU B 164 -8.211 -7.882 38.500 1.00101.48 N \nANISOU 3808 N GLU B 164 12940 12561 13056 -2854 -1257 387 N \nATOM 3809 CA GLU B 164 -7.313 -7.817 39.661 1.00104.22 C \nANISOU 3809 CA GLU B 164 13091 13113 13397 -2903 -1204 387 C \nATOM 3810 C GLU B 164 -6.455 -9.054 39.775 1.00 94.06 C \nANISOU 3810 C GLU B 164 11606 11860 12272 -2658 -1119 332 C \nATOM 3811 O GLU B 164 -5.315 -8.988 40.232 1.00 81.75 O \nANISOU 3811 O GLU B 164 9845 10503 10713 -2640 -1061 315 O \nATOM 3812 CB GLU B 164 -8.061 -7.543 40.969 1.00111.34 C \nANISOU 3812 CB GLU B 164 14148 13954 14201 -3045 -1272 422 C \nATOM 3813 CG GLU B 164 -9.009 -8.618 41.458 1.00110.60 C \nANISOU 3813 CG GLU B 164 14213 13622 14187 -2871 -1311 399 C \nATOM 3814 CD GLU B 164 -9.769 -8.161 42.694 1.00110.77 C \nANISOU 3814 CD GLU B 164 14427 13577 14085 -3036 -1393 439 C \nATOM 3815 OE1 GLU B 164 -9.624 -6.989 43.098 1.00104.47 O \nANISOU 3815 OE1 GLU B 164 13655 12909 13128 -3317 -1424 492 O \nATOM 3816 OE2 GLU B 164 -10.521 -8.968 43.264 1.00119.28 O \nANISOU 3816 OE2 GLU B 164 15629 14487 15203 -2895 -1430 417 O \nATOM 3817 N GLU B 165 -7.008 -10.181 39.344 1.00 96.92 N \nANISOU 3817 N GLU B 165 12040 12039 12747 -2471 -1120 301 N \nATOM 3818 CA GLU B 165 -6.218 -11.402 39.154 1.00 89.62 C \nANISOU 3818 CA GLU B 165 10958 11137 11956 -2274 -1047 255 C \nATOM 3819 C GLU B 165 -4.973 -11.084 38.338 1.00 89.16 C \nANISOU 3819 C GLU B 165 10742 11227 11907 -2253 -991 240 C \nATOM 3820 O GLU B 165 -3.861 -11.436 38.746 1.00 88.52 O \nANISOU 3820 O GLU B 165 10520 11260 11854 -2179 -943 214 O \nATOM 3821 CB GLU B 165 -7.038 -12.473 38.446 1.00 87.19 C \nANISOU 3821 CB GLU B 165 10736 10670 11724 -2116 -1061 227 C \nATOM 3822 CG GLU B 165 -6.295 -13.798 38.308 1.00 86.71 C \nANISOU 3822 CG GLU B 165 10535 10641 11770 -1968 -995 189 C \nATOM 3823 CD GLU B 165 -7.215 -14.938 37.901 1.00 82.35 C \nANISOU 3823 CD GLU B 165 10036 9997 11255 -1833 -1011 160 C \nATOM 3824 OE1 GLU B 165 -8.463 -14.740 38.025 1.00 85.48 O \nANISOU 3824 OE1 GLU B 165 10588 10297 11594 -1814 -1080 162 O \nATOM 3825 OE2 GLU B 165 -6.690 -15.999 37.436 1.00 70.91 O \nANISOU 3825 OE2 GLU B 165 8487 8588 9868 -1750 -963 135 O \nATOM 3826 N ALA B 166 -5.169 -10.385 37.209 1.00 85.87 N \nANISOU 3826 N ALA B 166 10370 10805 11450 -2311 -1007 252 N \nATOM 3827 CA ALA B 166 -4.061 -9.997 36.338 1.00 82.20 C \nANISOU 3827 CA ALA B 166 9769 10486 10978 -2284 -962 235 C \nATOM 3828 C ALA B 166 -3.137 -9.039 37.046 1.00 93.58 C \nANISOU 3828 C ALA B 166 11068 12183 12307 -2378 -947 239 C \nATOM 3829 O ALA B 166 -1.911 -9.147 36.904 1.00 80.36 O \nANISOU 3829 O ALA B 166 9247 10654 10632 -2262 -903 201 O \nATOM 3830 CB ALA B 166 -4.571 -9.371 35.061 1.00 94.15 C \nANISOU 3830 CB ALA B 166 11368 11947 12459 -2346 -988 252 C \nATOM 3831 N ARG B 167 -3.735 -8.107 37.806 1.00105.09 N \nANISOU 3831 N ARG B 167 12580 13704 13643 -2584 -991 283 N \nATOM 3832 CA ARG B 167 -2.995 -7.061 38.508 1.00111.52 C \nANISOU 3832 CA ARG B 167 13243 14823 14306 -2717 -983 291 C \nATOM 3833 C ARG B 167 -2.198 -7.672 39.647 1.00105.14 C \nANISOU 3833 C ARG B 167 12310 14110 13529 -2586 -948 255 C \nATOM 3834 O ARG B 167 -1.007 -7.393 39.836 1.00 98.24 O \nANISOU 3834 O ARG B 167 11252 13487 12587 -2503 -914 216 O \nATOM 3835 CB ARG B 167 -3.982 -5.967 39.017 1.00125.47 C \nANISOU 3835 CB ARG B 167 15145 16614 15915 -3022 -1052 357 C \nATOM 3836 CG ARG B 167 -3.793 -5.457 40.451 1.00128.64 C \nANISOU 3836 CG ARG B 167 15469 17217 16193 -3168 -1062 376 C \nATOM 3837 CD ARG B 167 -4.925 -4.517 40.882 1.00133.01 C \nANISOU 3837 CD ARG B 167 16231 17722 16583 -3494 -1149 450 C \nATOM 3838 NE ARG B 167 -5.818 -5.075 41.913 1.00137.27 N \nANISOU 3838 NE ARG B 167 16957 18036 17164 -3502 -1196 469 N \nATOM 3839 CZ ARG B 167 -7.073 -4.679 42.150 1.00134.83 C \nANISOU 3839 CZ ARG B 167 16947 17523 16758 -3696 -1295 524 C \nATOM 3840 NH1 ARG B 167 -7.656 -3.749 41.402 1.00132.96 N \nANISOU 3840 NH1 ARG B 167 16890 17248 16381 -3917 -1364 572 N \nATOM 3841 NH2 ARG B 167 -7.772 -5.250 43.130 1.00135.91 N \nANISOU 3841 NH2 ARG B 167 17234 17475 16929 -3660 -1335 529 N \nATOM 3842 N LEU B 168 -2.875 -8.526 40.392 1.00101.37 N \nANISOU 3842 N LEU B 168 11943 13431 13142 -2549 -963 262 N \nATOM 3843 CA LEU B 168 -2.273 -9.127 41.575 1.00112.46 C \nANISOU 3843 CA LEU B 168 13260 14894 14573 -2449 -938 236 C \nATOM 3844 C LEU B 168 -1.137 -10.082 41.204 1.00112.53 C \nANISOU 3844 C LEU B 168 13186 14898 14672 -2205 -893 178 C \nATOM 3845 O LEU B 168 -0.126 -10.162 41.897 1.00105.93 O \nANISOU 3845 O LEU B 168 12240 14214 13792 -2105 -875 142 O \nATOM 3846 CB LEU B 168 -3.329 -9.856 42.408 1.00110.49 C \nANISOU 3846 CB LEU B 168 13157 14428 14395 -2467 -968 257 C \nATOM 3847 CG LEU B 168 -2.966 -10.134 43.861 1.00109.42 C \nANISOU 3847 CG LEU B 168 12954 14374 14247 -2450 -959 248 C \nATOM 3848 CD1 LEU B 168 -2.425 -8.895 44.579 1.00105.70 C \nANISOU 3848 CD1 LEU B 168 12352 14206 13603 -2603 -962 261 C \nATOM 3849 CD2 LEU B 168 -4.195 -10.693 44.571 1.00112.51 C \nANISOU 3849 CD2 LEU B 168 13511 14552 14687 -2487 -1000 273 C \nATOM 3850 N LYS B 169 -1.298 -10.785 40.089 1.00113.05 N \nANISOU 3850 N LYS B 169 13324 14789 14840 -2112 -884 168 N \nATOM 3851 CA LYS B 169 -0.281 -11.728 39.670 1.00111.73 C \nANISOU 3851 CA LYS B 169 13130 14584 14736 -1918 -855 122 C \nATOM 3852 C LYS B 169 0.778 -11.061 38.818 1.00 98.81 C \nANISOU 3852 C LYS B 169 11405 13116 13023 -1845 -844 90 C \nATOM 3853 O LYS B 169 1.784 -11.681 38.482 1.00 78.70 O \nANISOU 3853 O LYS B 169 8862 10552 10489 -1675 -835 47 O \nATOM 3854 CB LYS B 169 -0.921 -12.870 38.926 1.00129.65 C \nANISOU 3854 CB LYS B 169 15509 16623 17129 -1869 -853 125 C \nATOM 3855 CG LYS B 169 -0.100 -14.165 38.877 1.00135.70 C \nANISOU 3855 CG LYS B 169 16298 17307 17953 -1728 -836 92 C \nATOM 3856 CD LYS B 169 -0.134 -14.717 37.455 1.00136.78 C \nANISOU 3856 CD LYS B 169 16486 17341 18143 -1688 -828 87 C \nATOM 3857 CE LYS B 169 -1.256 -14.068 36.613 1.00149.44 C \nANISOU 3857 CE LYS B 169 18112 18911 19757 -1775 -837 114 C \nATOM 3858 NZ LYS B 169 -2.713 -14.339 36.897 1.00152.65 N \nANISOU 3858 NZ LYS B 169 18592 19212 20196 -1832 -861 137 N \nATOM 3859 N ARG B 170 0.537 -9.795 38.477 1.00108.66 N \nANISOU 3859 N ARG B 170 12591 14527 14169 -1980 -852 112 N \nATOM 3860 CA ARG B 170 1.548 -8.931 37.866 1.00110.81 C \nANISOU 3860 CA ARG B 170 12734 15046 14321 -1924 -843 78 C \nATOM 3861 C ARG B 170 2.450 -8.553 39.024 1.00113.36 C \nANISOU 3861 C ARG B 170 12921 15634 14518 -1857 -843 42 C \nATOM 3862 O ARG B 170 3.663 -8.744 39.002 1.00 97.24 O \nANISOU 3862 O ARG B 170 10821 13706 12419 -1641 -841 -21 O \nATOM 3863 CB ARG B 170 0.887 -7.683 37.311 1.00116.30 C \nANISOU 3863 CB ARG B 170 13404 15862 14922 -2141 -857 122 C \nATOM 3864 CG ARG B 170 1.619 -6.951 36.198 1.00122.90 C \nANISOU 3864 CG ARG B 170 14139 16887 15669 -2096 -846 95 C \nATOM 3865 CD ARG B 170 0.748 -5.784 35.718 1.00120.96 C \nANISOU 3865 CD ARG B 170 13909 16721 15329 -2368 -869 153 C \nATOM 3866 NE ARG B 170 -0.585 -6.257 35.302 1.00114.11 N \nANISOU 3866 NE ARG B 170 13257 15513 14586 -2463 -895 202 N \nATOM 3867 CZ ARG B 170 -1.711 -5.539 35.333 1.00106.97 C \nANISOU 3867 CZ ARG B 170 12478 14552 13613 -2711 -942 263 C \nATOM 3868 NH1 ARG B 170 -1.699 -4.272 35.738 1.00118.29 N \nANISOU 3868 NH1 ARG B 170 13840 16255 14851 -2949 -965 296 N \nATOM 3869 NH2 ARG B 170 -2.858 -6.082 34.940 1.00 89.09 N \nANISOU 3869 NH2 ARG B 170 10426 11973 11450 -2723 -976 289 N \nATOM 3870 N GLU B 171 1.801 -8.077 40.082 1.00121.18 N \nANISOU 3870 N GLU B 171 13886 16703 15455 -2036 -854 81 N \nATOM 3871 CA GLU B 171 2.468 -7.622 41.299 1.00124.58 C \nANISOU 3871 CA GLU B 171 14172 17415 15748 -2014 -855 54 C \nATOM 3872 C GLU B 171 3.312 -8.683 42.013 1.00119.60 C \nANISOU 3872 C GLU B 171 13565 16707 15171 -1767 -852 -1 C \nATOM 3873 O GLU B 171 4.093 -8.342 42.905 1.00117.57 O \nANISOU 3873 O GLU B 171 13183 16704 14783 -1679 -857 -42 O \nATOM 3874 CB GLU B 171 1.439 -6.999 42.250 1.00124.14 C \nANISOU 3874 CB GLU B 171 14130 17405 15633 -2293 -874 118 C \nATOM 3875 CG GLU B 171 0.896 -5.671 41.729 1.00123.69 C \nANISOU 3875 CG GLU B 171 14038 17529 15431 -2565 -893 167 C \nATOM 3876 CD GLU B 171 -0.431 -5.266 42.347 1.00127.80 C \nANISOU 3876 CD GLU B 171 14703 17934 15920 -2866 -936 246 C \nATOM 3877 OE1 GLU B 171 -1.173 -4.494 41.702 1.00120.67 O \nANISOU 3877 OE1 GLU B 171 13894 17012 14944 -3092 -970 298 O \nATOM 3878 OE2 GLU B 171 -0.731 -5.715 43.479 1.00134.50 O \nANISOU 3878 OE2 GLU B 171 15598 18701 16805 -2875 -945 256 O \nATOM 3879 N GLU B 172 3.183 -9.948 41.620 1.00114.44 N \nANISOU 3879 N GLU B 172 13071 15727 14683 -1662 -850 -2 N \nATOM 3880 CA GLU B 172 4.195 -10.945 42.004 1.00120.28 C \nANISOU 3880 CA GLU B 172 13871 16388 15441 -1426 -860 -57 C \nATOM 3881 C GLU B 172 5.584 -10.610 41.445 1.00130.81 C \nANISOU 3881 C GLU B 172 15154 17906 16642 -1193 -877 -132 C \nATOM 3882 O GLU B 172 6.587 -10.954 42.069 1.00140.19 O \nANISOU 3882 O GLU B 172 16363 19152 17752 -986 -904 -191 O \nATOM 3883 CB GLU B 172 3.829 -12.365 41.599 1.00120.43 C \nANISOU 3883 CB GLU B 172 14073 16058 15628 -1399 -860 -40 C \nATOM 3884 CG GLU B 172 4.749 -13.400 42.250 1.00115.79 C \nANISOU 3884 CG GLU B 172 13584 15378 15035 -1222 -883 -82 C \nATOM 3885 CD GLU B 172 4.261 -14.832 42.141 1.00115.78 C \nANISOU 3885 CD GLU B 172 13741 15081 15169 -1264 -883 -55 C \nATOM 3886 OE1 GLU B 172 3.104 -15.104 42.518 1.00117.91 O \nANISOU 3886 OE1 GLU B 172 14006 15265 15530 -1412 -865 -8 O \nATOM 3887 OE2 GLU B 172 5.046 -15.697 41.707 1.00109.89 O \nANISOU 3887 OE2 GLU B 172 13134 14204 14416 -1150 -908 -81 O \nATOM 3888 N ILE B 173 5.643 -9.968 40.274 1.00135.17 N \nANISOU 3888 N ILE B 173 15660 18540 17159 -1208 -870 -134 N \nATOM 3889 CA ILE B 173 6.926 -9.502 39.713 1.00139.98 C \nANISOU 3889 CA ILE B 173 16206 19366 17613 -973 -891 -212 C \nATOM 3890 C ILE B 173 7.345 -8.163 40.337 1.00135.43 C \nANISOU 3890 C ILE B 173 15382 19258 16817 -976 -891 -245 C \nATOM 3891 O ILE B 173 8.125 -8.119 41.296 1.00130.50 O \nANISOU 3891 O ILE B 173 14693 18823 16066 -807 -913 -302 O \nATOM 3892 CB ILE B 173 6.926 -9.407 38.160 1.00136.68 C \nANISOU 3892 CB ILE B 173 15836 18861 17235 -965 -886 -208 C \nATOM 3893 CG1 ILE B 173 8.354 -9.203 37.623 1.00137.36 C \nANISOU 3893 CG1 ILE B 173 15916 19111 17165 -662 -923 -300 C \nATOM 3894 CG2 ILE B 173 6.051 -8.282 37.640 1.00140.38 C \nANISOU 3894 CG2 ILE B 173 16173 19486 17680 -1212 -858 -155 C \nATOM 3895 CD1 ILE B 173 9.311 -10.323 37.977 1.00135.00 C \nANISOU 3895 CD1 ILE B 173 15823 18615 16856 -405 -975 -355 C \nTER 3896 ILE B 173 \nHETATM 3897 C1 NAG A 401 -28.687 -9.969 -66.680 1.00 83.68 C \nHETATM 3898 C2 NAG A 401 -30.138 -9.504 -66.364 1.00 90.43 C \nHETATM 3899 C3 NAG A 401 -30.386 -7.974 -66.439 1.00 98.70 C \nHETATM 3900 C4 NAG A 401 -29.175 -7.104 -66.142 1.00 98.24 C \nHETATM 3901 C5 NAG A 401 -27.985 -7.750 -66.848 1.00 96.14 C \nHETATM 3902 C6 NAG A 401 -26.679 -6.984 -66.749 1.00 96.77 C \nHETATM 3903 C7 NAG A 401 -32.342 -9.889 -67.433 1.00 96.37 C \nHETATM 3904 C8 NAG A 401 -33.091 -10.665 -68.484 1.00 91.89 C \nHETATM 3905 N2 NAG A 401 -31.027 -10.155 -67.319 1.00 98.43 N \nHETATM 3906 O3 NAG A 401 -31.417 -7.558 -65.565 1.00109.88 O \nHETATM 3907 O4 NAG A 401 -29.456 -5.807 -66.614 1.00 88.78 O \nHETATM 3908 O5 NAG A 401 -27.786 -8.991 -66.215 1.00 93.39 O \nHETATM 3909 O6 NAG A 401 -26.188 -7.060 -68.069 1.00 86.27 O \nHETATM 3910 O7 NAG A 401 -32.941 -9.070 -66.729 1.00 82.71 O \nHETATM 3911 C1 NAG B 201 -18.050 -16.983 20.478 1.00139.78 C \nHETATM 3912 C2 NAG B 201 -18.659 -17.928 19.448 1.00152.91 C \nHETATM 3913 C3 NAG B 201 -19.983 -17.329 18.949 1.00145.45 C \nHETATM 3914 C4 NAG B 201 -20.902 -16.925 20.111 1.00144.30 C \nHETATM 3915 C5 NAG B 201 -20.129 -16.115 21.154 1.00151.00 C \nHETATM 3916 C6 NAG B 201 -20.923 -15.790 22.425 1.00150.19 C \nHETATM 3917 C7 NAG B 201 -17.545 -19.317 17.716 1.00154.15 C \nHETATM 3918 C8 NAG B 201 -16.533 -19.330 16.601 1.00138.57 C \nHETATM 3919 N2 NAG B 201 -17.730 -18.141 18.344 1.00167.86 N \nHETATM 3920 O3 NAG B 201 -20.636 -18.247 18.095 1.00132.58 O \nHETATM 3921 O4 NAG B 201 -22.029 -16.209 19.647 1.00138.55 O \nHETATM 3922 O5 NAG B 201 -19.043 -16.957 21.495 1.00150.86 O \nHETATM 3923 O6 NAG B 201 -20.074 -15.278 23.442 1.00134.09 O \nHETATM 3924 O7 NAG B 201 -18.141 -20.360 17.996 1.00142.23 O \nHETATM 3925 O HOH A 501 -2.071 -8.558 -54.237 1.00 31.99 O \nHETATM 3926 O HOH A 502 -6.316 -9.976 -60.932 1.00 31.51 O \nHETATM 3927 O HOH A 503 0.031 -8.805 -68.956 1.00 32.53 O \nHETATM 3928 O HOH A 504 -7.524 -10.804 -86.140 1.00 46.03 O \nHETATM 3929 O HOH A 505 -11.988 -13.919 -41.933 1.00 48.80 O \nHETATM 3930 O HOH A 506 -1.024 -23.518 -6.059 1.00 55.30 O \nHETATM 3931 O HOH A 507 -10.844 -27.096 -58.123 1.00 53.39 O \nHETATM 3932 O HOH A 508 -18.961 -8.116 -53.601 1.00 57.16 O \nHETATM 3933 O HOH A 509 -3.978 -3.758 -49.620 1.00 19.76 O \nHETATM 3934 O HOH A 510 -9.098 -8.570 -51.498 1.00 30.40 O \nHETATM 3935 O HOH A 511 -15.518 -21.376 -80.663 1.00 46.19 O \nHETATM 3936 O HOH A 512 -1.028 -5.511 -71.495 1.00 53.73 O \nHETATM 3937 O HOH A 513 -12.845 -8.368 -43.271 1.00 49.29 O \nHETATM 3938 O HOH A 514 -3.306 -9.634 -85.354 1.00 45.37 O \nHETATM 3939 O HOH A 515 1.739 -6.912 -83.670 1.00 31.59 O \nHETATM 3940 O HOH A 516 -19.424 -7.281 -60.468 1.00 24.07 O \nHETATM 3941 O HOH A 517 0.227 -7.857 -70.839 1.00 33.39 O \nHETATM 3942 O HOH A 518 3.652 -9.741 -66.919 1.00 48.02 O \nHETATM 3943 O HOH A 519 1.552 -8.470 -79.177 1.00 30.05 O \nHETATM 3944 O HOH A 520 5.039 -22.650 -54.297 1.00 59.15 O \nHETATM 3945 O HOH A 521 -7.309 -8.160 -59.558 1.00 31.17 O \nHETATM 3946 O HOH A 522 -0.499 -8.076 -58.475 1.00 62.33 O \nHETATM 3947 O HOH A 523 5.403 -7.356 -77.759 1.00 39.73 O \nHETATM 3948 O HOH A 524 -3.274 -5.353 -79.745 1.00 39.76 O \nHETATM 3949 O HOH A 525 0.575 -10.602 -56.488 1.00 54.88 O \nHETATM 3950 O HOH A 526 -12.449 -3.836 -72.184 1.00 56.61 O \nHETATM 3951 O HOH A 527 -9.068 -30.258 -46.407 1.00 59.63 O \nHETATM 3952 O HOH A 528 -0.183 -10.476 -80.075 1.00 69.83 O \nHETATM 3953 O HOH A 529 1.105 -19.725 -52.670 1.00 62.21 O \nHETATM 3954 O HOH A 530 1.076 -17.614 35.056 1.00 54.80 O \nHETATM 3955 O HOH A 531 6.590 -25.900 -57.881 1.00 80.59 O \nHETATM 3956 O HOH A 532 -13.195 -28.701 -44.042 1.00 54.44 O \nHETATM 3957 O HOH A 533 -18.474 -28.732 -70.831 1.00 64.06 O \nHETATM 3958 O HOH A 534 -10.437 -1.889 -65.090 1.00 49.74 O \nHETATM 3959 O HOH A 535 -25.265 -15.342 -68.898 1.00 76.55 O \nHETATM 3960 O HOH A 536 -14.598 -7.415 -73.586 1.00 57.63 O \nHETATM 3961 O HOH A 537 -9.433 -8.502 -58.992 1.00 52.13 O \nHETATM 3962 O HOH A 538 4.687 -10.622 -64.661 1.00 59.98 O \nHETATM 3963 O HOH A 539 -6.680 -22.084 -16.014 1.00 57.50 O \nHETATM 3964 O HOH B 301 9.836 -7.213 -42.737 1.00 32.60 O \nHETATM 3965 O HOH B 302 4.631 -11.678 -46.582 1.00 29.21 O \nHETATM 3966 O HOH B 303 4.069 -10.136 21.045 1.00 46.54 O \nHETATM 3967 O HOH B 304 2.054 -18.298 11.821 1.00 48.88 O \nHETATM 3968 O HOH B 305 9.947 -6.355 -44.863 1.00 42.66 O \nHETATM 3969 O HOH B 306 4.081 -11.498 -44.178 1.00 37.94 O \nHETATM 3970 O HOH B 307 4.700 -8.517 2.088 1.00 36.93 O \nHETATM 3971 O HOH B 308 0.621 -2.174 -52.116 1.00 23.26 O \nHETATM 3972 O HOH B 309 4.076 -9.477 -42.204 1.00 55.67 O \nHETATM 3973 O HOH B 310 -14.427 -15.267 12.617 1.00 58.09 O \nHETATM 3974 O HOH B 311 0.000 0.000 -21.930 0.33 55.81 O \nHETATM 3975 O HOH B 312 -7.358 -26.394 25.208 1.00 76.02 O \nHETATM 3976 O HOH B 313 -10.256 -9.911 38.528 1.00 74.49 O \nHETATM 3977 O HOH B 314 -15.219 -7.586 7.576 1.00 67.10 O \nHETATM 3978 O HOH B 315 -5.856 -22.480 19.677 1.00 66.83 O \nHETATM 3979 O HOH B 316 11.983 -6.176 -46.099 1.00 84.95 O \nHETATM 3980 O HOH B 317 8.046 -9.034 -42.559 1.00 51.73 O \nHETATM 3981 O HOH B 318 0.000 0.000 -18.054 0.33 75.84 O \nENDMDL \nMASTER 0 0 0 28 111 0 0 15 3979 2 0 120 \nEND \n", "sitemap": {"-1": {"chains": "A", "protein_site": -11, "sequential_site": 6}, "-2": {"chains": "A", "protein_site": -12, "sequential_site": 5}, "-3": {"chains": "A", "protein_site": -13, "sequential_site": 4}, "-4": {"chains": "A", "protein_site": -14, "sequential_site": 3}, "-5": {"chains": "A", "protein_site": -15, "sequential_site": 2}, "-6": {"chains": "A", "protein_site": -16, "sequential_site": 1}, "1": {"chains": "A", "protein_site": -10, "sequential_site": 7}, "10": {"chains": "A", "protein_site": -1, "sequential_site": 16}, "100": {"chains": "A", "protein_site": 93, "sequential_site": 109}, "101": {"chains": "A", "protein_site": 94, "sequential_site": 110}, "102": {"chains": "A", "protein_site": 95, "sequential_site": 111}, "103": {"chains": "A", "protein_site": 96, "sequential_site": 112}, "104": {"chains": "A", "protein_site": 97, "sequential_site": 113}, "105": {"chains": "A", "protein_site": 98, "sequential_site": 114}, "106": {"chains": "A", "protein_site": 99, "sequential_site": 115}, "107": {"chains": "A", "protein_site": 100, "sequential_site": 116}, "108": {"chains": "A", "protein_site": 101, "sequential_site": 117}, "109": {"chains": "A", "protein_site": 102, "sequential_site": 118}, "11": {"chains": "A", "protein_site": 1, "sequential_site": 17}, "110": {"chains": "A", "protein_site": 103, "sequential_site": 119}, "111": {"chains": "A", "protein_site": 104, "sequential_site": 120}, "112": {"chains": "A", "protein_site": 105, "sequential_site": 121}, "113": {"chains": "A", "protein_site": 106, "sequential_site": 122}, "114": {"chains": "A", "protein_site": 107, "sequential_site": 123}, "115": {"chains": "A", "protein_site": 108, "sequential_site": 124}, "116": {"chains": "A", "protein_site": 109, "sequential_site": 125}, "117": {"chains": "A", "protein_site": 110, "sequential_site": 126}, "118": {"chains": "A", "protein_site": 111, "sequential_site": 127}, "119": {"chains": "A", "protein_site": 112, "sequential_site": 128}, "12": {"chains": "A", "protein_site": 2, "sequential_site": 18}, "120": {"chains": "A", "protein_site": 113, "sequential_site": 129}, "121": {"chains": "A", "protein_site": 114, "sequential_site": 130}, "122": {"chains": "A", "protein_site": 115, "sequential_site": 131}, "123": {"chains": "A", "protein_site": 116, "sequential_site": 132}, "124": {"chains": "A", "protein_site": 117, "sequential_site": 133}, "125": {"chains": "A", "protein_site": 118, "sequential_site": 134}, "125a": {"chains": "A", "protein_site": 119, "sequential_site": 135}, "125b": {"chains": "A", "protein_site": 120, "sequential_site": 136}, "126": {"chains": "A", "protein_site": 121, "sequential_site": 137}, "127": {"chains": "A", "protein_site": 122, "sequential_site": 138}, "128": {"chains": "A", "protein_site": 123, "sequential_site": 139}, "129": {"chains": "A", "protein_site": 124, "sequential_site": 140}, "13": {"chains": "A", "protein_site": 3, "sequential_site": 19}, "130": {"chains": "A", "protein_site": 125, "sequential_site": 141}, "131": {"chains": "A", "protein_site": 126, "sequential_site": 142}, "132": {"chains": "A", "protein_site": 127, "sequential_site": 143}, "133": {"chains": "A", "protein_site": 128, "sequential_site": 144}, "133a": {"chains": "A", "protein_site": 129, "sequential_site": 145}, "134": {"chains": "A", "protein_site": 130, "sequential_site": 146}, "135": {"chains": "A", "protein_site": 131, "sequential_site": 147}, "136": {"chains": "A", "protein_site": 132, "sequential_site": 148}, "137": {"chains": "A", "protein_site": 133, "sequential_site": 149}, "138": {"chains": "A", "protein_site": 134, "sequential_site": 150}, "139": {"chains": "A", "protein_site": 135, "sequential_site": 151}, "14": {"chains": "A", "protein_site": 4, "sequential_site": 20}, "140": {"chains": "A", "protein_site": 136, "sequential_site": 152}, "141": {"chains": "A", "protein_site": 137, "sequential_site": 153}, "142": {"chains": "A", "protein_site": 138, "sequential_site": 154}, "143": {"chains": "A", "protein_site": 139, "sequential_site": 155}, "144": {"chains": "A", "protein_site": 140, "sequential_site": 156}, "145": {"chains": "A", "protein_site": 141, "sequential_site": 157}, "146": {"chains": "A", "protein_site": 142, "sequential_site": 158}, "147": {"chains": "A", "protein_site": 143, "sequential_site": 159}, "148": {"chains": "A", "protein_site": 144, "sequential_site": 160}, "149": {"chains": "A", "protein_site": 145, "sequential_site": 161}, "15": {"chains": "A", "protein_site": 5, "sequential_site": 21}, "150": {"chains": "A", "protein_site": 146, "sequential_site": 162}, "151": {"chains": "A", "protein_site": 147, "sequential_site": 163}, "152": {"chains": "A", "protein_site": 148, "sequential_site": 164}, "153": {"chains": "A", "protein_site": 149, "sequential_site": 165}, "154": {"chains": "A", "protein_site": 150, "sequential_site": 166}, "155": {"chains": "A", "protein_site": 151, "sequential_site": 167}, "156": {"chains": "A", "protein_site": 152, "sequential_site": 168}, "157": {"chains": "A", "protein_site": 153, "sequential_site": 169}, "158": {"chains": "A", "protein_site": 154, "sequential_site": 170}, "159": {"chains": "A", "protein_site": 155, "sequential_site": 171}, "16": {"chains": "A", "protein_site": 6, "sequential_site": 22}, "160": {"chains": "A", "protein_site": 156, "sequential_site": 172}, "161": {"chains": "A", "protein_site": 157, "sequential_site": 173}, "162": {"chains": "A", "protein_site": 158, "sequential_site": 174}, "163": {"chains": "A", "protein_site": 159, "sequential_site": 175}, "164": {"chains": "A", "protein_site": 160, "sequential_site": 176}, "165": {"chains": "A", "protein_site": 161, "sequential_site": 177}, "166": {"chains": "A", "protein_site": 162, "sequential_site": 178}, "167": {"chains": "A", "protein_site": 163, "sequential_site": 179}, "168": {"chains": "A", "protein_site": 164, "sequential_site": 180}, "169": {"chains": "A", "protein_site": 165, "sequential_site": 181}, "17": {"chains": "A", "protein_site": 7, "sequential_site": 23}, "170": {"chains": "A", "protein_site": 166, "sequential_site": 182}, "171": {"chains": "A", "protein_site": 167, "sequential_site": 183}, "172": {"chains": "A", "protein_site": 168, "sequential_site": 184}, "173": {"chains": "A", "protein_site": 169, "sequential_site": 185}, "174": {"chains": "A", "protein_site": 170, "sequential_site": 186}, "175": {"chains": "A", "protein_site": 171, "sequential_site": 187}, "176": {"chains": "A", "protein_site": 172, "sequential_site": 188}, "177": {"chains": "A", "protein_site": 173, "sequential_site": 189}, "178": {"chains": "A", "protein_site": 174, "sequential_site": 190}, "179": {"chains": "A", "protein_site": 175, "sequential_site": 191}, "18": {"chains": "A", "protein_site": 8, "sequential_site": 24}, "180": {"chains": "A", "protein_site": 176, "sequential_site": 192}, "181": {"chains": "A", "protein_site": 177, "sequential_site": 193}, "182": {"chains": "A", "protein_site": 178, "sequential_site": 194}, "183": {"chains": "A", "protein_site": 179, "sequential_site": 195}, "184": {"chains": "A", "protein_site": 180, "sequential_site": 196}, "185": {"chains": "A", "protein_site": 181, "sequential_site": 197}, "186": {"chains": "A", "protein_site": 182, "sequential_site": 198}, "187": {"chains": "A", "protein_site": 183, "sequential_site": 199}, "188": {"chains": "A", "protein_site": 184, "sequential_site": 200}, "189": {"chains": "A", "protein_site": 185, "sequential_site": 201}, "19": {"chains": "A", "protein_site": 9, "sequential_site": 25}, "190": {"chains": "A", "protein_site": 186, "sequential_site": 202}, "191": {"chains": "A", "protein_site": 187, "sequential_site": 203}, "192": {"chains": "A", "protein_site": 188, "sequential_site": 204}, "193": {"chains": "A", "protein_site": 189, "sequential_site": 205}, "194": {"chains": "A", "protein_site": 190, "sequential_site": 206}, "195": {"chains": "A", "protein_site": 191, "sequential_site": 207}, "196": {"chains": "A", "protein_site": 192, "sequential_site": 208}, "197": {"chains": "A", "protein_site": 193, "sequential_site": 209}, "198": {"chains": "A", "protein_site": 194, "sequential_site": 210}, "199": {"chains": "A", "protein_site": 195, "sequential_site": 211}, "2": {"chains": "A", "protein_site": -9, "sequential_site": 8}, "20": {"chains": "A", "protein_site": 10, "sequential_site": 26}, "200": {"chains": "A", "protein_site": 196, "sequential_site": 212}, "201": {"chains": "A", "protein_site": 197, "sequential_site": 213}, "202": {"chains": "A", "protein_site": 198, "sequential_site": 214}, "203": {"chains": "A", "protein_site": 199, "sequential_site": 215}, "204": {"chains": "A", "protein_site": 200, "sequential_site": 216}, "205": {"chains": "A", "protein_site": 201, "sequential_site": 217}, "206": {"chains": "A", "protein_site": 202, "sequential_site": 218}, "207": {"chains": "A", "protein_site": 203, "sequential_site": 219}, "208": {"chains": "A", "protein_site": 204, "sequential_site": 220}, "209": {"chains": "A", "protein_site": 205, "sequential_site": 221}, "21": {"chains": "A", "protein_site": 11, "sequential_site": 27}, "210": {"chains": "A", "protein_site": 206, "sequential_site": 222}, "211": {"chains": "A", "protein_site": 207, "sequential_site": 223}, "212": {"chains": "A", "protein_site": 208, "sequential_site": 224}, "213": {"chains": "A", "protein_site": 209, "sequential_site": 225}, "214": {"chains": "A", "protein_site": 210, "sequential_site": 226}, "215": {"chains": "A", "protein_site": 211, "sequential_site": 227}, "216": {"chains": "A", "protein_site": 212, "sequential_site": 228}, "217": {"chains": "A", "protein_site": 213, "sequential_site": 229}, "218": {"chains": "A", "protein_site": 214, "sequential_site": 230}, "219": {"chains": "A", "protein_site": 215, "sequential_site": 231}, "22": {"chains": "A", "protein_site": 12, "sequential_site": 28}, "220": {"chains": "A", "protein_site": 216, "sequential_site": 232}, "221": {"chains": "A", "protein_site": 217, "sequential_site": 233}, "222": {"chains": "A", "protein_site": 218, "sequential_site": 234}, "223": {"chains": "A", "protein_site": 219, "sequential_site": 235}, "224": {"chains": "A", "protein_site": 220, "sequential_site": 236}, "225": {"chains": "A", "protein_site": 221, "sequential_site": 237}, "226": {"chains": "A", "protein_site": 222, "sequential_site": 238}, "227": {"chains": "A", "protein_site": 223, "sequential_site": 239}, "228": {"chains": "A", "protein_site": 224, "sequential_site": 240}, "229": {"chains": "A", "protein_site": 225, "sequential_site": 241}, "23": {"chains": "A", "protein_site": 13, "sequential_site": 29}, "230": {"chains": "A", "protein_site": 226, "sequential_site": 242}, "231": {"chains": "A", "protein_site": 227, "sequential_site": 243}, "232": {"chains": "A", "protein_site": 228, "sequential_site": 244}, "233": {"chains": "A", "protein_site": 229, "sequential_site": 245}, "234": {"chains": "A", "protein_site": 230, "sequential_site": 246}, "235": {"chains": "A", "protein_site": 231, "sequential_site": 247}, "236": {"chains": "A", "protein_site": 232, "sequential_site": 248}, "237": {"chains": "A", "protein_site": 233, "sequential_site": 249}, "238": {"chains": "A", "protein_site": 234, "sequential_site": 250}, "239": {"chains": "A", "protein_site": 235, "sequential_site": 251}, "24": {"chains": "A", "protein_site": 14, "sequential_site": 30}, "240": {"chains": "A", "protein_site": 236, "sequential_site": 252}, "241": {"chains": "A", "protein_site": 237, "sequential_site": 253}, "242": {"chains": "A", "protein_site": 238, "sequential_site": 254}, "243": {"chains": "A", "protein_site": 239, "sequential_site": 255}, "244": {"chains": "A", "protein_site": 240, "sequential_site": 256}, "245": {"chains": "A", "protein_site": 241, "sequential_site": 257}, "246": {"chains": "A", "protein_site": 242, "sequential_site": 258}, "247": {"chains": "A", "protein_site": 243, "sequential_site": 259}, "248": {"chains": "A", "protein_site": 244, "sequential_site": 260}, "249": {"chains": "A", "protein_site": 245, "sequential_site": 261}, "25": {"chains": "A", "protein_site": 15, "sequential_site": 31}, "250": {"chains": "A", "protein_site": 246, "sequential_site": 262}, "251": {"chains": "A", "protein_site": 247, "sequential_site": 263}, "252": {"chains": "A", "protein_site": 248, "sequential_site": 264}, "253": {"chains": "A", "protein_site": 249, "sequential_site": 265}, "254": {"chains": "A", "protein_site": 250, "sequential_site": 266}, "255": {"chains": "A", "protein_site": 251, "sequential_site": 267}, "256": {"chains": "A", "protein_site": 252, "sequential_site": 268}, "257": {"chains": "A", "protein_site": 253, "sequential_site": 269}, "258": {"chains": "A", "protein_site": 254, "sequential_site": 270}, "259": {"chains": "A", "protein_site": 255, "sequential_site": 271}, "26": {"chains": "A", "protein_site": 16, "sequential_site": 32}, "260": {"chains": "A", "protein_site": 256, "sequential_site": 272}, "261": {"chains": "A", "protein_site": 257, "sequential_site": 273}, "262": {"chains": "A", "protein_site": 258, "sequential_site": 274}, "262a": {"chains": "A", "protein_site": 259, "sequential_site": 275}, "263": {"chains": "A", "protein_site": 260, "sequential_site": 276}, "264": {"chains": "A", "protein_site": 261, "sequential_site": 277}, "265": {"chains": "A", "protein_site": 262, "sequential_site": 278}, "266": {"chains": "A", "protein_site": 263, "sequential_site": 279}, "267": {"chains": "A", "protein_site": 264, "sequential_site": 280}, "268": {"chains": "A", "protein_site": 265, "sequential_site": 281}, "269": {"chains": "A", "protein_site": 266, "sequential_site": 282}, "27": {"chains": "A", "protein_site": 17, "sequential_site": 33}, "270": {"chains": "A", "protein_site": 267, "sequential_site": 283}, "271": {"chains": "A", "protein_site": 268, "sequential_site": 284}, "272": {"chains": "A", "protein_site": 269, "sequential_site": 285}, "273": {"chains": "A", "protein_site": 270, "sequential_site": 286}, "274": {"chains": "A", "protein_site": 271, "sequential_site": 287}, "275": {"chains": "A", "protein_site": 272, "sequential_site": 288}, "276": {"chains": "A", "protein_site": 273, "sequential_site": 289}, "277": {"chains": "A", "protein_site": 274, "sequential_site": 290}, "278": {"chains": "A", "protein_site": 275, "sequential_site": 291}, "279": {"chains": "A", "protein_site": 276, "sequential_site": 292}, "28": {"chains": "A", "protein_site": 18, "sequential_site": 34}, "280": {"chains": "A", "protein_site": 277, "sequential_site": 293}, "281": {"chains": "A", "protein_site": 278, "sequential_site": 294}, "282": {"chains": "A", "protein_site": 279, "sequential_site": 295}, "283": {"chains": "A", "protein_site": 280, "sequential_site": 296}, "284": {"chains": "A", "protein_site": 281, "sequential_site": 297}, "285": {"chains": "A", "protein_site": 282, "sequential_site": 298}, "286": {"chains": "A", "protein_site": 283, "sequential_site": 299}, "287": {"chains": "A", "protein_site": 284, "sequential_site": 300}, "288": {"chains": "A", "protein_site": 285, "sequential_site": 301}, "289": {"chains": "A", "protein_site": 286, "sequential_site": 302}, "29": {"chains": "A", "protein_site": 19, "sequential_site": 35}, "290": {"chains": "A", "protein_site": 287, "sequential_site": 303}, "291": {"chains": "A", "protein_site": 288, "sequential_site": 304}, "292": {"chains": "A", "protein_site": 289, "sequential_site": 305}, "293": {"chains": "A", "protein_site": 290, "sequential_site": 306}, "294": {"chains": "A", "protein_site": 291, "sequential_site": 307}, "295": {"chains": "A", "protein_site": 292, "sequential_site": 308}, "296": {"chains": "A", "protein_site": 293, "sequential_site": 309}, "297": {"chains": "A", "protein_site": 294, "sequential_site": 310}, "298": {"chains": "A", "protein_site": 295, "sequential_site": 311}, "299": {"chains": "A", "protein_site": 296, "sequential_site": 312}, "3": {"chains": "A", "protein_site": -8, "sequential_site": 9}, "30": {"chains": "A", "protein_site": 20, "sequential_site": 36}, "300": {"chains": "A", "protein_site": 297, "sequential_site": 313}, "301": {"chains": "A", "protein_site": 298, "sequential_site": 314}, "302": {"chains": "A", "protein_site": 299, "sequential_site": 315}, "303": {"chains": "A", "protein_site": 300, "sequential_site": 316}, "304": {"chains": "A", "protein_site": 301, "sequential_site": 317}, "305": {"chains": "A", "protein_site": 302, "sequential_site": 318}, "306": {"chains": "A", "protein_site": 303, "sequential_site": 319}, "307": {"chains": "A", "protein_site": 304, "sequential_site": 320}, "308": {"chains": "A", "protein_site": 305, "sequential_site": 321}, "309": {"chains": "A", "protein_site": 306, "sequential_site": 322}, "31": {"chains": "A", "protein_site": 21, "sequential_site": 37}, "310": {"chains": "A", "protein_site": 307, "sequential_site": 323}, "311": {"chains": "A", "protein_site": 308, "sequential_site": 324}, "312": {"chains": "A", "protein_site": 309, "sequential_site": 325}, "313": {"chains": "A", "protein_site": 310, "sequential_site": 326}, "314": {"chains": "A", "protein_site": 311, "sequential_site": 327}, "315": {"chains": "A", "protein_site": 312, "sequential_site": 328}, "316": {"chains": "A", "protein_site": 313, "sequential_site": 329}, "317": {"chains": "A", "protein_site": 314, "sequential_site": 330}, "318": {"chains": "A", "protein_site": 315, "sequential_site": 331}, "319": {"chains": "A", "protein_site": 316, "sequential_site": 332}, "32": {"chains": "A", "protein_site": 22, "sequential_site": 38}, "320": {"chains": "A", "protein_site": 317, "sequential_site": 333}, "321": {"chains": "A", "protein_site": 318, "sequential_site": 334}, "322": {"chains": "A", "protein_site": 319, "sequential_site": 335}, "323": {"chains": "A", "protein_site": 320, "sequential_site": 336}, "324": {"chains": "A", "protein_site": 321, "sequential_site": 337}, "325": {"chains": "A", "protein_site": 322, "sequential_site": 338}, "326": {"chains": "A", "protein_site": 323, "sequential_site": 339}, "327": {"chains": "A", "protein_site": 324, "sequential_site": 340}, "328": {"chains": "A", "protein_site": 325, "sequential_site": 341}, "328a": {"chains": "A", "protein_site": 326, "sequential_site": 342}, "328b": {"chains": "A", "protein_site": 327, "sequential_site": 343}, "328c": {"chains": "A", "protein_site": 328, "sequential_site": 344}, "329": {"chains": "A", "protein_site": 329, "sequential_site": 345}, "33": {"chains": "A", "protein_site": 23, "sequential_site": 39}, "330": {"chains": "B", "protein_site": 1, "sequential_site": 346}, "331": {"chains": "B", "protein_site": 2, "sequential_site": 347}, "332": {"chains": "B", "protein_site": 3, "sequential_site": 348}, "333": {"chains": "B", "protein_site": 4, "sequential_site": 349}, "334": {"chains": "B", "protein_site": 5, "sequential_site": 350}, "335": {"chains": "B", "protein_site": 6, "sequential_site": 351}, "336": {"chains": "B", "protein_site": 7, "sequential_site": 352}, "337": {"chains": "B", "protein_site": 8, "sequential_site": 353}, "338": {"chains": "B", "protein_site": 9, "sequential_site": 354}, "339": {"chains": "B", "protein_site": 10, "sequential_site": 355}, "34": {"chains": "A", "protein_site": 24, "sequential_site": 40}, "340": {"chains": "B", "protein_site": 11, "sequential_site": 356}, "341": {"chains": "B", "protein_site": 12, "sequential_site": 357}, "342": {"chains": "B", "protein_site": 13, "sequential_site": 358}, "343": {"chains": "B", "protein_site": 14, "sequential_site": 359}, "344": {"chains": "B", "protein_site": 15, "sequential_site": 360}, "345": {"chains": "B", "protein_site": 16, "sequential_site": 361}, "346": {"chains": "B", "protein_site": 17, "sequential_site": 362}, "347": {"chains": "B", "protein_site": 18, "sequential_site": 363}, "348": {"chains": "B", "protein_site": 19, "sequential_site": 364}, "349": {"chains": "B", "protein_site": 20, "sequential_site": 365}, "35": {"chains": "A", "protein_site": 25, "sequential_site": 41}, "350": {"chains": "B", "protein_site": 21, "sequential_site": 366}, "351": {"chains": "B", "protein_site": 22, "sequential_site": 367}, "352": {"chains": "B", "protein_site": 23, "sequential_site": 368}, "353": {"chains": "B", "protein_site": 24, "sequential_site": 369}, "354": {"chains": "B", "protein_site": 25, "sequential_site": 370}, "355": {"chains": "B", "protein_site": 26, "sequential_site": 371}, "356": {"chains": "B", "protein_site": 27, "sequential_site": 372}, "357": {"chains": "B", "protein_site": 28, "sequential_site": 373}, "358": {"chains": "B", "protein_site": 29, "sequential_site": 374}, "359": {"chains": "B", "protein_site": 30, "sequential_site": 375}, "36": {"chains": "A", "protein_site": 26, "sequential_site": 42}, "360": {"chains": "B", "protein_site": 31, "sequential_site": 376}, "361": {"chains": "B", "protein_site": 32, "sequential_site": 377}, "362": {"chains": "B", "protein_site": 33, "sequential_site": 378}, "363": {"chains": "B", "protein_site": 34, "sequential_site": 379}, "364": {"chains": "B", "protein_site": 35, "sequential_site": 380}, "365": {"chains": "B", "protein_site": 36, "sequential_site": 381}, "366": {"chains": "B", "protein_site": 37, "sequential_site": 382}, "367": {"chains": "B", "protein_site": 38, "sequential_site": 383}, "368": {"chains": "B", "protein_site": 39, "sequential_site": 384}, "369": {"chains": "B", "protein_site": 40, "sequential_site": 385}, "37": {"chains": "A", "protein_site": 27, "sequential_site": 43}, "370": {"chains": "B", "protein_site": 41, "sequential_site": 386}, "371": {"chains": "B", "protein_site": 42, "sequential_site": 387}, "372": {"chains": "B", "protein_site": 43, "sequential_site": 388}, "373": {"chains": "B", "protein_site": 44, "sequential_site": 389}, "374": {"chains": "B", "protein_site": 45, "sequential_site": 390}, "375": {"chains": "B", "protein_site": 46, "sequential_site": 391}, "376": {"chains": "B", "protein_site": 47, "sequential_site": 392}, "377": {"chains": "B", "protein_site": 48, "sequential_site": 393}, "378": {"chains": "B", "protein_site": 49, "sequential_site": 394}, "379": {"chains": "B", "protein_site": 50, "sequential_site": 395}, "38": {"chains": "A", "protein_site": 28, "sequential_site": 44}, "380": {"chains": "B", "protein_site": 51, "sequential_site": 396}, "381": {"chains": "B", "protein_site": 52, "sequential_site": 397}, "382": {"chains": "B", "protein_site": 53, "sequential_site": 398}, "383": {"chains": "B", "protein_site": 54, "sequential_site": 399}, "384": {"chains": "B", "protein_site": 55, "sequential_site": 400}, "385": {"chains": "B", "protein_site": 56, "sequential_site": 401}, "386": {"chains": "B", "protein_site": 57, "sequential_site": 402}, "387": {"chains": "B", "protein_site": 58, "sequential_site": 403}, "388": {"chains": "B", "protein_site": 59, "sequential_site": 404}, "389": {"chains": "B", "protein_site": 60, "sequential_site": 405}, "39": {"chains": "A", "protein_site": 29, "sequential_site": 45}, "390": {"chains": "B", "protein_site": 61, "sequential_site": 406}, "391": {"chains": "B", "protein_site": 62, "sequential_site": 407}, "392": {"chains": "B", "protein_site": 63, "sequential_site": 408}, "393": {"chains": "B", "protein_site": 64, "sequential_site": 409}, "394": {"chains": "B", "protein_site": 65, "sequential_site": 410}, "395": {"chains": "B", "protein_site": 66, "sequential_site": 411}, "396": {"chains": "B", "protein_site": 67, "sequential_site": 412}, "397": {"chains": "B", "protein_site": 68, "sequential_site": 413}, "398": {"chains": "B", "protein_site": 69, "sequential_site": 414}, "399": {"chains": "B", "protein_site": 70, "sequential_site": 415}, "4": {"chains": "A", "protein_site": -7, "sequential_site": 10}, "40": {"chains": "A", "protein_site": 30, "sequential_site": 46}, "400": {"chains": "B", "protein_site": 71, "sequential_site": 416}, "401": {"chains": "B", "protein_site": 72, "sequential_site": 417}, "402": {"chains": "B", "protein_site": 73, "sequential_site": 418}, "403": {"chains": "B", "protein_site": 74, "sequential_site": 419}, "404": {"chains": "B", "protein_site": 75, "sequential_site": 420}, "405": {"chains": "B", "protein_site": 76, "sequential_site": 421}, "406": {"chains": "B", "protein_site": 77, "sequential_site": 422}, "407": {"chains": "B", "protein_site": 78, "sequential_site": 423}, "408": {"chains": "B", "protein_site": 79, "sequential_site": 424}, "409": {"chains": "B", "protein_site": 80, "sequential_site": 425}, "41": {"chains": "A", "protein_site": 31, "sequential_site": 47}, "410": {"chains": "B", "protein_site": 81, "sequential_site": 426}, "411": {"chains": "B", "protein_site": 82, "sequential_site": 427}, "412": {"chains": "B", "protein_site": 83, "sequential_site": 428}, "413": {"chains": "B", "protein_site": 84, "sequential_site": 429}, "414": {"chains": "B", "protein_site": 85, "sequential_site": 430}, "415": {"chains": "B", "protein_site": 86, "sequential_site": 431}, "416": {"chains": "B", "protein_site": 87, "sequential_site": 432}, "417": {"chains": "B", "protein_site": 88, "sequential_site": 433}, "418": {"chains": "B", "protein_site": 89, "sequential_site": 434}, "419": {"chains": "B", "protein_site": 90, "sequential_site": 435}, "42": {"chains": "A", "protein_site": 32, "sequential_site": 48}, "420": {"chains": "B", "protein_site": 91, "sequential_site": 436}, "421": {"chains": "B", "protein_site": 92, "sequential_site": 437}, "422": {"chains": "B", "protein_site": 93, "sequential_site": 438}, "423": {"chains": "B", "protein_site": 94, "sequential_site": 439}, "424": {"chains": "B", "protein_site": 95, "sequential_site": 440}, "425": {"chains": "B", "protein_site": 96, "sequential_site": 441}, "426": {"chains": "B", "protein_site": 97, "sequential_site": 442}, "427": {"chains": "B", "protein_site": 98, "sequential_site": 443}, "428": {"chains": "B", "protein_site": 99, "sequential_site": 444}, "429": {"chains": "B", "protein_site": 100, "sequential_site": 445}, "43": {"chains": "A", "protein_site": 33, "sequential_site": 49}, "430": {"chains": "B", "protein_site": 101, "sequential_site": 446}, "431": {"chains": "B", "protein_site": 102, "sequential_site": 447}, "432": {"chains": "B", "protein_site": 103, "sequential_site": 448}, "433": {"chains": "B", "protein_site": 104, "sequential_site": 449}, "434": {"chains": "B", "protein_site": 105, "sequential_site": 450}, "435": {"chains": "B", "protein_site": 106, "sequential_site": 451}, "436": {"chains": "B", "protein_site": 107, "sequential_site": 452}, "437": {"chains": "B", "protein_site": 108, "sequential_site": 453}, "438": {"chains": "B", "protein_site": 109, "sequential_site": 454}, "439": {"chains": "B", "protein_site": 110, "sequential_site": 455}, "44": {"chains": "A", "protein_site": 34, "sequential_site": 50}, "440": {"chains": "B", "protein_site": 111, "sequential_site": 456}, "441": {"chains": "B", "protein_site": 112, "sequential_site": 457}, "442": {"chains": "B", "protein_site": 113, "sequential_site": 458}, "443": {"chains": "B", "protein_site": 114, "sequential_site": 459}, "444": {"chains": "B", "protein_site": 115, "sequential_site": 460}, "445": {"chains": "B", "protein_site": 116, "sequential_site": 461}, "446": {"chains": "B", "protein_site": 117, "sequential_site": 462}, "447": {"chains": "B", "protein_site": 118, "sequential_site": 463}, "448": {"chains": "B", "protein_site": 119, "sequential_site": 464}, "449": {"chains": "B", "protein_site": 120, "sequential_site": 465}, "45": {"chains": "A", "protein_site": 35, "sequential_site": 51}, "450": {"chains": "B", "protein_site": 121, "sequential_site": 466}, "451": {"chains": "B", "protein_site": 122, "sequential_site": 467}, "452": {"chains": "B", "protein_site": 123, "sequential_site": 468}, "453": {"chains": "B", "protein_site": 124, "sequential_site": 469}, "454": {"chains": "B", "protein_site": 125, "sequential_site": 470}, "455": {"chains": "B", "protein_site": 126, "sequential_site": 471}, "456": {"chains": "B", "protein_site": 127, "sequential_site": 472}, "457": {"chains": "B", "protein_site": 128, "sequential_site": 473}, "458": {"chains": "B", "protein_site": 129, "sequential_site": 474}, "459": {"chains": "B", "protein_site": 130, "sequential_site": 475}, "46": {"chains": "A", "protein_site": 36, "sequential_site": 52}, "460": {"chains": "B", "protein_site": 131, "sequential_site": 476}, "461": {"chains": "B", "protein_site": 132, "sequential_site": 477}, "462": {"chains": "B", "protein_site": 133, "sequential_site": 478}, "463": {"chains": "B", "protein_site": 134, "sequential_site": 479}, "464": {"chains": "B", "protein_site": 135, "sequential_site": 480}, "465": {"chains": "B", "protein_site": 136, "sequential_site": 481}, "466": {"chains": "B", "protein_site": 137, "sequential_site": 482}, "467": {"chains": "B", "protein_site": 138, "sequential_site": 483}, "468": {"chains": "B", "protein_site": 139, "sequential_site": 484}, "469": {"chains": "B", "protein_site": 140, "sequential_site": 485}, "47": {"chains": "A", "protein_site": 37, "sequential_site": 53}, "470": {"chains": "B", "protein_site": 141, "sequential_site": 486}, "471": {"chains": "B", "protein_site": 142, "sequential_site": 487}, "472": {"chains": "B", "protein_site": 143, "sequential_site": 488}, "473": {"chains": "B", "protein_site": 144, "sequential_site": 489}, "474": {"chains": "B", "protein_site": 145, "sequential_site": 490}, "475": {"chains": "B", "protein_site": 146, "sequential_site": 491}, "476": {"chains": "B", "protein_site": 147, "sequential_site": 492}, "477": {"chains": "B", "protein_site": 148, "sequential_site": 493}, "478": {"chains": "B", "protein_site": 149, "sequential_site": 494}, "479": {"chains": "B", "protein_site": 150, "sequential_site": 495}, "48": {"chains": "A", "protein_site": 38, "sequential_site": 54}, "480": {"chains": "B", "protein_site": 151, "sequential_site": 496}, "481": {"chains": "B", "protein_site": 152, "sequential_site": 497}, "482": {"chains": "B", "protein_site": 153, "sequential_site": 498}, "483": {"chains": "B", "protein_site": 154, "sequential_site": 499}, "484": {"chains": "B", "protein_site": 155, "sequential_site": 500}, "485": {"chains": "B", "protein_site": 156, "sequential_site": 501}, "486": {"chains": "B", "protein_site": 157, "sequential_site": 502}, "487": {"chains": "B", "protein_site": 158, "sequential_site": 503}, "488": {"chains": "B", "protein_site": 159, "sequential_site": 504}, "489": {"chains": "B", "protein_site": 160, "sequential_site": 505}, "49": {"chains": "A", "protein_site": 39, "sequential_site": 55}, "490": {"chains": "B", "protein_site": 161, "sequential_site": 506}, "491": {"chains": "B", "protein_site": 162, "sequential_site": 507}, "492": {"chains": "B", "protein_site": 163, "sequential_site": 508}, "493": {"chains": "B", "protein_site": 164, "sequential_site": 509}, "494": {"chains": "B", "protein_site": 165, "sequential_site": 510}, "495": {"chains": "B", "protein_site": 166, "sequential_site": 511}, "496": {"chains": "B", "protein_site": 167, "sequential_site": 512}, "497": {"chains": "B", "protein_site": 168, "sequential_site": 513}, "498": {"chains": "B", "protein_site": 169, "sequential_site": 514}, "499": {"chains": "B", "protein_site": 170, "sequential_site": 515}, "5": {"chains": "A", "protein_site": -6, "sequential_site": 11}, "50": {"chains": "A", "protein_site": 40, "sequential_site": 56}, "500": {"chains": "B", "protein_site": 171, "sequential_site": 516}, "501": {"chains": "B", "protein_site": 172, "sequential_site": 517}, "502": {"chains": "B", "protein_site": 173, "sequential_site": 518}, "503": {"chains": "B", "protein_site": 174, "sequential_site": 519}, "504": {"chains": "B", "protein_site": 175, "sequential_site": 520}, "505": {"chains": "B", "protein_site": 176, "sequential_site": 521}, "506": {"chains": "B", "protein_site": 177, "sequential_site": 522}, "507": {"chains": "B", "protein_site": 178, "sequential_site": 523}, "508": {"chains": "B", "protein_site": 179, "sequential_site": 524}, "509": {"chains": "B", "protein_site": 180, "sequential_site": 525}, "51": {"chains": "A", "protein_site": 41, "sequential_site": 57}, "510": {"chains": "B", "protein_site": 181, "sequential_site": 526}, "510a": {"chains": "B", "protein_site": 182, "sequential_site": 527}, "511": {"chains": "B", "protein_site": 183, "sequential_site": 528}, "512": {"chains": "B", "protein_site": 184, "sequential_site": 529}, "513": {"chains": "B", "protein_site": 185, "sequential_site": 530}, "514": {"chains": "B", "protein_site": 186, "sequential_site": 531}, "515": {"chains": "B", "protein_site": 187, "sequential_site": 532}, "516": {"chains": "B", "protein_site": 188, "sequential_site": 533}, "517": {"chains": "B", "protein_site": 189, "sequential_site": 534}, "518": {"chains": "B", "protein_site": 190, "sequential_site": 535}, "519": {"chains": "B", "protein_site": 191, "sequential_site": 536}, "52": {"chains": "A", "protein_site": 42, "sequential_site": 58}, "520": {"chains": "B", "protein_site": 192, "sequential_site": 537}, "521": {"chains": "B", "protein_site": 193, "sequential_site": 538}, "522": {"chains": "B", "protein_site": 194, "sequential_site": 539}, "523": {"chains": "B", "protein_site": 195, "sequential_site": 540}, "524": {"chains": "B", "protein_site": 196, "sequential_site": 541}, "525": {"chains": "B", "protein_site": 197, "sequential_site": 542}, "526": {"chains": "B", "protein_site": 198, "sequential_site": 543}, "527": {"chains": "B", "protein_site": 199, "sequential_site": 544}, "528": {"chains": "B", "protein_site": 200, "sequential_site": 545}, "529": {"chains": "B", "protein_site": 201, "sequential_site": 546}, "53": {"chains": "A", "protein_site": 43, "sequential_site": 59}, "530": {"chains": "B", "protein_site": 202, "sequential_site": 547}, "531": {"chains": "B", "protein_site": 203, "sequential_site": 548}, "532": {"chains": "B", "protein_site": 204, "sequential_site": 549}, "533": {"chains": "B", "protein_site": 205, "sequential_site": 550}, "534": {"chains": "B", "protein_site": 206, "sequential_site": 551}, "535": {"chains": "B", "protein_site": 207, "sequential_site": 552}, "536": {"chains": "B", "protein_site": 208, "sequential_site": 553}, "537": {"chains": "B", "protein_site": 209, "sequential_site": 554}, "538": {"chains": "B", "protein_site": 210, "sequential_site": 555}, "539": {"chains": "B", "protein_site": 211, "sequential_site": 556}, "54": {"chains": "A", "protein_site": 44, "sequential_site": 60}, "541": {"chains": "B", "protein_site": 213, "sequential_site": 558}, "542": {"chains": "B", "protein_site": 214, "sequential_site": 559}, "543": {"chains": "B", "protein_site": 215, "sequential_site": 560}, "544": {"chains": "B", "protein_site": 216, "sequential_site": 561}, "545": {"chains": "B", "protein_site": 217, "sequential_site": 562}, "546": {"chains": "B", "protein_site": 218, "sequential_site": 563}, "547": {"chains": "B", "protein_site": 219, "sequential_site": 564}, "548": {"chains": "B", "protein_site": 220, "sequential_site": 565}, "549": {"chains": "B", "protein_site": 221, "sequential_site": 566}, "54a": {"chains": "A", "protein_site": 45, "sequential_site": 61}, "55": {"chains": "A", "protein_site": 46, "sequential_site": 62}, "550": {"chains": "B", "protein_site": 222, "sequential_site": 567}, "56": {"chains": "A", "protein_site": 47, "sequential_site": 63}, "57": {"chains": "A", "protein_site": 48, "sequential_site": 64}, "58": {"chains": "A", "protein_site": 49, "sequential_site": 65}, "59": {"chains": "A", "protein_site": 50, "sequential_site": 66}, "6": {"chains": "A", "protein_site": -5, "sequential_site": 12}, "60": {"chains": "A", "protein_site": 51, "sequential_site": 67}, "61": {"chains": "A", "protein_site": 52, "sequential_site": 68}, "62": {"chains": "A", "protein_site": 53, "sequential_site": 69}, "63": {"chains": "A", "protein_site": 54, "sequential_site": 70}, "64": {"chains": "A", "protein_site": 55, "sequential_site": 71}, "65": {"chains": "A", "protein_site": 56, "sequential_site": 72}, "66": {"chains": "A", "protein_site": 57, "sequential_site": 73}, "67": {"chains": "A", "protein_site": 58, "sequential_site": 74}, "68": {"chains": "A", "protein_site": 59, "sequential_site": 75}, "69": {"chains": "A", "protein_site": 60, "sequential_site": 76}, "7": {"chains": "A", "protein_site": -4, "sequential_site": 13}, "70": {"chains": "A", "protein_site": 61, "sequential_site": 77}, "71": {"chains": "A", "protein_site": 62, "sequential_site": 78}, "72": {"chains": "A", "protein_site": 63, "sequential_site": 79}, "73": {"chains": "A", "protein_site": 64, "sequential_site": 80}, "74": {"chains": "A", "protein_site": 65, "sequential_site": 81}, "75": {"chains": "A", "protein_site": 66, "sequential_site": 82}, "76": {"chains": "A", "protein_site": 67, "sequential_site": 83}, "77": {"chains": "A", "protein_site": 68, "sequential_site": 84}, "78": {"chains": "A", "protein_site": 69, "sequential_site": 85}, "79": {"chains": "A", "protein_site": 70, "sequential_site": 86}, "8": {"chains": "A", "protein_site": -3, "sequential_site": 14}, "80": {"chains": "A", "protein_site": 71, "sequential_site": 87}, "81": {"chains": "A", "protein_site": 72, "sequential_site": 88}, "82": {"chains": "A", "protein_site": 73, "sequential_site": 89}, "82a": {"chains": "A", "protein_site": 74, "sequential_site": 90}, "83": {"chains": "A", "protein_site": 75, "sequential_site": 91}, "84": {"chains": "A", "protein_site": 76, "sequential_site": 92}, "85": {"chains": "A", "protein_site": 77, "sequential_site": 93}, "86": {"chains": "A", "protein_site": 78, "sequential_site": 94}, "87": {"chains": "A", "protein_site": 79, "sequential_site": 95}, "88": {"chains": "A", "protein_site": 80, "sequential_site": 96}, "89": {"chains": "A", "protein_site": 81, "sequential_site": 97}, "9": {"chains": "A", "protein_site": -2, "sequential_site": 15}, "90": {"chains": "A", "protein_site": 82, "sequential_site": 98}, "91": {"chains": "A", "protein_site": 83, "sequential_site": 99}, "92": {"chains": "A", "protein_site": 84, "sequential_site": 100}, "92a": {"chains": "A", "protein_site": 85, "sequential_site": 101}, "93": {"chains": "A", "protein_site": 86, "sequential_site": 102}, "94": {"chains": "A", "protein_site": 87, "sequential_site": 103}, "95": {"chains": "A", "protein_site": 88, "sequential_site": 104}, "96": {"chains": "A", "protein_site": 89, "sequential_site": 105}, "97": {"chains": "A", "protein_site": 90, "sequential_site": 106}, "98": {"chains": "A", "protein_site": 91, "sequential_site": 107}, "99": {"chains": "A", "protein_site": 92, "sequential_site": 108}}, "summary_stat": "sum", "title": "Effects of mutations to an influenza H5 HA (clade 2.3.4.4b) on a26 usage", "tooltip_cols": {"cell_entry": "cell entry", "ferret_sera_escape": "ferret sera escape", "mature_H5_site": "mature H5 site", "mouse_sera_escape": "mouse sera escape", "mutation": "mutation", "region": "region", "sequential_site": "sequential site", "stability": "stability"}}}
\ No newline at end of file
diff --git a/results/dms-viz/cell_entry.json b/results/dms-viz/cell_entry.json
new file mode 100644
index 0000000..45222ac
--- /dev/null
+++ b/results/dms-viz/cell_entry.json
@@ -0,0 +1 @@
+{"cell entry": {"alphabet": ["R", "K", "H", "D", "E", "Q", "N", "S", "T", "Y", "W", "F", "A", "I", "L", "M", "V", "G", "P", "C"], "condition_col": null, "condition_colors": {"default": "#0072B2"}, "conditions": [], "dataChains": ["A", "B"], "description": "cell_entry", "excludeChains": ["none"], "excludedAminoAcids": null, "filter_cols": null, "filter_limits": null, "floor": false, "heatmap_limits": null, "metric_col": "cell_entry", "mut_metric_df": [{"a26_usage": 0.0, "cell_entry": -1.245, "ferret_sera_escape": 0.1399, "mature_H5_site": -11, "mouse_sera_escape": 0.09076, "mutant": "A", "mutation": "L-1A", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.03853, "ferret_sera_escape": 0.03064, "mature_H5_site": -11, "mouse_sera_escape": -0.02769, "mutant": "C", "mutation": "L-1C", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.012, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.869, "ferret_sera_escape": null, "mature_H5_site": -11, "mouse_sera_escape": null, "mutant": "D", "mutation": "L-1D", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.358, "ferret_sera_escape": -0.1733, "mature_H5_site": -11, "mouse_sera_escape": -0.2392, "mutant": "E", "mutation": "L-1E", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.07267, "ferret_sera_escape": 0.06955, "mature_H5_site": -11, "mouse_sera_escape": 0.02876, "mutant": "F", "mutation": "L-1F", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": 0.04901, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3239, "ferret_sera_escape": -0.1388, "mature_H5_site": -11, "mouse_sera_escape": -0.005618, "mutant": "G", "mutation": "L-1G", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.04929, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9294, "ferret_sera_escape": 0.1216, "mature_H5_site": -11, "mouse_sera_escape": 0.051, "mutant": "H", "mutation": "L-1H", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.04745, "ferret_sera_escape": null, "mature_H5_site": -11, "mouse_sera_escape": null, "mutant": "I", "mutation": "L-1I", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1128, "ferret_sera_escape": 0.0343, "mature_H5_site": -11, "mouse_sera_escape": 0.008792, "mutant": "K", "mutation": "L-1K", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.02494, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -11, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L-1L", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.06521, "ferret_sera_escape": null, "mature_H5_site": -11, "mouse_sera_escape": null, "mutant": "M", "mutation": "L-1M", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3614, "ferret_sera_escape": null, "mature_H5_site": -11, "mouse_sera_escape": null, "mutant": "N", "mutation": "L-1N", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4627, "ferret_sera_escape": 0.05371, "mature_H5_site": -11, "mouse_sera_escape": 0.04601, "mutant": "P", "mutation": "L-1P", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.0401, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2653, "ferret_sera_escape": -0.06313, "mature_H5_site": -11, "mouse_sera_escape": -0.1085, "mutant": "Q", "mutation": "L-1Q", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.03568, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4204, "ferret_sera_escape": -0.07986, "mature_H5_site": -11, "mouse_sera_escape": -0.03362, "mutant": "R", "mutation": "L-1R", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.1429, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.324, "ferret_sera_escape": -0.1955, "mature_H5_site": -11, "mouse_sera_escape": 0.02869, "mutant": "S", "mutation": "L-1S", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.02898, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.451, "ferret_sera_escape": -0.141, "mature_H5_site": -11, "mouse_sera_escape": -0.00653, "mutant": "T", "mutation": "L-1T", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.07345, "wildtype": "L"}, {"a26_usage": 0.09625, "cell_entry": -0.3508, "ferret_sera_escape": -0.07118, "mature_H5_site": -11, "mouse_sera_escape": -0.01654, "mutant": "V", "mutation": "L-1V", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": 0.01858, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.00238, "ferret_sera_escape": -0.03238, "mature_H5_site": -11, "mouse_sera_escape": -0.01929, "mutant": "W", "mutation": "L-1W", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.04572, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1909, "ferret_sera_escape": -0.05136, "mature_H5_site": -11, "mouse_sera_escape": -0.03029, "mutant": "Y", "mutation": "L-1Y", "reference_site": "-1", "region": "HA1", "sequential_site": 6, "stability": -0.01871, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4358, "ferret_sera_escape": -0.03984, "mature_H5_site": -12, "mouse_sera_escape": 0.08766, "mutant": "A", "mutation": "V-2A", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.02578, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1783, "ferret_sera_escape": null, "mature_H5_site": -12, "mouse_sera_escape": null, "mutant": "C", "mutation": "V-2C", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.839, "ferret_sera_escape": null, "mature_H5_site": -12, "mouse_sera_escape": null, "mutant": "D", "mutation": "V-2D", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": null, "wildtype": "V"}, {"a26_usage": 0.1909, "cell_entry": -0.01653, "ferret_sera_escape": -0.1249, "mature_H5_site": -12, "mouse_sera_escape": null, "mutant": "F", "mutation": "V-2F", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.05354, "ferret_sera_escape": -0.125, "mature_H5_site": -12, "mouse_sera_escape": -0.09246, "mutant": "G", "mutation": "V-2G", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.08783, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1321, "ferret_sera_escape": -0.07602, "mature_H5_site": -12, "mouse_sera_escape": -0.05556, "mutant": "H", "mutation": "V-2H", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.1425, "wildtype": "V"}, {"a26_usage": 0.05446, "cell_entry": -0.06828, "ferret_sera_escape": 0.00758, "mature_H5_site": -12, "mouse_sera_escape": 0.0334, "mutant": "I", "mutation": "V-2I", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": 0.002624, "wildtype": "V"}, {"a26_usage": 0.7789, "cell_entry": -2.523, "ferret_sera_escape": -0.1365, "mature_H5_site": -12, "mouse_sera_escape": -0.07495, "mutant": "K", "mutation": "V-2K", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": 0.02778, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.06581, "ferret_sera_escape": -0.2266, "mature_H5_site": -12, "mouse_sera_escape": 0.03579, "mutant": "L", "mutation": "V-2L", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.1385, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6403, "ferret_sera_escape": -0.07976, "mature_H5_site": -12, "mouse_sera_escape": 0.1191, "mutant": "M", "mutation": "V-2M", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2955, "ferret_sera_escape": -0.02835, "mature_H5_site": -12, "mouse_sera_escape": 0.09179, "mutant": "N", "mutation": "V-2N", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.143, "wildtype": "V"}, {"a26_usage": 0.6224, "cell_entry": -0.437, "ferret_sera_escape": -0.1216, "mature_H5_site": -12, "mouse_sera_escape": 0.1131, "mutant": "P", "mutation": "V-2P", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.07675, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7976, "ferret_sera_escape": -0.1084, "mature_H5_site": -12, "mouse_sera_escape": -0.03152, "mutant": "Q", "mutation": "V-2Q", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.282, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5964, "ferret_sera_escape": -0.04892, "mature_H5_site": -12, "mouse_sera_escape": -0.01483, "mutant": "R", "mutation": "V-2R", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.1276, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.278, "ferret_sera_escape": 0.04059, "mature_H5_site": -12, "mouse_sera_escape": 0.03146, "mutant": "S", "mutation": "V-2S", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.04184, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.236, "ferret_sera_escape": -0.01706, "mature_H5_site": -12, "mouse_sera_escape": -0.01222, "mutant": "T", "mutation": "V-2T", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.03014, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -12, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V-2V", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.02014, "ferret_sera_escape": 0.1234, "mature_H5_site": -12, "mouse_sera_escape": 0.05897, "mutant": "W", "mutation": "V-2W", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.003526, "wildtype": "V"}, {"a26_usage": 0.01565, "cell_entry": -0.2677, "ferret_sera_escape": -0.1124, "mature_H5_site": -12, "mouse_sera_escape": -0.06881, "mutant": "Y", "mutation": "V-2Y", "reference_site": "-2", "region": "HA1", "sequential_site": 5, "stability": -0.02421, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.009745, "ferret_sera_escape": 0.05715, "mature_H5_site": -13, "mouse_sera_escape": -0.1669, "mutant": "A", "mutation": "I-3A", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.676, "ferret_sera_escape": null, "mature_H5_site": -13, "mouse_sera_escape": null, "mutant": "D", "mutation": "I-3D", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.694, "ferret_sera_escape": -0.1485, "mature_H5_site": -13, "mouse_sera_escape": -0.148, "mutant": "E", "mutation": "I-3E", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.2952, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2824, "ferret_sera_escape": 0.02052, "mature_H5_site": -13, "mouse_sera_escape": -0.0436, "mutant": "F", "mutation": "I-3F", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.0492, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.212, "ferret_sera_escape": -0.06512, "mature_H5_site": -13, "mouse_sera_escape": -0.1015, "mutant": "H", "mutation": "I-3H", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -13, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I-3I", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5239, "ferret_sera_escape": -0.3044, "mature_H5_site": -13, "mouse_sera_escape": -0.04926, "mutant": "K", "mutation": "I-3K", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.1119, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06609, "ferret_sera_escape": 0.02034, "mature_H5_site": -13, "mouse_sera_escape": 0.05017, "mutant": "L", "mutation": "I-3L", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": 0.03895, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.347, "ferret_sera_escape": -0.1789, "mature_H5_site": -13, "mouse_sera_escape": -0.05747, "mutant": "M", "mutation": "I-3M", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.07697, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4002, "ferret_sera_escape": -0.1069, "mature_H5_site": -13, "mouse_sera_escape": -0.1478, "mutant": "N", "mutation": "I-3N", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.08407, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.08928, "ferret_sera_escape": -0.06848, "mature_H5_site": -13, "mouse_sera_escape": -0.1155, "mutant": "P", "mutation": "I-3P", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": 0.00754, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.24, "ferret_sera_escape": -0.05439, "mature_H5_site": -13, "mouse_sera_escape": -0.0607, "mutant": "Q", "mutation": "I-3Q", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.08256, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3754, "ferret_sera_escape": -0.03504, "mature_H5_site": -13, "mouse_sera_escape": 0.01704, "mutant": "R", "mutation": "I-3R", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.04163, "wildtype": "I"}, {"a26_usage": 0.168, "cell_entry": 0.04928, "ferret_sera_escape": 0.06774, "mature_H5_site": -13, "mouse_sera_escape": 0.09582, "mutant": "S", "mutation": "I-3S", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.02985, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.228, "ferret_sera_escape": -0.07193, "mature_H5_site": -13, "mouse_sera_escape": 0.02597, "mutant": "T", "mutation": "I-3T", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.02561, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.216, "ferret_sera_escape": -0.06122, "mature_H5_site": -13, "mouse_sera_escape": -0.0356, "mutant": "V", "mutation": "I-3V", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.005692, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.05539, "ferret_sera_escape": 0.0584, "mature_H5_site": -13, "mouse_sera_escape": 0.01083, "mutant": "W", "mutation": "I-3W", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": -0.01946, "wildtype": "I"}, {"a26_usage": 0.05035, "cell_entry": 0.06426, "ferret_sera_escape": 0.0126, "mature_H5_site": -13, "mouse_sera_escape": 0.05702, "mutant": "Y", "mutation": "I-3Y", "reference_site": "-3", "region": "HA1", "sequential_site": 4, "stability": 0.005714, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.05586, "ferret_sera_escape": -0.05033, "mature_H5_site": -14, "mouse_sera_escape": -0.1021, "mutant": "A", "mutation": "N-4A", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.02321, "wildtype": "N"}, {"a26_usage": 0.135, "cell_entry": 0.003655, "ferret_sera_escape": 0.02935, "mature_H5_site": -14, "mouse_sera_escape": -0.001244, "mutant": "C", "mutation": "N-4C", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.02054, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.08413, "ferret_sera_escape": -0.002813, "mature_H5_site": -14, "mouse_sera_escape": -0.163, "mutant": "D", "mutation": "N-4D", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.06871, "wildtype": "N"}, {"a26_usage": 0.0387, "cell_entry": 0.04051, "ferret_sera_escape": -0.2673, "mature_H5_site": -14, "mouse_sera_escape": -0.153, "mutant": "E", "mutation": "N-4E", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.0278, "wildtype": "N"}, {"a26_usage": 0.00718, "cell_entry": 0.06012, "ferret_sera_escape": 0.07864, "mature_H5_site": -14, "mouse_sera_escape": -0.02172, "mutant": "F", "mutation": "N-4F", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.03079, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.586, "ferret_sera_escape": 0.02851, "mature_H5_site": -14, "mouse_sera_escape": -0.04352, "mutant": "G", "mutation": "N-4G", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.0803, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.05198, "ferret_sera_escape": 0.006373, "mature_H5_site": -14, "mouse_sera_escape": 0.03972, "mutant": "H", "mutation": "N-4H", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.02858, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.01491, "ferret_sera_escape": -0.06101, "mature_H5_site": -14, "mouse_sera_escape": -0.02869, "mutant": "I", "mutation": "N-4I", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.01225, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1131, "ferret_sera_escape": 0.02878, "mature_H5_site": -14, "mouse_sera_escape": 0.07167, "mutant": "K", "mutation": "N-4K", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.00644, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02193, "ferret_sera_escape": -0.01945, "mature_H5_site": -14, "mouse_sera_escape": -0.01634, "mutant": "L", "mutation": "N-4L", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.02384, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4973, "ferret_sera_escape": -0.08876, "mature_H5_site": -14, "mouse_sera_escape": 0.01546, "mutant": "M", "mutation": "N-4M", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.0004297, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -14, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N-4N", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2194, "ferret_sera_escape": null, "mature_H5_site": -14, "mouse_sera_escape": null, "mutant": "P", "mutation": "N-4P", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.05024, "ferret_sera_escape": 0.1632, "mature_H5_site": -14, "mouse_sera_escape": 0.08081, "mutant": "Q", "mutation": "N-4Q", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.01272, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2761, "ferret_sera_escape": 0.05278, "mature_H5_site": -14, "mouse_sera_escape": 0.05871, "mutant": "R", "mutation": "N-4R", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.01737, "wildtype": "N"}, {"a26_usage": 0.2356, "cell_entry": -0.01706, "ferret_sera_escape": null, "mature_H5_site": -14, "mouse_sera_escape": null, "mutant": "S", "mutation": "N-4S", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.25, "ferret_sera_escape": -0.02431, "mature_H5_site": -14, "mouse_sera_escape": 0.07851, "mutant": "T", "mutation": "N-4T", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.103, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07004, "ferret_sera_escape": 0.07758, "mature_H5_site": -14, "mouse_sera_escape": 0.002088, "mutant": "V", "mutation": "N-4V", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": -0.04333, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.0767, "ferret_sera_escape": -0.1399, "mature_H5_site": -14, "mouse_sera_escape": -0.1141, "mutant": "W", "mutation": "N-4W", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.03292, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1686, "ferret_sera_escape": -0.1309, "mature_H5_site": -14, "mouse_sera_escape": -0.08805, "mutant": "Y", "mutation": "N-4Y", "reference_site": "-4", "region": "HA1", "sequential_site": 3, "stability": 0.01852, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2561, "ferret_sera_escape": -0.008391, "mature_H5_site": -15, "mouse_sera_escape": -0.08185, "mutant": "A", "mutation": "E-5A", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.02286, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06022, "ferret_sera_escape": 0.01947, "mature_H5_site": -15, "mouse_sera_escape": 0.04017, "mutant": "C", "mutation": "E-5C", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.09208, "wildtype": "E"}, {"a26_usage": null, "cell_entry": -1.186, "ferret_sera_escape": 0.09399, "mature_H5_site": -15, "mouse_sera_escape": 0.1309, "mutant": "D", "mutation": "E-5D", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.04074, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -15, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E-5E", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.09452, "ferret_sera_escape": 0.02128, "mature_H5_site": -15, "mouse_sera_escape": 0.03576, "mutant": "F", "mutation": "E-5F", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": 0.02081, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1468, "ferret_sera_escape": -0.04239, "mature_H5_site": -15, "mouse_sera_escape": -0.0351, "mutant": "G", "mutation": "E-5G", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.04565, "wildtype": "E"}, {"a26_usage": 0.02133, "cell_entry": 0.01327, "ferret_sera_escape": 0.08542, "mature_H5_site": -15, "mouse_sera_escape": -0.04393, "mutant": "H", "mutation": "E-5H", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.07941, "wildtype": "E"}, {"a26_usage": 0.1075, "cell_entry": 0.0358, "ferret_sera_escape": -0.04365, "mature_H5_site": -15, "mouse_sera_escape": -0.1141, "mutant": "I", "mutation": "E-5I", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.05551, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07079, "ferret_sera_escape": 0.0177, "mature_H5_site": -15, "mouse_sera_escape": -0.02258, "mutant": "K", "mutation": "E-5K", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": 0.05094, "wildtype": "E"}, {"a26_usage": 0.2101, "cell_entry": -0.07343, "ferret_sera_escape": -0.001367, "mature_H5_site": -15, "mouse_sera_escape": -0.02937, "mutant": "L", "mutation": "E-5L", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": 0.01415, "wildtype": "E"}, {"a26_usage": 0.279, "cell_entry": -0.166, "ferret_sera_escape": 0.1469, "mature_H5_site": -15, "mouse_sera_escape": -0.0462, "mutant": "M", "mutation": "E-5M", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.0842, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1724, "ferret_sera_escape": 0.07249, "mature_H5_site": -15, "mouse_sera_escape": -0.02767, "mutant": "N", "mutation": "E-5N", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.008196, "wildtype": "E"}, {"a26_usage": 0.05953, "cell_entry": -0.02672, "ferret_sera_escape": 0.0773, "mature_H5_site": -15, "mouse_sera_escape": 0.001269, "mutant": "P", "mutation": "E-5P", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.03283, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02099, "ferret_sera_escape": 0.1871, "mature_H5_site": -15, "mouse_sera_escape": -0.01596, "mutant": "Q", "mutation": "E-5Q", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": 0.01893, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02275, "ferret_sera_escape": 0.01843, "mature_H5_site": -15, "mouse_sera_escape": -0.04472, "mutant": "R", "mutation": "E-5R", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.005445, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.05347, "ferret_sera_escape": 0.007843, "mature_H5_site": -15, "mouse_sera_escape": -0.05206, "mutant": "S", "mutation": "E-5S", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.02974, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.05712, "ferret_sera_escape": -0.04577, "mature_H5_site": -15, "mouse_sera_escape": 0.0802, "mutant": "T", "mutation": "E-5T", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.003879, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.000975, "ferret_sera_escape": -0.1021, "mature_H5_site": -15, "mouse_sera_escape": -0.1608, "mutant": "V", "mutation": "E-5V", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": 0.02445, "wildtype": "E"}, {"a26_usage": 0.1004, "cell_entry": -0.03492, "ferret_sera_escape": 0.01437, "mature_H5_site": -15, "mouse_sera_escape": -0.0247, "mutant": "W", "mutation": "E-5W", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.03784, "wildtype": "E"}, {"a26_usage": 0.1807, "cell_entry": -0.3705, "ferret_sera_escape": 0.02313, "mature_H5_site": -15, "mouse_sera_escape": 0.09003, "mutant": "Y", "mutation": "E-5Y", "reference_site": "-5", "region": "HA1", "sequential_site": 2, "stability": -0.02677, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "A", "mutation": "M-6A", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "C", "mutation": "M-6C", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "D", "mutation": "M-6D", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.993, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "E", "mutation": "M-6E", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "F", "mutation": "M-6F", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "G", "mutation": "M-6G", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "H", "mutation": "M-6H", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.724, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "I", "mutation": "M-6I", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "L", "mutation": "M-6L", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -16, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M-6M", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "N", "mutation": "M-6N", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "P", "mutation": "M-6P", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.705, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "Q", "mutation": "M-6Q", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "R", "mutation": "M-6R", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "S", "mutation": "M-6S", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "T", "mutation": "M-6T", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.874, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "V", "mutation": "M-6V", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "W", "mutation": "M-6W", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": -16, "mouse_sera_escape": null, "mutant": "Y", "mutation": "M-6Y", "reference_site": "-6", "region": "HA1", "sequential_site": 1, "stability": null, "wildtype": "M"}, {"a26_usage": 0.3791, "cell_entry": -0.2586, "ferret_sera_escape": -0.06088, "mature_H5_site": -10, "mouse_sera_escape": 0.06847, "mutant": "C", "mutation": "L1C", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.01734, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": -10, "mouse_sera_escape": null, "mutant": "D", "mutation": "L1D", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.003785, "ferret_sera_escape": 0.007419, "mature_H5_site": -10, "mouse_sera_escape": 0.02466, "mutant": "G", "mutation": "L1G", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.005143, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.514, "ferret_sera_escape": -0.3188, "mature_H5_site": -10, "mouse_sera_escape": -0.04519, "mutant": "H", "mutation": "L1H", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.1634, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.001975, "ferret_sera_escape": 0.01725, "mature_H5_site": -10, "mouse_sera_escape": -0.000932, "mutant": "I", "mutation": "L1I", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.04037, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.888, "ferret_sera_escape": null, "mature_H5_site": -10, "mouse_sera_escape": null, "mutant": "K", "mutation": "L1K", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -10, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L1L", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.755, "ferret_sera_escape": -0.09714, "mature_H5_site": -10, "mouse_sera_escape": 0.02096, "mutant": "M", "mutation": "L1M", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": 0.007317, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.2, "ferret_sera_escape": null, "mature_H5_site": -10, "mouse_sera_escape": null, "mutant": "N", "mutation": "L1N", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.662, "ferret_sera_escape": null, "mature_H5_site": -10, "mouse_sera_escape": null, "mutant": "P", "mutation": "L1P", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.482, "ferret_sera_escape": null, "mature_H5_site": -10, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L1Q", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.918, "ferret_sera_escape": null, "mature_H5_site": -10, "mouse_sera_escape": null, "mutant": "R", "mutation": "L1R", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5069, "ferret_sera_escape": -0.09302, "mature_H5_site": -10, "mouse_sera_escape": -0.2003, "mutant": "S", "mutation": "L1S", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.1385, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3497, "ferret_sera_escape": -0.2964, "mature_H5_site": -10, "mouse_sera_escape": -0.2589, "mutant": "T", "mutation": "L1T", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.07914, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06815, "ferret_sera_escape": -0.2355, "mature_H5_site": -10, "mouse_sera_escape": -0.06764, "mutant": "V", "mutation": "L1V", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.0294, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06074, "ferret_sera_escape": -0.04438, "mature_H5_site": -10, "mouse_sera_escape": -0.07503, "mutant": "W", "mutation": "L1W", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.02312, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.239, "ferret_sera_escape": -0.02684, "mature_H5_site": -10, "mouse_sera_escape": -0.03437, "mutant": "Y", "mutation": "L1Y", "reference_site": "1", "region": "HA1", "sequential_site": 7, "stability": -0.02537, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.179, "ferret_sera_escape": -0.06115, "mature_H5_site": -1, "mouse_sera_escape": 0.07643, "mutant": "A", "mutation": "S10A", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": -0.05873, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.01148, "ferret_sera_escape": -0.003939, "mature_H5_site": -1, "mouse_sera_escape": 0.006246, "mutant": "C", "mutation": "S10C", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": 0.01653, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "D", "mutation": "S10D", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -6.024, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "E", "mutation": "S10E", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "F", "mutation": "S10F", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2729, "ferret_sera_escape": -0.03462, "mature_H5_site": -1, "mouse_sera_escape": -0.1214, "mutant": "G", "mutation": "S10G", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": -0.06492, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.857, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "H", "mutation": "S10H", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "I", "mutation": "S10I", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.375, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "K", "mutation": "S10K", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.461, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "L", "mutation": "S10L", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.337, "ferret_sera_escape": 0.1397, "mature_H5_site": -1, "mouse_sera_escape": 0.2008, "mutant": "N", "mutation": "S10N", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": -0.1902, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.418, "ferret_sera_escape": -0.02479, "mature_H5_site": -1, "mouse_sera_escape": -0.02458, "mutant": "P", "mutation": "S10P", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": -0.06731, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "Q", "mutation": "S10Q", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2168, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "R", "mutation": "S10R", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -1, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S10S", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6802, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "T", "mutation": "S10T", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "V", "mutation": "S10V", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "W", "mutation": "S10W", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": -1, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S10Y", "reference_site": "10", "region": "HA1", "sequential_site": 16, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3704, "ferret_sera_escape": 0.2911, "mature_H5_site": 93, "mouse_sera_escape": 0.3482, "mutant": "A", "mutation": "G100A", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": -0.01652, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.194, "ferret_sera_escape": -0.1604, "mature_H5_site": 93, "mouse_sera_escape": 0.1337, "mutant": "C", "mutation": "G100C", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "D", "mutation": "G100D", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "E", "mutation": "G100E", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.111, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "F", "mutation": "G100F", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 93, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G100G", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "I", "mutation": "G100I", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "K", "mutation": "G100K", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.537, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "L", "mutation": "G100L", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.237, "ferret_sera_escape": -1.199, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "M", "mutation": "G100M", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": 0.8172, "wildtype": "G"}, {"a26_usage": null, "cell_entry": -2.256, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "N", "mutation": "G100N", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "P", "mutation": "G100P", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G100Q", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "R", "mutation": "G100R", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.103, "ferret_sera_escape": 0.7064, "mature_H5_site": 93, "mouse_sera_escape": 0.3669, "mutant": "S", "mutation": "G100S", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": 0.04607, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.6131, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "T", "mutation": "G100T", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.035, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "V", "mutation": "G100V", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.007, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "W", "mutation": "G100W", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.85, "ferret_sera_escape": null, "mature_H5_site": 93, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G100Y", "reference_site": "100", "region": "HA1", "sequential_site": 109, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.0956, "ferret_sera_escape": 0.08852, "mature_H5_site": 94, "mouse_sera_escape": 0.09252, "mutant": "C", "mutation": "S101C", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.1393, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.02678, "ferret_sera_escape": -0.225, "mature_H5_site": 94, "mouse_sera_escape": -0.1292, "mutant": "D", "mutation": "S101D", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.5958, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.02001, "ferret_sera_escape": -0.09533, "mature_H5_site": 94, "mouse_sera_escape": 0.01473, "mutant": "F", "mutation": "S101F", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.08201, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.088, "ferret_sera_escape": 0.001853, "mature_H5_site": 94, "mouse_sera_escape": 0.0969, "mutant": "G", "mutation": "S101G", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.1145, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.02848, "ferret_sera_escape": 0.004616, "mature_H5_site": 94, "mouse_sera_escape": 0.0515, "mutant": "H", "mutation": "S101H", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.1056, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.02118, "ferret_sera_escape": null, "mature_H5_site": 94, "mouse_sera_escape": null, "mutant": "I", "mutation": "S101I", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.04996, "ferret_sera_escape": null, "mature_H5_site": 94, "mouse_sera_escape": null, "mutant": "K", "mutation": "S101K", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2838, "ferret_sera_escape": -0.02421, "mature_H5_site": 94, "mouse_sera_escape": -0.003721, "mutant": "L", "mutation": "S101L", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.1632, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0626, "ferret_sera_escape": -0.004853, "mature_H5_site": 94, "mouse_sera_escape": -0.03908, "mutant": "M", "mutation": "S101M", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.1243, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.05616, "ferret_sera_escape": 0.1308, "mature_H5_site": 94, "mouse_sera_escape": -0.01041, "mutant": "N", "mutation": "S101N", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.1351, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8402, "ferret_sera_escape": null, "mature_H5_site": 94, "mouse_sera_escape": null, "mutant": "P", "mutation": "S101P", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06219, "ferret_sera_escape": 0.01409, "mature_H5_site": 94, "mouse_sera_escape": 0.05295, "mutant": "Q", "mutation": "S101Q", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.2181, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06874, "ferret_sera_escape": -0.001903, "mature_H5_site": 94, "mouse_sera_escape": -0.06873, "mutant": "R", "mutation": "S101R", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.2126, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 94, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S101S", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.2333, "cell_entry": -0.7448, "ferret_sera_escape": 0.02583, "mature_H5_site": 94, "mouse_sera_escape": 0.03765, "mutant": "T", "mutation": "S101T", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": -0.05061, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1032, "ferret_sera_escape": null, "mature_H5_site": 94, "mouse_sera_escape": null, "mutant": "V", "mutation": "S101V", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.122, "ferret_sera_escape": 0.03847, "mature_H5_site": 94, "mouse_sera_escape": -0.001845, "mutant": "Y", "mutation": "S101Y", "reference_site": "101", "region": "HA1", "sequential_site": 110, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3681, "ferret_sera_escape": -0.1296, "mature_H5_site": 95, "mouse_sera_escape": 0.1277, "mutant": "C", "mutation": "L102C", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": 1.104, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.904, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "D", "mutation": "L102D", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.018, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "E", "mutation": "L102E", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4405, "ferret_sera_escape": 0.009433, "mature_H5_site": 95, "mouse_sera_escape": -0.05607, "mutant": "F", "mutation": "L102F", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": 0.04832, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.73, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "H", "mutation": "L102H", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9331, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "I", "mutation": "L102I", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "K", "mutation": "L102K", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 95, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L102L", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.04134, "ferret_sera_escape": -0.1501, "mature_H5_site": 95, "mouse_sera_escape": 0.1145, "mutant": "M", "mutation": "L102M", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": 1.198, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.542, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "P", "mutation": "L102P", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.78, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L102Q", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "R", "mutation": "L102R", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.505, "ferret_sera_escape": -0.2277, "mature_H5_site": 95, "mouse_sera_escape": 0.1359, "mutant": "V", "mutation": "L102V", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5562, "ferret_sera_escape": null, "mature_H5_site": 95, "mouse_sera_escape": null, "mutant": "W", "mutation": "L102W", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4255, "ferret_sera_escape": -0.3436, "mature_H5_site": 95, "mouse_sera_escape": -0.1758, "mutant": "Y", "mutation": "L102Y", "reference_site": "102", "region": "HA1", "sequential_site": 111, "stability": -0.2239, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3189, "ferret_sera_escape": -0.05702, "mature_H5_site": 96, "mouse_sera_escape": 0.0539, "mutant": "A", "mutation": "N103A", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": 0.6112, "wildtype": "N"}, {"a26_usage": 0.06635, "cell_entry": -0.084, "ferret_sera_escape": -0.07074, "mature_H5_site": 96, "mouse_sera_escape": -0.04494, "mutant": "D", "mutation": "N103D", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": 1.244, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02871, "ferret_sera_escape": 0.02547, "mature_H5_site": 96, "mouse_sera_escape": -0.003999, "mutant": "E", "mutation": "N103E", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": 0.3767, "wildtype": "N"}, {"a26_usage": 1.673, "cell_entry": -1.386, "ferret_sera_escape": -0.08738, "mature_H5_site": 96, "mouse_sera_escape": null, "mutant": "F", "mutation": "N103F", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7171, "ferret_sera_escape": -0.0101, "mature_H5_site": 96, "mouse_sera_escape": -0.07403, "mutant": "H", "mutation": "N103H", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": 0.0574, "wildtype": "N"}, {"a26_usage": 0.3988, "cell_entry": -0.4207, "ferret_sera_escape": 0.05185, "mature_H5_site": 96, "mouse_sera_escape": null, "mutant": "I", "mutation": "N103I", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.1474, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9121, "ferret_sera_escape": 0.07765, "mature_H5_site": 96, "mouse_sera_escape": 0.1095, "mutant": "K", "mutation": "N103K", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": 0.4187, "wildtype": "N"}, {"a26_usage": 0.4435, "cell_entry": -1.204, "ferret_sera_escape": -0.05798, "mature_H5_site": 96, "mouse_sera_escape": 0.0602, "mutant": "L", "mutation": "N103L", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": null, "wildtype": "N"}, {"a26_usage": 0.3476, "cell_entry": -0.1763, "ferret_sera_escape": 0.05633, "mature_H5_site": 96, "mouse_sera_escape": -0.1453, "mutant": "M", "mutation": "N103M", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.2793, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 96, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N103N", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02512, "ferret_sera_escape": -0.1215, "mature_H5_site": 96, "mouse_sera_escape": -0.1573, "mutant": "P", "mutation": "N103P", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.9346, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9675, "ferret_sera_escape": 0.09591, "mature_H5_site": 96, "mouse_sera_escape": 0.03998, "mutant": "Q", "mutation": "N103Q", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": 0.05876, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.003446, "ferret_sera_escape": 0.1779, "mature_H5_site": 96, "mouse_sera_escape": 0.1499, "mutant": "R", "mutation": "N103R", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.03089, "wildtype": "N"}, {"a26_usage": 0.3475, "cell_entry": -0.2763, "ferret_sera_escape": null, "mature_H5_site": 96, "mouse_sera_escape": null, "mutant": "S", "mutation": "N103S", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3932, "ferret_sera_escape": 0.2001, "mature_H5_site": 96, "mouse_sera_escape": 0.1697, "mutant": "T", "mutation": "N103T", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.03126, "wildtype": "N"}, {"a26_usage": 0.4491, "cell_entry": 0.02977, "ferret_sera_escape": 0.1418, "mature_H5_site": 96, "mouse_sera_escape": 0.0667, "mutant": "V", "mutation": "N103V", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.09997, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.01744, "ferret_sera_escape": -0.004827, "mature_H5_site": 96, "mouse_sera_escape": -0.05848, "mutant": "W", "mutation": "N103W", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.1065, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2094, "ferret_sera_escape": 0.01557, "mature_H5_site": 96, "mouse_sera_escape": -0.08108, "mutant": "Y", "mutation": "N103Y", "reference_site": "103", "region": "HA1", "sequential_site": 112, "stability": -0.07279, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02471, "ferret_sera_escape": -0.07998, "mature_H5_site": 97, "mouse_sera_escape": -0.01826, "mutant": "A", "mutation": "D104A", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2377, "ferret_sera_escape": 0.09037, "mature_H5_site": 97, "mouse_sera_escape": 0.1668, "mutant": "C", "mutation": "D104C", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 0.2299, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 97, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D104D", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.01429, "ferret_sera_escape": 0.1727, "mature_H5_site": 97, "mouse_sera_escape": 0.2197, "mutant": "E", "mutation": "D104E", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 0.255, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.251, "ferret_sera_escape": 0.1318, "mature_H5_site": 97, "mouse_sera_escape": 0.09558, "mutant": "F", "mutation": "D104F", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 0.1838, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2573, "ferret_sera_escape": -0.07073, "mature_H5_site": 97, "mouse_sera_escape": -0.069, "mutant": "G", "mutation": "D104G", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": -0.4201, "wildtype": "D"}, {"a26_usage": 0.3481, "cell_entry": -0.7358, "ferret_sera_escape": -0.001116, "mature_H5_site": 97, "mouse_sera_escape": -0.1315, "mutant": "H", "mutation": "D104H", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": -0.05201, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7713, "ferret_sera_escape": 0.03996, "mature_H5_site": 97, "mouse_sera_escape": 0.135, "mutant": "I", "mutation": "D104I", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 1.357, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6242, "ferret_sera_escape": 0.2878, "mature_H5_site": 97, "mouse_sera_escape": 0.1228, "mutant": "L", "mutation": "D104L", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4873, "ferret_sera_escape": 0.3085, "mature_H5_site": 97, "mouse_sera_escape": 0.1706, "mutant": "N", "mutation": "D104N", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 0.2268, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.051, "ferret_sera_escape": -0.7131, "mature_H5_site": 97, "mouse_sera_escape": -0.2221, "mutant": "P", "mutation": "D104P", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": -0.07339, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.07743, "ferret_sera_escape": 0.1311, "mature_H5_site": 97, "mouse_sera_escape": 0.2509, "mutant": "Q", "mutation": "D104Q", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 0.5107, "wildtype": "D"}, {"a26_usage": 0.02376, "cell_entry": -1.084, "ferret_sera_escape": 0.01413, "mature_H5_site": 97, "mouse_sera_escape": null, "mutant": "S", "mutation": "D104S", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.04689, "ferret_sera_escape": null, "mature_H5_site": 97, "mouse_sera_escape": null, "mutant": "T", "mutation": "D104T", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5111, "ferret_sera_escape": 0.0017, "mature_H5_site": 97, "mouse_sera_escape": -0.04573, "mutant": "V", "mutation": "D104V", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 1.073, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2975, "ferret_sera_escape": -0.268, "mature_H5_site": 97, "mouse_sera_escape": 0.00378, "mutant": "W", "mutation": "D104W", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": -0.2584, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.177, "ferret_sera_escape": 0.02099, "mature_H5_site": 97, "mouse_sera_escape": 0.1576, "mutant": "Y", "mutation": "D104Y", "reference_site": "104", "region": "HA1", "sequential_site": 113, "stability": 0.08196, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7893, "ferret_sera_escape": -0.07844, "mature_H5_site": 98, "mouse_sera_escape": 0.07267, "mutant": "A", "mutation": "Y105A", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4215, "ferret_sera_escape": null, "mature_H5_site": 98, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y105C", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.602, "ferret_sera_escape": null, "mature_H5_site": 98, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y105D", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3245, "ferret_sera_escape": -0.4073, "mature_H5_site": 98, "mouse_sera_escape": -0.1551, "mutant": "E", "mutation": "Y105E", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": 0.4716, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.05183, "ferret_sera_escape": 0.02107, "mature_H5_site": 98, "mouse_sera_escape": 0.02409, "mutant": "H", "mutation": "Y105H", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": -0.03956, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.09787, "ferret_sera_escape": -0.2429, "mature_H5_site": 98, "mouse_sera_escape": -0.1218, "mutant": "I", "mutation": "Y105I", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": -0.2086, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.5174, "ferret_sera_escape": 0.05186, "mature_H5_site": 98, "mouse_sera_escape": 0.07989, "mutant": "K", "mutation": "Y105K", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": 0.007635, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1983, "ferret_sera_escape": -0.1691, "mature_H5_site": 98, "mouse_sera_escape": -0.2671, "mutant": "L", "mutation": "Y105L", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": -0.1696, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.03292, "ferret_sera_escape": -0.2917, "mature_H5_site": 98, "mouse_sera_escape": -0.2249, "mutant": "M", "mutation": "Y105M", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.06217, "ferret_sera_escape": -0.05077, "mature_H5_site": 98, "mouse_sera_escape": -0.01194, "mutant": "N", "mutation": "Y105N", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": 0.1156, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.07, "ferret_sera_escape": null, "mature_H5_site": 98, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y105P", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6564, "ferret_sera_escape": -0.05188, "mature_H5_site": 98, "mouse_sera_escape": -0.05163, "mutant": "Q", "mutation": "Y105Q", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": -0.1784, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4109, "ferret_sera_escape": 0.1226, "mature_H5_site": 98, "mouse_sera_escape": 0.1273, "mutant": "R", "mutation": "Y105R", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": -0.007835, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 98, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y105T", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.1998, "cell_entry": -0.07614, "ferret_sera_escape": -0.09536, "mature_H5_site": 98, "mouse_sera_escape": -0.04518, "mutant": "V", "mutation": "Y105V", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": 0.03976, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.01433, "ferret_sera_escape": -0.6618, "mature_H5_site": 98, "mouse_sera_escape": -0.4701, "mutant": "W", "mutation": "Y105W", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": -0.2074, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 98, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y105Y", "reference_site": "105", "region": "HA1", "sequential_site": 114, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.236, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "A", "mutation": "E106A", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6726, "ferret_sera_escape": -0.1947, "mature_H5_site": 99, "mouse_sera_escape": -0.06487, "mutant": "D", "mutation": "E106D", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": 2.314, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 99, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E106E", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7146, "ferret_sera_escape": 0.05522, "mature_H5_site": 99, "mouse_sera_escape": 0.2465, "mutant": "F", "mutation": "E106F", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": -0.2561, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3959, "ferret_sera_escape": -0.08366, "mature_H5_site": 99, "mouse_sera_escape": 0.009521, "mutant": "G", "mutation": "E106G", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": -0.312, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3512, "ferret_sera_escape": -0.05625, "mature_H5_site": 99, "mouse_sera_escape": 0.0029, "mutant": "H", "mutation": "E106H", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": -0.3134, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "I", "mutation": "E106I", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.096, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "K", "mutation": "E106K", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5907, "ferret_sera_escape": 0.086, "mature_H5_site": 99, "mouse_sera_escape": 0.4239, "mutant": "L", "mutation": "E106L", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": 0.536, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.09538, "ferret_sera_escape": 0.04506, "mature_H5_site": 99, "mouse_sera_escape": 0.06197, "mutant": "M", "mutation": "E106M", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": -0.1329, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.649, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "N", "mutation": "E106N", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.798, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "P", "mutation": "E106P", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1303, "ferret_sera_escape": -0.05695, "mature_H5_site": 99, "mouse_sera_escape": 0.106, "mutant": "Q", "mutation": "E106Q", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": -0.2405, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "R", "mutation": "E106R", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.585, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "V", "mutation": "E106V", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.778, "ferret_sera_escape": null, "mature_H5_site": 99, "mouse_sera_escape": null, "mutant": "W", "mutation": "E106W", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.537, "ferret_sera_escape": 0.1976, "mature_H5_site": 99, "mouse_sera_escape": 0.2566, "mutant": "Y", "mutation": "E106Y", "reference_site": "106", "region": "HA1", "sequential_site": 115, "stability": -0.1213, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "A", "mutation": "E107A", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "C", "mutation": "E107C", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.242, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "D", "mutation": "E107D", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 100, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E107E", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "F", "mutation": "E107F", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.588, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "H", "mutation": "E107H", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "I", "mutation": "E107I", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "K", "mutation": "E107K", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.363, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "N", "mutation": "E107N", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "P", "mutation": "E107P", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "Q", "mutation": "E107Q", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "S", "mutation": "E107S", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "T", "mutation": "E107T", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "W", "mutation": "E107W", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 100, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E107Y", "reference_site": "107", "region": "HA1", "sequential_site": 116, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.015, "ferret_sera_escape": -0.2781, "mature_H5_site": 101, "mouse_sera_escape": -0.01582, "mutant": "C", "mutation": "L108C", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "D", "mutation": "L108D", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "E", "mutation": "L108E", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.646, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "F", "mutation": "L108F", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.742, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "G", "mutation": "L108G", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 101, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L108L", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2334, "ferret_sera_escape": 0.06355, "mature_H5_site": 101, "mouse_sera_escape": 0.01203, "mutant": "M", "mutation": "L108M", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": -0.502, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "P", "mutation": "L108P", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.013, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "R", "mutation": "L108R", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.643, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "S", "mutation": "L108S", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.534, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "T", "mutation": "L108T", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "W", "mutation": "L108W", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.605, "ferret_sera_escape": null, "mature_H5_site": 101, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L108Y", "reference_site": "108", "region": "HA1", "sequential_site": 117, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.07599, "ferret_sera_escape": -0.2911, "mature_H5_site": 102, "mouse_sera_escape": -0.1074, "mutant": "A", "mutation": "K109A", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": 1.435, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6565, "ferret_sera_escape": -0.113, "mature_H5_site": 102, "mouse_sera_escape": 0.1487, "mutant": "C", "mutation": "K109C", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": 2.143, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.835, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "D", "mutation": "K109D", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.925, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "E", "mutation": "K109E", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6996, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "G", "mutation": "K109G", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.855, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "I", "mutation": "K109I", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 102, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K109K", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.582, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "L", "mutation": "K109L", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.187, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "M", "mutation": "K109M", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.342, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "N", "mutation": "K109N", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1584, "ferret_sera_escape": -0.1852, "mature_H5_site": 102, "mouse_sera_escape": -0.0456, "mutant": "Q", "mutation": "K109Q", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": 1.619, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1504, "ferret_sera_escape": -0.1975, "mature_H5_site": 102, "mouse_sera_escape": 0.1554, "mutant": "R", "mutation": "K109R", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": 0.9188, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.095, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "T", "mutation": "K109T", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 102, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K109Y", "reference_site": "109", "region": "HA1", "sequential_site": 118, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.852, "ferret_sera_escape": -0.0044, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "A", "mutation": "D11A", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.285, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "C", "mutation": "D11C", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 1, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D11D", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.812, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "E", "mutation": "D11E", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.008, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "F", "mutation": "D11F", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.651, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "G", "mutation": "D11G", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.888, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "H", "mutation": "D11H", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.882, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "I", "mutation": "D11I", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.715, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "K", "mutation": "D11K", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "L", "mutation": "D11L", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "M", "mutation": "D11M", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 1.724, "cell_entry": -0.3773, "ferret_sera_escape": -0.06737, "mature_H5_site": 1, "mouse_sera_escape": 0.08058, "mutant": "N", "mutation": "D11N", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.978, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "P", "mutation": "D11P", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "Q", "mutation": "D11Q", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "R", "mutation": "D11R", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.739, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "S", "mutation": "D11S", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "V", "mutation": "D11V", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "W", "mutation": "D11W", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.577, "ferret_sera_escape": null, "mature_H5_site": 1, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D11Y", "reference_site": "11", "region": "HA1", "sequential_site": 17, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.366, "ferret_sera_escape": -0.02295, "mature_H5_site": 103, "mouse_sera_escape": 0.1987, "mutant": "A", "mutation": "H110A", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 0.8676, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.888, "ferret_sera_escape": 0.0003133, "mature_H5_site": 103, "mouse_sera_escape": 0.04419, "mutant": "C", "mutation": "H110C", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 0.5846, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.242, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "D", "mutation": "H110D", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.331, "ferret_sera_escape": -0.2582, "mature_H5_site": 103, "mouse_sera_escape": -0.09606, "mutant": "E", "mutation": "H110E", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.488, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "G", "mutation": "H110G", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 103, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H110H", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.191, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "I", "mutation": "H110I", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.429, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "K", "mutation": "H110K", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4132, "ferret_sera_escape": 0.1378, "mature_H5_site": 103, "mouse_sera_escape": 0.1479, "mutant": "L", "mutation": "H110L", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.883, "ferret_sera_escape": 0.4555, "mature_H5_site": 103, "mouse_sera_escape": 0.2626, "mutant": "M", "mutation": "H110M", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 1.219, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.7925, "ferret_sera_escape": -0.03114, "mature_H5_site": 103, "mouse_sera_escape": 0.007151, "mutant": "N", "mutation": "H110N", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 0.5528, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "P", "mutation": "H110P", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.601, "ferret_sera_escape": 0.0464, "mature_H5_site": 103, "mouse_sera_escape": 0.5806, "mutant": "Q", "mutation": "H110Q", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 0.7464, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.739, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "R", "mutation": "H110R", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5953, "ferret_sera_escape": -0.02457, "mature_H5_site": 103, "mouse_sera_escape": 0.2301, "mutant": "S", "mutation": "H110S", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 1.204, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.135, "ferret_sera_escape": -0.2959, "mature_H5_site": 103, "mouse_sera_escape": 0.6494, "mutant": "T", "mutation": "H110T", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 0.6905, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.335, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "V", "mutation": "H110V", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 103, "mouse_sera_escape": null, "mutant": "W", "mutation": "H110W", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.351, "ferret_sera_escape": 0.02023, "mature_H5_site": 103, "mouse_sera_escape": 0.2874, "mutant": "Y", "mutation": "H110Y", "reference_site": "110", "region": "HA1", "sequential_site": 119, "stability": 1.377, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.491, "ferret_sera_escape": -0.1108, "mature_H5_site": 104, "mouse_sera_escape": -0.4416, "mutant": "A", "mutation": "M111A", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": -0.7941, "wildtype": "M"}, {"a26_usage": 1.469, "cell_entry": -0.8764, "ferret_sera_escape": -0.06913, "mature_H5_site": 104, "mouse_sera_escape": -0.2128, "mutant": "C", "mutation": "M111C", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": -0.173, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.17, "ferret_sera_escape": 0.1032, "mature_H5_site": 104, "mouse_sera_escape": -0.02907, "mutant": "D", "mutation": "M111D", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.907, "ferret_sera_escape": null, "mature_H5_site": 104, "mouse_sera_escape": null, "mutant": "E", "mutation": "M111E", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.3729, "ferret_sera_escape": 0.1247, "mature_H5_site": 104, "mouse_sera_escape": 0.05982, "mutant": "F", "mutation": "M111F", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.03574, "cell_entry": 0.02311, "ferret_sera_escape": 0.04219, "mature_H5_site": 104, "mouse_sera_escape": -0.1144, "mutant": "G", "mutation": "M111G", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": -0.268, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.01186, "ferret_sera_escape": -0.1427, "mature_H5_site": 104, "mouse_sera_escape": -0.122, "mutant": "H", "mutation": "M111H", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": -0.06913, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.01526, "ferret_sera_escape": -0.1681, "mature_H5_site": 104, "mouse_sera_escape": -0.1461, "mutant": "I", "mutation": "M111I", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": -0.2299, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.879, "ferret_sera_escape": -0.2589, "mature_H5_site": 104, "mouse_sera_escape": -0.0959, "mutant": "K", "mutation": "M111K", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": null, "cell_entry": -0.01373, "ferret_sera_escape": -0.1433, "mature_H5_site": 104, "mouse_sera_escape": -0.08549, "mutant": "L", "mutation": "M111L", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": -0.1704, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 104, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M111M", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 104, "mouse_sera_escape": null, "mutant": "N", "mutation": "M111N", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.62, "ferret_sera_escape": null, "mature_H5_site": 104, "mouse_sera_escape": null, "mutant": "P", "mutation": "M111P", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.809, "ferret_sera_escape": -0.3003, "mature_H5_site": 104, "mouse_sera_escape": -0.2054, "mutant": "Q", "mutation": "M111Q", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.35, "ferret_sera_escape": -0.3688, "mature_H5_site": 104, "mouse_sera_escape": null, "mutant": "R", "mutation": "M111R", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.4343, "ferret_sera_escape": -0.1184, "mature_H5_site": 104, "mouse_sera_escape": -0.1352, "mutant": "S", "mutation": "M111S", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": -0.4975, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.037, "ferret_sera_escape": -0.2691, "mature_H5_site": 104, "mouse_sera_escape": -0.1786, "mutant": "T", "mutation": "M111T", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.49, "ferret_sera_escape": -0.6113, "mature_H5_site": 104, "mouse_sera_escape": null, "mutant": "V", "mutation": "M111V", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.444, "ferret_sera_escape": 0.01694, "mature_H5_site": 104, "mouse_sera_escape": -0.008168, "mutant": "W", "mutation": "M111W", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": -0.1458, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.2695, "ferret_sera_escape": 0.1096, "mature_H5_site": 104, "mouse_sera_escape": 0.1976, "mutant": "Y", "mutation": "M111Y", "reference_site": "111", "region": "HA1", "sequential_site": 120, "stability": 1.441, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.5832, "ferret_sera_escape": 0.1818, "mature_H5_site": 105, "mouse_sera_escape": 0.3458, "mutant": "A", "mutation": "L112A", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5001, "ferret_sera_escape": 0.08374, "mature_H5_site": 105, "mouse_sera_escape": 0.3635, "mutant": "C", "mutation": "L112C", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": 0.4412, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "D", "mutation": "L112D", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "E", "mutation": "L112E", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.627, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "F", "mutation": "L112F", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.871, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "G", "mutation": "L112G", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.696, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "H", "mutation": "L112H", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4761, "ferret_sera_escape": 0.08279, "mature_H5_site": 105, "mouse_sera_escape": 0.1091, "mutant": "I", "mutation": "L112I", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": 0.2906, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "K", "mutation": "L112K", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 105, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L112L", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.01458, "cell_entry": 0.07681, "ferret_sera_escape": 0.007209, "mature_H5_site": 105, "mouse_sera_escape": -0.009453, "mutant": "M", "mutation": "L112M", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": -0.005374, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "P", "mutation": "L112P", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.463, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L112Q", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "R", "mutation": "L112R", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.913, "ferret_sera_escape": 0.1084, "mature_H5_site": 105, "mouse_sera_escape": 0.1756, "mutant": "S", "mutation": "L112S", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": 0.06213, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.093, "ferret_sera_escape": 0.1685, "mature_H5_site": 105, "mouse_sera_escape": 0.1705, "mutant": "V", "mutation": "L112V", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": 0.9275, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.481, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "W", "mutation": "L112W", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.751, "ferret_sera_escape": null, "mature_H5_site": 105, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L112Y", "reference_site": "112", "region": "HA1", "sequential_site": 121, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.04543, "ferret_sera_escape": 0.03732, "mature_H5_site": 106, "mouse_sera_escape": 0.02021, "mutant": "A", "mutation": "S113A", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": -0.02404, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.598, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "C", "mutation": "S113C", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "E", "mutation": "S113E", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.981, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": -0.09506, "mutant": "G", "mutation": "S113G", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": -0.1768, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "I", "mutation": "S113I", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "L", "mutation": "S113L", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.621, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "N", "mutation": "S113N", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.885, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "P", "mutation": "S113P", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "R", "mutation": "S113R", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 106, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S113S", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3958, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "T", "mutation": "S113T", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.781, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "V", "mutation": "S113V", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 106, "mouse_sera_escape": null, "mutant": "W", "mutation": "S113W", "reference_site": "113", "region": "HA1", "sequential_site": 122, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.04878, "ferret_sera_escape": -0.006683, "mature_H5_site": 107, "mouse_sera_escape": 0.09516, "mutant": "C", "mutation": "R114C", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": 1.667, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.931, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "D", "mutation": "R114D", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.925, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "E", "mutation": "R114E", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.121, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "F", "mutation": "R114F", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.109, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "G", "mutation": "R114G", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "I", "mutation": "R114I", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.285, "ferret_sera_escape": -0.1563, "mature_H5_site": 107, "mouse_sera_escape": 0.05366, "mutant": "K", "mutation": "R114K", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": 1.28, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.505, "ferret_sera_escape": 0.1208, "mature_H5_site": 107, "mouse_sera_escape": -0.05803, "mutant": "L", "mutation": "R114L", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": -0.08478, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.595, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "M", "mutation": "R114M", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.274, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "N", "mutation": "R114N", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "P", "mutation": "R114P", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.156, "ferret_sera_escape": -0.008133, "mature_H5_site": 107, "mouse_sera_escape": 0.238, "mutant": "Q", "mutation": "R114Q", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": 2.131, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 107, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R114R", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.874, "ferret_sera_escape": null, "mature_H5_site": 107, "mouse_sera_escape": null, "mutant": "S", "mutation": "R114S", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.959, "ferret_sera_escape": 0.9309, "mature_H5_site": 107, "mouse_sera_escape": 0.5398, "mutant": "T", "mutation": "R114T", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4584, "ferret_sera_escape": 0.1796, "mature_H5_site": 107, "mouse_sera_escape": 0.05447, "mutant": "W", "mutation": "R114W", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": -0.03309, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5778, "ferret_sera_escape": -0.02443, "mature_H5_site": 107, "mouse_sera_escape": -0.06574, "mutant": "Y", "mutation": "R114Y", "reference_site": "114", "region": "HA1", "sequential_site": 123, "stability": -0.1791, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.322, "ferret_sera_escape": 0.2378, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "A", "mutation": "I115A", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.05556, "ferret_sera_escape": 0.1317, "mature_H5_site": 108, "mouse_sera_escape": 0.1036, "mutant": "C", "mutation": "I115C", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.849, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "D", "mutation": "I115D", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.696, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "E", "mutation": "I115E", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "G", "mutation": "I115G", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "H", "mutation": "I115H", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 108, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I115I", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.721, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "K", "mutation": "I115K", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.9204, "ferret_sera_escape": 0.003223, "mature_H5_site": 108, "mouse_sera_escape": 0.2126, "mutant": "L", "mutation": "I115L", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": 0.7604, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.693, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "M", "mutation": "I115M", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.441, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "N", "mutation": "I115N", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "P", "mutation": "I115P", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I115Q", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "R", "mutation": "I115R", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.51, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "S", "mutation": "I115S", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.509, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "W", "mutation": "I115W", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.964, "ferret_sera_escape": null, "mature_H5_site": 108, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I115Y", "reference_site": "115", "region": "HA1", "sequential_site": 124, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.2, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "A", "mutation": "N116A", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4717, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "C", "mutation": "N116C", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.875, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "D", "mutation": "N116D", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.873, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "E", "mutation": "N116E", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7453, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "F", "mutation": "N116F", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.67, "ferret_sera_escape": -0.2392, "mature_H5_site": 109, "mouse_sera_escape": 0.7442, "mutant": "G", "mutation": "N116G", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": 1.475, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.07, "ferret_sera_escape": -0.06054, "mature_H5_site": 109, "mouse_sera_escape": 0.3277, "mutant": "H", "mutation": "N116H", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": 0.7992, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.00154, "ferret_sera_escape": -0.04435, "mature_H5_site": 109, "mouse_sera_escape": -0.1302, "mutant": "K", "mutation": "N116K", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": -0.003525, "wildtype": "N"}, {"a26_usage": null, "cell_entry": -3.069, "ferret_sera_escape": 0.107, "mature_H5_site": 109, "mouse_sera_escape": -0.07688, "mutant": "L", "mutation": "N116L", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7297, "ferret_sera_escape": 0.203, "mature_H5_site": 109, "mouse_sera_escape": -0.05687, "mutant": "M", "mutation": "N116M", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": -0.01088, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 109, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N116N", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.405, "ferret_sera_escape": -0.006397, "mature_H5_site": 109, "mouse_sera_escape": 0.1877, "mutant": "P", "mutation": "N116P", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": 0.1759, "wildtype": "N"}, {"a26_usage": 0.2646, "cell_entry": -0.0768, "ferret_sera_escape": -0.03377, "mature_H5_site": 109, "mouse_sera_escape": -0.02719, "mutant": "Q", "mutation": "N116Q", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": -0.03417, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.368, "ferret_sera_escape": -0.2039, "mature_H5_site": 109, "mouse_sera_escape": 0.217, "mutant": "S", "mutation": "N116S", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": 1.931, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9864, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "T", "mutation": "N116T", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7876, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "V", "mutation": "N116V", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.089, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "W", "mutation": "N116W", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.573, "ferret_sera_escape": null, "mature_H5_site": 109, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N116Y", "reference_site": "116", "region": "HA1", "sequential_site": 125, "stability": 0.6817, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.792, "ferret_sera_escape": null, "mature_H5_site": 110, "mouse_sera_escape": null, "mutant": "A", "mutation": "H117A", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.449, "ferret_sera_escape": -0.08407, "mature_H5_site": 110, "mouse_sera_escape": 0.08362, "mutant": "C", "mutation": "H117C", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": -0.5506, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.2694, "ferret_sera_escape": 0.2168, "mature_H5_site": 110, "mouse_sera_escape": 0.298, "mutant": "D", "mutation": "H117D", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": 0.8161, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.9804, "ferret_sera_escape": null, "mature_H5_site": 110, "mouse_sera_escape": null, "mutant": "F", "mutation": "H117F", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": null, "wildtype": "H"}, {"a26_usage": null, "cell_entry": -2.237, "ferret_sera_escape": null, "mature_H5_site": 110, "mouse_sera_escape": null, "mutant": "G", "mutation": "H117G", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 110, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H117H", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.6603, "ferret_sera_escape": -0.1432, "mature_H5_site": 110, "mouse_sera_escape": 0.07822, "mutant": "I", "mutation": "H117I", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": 1.152, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.02034, "ferret_sera_escape": -0.02157, "mature_H5_site": 110, "mouse_sera_escape": -0.007581, "mutant": "K", "mutation": "H117K", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": null, "wildtype": "H"}, {"a26_usage": 0.453, "cell_entry": 0.00568, "ferret_sera_escape": 0.1622, "mature_H5_site": 110, "mouse_sera_escape": 0.1682, "mutant": "L", "mutation": "H117L", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": null, "wildtype": "H"}, {"a26_usage": 0.1445, "cell_entry": -0.03195, "ferret_sera_escape": -0.0005367, "mature_H5_site": 110, "mouse_sera_escape": 0.1503, "mutant": "N", "mutation": "H117N", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": 0.551, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.776, "ferret_sera_escape": null, "mature_H5_site": 110, "mouse_sera_escape": null, "mutant": "P", "mutation": "H117P", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3424, "ferret_sera_escape": 0.1592, "mature_H5_site": 110, "mouse_sera_escape": 0.01248, "mutant": "Q", "mutation": "H117Q", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": -0.2107, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3956, "ferret_sera_escape": -0.2361, "mature_H5_site": 110, "mouse_sera_escape": -0.09411, "mutant": "R", "mutation": "H117R", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": 0.6336, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.03186, "ferret_sera_escape": -0.00175, "mature_H5_site": 110, "mouse_sera_escape": 0.03342, "mutant": "S", "mutation": "H117S", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": -0.1941, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5314, "ferret_sera_escape": 0.03427, "mature_H5_site": 110, "mouse_sera_escape": 0.1568, "mutant": "T", "mutation": "H117T", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": 1.433, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5263, "ferret_sera_escape": 0.1057, "mature_H5_site": 110, "mouse_sera_escape": 0.2452, "mutant": "V", "mutation": "H117V", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.03752, "ferret_sera_escape": -0.03046, "mature_H5_site": 110, "mouse_sera_escape": 0.146, "mutant": "W", "mutation": "H117W", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": -0.1614, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5233, "ferret_sera_escape": 0.07712, "mature_H5_site": 110, "mouse_sera_escape": 0.5755, "mutant": "Y", "mutation": "H117Y", "reference_site": "117", "region": "HA1", "sequential_site": 126, "stability": 1.591, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.9971, "ferret_sera_escape": 0.3467, "mature_H5_site": 111, "mouse_sera_escape": 0.3955, "mutant": "C", "mutation": "F118C", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": -0.179, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.71, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "D", "mutation": "F118D", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.61, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "E", "mutation": "F118E", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 111, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F118F", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.575, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "G", "mutation": "F118G", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.5722, "ferret_sera_escape": -0.04881, "mature_H5_site": 111, "mouse_sera_escape": 0.0529, "mutant": "H", "mutation": "F118H", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": -0.3066, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "I", "mutation": "F118I", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.165, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "K", "mutation": "F118K", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": null, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "L", "mutation": "F118L", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.885, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "M", "mutation": "F118M", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "P", "mutation": "F118P", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.374, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "R", "mutation": "F118R", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.001, "ferret_sera_escape": null, "mature_H5_site": 111, "mouse_sera_escape": null, "mutant": "T", "mutation": "F118T", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.8548, "ferret_sera_escape": -0.2194, "mature_H5_site": 111, "mouse_sera_escape": 0.0292, "mutant": "Y", "mutation": "F118Y", "reference_site": "118", "region": "HA1", "sequential_site": 127, "stability": 1.102, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.7303, "ferret_sera_escape": -0.007021, "mature_H5_site": 112, "mouse_sera_escape": 0.5059, "mutant": "A", "mutation": "E119A", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3972, "ferret_sera_escape": 0.01207, "mature_H5_site": 112, "mouse_sera_escape": 0.1987, "mutant": "D", "mutation": "E119D", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.1383, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 112, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E119E", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.011, "ferret_sera_escape": 0.07942, "mature_H5_site": 112, "mouse_sera_escape": 0.4685, "mutant": "F", "mutation": "E119F", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.2926, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.479, "ferret_sera_escape": -0.03309, "mature_H5_site": 112, "mouse_sera_escape": 0.4335, "mutant": "G", "mutation": "E119G", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": 0.1543, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07822, "ferret_sera_escape": -0.2683, "mature_H5_site": 112, "mouse_sera_escape": 0.2027, "mutant": "H", "mutation": "E119H", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.2699, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.676, "ferret_sera_escape": -0.3211, "mature_H5_site": 112, "mouse_sera_escape": null, "mutant": "I", "mutation": "E119I", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.161, "ferret_sera_escape": 0.01283, "mature_H5_site": 112, "mouse_sera_escape": 0.2333, "mutant": "K", "mutation": "E119K", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.31, "ferret_sera_escape": null, "mature_H5_site": 112, "mouse_sera_escape": null, "mutant": "L", "mutation": "E119L", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.0783, "ferret_sera_escape": -0.01155, "mature_H5_site": 112, "mouse_sera_escape": 0.3304, "mutant": "M", "mutation": "E119M", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.3872, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4814, "ferret_sera_escape": -0.1562, "mature_H5_site": 112, "mouse_sera_escape": 0.1856, "mutant": "N", "mutation": "E119N", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.1858, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5314, "ferret_sera_escape": -0.06123, "mature_H5_site": 112, "mouse_sera_escape": 0.1378, "mutant": "Q", "mutation": "E119Q", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06823, "ferret_sera_escape": 0.198, "mature_H5_site": 112, "mouse_sera_escape": 0.2477, "mutant": "R", "mutation": "E119R", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.1964, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5659, "ferret_sera_escape": 0.1639, "mature_H5_site": 112, "mouse_sera_escape": 0.5332, "mutant": "S", "mutation": "E119S", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": 1.102, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3562, "ferret_sera_escape": -0.03967, "mature_H5_site": 112, "mouse_sera_escape": 0.2888, "mutant": "T", "mutation": "E119T", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.1227, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4491, "ferret_sera_escape": -0.2743, "mature_H5_site": 112, "mouse_sera_escape": 0.1416, "mutant": "V", "mutation": "E119V", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.1525, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.804, "ferret_sera_escape": 0.1825, "mature_H5_site": 112, "mouse_sera_escape": 0.6633, "mutant": "W", "mutation": "E119W", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6957, "ferret_sera_escape": -0.08007, "mature_H5_site": 112, "mouse_sera_escape": 0.4956, "mutant": "Y", "mutation": "E119Y", "reference_site": "119", "region": "HA1", "sequential_site": 128, "stability": -0.2248, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.02366, "ferret_sera_escape": null, "mature_H5_site": 2, "mouse_sera_escape": null, "mutant": "A", "mutation": "Q12A", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.06322, "ferret_sera_escape": -0.06943, "mature_H5_site": 2, "mouse_sera_escape": 0.01982, "mutant": "C", "mutation": "Q12C", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": -0.1146, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.4799, "ferret_sera_escape": -0.04659, "mature_H5_site": 2, "mouse_sera_escape": 0.03173, "mutant": "E", "mutation": "Q12E", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": 0.06995, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.00978, "ferret_sera_escape": 0.07101, "mature_H5_site": 2, "mouse_sera_escape": 0.02075, "mutant": "F", "mutation": "Q12F", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": 0.04321, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1774, "ferret_sera_escape": -0.02569, "mature_H5_site": 2, "mouse_sera_escape": -0.01853, "mutant": "G", "mutation": "Q12G", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2583, "ferret_sera_escape": 0.04559, "mature_H5_site": 2, "mouse_sera_escape": 0.1129, "mutant": "H", "mutation": "Q12H", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": -0.03355, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.0239, "ferret_sera_escape": -0.1091, "mature_H5_site": 2, "mouse_sera_escape": -0.04236, "mutant": "I", "mutation": "Q12I", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": -0.02679, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.03238, "ferret_sera_escape": 0.0665, "mature_H5_site": 2, "mouse_sera_escape": -0.03443, "mutant": "K", "mutation": "Q12K", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": -0.06683, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.01749, "ferret_sera_escape": null, "mature_H5_site": 2, "mouse_sera_escape": null, "mutant": "L", "mutation": "Q12L", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1825, "ferret_sera_escape": 0.1607, "mature_H5_site": 2, "mouse_sera_escape": -0.1084, "mutant": "M", "mutation": "Q12M", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": 0.05007, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.05822, "ferret_sera_escape": -0.08021, "mature_H5_site": 2, "mouse_sera_escape": 0.06707, "mutant": "N", "mutation": "Q12N", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": -0.06364, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 2, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q12P", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 2, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q12Q", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1152, "ferret_sera_escape": -0.00437, "mature_H5_site": 2, "mouse_sera_escape": -0.01257, "mutant": "R", "mutation": "Q12R", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": -0.03848, "wildtype": "Q"}, {"a26_usage": 0.0511, "cell_entry": -0.372, "ferret_sera_escape": 0.08018, "mature_H5_site": 2, "mouse_sera_escape": 0.1517, "mutant": "S", "mutation": "Q12S", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": 0.007057, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.01009, "ferret_sera_escape": -0.1059, "mature_H5_site": 2, "mouse_sera_escape": -0.07769, "mutant": "V", "mutation": "Q12V", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": -0.04021, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.9424, "ferret_sera_escape": 0.08115, "mature_H5_site": 2, "mouse_sera_escape": -0.09026, "mutant": "Y", "mutation": "Q12Y", "reference_site": "12", "region": "HA1", "sequential_site": 18, "stability": 0.05847, "wildtype": "Q"}, {"a26_usage": 0.2121, "cell_entry": 0.01951, "ferret_sera_escape": 0.06413, "mature_H5_site": 113, "mouse_sera_escape": 0.1999, "mutant": "A", "mutation": "K120A", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.2158, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.871, "ferret_sera_escape": null, "mature_H5_site": 113, "mouse_sera_escape": null, "mutant": "C", "mutation": "K120C", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2547, "ferret_sera_escape": 0.02695, "mature_H5_site": 113, "mouse_sera_escape": 0.4276, "mutant": "E", "mutation": "K120E", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.3969, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.074, "ferret_sera_escape": null, "mature_H5_site": 113, "mouse_sera_escape": null, "mutant": "F", "mutation": "K120F", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8044, "ferret_sera_escape": 0.1423, "mature_H5_site": 113, "mouse_sera_escape": 0.4168, "mutant": "G", "mutation": "K120G", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.2829, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5709, "ferret_sera_escape": 0.1384, "mature_H5_site": 113, "mouse_sera_escape": 0.3636, "mutant": "H", "mutation": "K120H", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.2186, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3311, "ferret_sera_escape": 0.1034, "mature_H5_site": 113, "mouse_sera_escape": 0.07147, "mutant": "I", "mutation": "K120I", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.3458, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 113, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K120K", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.737, "ferret_sera_escape": -0.0535, "mature_H5_site": 113, "mouse_sera_escape": 0.1954, "mutant": "L", "mutation": "K120L", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03023, "ferret_sera_escape": 0.1793, "mature_H5_site": 113, "mouse_sera_escape": 0.1963, "mutant": "M", "mutation": "K120M", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.1926, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.05283, "ferret_sera_escape": -0.04832, "mature_H5_site": 113, "mouse_sera_escape": 0.2196, "mutant": "P", "mutation": "K120P", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.2831, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.02981, "ferret_sera_escape": 0.1389, "mature_H5_site": 113, "mouse_sera_escape": 0.1142, "mutant": "Q", "mutation": "K120Q", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.3505, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.692, "ferret_sera_escape": -0.1712, "mature_H5_site": 113, "mouse_sera_escape": null, "mutant": "R", "mutation": "K120R", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.304, "ferret_sera_escape": null, "mature_H5_site": 113, "mouse_sera_escape": null, "mutant": "S", "mutation": "K120S", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0716, "ferret_sera_escape": 0.08107, "mature_H5_site": 113, "mouse_sera_escape": 0.04453, "mutant": "T", "mutation": "K120T", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.2676, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.463, "ferret_sera_escape": null, "mature_H5_site": 113, "mouse_sera_escape": null, "mutant": "W", "mutation": "K120W", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.438, "ferret_sera_escape": 0.08088, "mature_H5_site": 113, "mouse_sera_escape": 0.439, "mutant": "Y", "mutation": "K120Y", "reference_site": "120", "region": "HA1", "sequential_site": 129, "stability": -0.1666, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03422, "ferret_sera_escape": 0.139, "mature_H5_site": 114, "mouse_sera_escape": 0.2643, "mutant": "A", "mutation": "I121A", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.1992, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.531, "ferret_sera_escape": 0.06269, "mature_H5_site": 114, "mouse_sera_escape": 0.446, "mutant": "C", "mutation": "I121C", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.0504, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -0.2287, "ferret_sera_escape": null, "mature_H5_site": 114, "mouse_sera_escape": null, "mutant": "D", "mutation": "I121D", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3542, "ferret_sera_escape": 0.02722, "mature_H5_site": 114, "mouse_sera_escape": 0.537, "mutant": "E", "mutation": "I121E", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.2802, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1405, "ferret_sera_escape": 0.05012, "mature_H5_site": 114, "mouse_sera_escape": -0.07388, "mutant": "F", "mutation": "I121F", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.04933, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.041, "ferret_sera_escape": null, "mature_H5_site": 114, "mouse_sera_escape": null, "mutant": "H", "mutation": "I121H", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 114, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I121I", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.04127, "cell_entry": 0.0355, "ferret_sera_escape": 0.2231, "mature_H5_site": 114, "mouse_sera_escape": 0.5063, "mutant": "K", "mutation": "I121K", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": 0.001318, "wildtype": "I"}, {"a26_usage": 0.04269, "cell_entry": 0.03692, "ferret_sera_escape": 0.1855, "mature_H5_site": 114, "mouse_sera_escape": -0.06186, "mutant": "M", "mutation": "I121M", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.1251, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.06919, "ferret_sera_escape": -0.01617, "mature_H5_site": 114, "mouse_sera_escape": 0.05666, "mutant": "N", "mutation": "I121N", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.2273, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2019, "ferret_sera_escape": 0.04829, "mature_H5_site": 114, "mouse_sera_escape": 0.1697, "mutant": "R", "mutation": "I121R", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.02168, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6339, "ferret_sera_escape": 0.01904, "mature_H5_site": 114, "mouse_sera_escape": 0.07199, "mutant": "S", "mutation": "I121S", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": -0.2154, "wildtype": "I"}, {"a26_usage": 0.009325, "cell_entry": 0.03352, "ferret_sera_escape": 0.06616, "mature_H5_site": 114, "mouse_sera_escape": 0.1681, "mutant": "T", "mutation": "I121T", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": 0.04997, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6371, "ferret_sera_escape": null, "mature_H5_site": 114, "mouse_sera_escape": null, "mutant": "V", "mutation": "I121V", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2212, "ferret_sera_escape": 0.07685, "mature_H5_site": 114, "mouse_sera_escape": 0.6259, "mutant": "W", "mutation": "I121W", "reference_site": "121", "region": "HA1", "sequential_site": 130, "stability": 0.3749, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4973, "ferret_sera_escape": 0.1542, "mature_H5_site": 115, "mouse_sera_escape": 0.791, "mutant": "E", "mutation": "L122E", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.1891, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3482, "ferret_sera_escape": 0.2659, "mature_H5_site": 115, "mouse_sera_escape": 0.5386, "mutant": "F", "mutation": "L122F", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.04354, "wildtype": "L"}, {"a26_usage": 0.04686, "cell_entry": -0.02544, "ferret_sera_escape": 0.2178, "mature_H5_site": 115, "mouse_sera_escape": 0.568, "mutant": "H", "mutation": "L122H", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.117, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3065, "ferret_sera_escape": 0.1004, "mature_H5_site": 115, "mouse_sera_escape": -0.08553, "mutant": "I", "mutation": "L122I", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.2018, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.163, "ferret_sera_escape": 0.1819, "mature_H5_site": 115, "mouse_sera_escape": 0.8897, "mutant": "K", "mutation": "L122K", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.04212, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 115, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L122L", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.4457, "cell_entry": -0.4126, "ferret_sera_escape": 0.1999, "mature_H5_site": 115, "mouse_sera_escape": 0.5115, "mutant": "M", "mutation": "L122M", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": 0.01129, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3185, "ferret_sera_escape": 0.147, "mature_H5_site": 115, "mouse_sera_escape": 0.4331, "mutant": "N", "mutation": "L122N", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.3171, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.001835, "ferret_sera_escape": -0.003034, "mature_H5_site": 115, "mouse_sera_escape": 0.5701, "mutant": "P", "mutation": "L122P", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.1419, "wildtype": "L"}, {"a26_usage": 0.01632, "cell_entry": 0.07306, "ferret_sera_escape": 0.2563, "mature_H5_site": 115, "mouse_sera_escape": 0.961, "mutant": "Q", "mutation": "L122Q", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.1612, "wildtype": "L"}, {"a26_usage": 0.02365, "cell_entry": -0.01141, "ferret_sera_escape": 0.1559, "mature_H5_site": 115, "mouse_sera_escape": 0.8943, "mutant": "R", "mutation": "L122R", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.02051, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1468, "ferret_sera_escape": 0.1748, "mature_H5_site": 115, "mouse_sera_escape": 0.811, "mutant": "W", "mutation": "L122W", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": -0.1857, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4136, "ferret_sera_escape": null, "mature_H5_site": 115, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L122Y", "reference_site": "122", "region": "region-A", "sequential_site": 131, "stability": null, "wildtype": "L"}, {"a26_usage": 0.1715, "cell_entry": -0.1908, "ferret_sera_escape": 0.01131, "mature_H5_site": 116, "mouse_sera_escape": 0.04951, "mutant": "A", "mutation": "I123A", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": -0.01557, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2295, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "C", "mutation": "I123C", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "D", "mutation": "I123D", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -5.79, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "E", "mutation": "I123E", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1483, "ferret_sera_escape": -0.189, "mature_H5_site": 116, "mouse_sera_escape": -0.03222, "mutant": "F", "mutation": "I123F", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": 0.6041, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "H", "mutation": "I123H", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 116, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I123I", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "K", "mutation": "I123K", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1876, "ferret_sera_escape": -0.3222, "mature_H5_site": 116, "mouse_sera_escape": -0.046, "mutant": "L", "mutation": "I123L", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": 0.04245, "wildtype": "I"}, {"a26_usage": 0.1931, "cell_entry": -0.001085, "ferret_sera_escape": -0.1431, "mature_H5_site": 116, "mouse_sera_escape": -0.1472, "mutant": "M", "mutation": "I123M", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": 0.2061, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "N", "mutation": "I123N", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "P", "mutation": "I123P", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.28, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I123Q", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "R", "mutation": "I123R", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.579, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "S", "mutation": "I123S", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0201, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "T", "mutation": "I123T", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2315, "ferret_sera_escape": 0.05292, "mature_H5_site": 116, "mouse_sera_escape": -0.1023, "mutant": "V", "mutation": "I123V", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": -0.1174, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06524, "ferret_sera_escape": -0.3703, "mature_H5_site": 116, "mouse_sera_escape": -0.07444, "mutant": "W", "mutation": "I123W", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": 0.8999, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.534, "ferret_sera_escape": null, "mature_H5_site": 116, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I123Y", "reference_site": "123", "region": "region-A", "sequential_site": 132, "stability": null, "wildtype": "I"}, {"a26_usage": 0.254, "cell_entry": -0.06385, "ferret_sera_escape": -0.03113, "mature_H5_site": 117, "mouse_sera_escape": 0.3902, "mutant": "A", "mutation": "I124A", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.1237, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5464, "ferret_sera_escape": -0.7002, "mature_H5_site": 117, "mouse_sera_escape": -0.1467, "mutant": "D", "mutation": "I124D", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.09661, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.04497, "ferret_sera_escape": -0.2474, "mature_H5_site": 117, "mouse_sera_escape": -0.1174, "mutant": "E", "mutation": "I124E", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.2519, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5749, "ferret_sera_escape": null, "mature_H5_site": 117, "mouse_sera_escape": null, "mutant": "F", "mutation": "I124F", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1112, "ferret_sera_escape": -0.4954, "mature_H5_site": 117, "mouse_sera_escape": 0.04335, "mutant": "H", "mutation": "I124H", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.3823, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 117, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I124I", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4002, "ferret_sera_escape": -0.2841, "mature_H5_site": 117, "mouse_sera_escape": -0.1498, "mutant": "K", "mutation": "I124K", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.1667, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1626, "ferret_sera_escape": -0.08846, "mature_H5_site": 117, "mouse_sera_escape": 0.01699, "mutant": "L", "mutation": "I124L", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": 0.01976, "wildtype": "I"}, {"a26_usage": 0.1139, "cell_entry": -0.4244, "ferret_sera_escape": null, "mature_H5_site": 117, "mouse_sera_escape": null, "mutant": "M", "mutation": "I124M", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0379, "ferret_sera_escape": -0.07757, "mature_H5_site": 117, "mouse_sera_escape": 0.207, "mutant": "N", "mutation": "I124N", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.2935, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.078, "ferret_sera_escape": -0.3268, "mature_H5_site": 117, "mouse_sera_escape": -0.2583, "mutant": "Q", "mutation": "I124Q", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.1901, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2653, "ferret_sera_escape": -0.6023, "mature_H5_site": 117, "mouse_sera_escape": 0.07468, "mutant": "R", "mutation": "I124R", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.2161, "wildtype": "I"}, {"a26_usage": 0.3874, "cell_entry": -0.6515, "ferret_sera_escape": -0.1699, "mature_H5_site": 117, "mouse_sera_escape": 0.2714, "mutant": "S", "mutation": "I124S", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.3359, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.07219, "ferret_sera_escape": -0.07608, "mature_H5_site": 117, "mouse_sera_escape": 0.0531, "mutant": "T", "mutation": "I124T", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.5167, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.01622, "ferret_sera_escape": 0.07459, "mature_H5_site": 117, "mouse_sera_escape": -0.06751, "mutant": "V", "mutation": "I124V", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.1503, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.0936, "ferret_sera_escape": -0.2043, "mature_H5_site": 117, "mouse_sera_escape": 0.05597, "mutant": "W", "mutation": "I124W", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.2049, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3624, "ferret_sera_escape": -0.07182, "mature_H5_site": 117, "mouse_sera_escape": 0.3287, "mutant": "Y", "mutation": "I124Y", "reference_site": "124", "region": "region-A", "sequential_site": 133, "stability": -0.1156, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03685, "ferret_sera_escape": 0.2289, "mature_H5_site": 118, "mouse_sera_escape": 0.6024, "mutant": "A", "mutation": "P125A", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.1599, "wildtype": "P"}, {"a26_usage": 0.09871, "cell_entry": -0.0963, "ferret_sera_escape": 0.4523, "mature_H5_site": 118, "mouse_sera_escape": 0.9187, "mutant": "D", "mutation": "P125D", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.1304, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.017, "ferret_sera_escape": null, "mature_H5_site": 118, "mouse_sera_escape": null, "mutant": "F", "mutation": "P125F", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0373, "ferret_sera_escape": 0.1372, "mature_H5_site": 118, "mouse_sera_escape": 0.5845, "mutant": "G", "mutation": "P125G", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.1556, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.6355, "ferret_sera_escape": 0.4348, "mature_H5_site": 118, "mouse_sera_escape": 1.411, "mutant": "H", "mutation": "P125H", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.534, "ferret_sera_escape": null, "mature_H5_site": 118, "mouse_sera_escape": null, "mutant": "I", "mutation": "P125I", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": null, "wildtype": "P"}, {"a26_usage": 0.1725, "cell_entry": -0.3328, "ferret_sera_escape": -0.3311, "mature_H5_site": 118, "mouse_sera_escape": 1.394, "mutant": "K", "mutation": "P125K", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.2165, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.2, "ferret_sera_escape": -0.05693, "mature_H5_site": 118, "mouse_sera_escape": 0.3239, "mutant": "L", "mutation": "P125L", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.06372, "ferret_sera_escape": 0.2874, "mature_H5_site": 118, "mouse_sera_escape": 1.028, "mutant": "N", "mutation": "P125N", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.1436, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 118, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P125P", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.00216, "ferret_sera_escape": 0.2116, "mature_H5_site": 118, "mouse_sera_escape": 1.065, "mutant": "Q", "mutation": "P125Q", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.1913, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1268, "ferret_sera_escape": -0.2021, "mature_H5_site": 118, "mouse_sera_escape": 0.9755, "mutant": "R", "mutation": "P125R", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.105, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.06537, "ferret_sera_escape": 0.09184, "mature_H5_site": 118, "mouse_sera_escape": 0.2775, "mutant": "S", "mutation": "P125S", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.101, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.00919, "ferret_sera_escape": 0.1164, "mature_H5_site": 118, "mouse_sera_escape": 0.4352, "mutant": "T", "mutation": "P125T", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": -0.215, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.552, "ferret_sera_escape": null, "mature_H5_site": 118, "mouse_sera_escape": null, "mutant": "W", "mutation": "P125W", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.787, "ferret_sera_escape": 0.1235, "mature_H5_site": 118, "mouse_sera_escape": 1.302, "mutant": "Y", "mutation": "P125Y", "reference_site": "125", "region": "region-A", "sequential_site": 134, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.121, "ferret_sera_escape": -0.1366, "mature_H5_site": 119, "mouse_sera_escape": 0.2876, "mutant": "A", "mutation": "K125aA", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.0403, "ferret_sera_escape": -0.204, "mature_H5_site": 119, "mouse_sera_escape": 0.8326, "mutant": "D", "mutation": "K125aD", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.1362, "wildtype": "K"}, {"a26_usage": 1.227, "cell_entry": -0.483, "ferret_sera_escape": null, "mature_H5_site": 119, "mouse_sera_escape": null, "mutant": "E", "mutation": "K125aE", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07407, "ferret_sera_escape": -0.03902, "mature_H5_site": 119, "mouse_sera_escape": -0.1187, "mutant": "F", "mutation": "K125aF", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.5187, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.04975, "ferret_sera_escape": -0.3119, "mature_H5_site": 119, "mouse_sera_escape": 0.333, "mutant": "G", "mutation": "K125aG", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.2285, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2167, "ferret_sera_escape": -0.2056, "mature_H5_site": 119, "mouse_sera_escape": 0.4839, "mutant": "H", "mutation": "K125aH", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.1923, "wildtype": "K"}, {"a26_usage": 0.2005, "cell_entry": 0.06885, "ferret_sera_escape": -0.1094, "mature_H5_site": 119, "mouse_sera_escape": 0.1697, "mutant": "I", "mutation": "K125aI", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.3254, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 119, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K125aK", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": 0.0, "wildtype": "K"}, {"a26_usage": null, "cell_entry": -0.1789, "ferret_sera_escape": null, "mature_H5_site": 119, "mouse_sera_escape": null, "mutant": "L", "mutation": "K125aL", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2719, "ferret_sera_escape": -0.1423, "mature_H5_site": 119, "mouse_sera_escape": 0.02126, "mutant": "M", "mutation": "K125aM", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.2628, "wildtype": "K"}, {"a26_usage": 0.1586, "cell_entry": -0.00878, "ferret_sera_escape": -0.08409, "mature_H5_site": 119, "mouse_sera_escape": 0.6693, "mutant": "N", "mutation": "K125aN", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.1554, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.02823, "ferret_sera_escape": null, "mature_H5_site": 119, "mouse_sera_escape": null, "mutant": "P", "mutation": "K125aP", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.195, "ferret_sera_escape": -0.08836, "mature_H5_site": 119, "mouse_sera_escape": 0.553, "mutant": "Q", "mutation": "K125aQ", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.2573, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.06646, "ferret_sera_escape": -0.1653, "mature_H5_site": 119, "mouse_sera_escape": -0.1249, "mutant": "R", "mutation": "K125aR", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": 0.1364, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.05916, "ferret_sera_escape": -0.2238, "mature_H5_site": 119, "mouse_sera_escape": 0.2622, "mutant": "S", "mutation": "K125aS", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.1871, "wildtype": "K"}, {"a26_usage": 0.05549, "cell_entry": -0.1732, "ferret_sera_escape": -0.1383, "mature_H5_site": 119, "mouse_sera_escape": 0.2038, "mutant": "T", "mutation": "K125aT", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.1012, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2305, "ferret_sera_escape": -0.1828, "mature_H5_site": 119, "mouse_sera_escape": -0.1123, "mutant": "V", "mutation": "K125aV", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.2153, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.203, "ferret_sera_escape": null, "mature_H5_site": 119, "mouse_sera_escape": null, "mutant": "W", "mutation": "K125aW", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2351, "ferret_sera_escape": 0.1527, "mature_H5_site": 119, "mouse_sera_escape": 0.7076, "mutant": "Y", "mutation": "K125aY", "reference_site": "125a", "region": "region-A", "sequential_site": 135, "stability": -0.4131, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4078, "ferret_sera_escape": 0.07581, "mature_H5_site": 120, "mouse_sera_escape": 0.8971, "mutant": "F", "mutation": "S125bF", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": -0.05079, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.07065, "ferret_sera_escape": 5.667e-05, "mature_H5_site": 120, "mouse_sera_escape": 0.6434, "mutant": "G", "mutation": "S125bG", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": -0.05795, "wildtype": "S"}, {"a26_usage": 0.000185, "cell_entry": 0.06391, "ferret_sera_escape": 0.08749, "mature_H5_site": 120, "mouse_sera_escape": 0.9044, "mutant": "I", "mutation": "S125bI", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": -0.1314, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.758, "ferret_sera_escape": -0.07666, "mature_H5_site": 120, "mouse_sera_escape": 1.219, "mutant": "K", "mutation": "S125bK", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3458, "ferret_sera_escape": -0.09508, "mature_H5_site": 120, "mouse_sera_escape": 0.7141, "mutant": "N", "mutation": "S125bN", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": 0.01952, "wildtype": "S"}, {"a26_usage": 0.2104, "cell_entry": -0.04187, "ferret_sera_escape": 0.001856, "mature_H5_site": 120, "mouse_sera_escape": 0.9045, "mutant": "P", "mutation": "S125bP", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": -0.2673, "wildtype": "S"}, {"a26_usage": 0.02079, "cell_entry": 0.02757, "ferret_sera_escape": 0.04404, "mature_H5_site": 120, "mouse_sera_escape": 1.206, "mutant": "Q", "mutation": "S125bQ", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": -0.05291, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 120, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S125bS", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.07107, "cell_entry": -0.1137, "ferret_sera_escape": -0.06737, "mature_H5_site": 120, "mouse_sera_escape": 0.5089, "mutant": "T", "mutation": "S125bT", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": -0.0361, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.05285, "ferret_sera_escape": null, "mature_H5_site": 120, "mouse_sera_escape": null, "mutant": "V", "mutation": "S125bV", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.0615, "ferret_sera_escape": null, "mature_H5_site": 120, "mouse_sera_escape": 0.7746, "mutant": "Y", "mutation": "S125bY", "reference_site": "125b", "region": "region-A", "sequential_site": 136, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.05417, "ferret_sera_escape": 0.0866, "mature_H5_site": 121, "mouse_sera_escape": 0.19, "mutant": "D", "mutation": "S126D", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.05232, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.07494, "ferret_sera_escape": 0.3368, "mature_H5_site": 121, "mouse_sera_escape": 0.5841, "mutant": "E", "mutation": "S126E", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.05151, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06291, "ferret_sera_escape": 0.08885, "mature_H5_site": 121, "mouse_sera_escape": 0.3642, "mutant": "F", "mutation": "S126F", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.03012, "wildtype": "S"}, {"a26_usage": 0.08582, "cell_entry": 0.06282, "ferret_sera_escape": -0.1746, "mature_H5_site": 121, "mouse_sera_escape": 0.2287, "mutant": "G", "mutation": "S126G", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.03831, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.05087, "ferret_sera_escape": -0.07557, "mature_H5_site": 121, "mouse_sera_escape": 0.2583, "mutant": "H", "mutation": "S126H", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.06371, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3866, "ferret_sera_escape": 0.3727, "mature_H5_site": 121, "mouse_sera_escape": 0.3507, "mutant": "I", "mutation": "S126I", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.06115, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4674, "ferret_sera_escape": -0.2642, "mature_H5_site": 121, "mouse_sera_escape": 0.7317, "mutant": "K", "mutation": "S126K", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": 0.01934, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3151, "ferret_sera_escape": null, "mature_H5_site": 121, "mouse_sera_escape": null, "mutant": "L", "mutation": "S126L", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.00303, "ferret_sera_escape": 0.0565, "mature_H5_site": 121, "mouse_sera_escape": -0.004226, "mutant": "M", "mutation": "S126M", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": null, "wildtype": "S"}, {"a26_usage": 0.08905, "cell_entry": 0.02509, "ferret_sera_escape": 0.01257, "mature_H5_site": 121, "mouse_sera_escape": 0.02041, "mutant": "N", "mutation": "S126N", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.06699, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4463, "ferret_sera_escape": null, "mature_H5_site": 121, "mouse_sera_escape": null, "mutant": "R", "mutation": "S126R", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 121, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S126S", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4739, "ferret_sera_escape": 0.1678, "mature_H5_site": 121, "mouse_sera_escape": 0.2315, "mutant": "V", "mutation": "S126V", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.05343, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3799, "ferret_sera_escape": -0.1019, "mature_H5_site": 121, "mouse_sera_escape": 0.4745, "mutant": "W", "mutation": "S126W", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.0185, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2207, "ferret_sera_escape": 0.0804, "mature_H5_site": 121, "mouse_sera_escape": 0.1175, "mutant": "Y", "mutation": "S126Y", "reference_site": "126", "region": "region-A", "sequential_site": 137, "stability": -0.04724, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8669, "ferret_sera_escape": 0.343, "mature_H5_site": 122, "mouse_sera_escape": 0.2889, "mutant": "A", "mutation": "W127A", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.2461, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.167, "ferret_sera_escape": 0.07442, "mature_H5_site": 122, "mouse_sera_escape": 0.519, "mutant": "C", "mutation": "W127C", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.2005, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": null, "mutant": "D", "mutation": "W127D", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.117, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": null, "mutant": "E", "mutation": "W127E", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.6939, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": null, "mutant": "F", "mutation": "W127F", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": null, "mutant": "G", "mutation": "W127G", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.4655, "cell_entry": 0.03642, "ferret_sera_escape": 0.2698, "mature_H5_site": 122, "mouse_sera_escape": 0.3101, "mutant": "H", "mutation": "W127H", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.2062, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.239, "ferret_sera_escape": -0.234, "mature_H5_site": 122, "mouse_sera_escape": 0.3829, "mutant": "I", "mutation": "W127I", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": null, "mutant": "K", "mutation": "W127K", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.1673, "ferret_sera_escape": 0.2912, "mature_H5_site": 122, "mouse_sera_escape": 0.3182, "mutant": "L", "mutation": "W127L", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.06663, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.1395, "ferret_sera_escape": 0.1936, "mature_H5_site": 122, "mouse_sera_escape": 0.184, "mutant": "M", "mutation": "W127M", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.1777, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.015, "ferret_sera_escape": 0.0079, "mature_H5_site": 122, "mouse_sera_escape": 0.3223, "mutant": "N", "mutation": "W127N", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.2415, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.039, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": null, "mutant": "P", "mutation": "W127P", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.579, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": 0.1908, "mutant": "Q", "mutation": "W127Q", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.282, "ferret_sera_escape": null, "mature_H5_site": 122, "mouse_sera_escape": null, "mutant": "R", "mutation": "W127R", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.3057, "ferret_sera_escape": 0.3968, "mature_H5_site": 122, "mouse_sera_escape": 0.2609, "mutant": "T", "mutation": "W127T", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.2593, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.2977, "ferret_sera_escape": 0.2686, "mature_H5_site": 122, "mouse_sera_escape": 0.3631, "mutant": "V", "mutation": "W127V", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.2031, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 122, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W127W", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.3755, "ferret_sera_escape": 0.5472, "mature_H5_site": 122, "mouse_sera_escape": 0.4295, "mutant": "Y", "mutation": "W127Y", "reference_site": "127", "region": "region-A", "sequential_site": 138, "stability": -0.1921, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.02553, "ferret_sera_escape": 0.01173, "mature_H5_site": 123, "mouse_sera_escape": 0.6237, "mutant": "A", "mutation": "P128A", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.06517, "ferret_sera_escape": null, "mature_H5_site": 123, "mouse_sera_escape": null, "mutant": "E", "mutation": "P128E", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.00625, "ferret_sera_escape": -0.2797, "mature_H5_site": 123, "mouse_sera_escape": 1.278, "mutant": "F", "mutation": "P128F", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": -0.03386, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.08099, "ferret_sera_escape": null, "mature_H5_site": 123, "mouse_sera_escape": null, "mutant": "G", "mutation": "P128G", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.03691, "ferret_sera_escape": 0.2743, "mature_H5_site": 123, "mouse_sera_escape": 1.219, "mutant": "H", "mutation": "P128H", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.02449, "wildtype": "P"}, {"a26_usage": 0.1639, "cell_entry": -0.02573, "ferret_sera_escape": -0.2017, "mature_H5_site": 123, "mouse_sera_escape": 1.184, "mutant": "I", "mutation": "P128I", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.4396, "ferret_sera_escape": 0.7022, "mature_H5_site": 123, "mouse_sera_escape": 1.538, "mutant": "K", "mutation": "P128K", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.04622, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.04475, "ferret_sera_escape": 0.2164, "mature_H5_site": 123, "mouse_sera_escape": 1.296, "mutant": "L", "mutation": "P128L", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": -0.02326, "wildtype": "P"}, {"a26_usage": null, "cell_entry": -0.03148, "ferret_sera_escape": null, "mature_H5_site": 123, "mouse_sera_escape": null, "mutant": "M", "mutation": "P128M", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.05714, "ferret_sera_escape": 0.9279, "mature_H5_site": 123, "mouse_sera_escape": 1.277, "mutant": "N", "mutation": "P128N", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.01802, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 123, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P128P", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.04128, "ferret_sera_escape": 0.816, "mature_H5_site": 123, "mouse_sera_escape": 0.9657, "mutant": "Q", "mutation": "P128Q", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.003147, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.006287, "ferret_sera_escape": 0.607, "mature_H5_site": 123, "mouse_sera_escape": 1.189, "mutant": "R", "mutation": "P128R", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.06397, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.07457, "ferret_sera_escape": 0.8335, "mature_H5_site": 123, "mouse_sera_escape": 0.8574, "mutant": "S", "mutation": "P128S", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": -0.1354, "wildtype": "P"}, {"a26_usage": 0.1089, "cell_entry": -0.449, "ferret_sera_escape": 0.9565, "mature_H5_site": 123, "mouse_sera_escape": 0.7175, "mutant": "T", "mutation": "P128T", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.06416, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.05711, "ferret_sera_escape": -0.7166, "mature_H5_site": 123, "mouse_sera_escape": 0.1646, "mutant": "V", "mutation": "P128V", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": 0.0663, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.08738, "ferret_sera_escape": -0.4155, "mature_H5_site": 123, "mouse_sera_escape": 1.143, "mutant": "Y", "mutation": "P128Y", "reference_site": "128", "region": "region-A", "sequential_site": 139, "stability": -0.02983, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.06982, "ferret_sera_escape": 1.102, "mature_H5_site": 124, "mouse_sera_escape": -0.2681, "mutant": "A", "mutation": "N129A", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": 0.003855, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.308, "ferret_sera_escape": null, "mature_H5_site": 124, "mouse_sera_escape": null, "mutant": "C", "mutation": "N129C", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1366, "ferret_sera_escape": 0.9875, "mature_H5_site": 124, "mouse_sera_escape": 0.41, "mutant": "E", "mutation": "N129E", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.0122, "wildtype": "N"}, {"a26_usage": 0.05192, "cell_entry": 0.07839, "ferret_sera_escape": 1.167, "mature_H5_site": 124, "mouse_sera_escape": 0.4335, "mutant": "G", "mutation": "N129G", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.02339, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07043, "ferret_sera_escape": 0.8285, "mature_H5_site": 124, "mouse_sera_escape": 0.4412, "mutant": "H", "mutation": "N129H", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.005448, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4981, "ferret_sera_escape": 1.018, "mature_H5_site": 124, "mouse_sera_escape": 0.3866, "mutant": "I", "mutation": "N129I", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.05773, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3603, "ferret_sera_escape": 1.368, "mature_H5_site": 124, "mouse_sera_escape": 0.6455, "mutant": "K", "mutation": "N129K", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.01055, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04486, "ferret_sera_escape": null, "mature_H5_site": 124, "mouse_sera_escape": null, "mutant": "L", "mutation": "N129L", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.0653, "ferret_sera_escape": 1.266, "mature_H5_site": 124, "mouse_sera_escape": 0.5631, "mutant": "M", "mutation": "N129M", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.007489, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 124, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N129N", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.088, "ferret_sera_escape": null, "mature_H5_site": 124, "mouse_sera_escape": null, "mutant": "P", "mutation": "N129P", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": null, "wildtype": "N"}, {"a26_usage": 0.1108, "cell_entry": -0.0363, "ferret_sera_escape": 0.9402, "mature_H5_site": 124, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N129Q", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": 0.006959, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2513, "ferret_sera_escape": 1.578, "mature_H5_site": 124, "mouse_sera_escape": 0.4452, "mutant": "R", "mutation": "N129R", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.0303, "wildtype": "N"}, {"a26_usage": 0.07468, "cell_entry": -0.1108, "ferret_sera_escape": 0.6417, "mature_H5_site": 124, "mouse_sera_escape": 0.2788, "mutant": "S", "mutation": "N129S", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.00207, "wildtype": "N"}, {"a26_usage": 0.03903, "cell_entry": 0.05205, "ferret_sera_escape": 1.215, "mature_H5_site": 124, "mouse_sera_escape": 0.5505, "mutant": "T", "mutation": "N129T", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.07662, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1836, "ferret_sera_escape": null, "mature_H5_site": 124, "mouse_sera_escape": null, "mutant": "W", "mutation": "N129W", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3927, "ferret_sera_escape": 1.523, "mature_H5_site": 124, "mouse_sera_escape": 0.617, "mutant": "Y", "mutation": "N129Y", "reference_site": "129", "region": "region-A", "sequential_site": 140, "stability": -0.01772, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "A", "mutation": "I13A", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.24, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "C", "mutation": "I13C", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "D", "mutation": "I13D", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "E", "mutation": "I13E", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.8341, "ferret_sera_escape": 0.1258, "mature_H5_site": 3, "mouse_sera_escape": 0.2332, "mutant": "F", "mutation": "I13F", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": -0.02318, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "G", "mutation": "I13G", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "H", "mutation": "I13H", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 3, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I13I", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.05027, "ferret_sera_escape": -0.03876, "mature_H5_site": 3, "mouse_sera_escape": -0.01954, "mutant": "L", "mutation": "I13L", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": 0.02535, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3934, "ferret_sera_escape": 0.005483, "mature_H5_site": 3, "mouse_sera_escape": 0.04868, "mutant": "M", "mutation": "I13M", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": 0.1987, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.006, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "N", "mutation": "I13N", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.532, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "P", "mutation": "I13P", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.836, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "R", "mutation": "I13R", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.012, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "S", "mutation": "I13S", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "T", "mutation": "I13T", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.8262, "ferret_sera_escape": 0.002215, "mature_H5_site": 3, "mouse_sera_escape": 0.02671, "mutant": "V", "mutation": "I13V", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": -0.06094, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "W", "mutation": "I13W", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.773, "ferret_sera_escape": null, "mature_H5_site": 3, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I13Y", "reference_site": "13", "region": "HA1", "sequential_site": 19, "stability": null, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -5.867, "ferret_sera_escape": null, "mature_H5_site": 125, "mouse_sera_escape": null, "mutant": "C", "mutation": "H130C", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1142, "ferret_sera_escape": 0.4988, "mature_H5_site": 125, "mouse_sera_escape": 0.4202, "mutant": "F", "mutation": "H130F", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": -0.24, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 125, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H130H", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4864, "ferret_sera_escape": 1.023, "mature_H5_site": 125, "mouse_sera_escape": 0.7472, "mutant": "I", "mutation": "H130I", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.739, "ferret_sera_escape": null, "mature_H5_site": 125, "mouse_sera_escape": null, "mutant": "K", "mutation": "H130K", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0569, "ferret_sera_escape": 0.6617, "mature_H5_site": 125, "mouse_sera_escape": 0.5717, "mutant": "L", "mutation": "H130L", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": -0.1888, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.583, "ferret_sera_escape": null, "mature_H5_site": 125, "mouse_sera_escape": null, "mutant": "N", "mutation": "H130N", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 125, "mouse_sera_escape": null, "mutant": "P", "mutation": "H130P", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.07983, "ferret_sera_escape": 0.1071, "mature_H5_site": 125, "mouse_sera_escape": 0.1426, "mutant": "Q", "mutation": "H130Q", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": -0.09587, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.698, "ferret_sera_escape": null, "mature_H5_site": 125, "mouse_sera_escape": null, "mutant": "S", "mutation": "H130S", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.966, "ferret_sera_escape": 1.329, "mature_H5_site": 125, "mouse_sera_escape": 1.159, "mutant": "T", "mutation": "H130T", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.488, "ferret_sera_escape": -0.0762, "mature_H5_site": 125, "mouse_sera_escape": 0.02141, "mutant": "W", "mutation": "H130W", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": 0.2098, "wildtype": "H"}, {"a26_usage": 0.1372, "cell_entry": 0.00101, "ferret_sera_escape": 0.0543, "mature_H5_site": 125, "mouse_sera_escape": 0.1582, "mutant": "Y", "mutation": "H130Y", "reference_site": "130", "region": "region-A", "sequential_site": 141, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.02402, "ferret_sera_escape": 0.6059, "mature_H5_site": 126, "mouse_sera_escape": 0.1227, "mutant": "A", "mutation": "E131A", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": -0.07321, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01229, "ferret_sera_escape": null, "mature_H5_site": 126, "mouse_sera_escape": null, "mutant": "C", "mutation": "E131C", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.06798, "ferret_sera_escape": -0.01182, "mature_H5_site": 126, "mouse_sera_escape": 0.5242, "mutant": "D", "mutation": "E131D", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 126, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E131E", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1736, "ferret_sera_escape": 0.6612, "mature_H5_site": 126, "mouse_sera_escape": 0.4638, "mutant": "F", "mutation": "E131F", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": -0.1464, "wildtype": "E"}, {"a26_usage": 0.4801, "cell_entry": -0.1622, "ferret_sera_escape": 0.869, "mature_H5_site": 126, "mouse_sera_escape": 0.6954, "mutant": "I", "mutation": "E131I", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": -0.8429, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5302, "ferret_sera_escape": 0.916, "mature_H5_site": 126, "mouse_sera_escape": 0.6261, "mutant": "K", "mutation": "E131K", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.943, "ferret_sera_escape": 0.2028, "mature_H5_site": 126, "mouse_sera_escape": 0.666, "mutant": "M", "mutation": "E131M", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0582, "ferret_sera_escape": 0.4527, "mature_H5_site": 126, "mouse_sera_escape": 1.124, "mutant": "N", "mutation": "E131N", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": -0.1746, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 126, "mouse_sera_escape": null, "mutant": "P", "mutation": "E131P", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4504, "ferret_sera_escape": 0.6634, "mature_H5_site": 126, "mouse_sera_escape": 0.5919, "mutant": "R", "mutation": "E131R", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": -0.06238, "wildtype": "E"}, {"a26_usage": 0.01043, "cell_entry": 0.0516, "ferret_sera_escape": 0.957, "mature_H5_site": 126, "mouse_sera_escape": 0.492, "mutant": "S", "mutation": "E131S", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": -0.06959, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.091, "ferret_sera_escape": 0.7882, "mature_H5_site": 126, "mouse_sera_escape": 0.7847, "mutant": "V", "mutation": "E131V", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.428, "ferret_sera_escape": 0.6129, "mature_H5_site": 126, "mouse_sera_escape": 0.6244, "mutant": "W", "mutation": "E131W", "reference_site": "131", "region": "region-A", "sequential_site": 142, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02217, "ferret_sera_escape": 0.3459, "mature_H5_site": 127, "mouse_sera_escape": 0.552, "mutant": "C", "mutation": "T132C", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.07873, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1347, "ferret_sera_escape": null, "mature_H5_site": 127, "mouse_sera_escape": null, "mutant": "E", "mutation": "T132E", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.09249, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7645, "ferret_sera_escape": 1.05, "mature_H5_site": 127, "mouse_sera_escape": 1.454, "mutant": "F", "mutation": "T132F", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": 0.07662, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.06669, "ferret_sera_escape": -0.3133, "mature_H5_site": 127, "mouse_sera_escape": 0.102, "mutant": "G", "mutation": "T132G", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.1468, "wildtype": "T"}, {"a26_usage": null, "cell_entry": -0.6061, "ferret_sera_escape": -0.08519, "mature_H5_site": 127, "mouse_sera_escape": 0.6161, "mutant": "H", "mutation": "T132H", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": null, "wildtype": "T"}, {"a26_usage": 0.1305, "cell_entry": -0.5881, "ferret_sera_escape": -0.01622, "mature_H5_site": 127, "mouse_sera_escape": 0.3317, "mutant": "I", "mutation": "T132I", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.1278, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1391, "ferret_sera_escape": -0.4659, "mature_H5_site": 127, "mouse_sera_escape": 1.114, "mutant": "K", "mutation": "T132K", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.09532, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.523, "ferret_sera_escape": null, "mature_H5_site": 127, "mouse_sera_escape": null, "mutant": "L", "mutation": "T132L", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.1323, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.00575, "ferret_sera_escape": -0.1473, "mature_H5_site": 127, "mouse_sera_escape": 0.1987, "mutant": "M", "mutation": "T132M", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.07034, "wildtype": "T"}, {"a26_usage": 0.5283, "cell_entry": -0.2738, "ferret_sera_escape": 0.0702, "mature_H5_site": 127, "mouse_sera_escape": 0.4626, "mutant": "N", "mutation": "T132N", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.07079, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3375, "ferret_sera_escape": -0.3185, "mature_H5_site": 127, "mouse_sera_escape": 0.1895, "mutant": "Q", "mutation": "T132Q", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.07467, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.08433, "ferret_sera_escape": -0.495, "mature_H5_site": 127, "mouse_sera_escape": 0.7781, "mutant": "R", "mutation": "T132R", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.1442, "wildtype": "T"}, {"a26_usage": 0.08259, "cell_entry": 0.01629, "ferret_sera_escape": 0.007933, "mature_H5_site": 127, "mouse_sera_escape": 0.1018, "mutant": "S", "mutation": "T132S", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.02971, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 127, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T132T", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1557, "ferret_sera_escape": 0.1522, "mature_H5_site": 127, "mouse_sera_escape": 0.1794, "mutant": "V", "mutation": "T132V", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": -0.006991, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1217, "ferret_sera_escape": -0.0455, "mature_H5_site": 127, "mouse_sera_escape": 1.041, "mutant": "W", "mutation": "T132W", "reference_site": "132", "region": "region-A", "sequential_site": 143, "stability": 0.02423, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1384, "ferret_sera_escape": -0.06157, "mature_H5_site": 128, "mouse_sera_escape": -0.2062, "mutant": "A", "mutation": "S133A", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.607, "ferret_sera_escape": null, "mature_H5_site": 128, "mouse_sera_escape": null, "mutant": "C", "mutation": "S133C", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": null, "wildtype": "S"}, {"a26_usage": 0.02568, "cell_entry": 0.06721, "ferret_sera_escape": -0.2533, "mature_H5_site": 128, "mouse_sera_escape": 0.2003, "mutant": "E", "mutation": "S133E", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": -0.06509, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.7262, "ferret_sera_escape": -0.2032, "mature_H5_site": 128, "mouse_sera_escape": 0.3111, "mutant": "G", "mutation": "S133G", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": 0.04624, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0365, "ferret_sera_escape": -0.02124, "mature_H5_site": 128, "mouse_sera_escape": -0.04567, "mutant": "H", "mutation": "S133H", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": -0.02982, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1876, "ferret_sera_escape": 0.2534, "mature_H5_site": 128, "mouse_sera_escape": -0.1883, "mutant": "I", "mutation": "S133I", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": -0.1216, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.01511, "ferret_sera_escape": 0.1206, "mature_H5_site": 128, "mouse_sera_escape": 0.7881, "mutant": "K", "mutation": "S133K", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": 0.005723, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.7413, "ferret_sera_escape": null, "mature_H5_site": 128, "mouse_sera_escape": null, "mutant": "M", "mutation": "S133M", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4726, "ferret_sera_escape": 0.02881, "mature_H5_site": 128, "mouse_sera_escape": 0.1795, "mutant": "N", "mutation": "S133N", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": 0.04195, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6122, "ferret_sera_escape": null, "mature_H5_site": 128, "mouse_sera_escape": null, "mutant": "P", "mutation": "S133P", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2461, "ferret_sera_escape": -0.07761, "mature_H5_site": 128, "mouse_sera_escape": 0.0685, "mutant": "Q", "mutation": "S133Q", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": null, "wildtype": "S"}, {"a26_usage": 0.5069, "cell_entry": -0.4765, "ferret_sera_escape": 0.001833, "mature_H5_site": 128, "mouse_sera_escape": 0.5465, "mutant": "R", "mutation": "S133R", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": -0.01084, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 128, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S133S", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0368, "ferret_sera_escape": 0.05302, "mature_H5_site": 128, "mouse_sera_escape": -0.01929, "mutant": "T", "mutation": "S133T", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": 0.01161, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.09649, "ferret_sera_escape": -0.3805, "mature_H5_site": 128, "mouse_sera_escape": -0.2654, "mutant": "Y", "mutation": "S133Y", "reference_site": "133", "region": "region-A", "sequential_site": 144, "stability": -0.06671, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.07979, "ferret_sera_escape": null, "mature_H5_site": 129, "mouse_sera_escape": null, "mutant": "A", "mutation": "L133aA", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.004685, "ferret_sera_escape": -0.02039, "mature_H5_site": 129, "mouse_sera_escape": 0.1093, "mutant": "C", "mutation": "L133aC", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1198, "ferret_sera_escape": -0.4148, "mature_H5_site": 129, "mouse_sera_escape": 0.001553, "mutant": "D", "mutation": "L133aD", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.1118, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.03465, "ferret_sera_escape": -0.6003, "mature_H5_site": 129, "mouse_sera_escape": -0.3156, "mutant": "E", "mutation": "L133aE", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.1547, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.57, "ferret_sera_escape": -0.1945, "mature_H5_site": 129, "mouse_sera_escape": -0.04586, "mutant": "F", "mutation": "L133aF", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.069, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1576, "ferret_sera_escape": -0.365, "mature_H5_site": 129, "mouse_sera_escape": -0.0976, "mutant": "G", "mutation": "L133aG", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.07034, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.03911, "ferret_sera_escape": 0.1167, "mature_H5_site": 129, "mouse_sera_escape": 0.4647, "mutant": "H", "mutation": "L133aH", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.05335, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.592, "ferret_sera_escape": null, "mature_H5_site": 129, "mouse_sera_escape": null, "mutant": "I", "mutation": "L133aI", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": null, "wildtype": "L"}, {"a26_usage": 0.8524, "cell_entry": -0.42, "ferret_sera_escape": 0.6561, "mature_H5_site": 129, "mouse_sera_escape": 0.5582, "mutant": "K", "mutation": "L133aK", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": 0.008684, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 129, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L133aL", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.09832, "ferret_sera_escape": -0.09323, "mature_H5_site": 129, "mouse_sera_escape": -0.2441, "mutant": "M", "mutation": "L133aM", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.03474, "wildtype": "L"}, {"a26_usage": 0.07267, "cell_entry": 0.02306, "ferret_sera_escape": 0.1135, "mature_H5_site": 129, "mouse_sera_escape": 0.2949, "mutant": "N", "mutation": "L133aN", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.03652, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.02408, "ferret_sera_escape": -0.2238, "mature_H5_site": 129, "mouse_sera_escape": 0.1119, "mutant": "P", "mutation": "L133aP", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.234, "ferret_sera_escape": 0.01676, "mature_H5_site": 129, "mouse_sera_escape": -0.04361, "mutant": "Q", "mutation": "L133aQ", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.05244, "wildtype": "L"}, {"a26_usage": 0.9525, "cell_entry": -0.5591, "ferret_sera_escape": 0.6532, "mature_H5_site": 129, "mouse_sera_escape": 0.6239, "mutant": "R", "mutation": "L133aR", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": 0.03741, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.795, "ferret_sera_escape": 0.3944, "mature_H5_site": 129, "mouse_sera_escape": 0.2457, "mutant": "S", "mutation": "L133aS", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.07976, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.07417, "ferret_sera_escape": 0.09999, "mature_H5_site": 129, "mouse_sera_escape": -0.1208, "mutant": "T", "mutation": "L133aT", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1648, "ferret_sera_escape": 0.3799, "mature_H5_site": 129, "mouse_sera_escape": 0.2852, "mutant": "V", "mutation": "L133aV", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.1296, "wildtype": "L"}, {"a26_usage": 0.08923, "cell_entry": -0.2945, "ferret_sera_escape": -0.03549, "mature_H5_site": 129, "mouse_sera_escape": 0.2445, "mutant": "W", "mutation": "L133aW", "reference_site": "133a", "region": "region-A", "sequential_site": 145, "stability": -0.02372, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.06, "ferret_sera_escape": -1.285, "mature_H5_site": 130, "mouse_sera_escape": -0.8322, "mutant": "A", "mutation": "G134A", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.987, "ferret_sera_escape": -0.1479, "mature_H5_site": 130, "mouse_sera_escape": 0.03293, "mutant": "C", "mutation": "G134C", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.962, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "D", "mutation": "G134D", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": null, "cell_entry": -5.727, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "E", "mutation": "G134E", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 130, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G134G", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.961, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "I", "mutation": "G134I", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.532, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "K", "mutation": "G134K", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.629, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "L", "mutation": "G134L", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.426, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "M", "mutation": "G134M", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.615, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "N", "mutation": "G134N", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7594, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "P", "mutation": "G134P", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.326, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G134Q", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "R", "mutation": "G134R", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.0477, "ferret_sera_escape": -1.17, "mature_H5_site": 130, "mouse_sera_escape": -0.7928, "mutant": "S", "mutation": "G134S", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": -0.22, "wildtype": "G"}, {"a26_usage": null, "cell_entry": -0.5085, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "T", "mutation": "G134T", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.835, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "W", "mutation": "G134W", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 130, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G134Y", "reference_site": "134", "region": "region-A", "sequential_site": 146, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0584, "ferret_sera_escape": -0.5081, "mature_H5_site": 131, "mouse_sera_escape": -0.6231, "mutant": "A", "mutation": "V135A", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.1256, "wildtype": "V"}, {"a26_usage": null, "cell_entry": -1.205, "ferret_sera_escape": null, "mature_H5_site": 131, "mouse_sera_escape": null, "mutant": "C", "mutation": "V135C", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1314, "ferret_sera_escape": -1.485, "mature_H5_site": 131, "mouse_sera_escape": -0.5943, "mutant": "D", "mutation": "V135D", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.1692, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.06537, "ferret_sera_escape": -0.6731, "mature_H5_site": 131, "mouse_sera_escape": -0.4901, "mutant": "E", "mutation": "V135E", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.326, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1621, "ferret_sera_escape": 0.1191, "mature_H5_site": 131, "mouse_sera_escape": -0.2342, "mutant": "F", "mutation": "V135F", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.03415, "wildtype": "V"}, {"a26_usage": 0.2292, "cell_entry": -0.1416, "ferret_sera_escape": 0.03765, "mature_H5_site": 131, "mouse_sera_escape": -0.03884, "mutant": "H", "mutation": "V135H", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.04178, "wildtype": "V"}, {"a26_usage": 0.03239, "cell_entry": 0.03009, "ferret_sera_escape": -0.3866, "mature_H5_site": 131, "mouse_sera_escape": -0.1185, "mutant": "I", "mutation": "V135I", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.01074, "wildtype": "V"}, {"a26_usage": null, "cell_entry": 0.01782, "ferret_sera_escape": -0.5726, "mature_H5_site": 131, "mouse_sera_escape": -0.6087, "mutant": "L", "mutation": "V135L", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.19, "ferret_sera_escape": -0.7412, "mature_H5_site": 131, "mouse_sera_escape": -0.8161, "mutant": "M", "mutation": "V135M", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.1683, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3763, "ferret_sera_escape": -0.1428, "mature_H5_site": 131, "mouse_sera_escape": -0.2637, "mutant": "N", "mutation": "V135N", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.07567, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.556, "ferret_sera_escape": null, "mature_H5_site": 131, "mouse_sera_escape": null, "mutant": "P", "mutation": "V135P", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0399, "cell_entry": -0.1167, "ferret_sera_escape": -0.6013, "mature_H5_site": 131, "mouse_sera_escape": -0.6525, "mutant": "Q", "mutation": "V135Q", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.1654, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1407, "ferret_sera_escape": null, "mature_H5_site": 131, "mouse_sera_escape": null, "mutant": "R", "mutation": "V135R", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.06751, "ferret_sera_escape": 0.05116, "mature_H5_site": 131, "mouse_sera_escape": -0.03117, "mutant": "T", "mutation": "V135T", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.08419, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 131, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V135V", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7648, "ferret_sera_escape": 0.1078, "mature_H5_site": 131, "mouse_sera_escape": -0.3941, "mutant": "W", "mutation": "V135W", "reference_site": "135", "region": "region-A", "sequential_site": 147, "stability": -0.0579, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.121, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "F", "mutation": "S136F", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.234, "ferret_sera_escape": -0.5063, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "G", "mutation": "S136G", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.538, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "H", "mutation": "S136H", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.692, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "I", "mutation": "S136I", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.44, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "K", "mutation": "S136K", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.724, "ferret_sera_escape": -0.6853, "mature_H5_site": 132, "mouse_sera_escape": 0.06785, "mutant": "L", "mutation": "S136L", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": 0.1276, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.074, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "N", "mutation": "S136N", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.934, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "P", "mutation": "S136P", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.692, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "R", "mutation": "S136R", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 132, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S136S", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": 0.0, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -0.4091, "ferret_sera_escape": -1.005, "mature_H5_site": 132, "mouse_sera_escape": -0.7437, "mutant": "T", "mutation": "S136T", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.646, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "V", "mutation": "S136V", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.967, "ferret_sera_escape": -0.1901, "mature_H5_site": 132, "mouse_sera_escape": 0.03639, "mutant": "W", "mutation": "S136W", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.412, "ferret_sera_escape": null, "mature_H5_site": 132, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S136Y", "reference_site": "136", "region": "region-A", "sequential_site": 148, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 133, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A137A", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.06001, "ferret_sera_escape": -0.6195, "mature_H5_site": 133, "mouse_sera_escape": -0.2885, "mutant": "C", "mutation": "A137C", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.2137, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4466, "ferret_sera_escape": -1.254, "mature_H5_site": 133, "mouse_sera_escape": null, "mutant": "D", "mutation": "A137D", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.1919, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7334, "ferret_sera_escape": -1.306, "mature_H5_site": 133, "mouse_sera_escape": -0.7148, "mutant": "E", "mutation": "A137E", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.2919, "wildtype": "A"}, {"a26_usage": 0.08923, "cell_entry": -0.04292, "ferret_sera_escape": -0.9273, "mature_H5_site": 133, "mouse_sera_escape": -0.7063, "mutant": "F", "mutation": "A137F", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.2004, "wildtype": "A"}, {"a26_usage": 0.05625, "cell_entry": 0.04366, "ferret_sera_escape": null, "mature_H5_site": 133, "mouse_sera_escape": null, "mutant": "G", "mutation": "A137G", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2374, "ferret_sera_escape": null, "mature_H5_site": 133, "mouse_sera_escape": null, "mutant": "H", "mutation": "A137H", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.04, "ferret_sera_escape": null, "mature_H5_site": 133, "mouse_sera_escape": null, "mutant": "I", "mutation": "A137I", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": null, "wildtype": "A"}, {"a26_usage": 0.5059, "cell_entry": -0.5479, "ferret_sera_escape": -0.4655, "mature_H5_site": 133, "mouse_sera_escape": -0.3315, "mutant": "K", "mutation": "A137K", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.07949, "wildtype": "A"}, {"a26_usage": 0.07783, "cell_entry": 0.05262, "ferret_sera_escape": -1.642, "mature_H5_site": 133, "mouse_sera_escape": -1.076, "mutant": "L", "mutation": "A137L", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.1886, "wildtype": "A"}, {"a26_usage": 0.007461, "cell_entry": 0.04101, "ferret_sera_escape": -0.6409, "mature_H5_site": 133, "mouse_sera_escape": -0.4938, "mutant": "M", "mutation": "A137M", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.04891, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.425, "ferret_sera_escape": -0.4842, "mature_H5_site": 133, "mouse_sera_escape": -0.2588, "mutant": "R", "mutation": "A137R", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.09275, "wildtype": "A"}, {"a26_usage": 0.2372, "cell_entry": -0.02125, "ferret_sera_escape": -1.183, "mature_H5_site": 133, "mouse_sera_escape": -0.7764, "mutant": "S", "mutation": "A137S", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.04579, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1539, "ferret_sera_escape": -1.478, "mature_H5_site": 133, "mouse_sera_escape": -0.8343, "mutant": "T", "mutation": "A137T", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.4922, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4816, "ferret_sera_escape": -1.022, "mature_H5_site": 133, "mouse_sera_escape": -0.5071, "mutant": "V", "mutation": "A137V", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.2293, "wildtype": "A"}, {"a26_usage": 0.9008, "cell_entry": -0.06102, "ferret_sera_escape": -1.345, "mature_H5_site": 133, "mouse_sera_escape": -0.8399, "mutant": "W", "mutation": "A137W", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": -0.1529, "wildtype": "A"}, {"a26_usage": null, "cell_entry": -0.7313, "ferret_sera_escape": -0.863, "mature_H5_site": 133, "mouse_sera_escape": -0.5607, "mutant": "Y", "mutation": "A137Y", "reference_site": "137", "region": "region-A", "sequential_site": 149, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 134, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A138A", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.475, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "C", "mutation": "A138C", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.587, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "D", "mutation": "A138D", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.079, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "E", "mutation": "A138E", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.225, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "G", "mutation": "A138G", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.681, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "H", "mutation": "A138H", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.296, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "I", "mutation": "A138I", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.702, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "K", "mutation": "A138K", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.53, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "M", "mutation": "A138M", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 2.474, "cell_entry": -2.856, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "N", "mutation": "A138N", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.413, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "P", "mutation": "A138P", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.236, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "R", "mutation": "A138R", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.07815, "cell_entry": 0.04583, "ferret_sera_escape": -1.234, "mature_H5_site": 134, "mouse_sera_escape": -0.8255, "mutant": "S", "mutation": "A138S", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": -0.03432, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1186, "ferret_sera_escape": -1.35, "mature_H5_site": 134, "mouse_sera_escape": -0.8478, "mutant": "T", "mutation": "A138T", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": -0.3418, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.014, "ferret_sera_escape": -1.1, "mature_H5_site": 134, "mouse_sera_escape": -0.475, "mutant": "V", "mutation": "A138V", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": -0.2705, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.821, "ferret_sera_escape": null, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "W", "mutation": "A138W", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.502, "ferret_sera_escape": -1.274, "mature_H5_site": 134, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A138Y", "reference_site": "138", "region": "region-A", "sequential_site": 150, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "A", "mutation": "C139A", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 135, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C139C", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.95, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "E", "mutation": "C139E", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "F", "mutation": "C139F", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.101, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "G", "mutation": "C139G", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -1.57, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "I", "mutation": "C139I", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.252, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "K", "mutation": "C139K", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.501, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "M", "mutation": "C139M", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.25, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "N", "mutation": "C139N", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.381, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "P", "mutation": "C139P", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.213, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "R", "mutation": "C139R", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.654, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "S", "mutation": "C139S", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.233, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "T", "mutation": "C139T", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.816, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "V", "mutation": "C139V", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.853, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "W", "mutation": "C139W", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.783, "ferret_sera_escape": null, "mature_H5_site": 135, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C139Y", "reference_site": "139", "region": "region-A", "sequential_site": 151, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 4, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C14C", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "D", "mutation": "C14D", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.024, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "E", "mutation": "C14E", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.684, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "F", "mutation": "C14F", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.719, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "G", "mutation": "C14G", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "H", "mutation": "C14H", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "I", "mutation": "C14I", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.675, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "K", "mutation": "C14K", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "L", "mutation": "C14L", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "M", "mutation": "C14M", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "N", "mutation": "C14N", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "P", "mutation": "C14P", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C14Q", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "R", "mutation": "C14R", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "S", "mutation": "C14S", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.058, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "T", "mutation": "C14T", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.735, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "V", "mutation": "C14V", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.652, "ferret_sera_escape": null, "mature_H5_site": 4, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C14Y", "reference_site": "14", "region": "HA1", "sequential_site": 20, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.2006, "ferret_sera_escape": null, "mature_H5_site": 136, "mouse_sera_escape": null, "mutant": "A", "mutation": "P140A", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.03188, "ferret_sera_escape": 0.1351, "mature_H5_site": 136, "mouse_sera_escape": -0.0009999, "mutant": "C", "mutation": "P140C", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.1304, "wildtype": "P"}, {"a26_usage": 0.122, "cell_entry": 0.009375, "ferret_sera_escape": -0.1594, "mature_H5_site": 136, "mouse_sera_escape": -0.2222, "mutant": "D", "mutation": "P140D", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.2477, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.2311, "ferret_sera_escape": null, "mature_H5_site": 136, "mouse_sera_escape": null, "mutant": "E", "mutation": "P140E", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.07475, "ferret_sera_escape": 0.2266, "mature_H5_site": 136, "mouse_sera_escape": 0.1248, "mutant": "F", "mutation": "P140F", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.006862, "wildtype": "P"}, {"a26_usage": 0.00538, "cell_entry": 0.06391, "ferret_sera_escape": -0.1248, "mature_H5_site": 136, "mouse_sera_escape": -0.08466, "mutant": "H", "mutation": "P140H", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.4241, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.0757, "ferret_sera_escape": 0.04189, "mature_H5_site": 136, "mouse_sera_escape": -0.01616, "mutant": "K", "mutation": "P140K", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.0664, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3775, "ferret_sera_escape": 0.2673, "mature_H5_site": 136, "mouse_sera_escape": 0.06134, "mutant": "L", "mutation": "P140L", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": 0.01035, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3911, "ferret_sera_escape": 0.06328, "mature_H5_site": 136, "mouse_sera_escape": -0.06081, "mutant": "M", "mutation": "P140M", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.01856, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.4926, "ferret_sera_escape": 0.05744, "mature_H5_site": 136, "mouse_sera_escape": -0.01702, "mutant": "N", "mutation": "P140N", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.09801, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 136, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P140P", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.09645, "ferret_sera_escape": null, "mature_H5_site": 136, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P140Q", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.02771, "ferret_sera_escape": 0.0359, "mature_H5_site": 136, "mouse_sera_escape": -0.1546, "mutant": "R", "mutation": "P140R", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.006545, "wildtype": "P"}, {"a26_usage": 0.2352, "cell_entry": 0.01783, "ferret_sera_escape": 0.1136, "mature_H5_site": 136, "mouse_sera_escape": 0.1258, "mutant": "S", "mutation": "P140S", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": 0.005422, "wildtype": "P"}, {"a26_usage": 0.1185, "cell_entry": -0.1215, "ferret_sera_escape": 0.1418, "mature_H5_site": 136, "mouse_sera_escape": -0.0442, "mutant": "T", "mutation": "P140T", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": -0.04083, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.158, "ferret_sera_escape": -0.03974, "mature_H5_site": 136, "mouse_sera_escape": -0.1382, "mutant": "V", "mutation": "P140V", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": 0.01869, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.423, "ferret_sera_escape": 0.3317, "mature_H5_site": 136, "mouse_sera_escape": null, "mutant": "W", "mutation": "P140W", "reference_site": "140", "region": "region-A", "sequential_site": 152, "stability": null, "wildtype": "P"}, {"a26_usage": 0.06292, "cell_entry": 0.05672, "ferret_sera_escape": -0.1593, "mature_H5_site": 137, "mouse_sera_escape": 0.02171, "mutant": "A", "mutation": "Y141A", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.1461, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.19, "ferret_sera_escape": 0.04533, "mature_H5_site": 137, "mouse_sera_escape": 0.2166, "mutant": "C", "mutation": "Y141C", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.04012, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.05149, "ferret_sera_escape": -0.09157, "mature_H5_site": 137, "mouse_sera_escape": -0.1519, "mutant": "D", "mutation": "Y141D", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.3075, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.2139, "ferret_sera_escape": 0.1761, "mature_H5_site": 137, "mouse_sera_escape": 0.3068, "mutant": "E", "mutation": "Y141E", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": 0.3077, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1863, "ferret_sera_escape": 0.01441, "mature_H5_site": 137, "mouse_sera_escape": 0.04581, "mutant": "F", "mutation": "Y141F", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.08138, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.007, "ferret_sera_escape": 0.06931, "mature_H5_site": 137, "mouse_sera_escape": 0.1555, "mutant": "H", "mutation": "Y141H", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": 0.05973, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.003315, "ferret_sera_escape": -0.4682, "mature_H5_site": 137, "mouse_sera_escape": 0.05976, "mutant": "I", "mutation": "Y141I", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.0468, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1364, "ferret_sera_escape": 0.04031, "mature_H5_site": 137, "mouse_sera_escape": 0.2216, "mutant": "K", "mutation": "Y141K", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": 0.3835, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.02181, "ferret_sera_escape": -0.1523, "mature_H5_site": 137, "mouse_sera_escape": 0.05584, "mutant": "N", "mutation": "Y141N", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": 0.3283, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.04773, "ferret_sera_escape": -1.316, "mature_H5_site": 137, "mouse_sera_escape": -0.6419, "mutant": "P", "mutation": "Y141P", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.2038, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3758, "ferret_sera_escape": 0.107, "mature_H5_site": 137, "mouse_sera_escape": 0.2954, "mutant": "R", "mutation": "Y141R", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": 0.05897, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6931, "ferret_sera_escape": -0.1755, "mature_H5_site": 137, "mouse_sera_escape": 0.009374, "mutant": "S", "mutation": "Y141S", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.6362, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4748, "ferret_sera_escape": -0.4537, "mature_H5_site": 137, "mouse_sera_escape": -0.0883, "mutant": "T", "mutation": "Y141T", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": -0.1588, "wildtype": "Y"}, {"a26_usage": 0.3402, "cell_entry": 0.00161, "ferret_sera_escape": -0.1788, "mature_H5_site": 137, "mouse_sera_escape": 0.2634, "mutant": "V", "mutation": "Y141V", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 137, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y141Y", "reference_site": "141", "region": "region-A", "sequential_site": 153, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.4779, "cell_entry": -0.1526, "ferret_sera_escape": -0.1971, "mature_H5_site": 138, "mouse_sera_escape": 0.1288, "mutant": "A", "mutation": "Q142A", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": 0.04142, "wildtype": "Q"}, {"a26_usage": 0.1221, "cell_entry": -0.2481, "ferret_sera_escape": null, "mature_H5_site": 138, "mouse_sera_escape": null, "mutant": "D", "mutation": "Q142D", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.003485, "ferret_sera_escape": -0.1547, "mature_H5_site": 138, "mouse_sera_escape": -0.1668, "mutant": "E", "mutation": "Q142E", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.1134, "wildtype": "Q"}, {"a26_usage": 0.02764, "cell_entry": 0.02674, "ferret_sera_escape": 0.05055, "mature_H5_site": 138, "mouse_sera_escape": -0.02252, "mutant": "F", "mutation": "Q142F", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": 0.02729, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.03895, "ferret_sera_escape": 0.1091, "mature_H5_site": 138, "mouse_sera_escape": -0.02431, "mutant": "G", "mutation": "Q142G", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.01943, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.07071, "ferret_sera_escape": -0.09697, "mature_H5_site": 138, "mouse_sera_escape": -0.09355, "mutant": "H", "mutation": "Q142H", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": 0.08323, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.05583, "ferret_sera_escape": -0.00781, "mature_H5_site": 138, "mouse_sera_escape": -0.01827, "mutant": "I", "mutation": "Q142I", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.0566, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1495, "ferret_sera_escape": 0.2063, "mature_H5_site": 138, "mouse_sera_escape": -0.001571, "mutant": "K", "mutation": "Q142K", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.06344, "ferret_sera_escape": 0.07519, "mature_H5_site": 138, "mouse_sera_escape": 0.1051, "mutant": "L", "mutation": "Q142L", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.02116, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.06843, "ferret_sera_escape": -0.07516, "mature_H5_site": 138, "mouse_sera_escape": -0.007081, "mutant": "M", "mutation": "Q142M", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.02039, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.05586, "ferret_sera_escape": 0.03197, "mature_H5_site": 138, "mouse_sera_escape": 0.09345, "mutant": "N", "mutation": "Q142N", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.00134, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.9557, "ferret_sera_escape": -0.3381, "mature_H5_site": 138, "mouse_sera_escape": -0.2151, "mutant": "P", "mutation": "Q142P", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.1584, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 138, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q142Q", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0455, "cell_entry": -0.2294, "ferret_sera_escape": null, "mature_H5_site": 138, "mouse_sera_escape": null, "mutant": "R", "mutation": "Q142R", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.07433, "ferret_sera_escape": -0.1218, "mature_H5_site": 138, "mouse_sera_escape": 0.06555, "mutant": "S", "mutation": "Q142S", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.1086, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.02991, "ferret_sera_escape": -0.01247, "mature_H5_site": 138, "mouse_sera_escape": -0.1274, "mutant": "T", "mutation": "Q142T", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.03931, "ferret_sera_escape": -0.007477, "mature_H5_site": 138, "mouse_sera_escape": -0.106, "mutant": "V", "mutation": "Q142V", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.1151, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2743, "ferret_sera_escape": 0.08913, "mature_H5_site": 138, "mouse_sera_escape": 0.01172, "mutant": "W", "mutation": "Q142W", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.0801, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.02496, "ferret_sera_escape": -0.01618, "mature_H5_site": 138, "mouse_sera_escape": -0.09149, "mutant": "Y", "mutation": "Q142Y", "reference_site": "142", "region": "region-A", "sequential_site": 154, "stability": -0.0479, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.499, "ferret_sera_escape": -0.5644, "mature_H5_site": 139, "mouse_sera_escape": -0.2673, "mutant": "C", "mutation": "G143C", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.1616, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0359, "ferret_sera_escape": -0.07701, "mature_H5_site": 139, "mouse_sera_escape": 0.05713, "mutant": "E", "mutation": "G143E", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.1339, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3977, "ferret_sera_escape": -0.02611, "mature_H5_site": 139, "mouse_sera_escape": -0.01171, "mutant": "F", "mutation": "G143F", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.116, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 139, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G143G", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8786, "ferret_sera_escape": 0.08105, "mature_H5_site": 139, "mouse_sera_escape": -0.08804, "mutant": "H", "mutation": "G143H", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.05291, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2626, "ferret_sera_escape": -0.0773, "mature_H5_site": 139, "mouse_sera_escape": 0.131, "mutant": "K", "mutation": "G143K", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.1033, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.06516, "ferret_sera_escape": -0.07744, "mature_H5_site": 139, "mouse_sera_escape": -0.05537, "mutant": "L", "mutation": "G143L", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.1297, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3786, "ferret_sera_escape": -0.02701, "mature_H5_site": 139, "mouse_sera_escape": 0.07322, "mutant": "M", "mutation": "G143M", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1142, "ferret_sera_escape": -0.07787, "mature_H5_site": 139, "mouse_sera_escape": -0.08921, "mutant": "N", "mutation": "G143N", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": 0.03558, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3872, "ferret_sera_escape": -0.9427, "mature_H5_site": 139, "mouse_sera_escape": null, "mutant": "P", "mutation": "G143P", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": null, "wildtype": "G"}, {"a26_usage": 0.3531, "cell_entry": 0.009535, "ferret_sera_escape": -0.02672, "mature_H5_site": 139, "mouse_sera_escape": 0.03664, "mutant": "R", "mutation": "G143R", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.113, "wildtype": "G"}, {"a26_usage": 0.1562, "cell_entry": -0.1981, "ferret_sera_escape": 0.04416, "mature_H5_site": 139, "mouse_sera_escape": 0.04985, "mutant": "S", "mutation": "G143S", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.06165, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.398, "ferret_sera_escape": null, "mature_H5_site": 139, "mouse_sera_escape": null, "mutant": "T", "mutation": "G143T", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3401, "ferret_sera_escape": -0.1387, "mature_H5_site": 139, "mouse_sera_escape": -0.1696, "mutant": "V", "mutation": "G143V", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.3285, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1149, "ferret_sera_escape": -0.1029, "mature_H5_site": 139, "mouse_sera_escape": -0.06403, "mutant": "W", "mutation": "G143W", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.09006, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.00378, "ferret_sera_escape": 0.027, "mature_H5_site": 139, "mouse_sera_escape": -0.003941, "mutant": "Y", "mutation": "G143Y", "reference_site": "143", "region": "region-A", "sequential_site": 155, "stability": -0.129, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 140, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A144A", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.0, "wildtype": "A"}, {"a26_usage": null, "cell_entry": -0.0881, "ferret_sera_escape": null, "mature_H5_site": 140, "mouse_sera_escape": null, "mutant": "C", "mutation": "A144C", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4667, "ferret_sera_escape": -0.1272, "mature_H5_site": 140, "mouse_sera_escape": -0.1396, "mutant": "D", "mutation": "A144D", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.1527, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.07616, "ferret_sera_escape": -0.214, "mature_H5_site": 140, "mouse_sera_escape": -0.148, "mutant": "E", "mutation": "A144E", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.03617, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.403, "ferret_sera_escape": 0.7396, "mature_H5_site": 140, "mouse_sera_escape": 0.5094, "mutant": "F", "mutation": "A144F", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.1525, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.01749, "ferret_sera_escape": -0.11, "mature_H5_site": 140, "mouse_sera_escape": -0.07908, "mutant": "G", "mutation": "A144G", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.04813, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3443, "ferret_sera_escape": 0.01942, "mature_H5_site": 140, "mouse_sera_escape": -0.2546, "mutant": "H", "mutation": "A144H", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.08874, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5277, "ferret_sera_escape": -0.02274, "mature_H5_site": 140, "mouse_sera_escape": -0.1282, "mutant": "I", "mutation": "A144I", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.004761, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.293, "ferret_sera_escape": null, "mature_H5_site": 140, "mouse_sera_escape": null, "mutant": "K", "mutation": "A144K", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.002535, "ferret_sera_escape": -0.03385, "mature_H5_site": 140, "mouse_sera_escape": -0.06989, "mutant": "M", "mutation": "A144M", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.009135, "wildtype": "A"}, {"a26_usage": 0.01726, "cell_entry": 0.04423, "ferret_sera_escape": 0.02021, "mature_H5_site": 140, "mouse_sera_escape": -0.08287, "mutant": "N", "mutation": "A144N", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.0005508, "wildtype": "A"}, {"a26_usage": 0.5438, "cell_entry": -0.3302, "ferret_sera_escape": -0.1502, "mature_H5_site": 140, "mouse_sera_escape": -0.1985, "mutant": "P", "mutation": "A144P", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.137, "wildtype": "A"}, {"a26_usage": 0.09518, "cell_entry": 0.00594, "ferret_sera_escape": 0.02001, "mature_H5_site": 140, "mouse_sera_escape": 0.03465, "mutant": "Q", "mutation": "A144Q", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.02713, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1412, "ferret_sera_escape": 0.2064, "mature_H5_site": 140, "mouse_sera_escape": 0.2766, "mutant": "R", "mutation": "A144R", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.04135, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.04508, "ferret_sera_escape": -0.03217, "mature_H5_site": 140, "mouse_sera_escape": -0.2069, "mutant": "S", "mutation": "A144S", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.05414, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2714, "ferret_sera_escape": 0.07443, "mature_H5_site": 140, "mouse_sera_escape": -0.06365, "mutant": "T", "mutation": "A144T", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": -0.03793, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.00038, "ferret_sera_escape": -0.002227, "mature_H5_site": 140, "mouse_sera_escape": -0.07155, "mutant": "V", "mutation": "A144V", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.02547, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2538, "ferret_sera_escape": 0.2328, "mature_H5_site": 140, "mouse_sera_escape": -0.1786, "mutant": "W", "mutation": "A144W", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.0211, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3796, "ferret_sera_escape": 0.03711, "mature_H5_site": 140, "mouse_sera_escape": -0.4439, "mutant": "Y", "mutation": "A144Y", "reference_site": "144", "region": "region-A", "sequential_site": 156, "stability": 0.01636, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.9688, "ferret_sera_escape": 0.2549, "mature_H5_site": 141, "mouse_sera_escape": 0.08867, "mutant": "C", "mutation": "P145C", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.06011, "ferret_sera_escape": null, "mature_H5_site": 141, "mouse_sera_escape": null, "mutant": "E", "mutation": "P145E", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3834, "ferret_sera_escape": null, "mature_H5_site": 141, "mouse_sera_escape": null, "mutant": "F", "mutation": "P145F", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": null, "wildtype": "P"}, {"a26_usage": 0.3064, "cell_entry": 0.03934, "ferret_sera_escape": null, "mature_H5_site": 141, "mouse_sera_escape": null, "mutant": "I", "mutation": "P145I", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.091, "ferret_sera_escape": 0.2313, "mature_H5_site": 141, "mouse_sera_escape": 0.3082, "mutant": "K", "mutation": "P145K", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.704, "ferret_sera_escape": 0.4556, "mature_H5_site": 141, "mouse_sera_escape": 0.3124, "mutant": "L", "mutation": "P145L", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": -0.02013, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.045, "ferret_sera_escape": 0.5671, "mature_H5_site": 141, "mouse_sera_escape": 0.4693, "mutant": "M", "mutation": "P145M", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": -0.01497, "wildtype": "P"}, {"a26_usage": 0.1405, "cell_entry": -1.513, "ferret_sera_escape": 0.1117, "mature_H5_site": 141, "mouse_sera_escape": 0.03363, "mutant": "N", "mutation": "P145N", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": 0.104, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 141, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P145P", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1068, "ferret_sera_escape": 0.3358, "mature_H5_site": 141, "mouse_sera_escape": 0.1982, "mutant": "Q", "mutation": "P145Q", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": -0.04468, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.8528, "ferret_sera_escape": 0.363, "mature_H5_site": 141, "mouse_sera_escape": 0.2814, "mutant": "R", "mutation": "P145R", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": -0.04319, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.07675, "ferret_sera_escape": -0.08747, "mature_H5_site": 141, "mouse_sera_escape": -0.115, "mutant": "T", "mutation": "P145T", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": -0.08383, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.2869, "ferret_sera_escape": -0.5012, "mature_H5_site": 141, "mouse_sera_escape": -0.4067, "mutant": "V", "mutation": "P145V", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": -0.06263, "wildtype": "P"}, {"a26_usage": 0.04858, "cell_entry": -0.0126, "ferret_sera_escape": -0.8703, "mature_H5_site": 141, "mouse_sera_escape": -0.4975, "mutant": "W", "mutation": "P145W", "reference_site": "145", "region": "region-A", "sequential_site": 157, "stability": -0.1619, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5789, "ferret_sera_escape": 0.04286, "mature_H5_site": 142, "mouse_sera_escape": 0.03123, "mutant": "A", "mutation": "S146A", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.216, "ferret_sera_escape": 0.2493, "mature_H5_site": 142, "mouse_sera_escape": 0.5512, "mutant": "C", "mutation": "S146C", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": -0.2059, "wildtype": "S"}, {"a26_usage": 0.1418, "cell_entry": 0.05071, "ferret_sera_escape": null, "mature_H5_site": 142, "mouse_sera_escape": null, "mutant": "E", "mutation": "S146E", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.01503, "ferret_sera_escape": 0.1651, "mature_H5_site": 142, "mouse_sera_escape": 0.5756, "mutant": "F", "mutation": "S146F", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": 0.0221, "wildtype": "S"}, {"a26_usage": 0.1526, "cell_entry": -0.134, "ferret_sera_escape": 0.01955, "mature_H5_site": 142, "mouse_sera_escape": 0.2568, "mutant": "G", "mutation": "S146G", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": 0.4316, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.04789, "ferret_sera_escape": -0.09482, "mature_H5_site": 142, "mouse_sera_escape": 0.4961, "mutant": "H", "mutation": "S146H", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": 0.3806, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8817, "ferret_sera_escape": -0.897, "mature_H5_site": 142, "mouse_sera_escape": -0.2507, "mutant": "I", "mutation": "S146I", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": -0.2662, "wildtype": "S"}, {"a26_usage": 1.095, "cell_entry": -1.206, "ferret_sera_escape": -0.1648, "mature_H5_site": 142, "mouse_sera_escape": null, "mutant": "K", "mutation": "S146K", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": null, "wildtype": "S"}, {"a26_usage": 0.5323, "cell_entry": -0.03554, "ferret_sera_escape": -0.08094, "mature_H5_site": 142, "mouse_sera_escape": 0.2317, "mutant": "L", "mutation": "S146L", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": -0.1237, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3524, "ferret_sera_escape": 0.02874, "mature_H5_site": 142, "mouse_sera_escape": 0.4124, "mutant": "N", "mutation": "S146N", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": -0.08306, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.678, "ferret_sera_escape": null, "mature_H5_site": 142, "mouse_sera_escape": null, "mutant": "P", "mutation": "S146P", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.09551, "ferret_sera_escape": 0.09578, "mature_H5_site": 142, "mouse_sera_escape": 0.4793, "mutant": "R", "mutation": "S146R", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": 0.3933, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 142, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S146S", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3361, "ferret_sera_escape": -0.1158, "mature_H5_site": 142, "mouse_sera_escape": 0.01304, "mutant": "T", "mutation": "S146T", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": -0.1401, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.316, "ferret_sera_escape": -0.4143, "mature_H5_site": 142, "mouse_sera_escape": -0.003905, "mutant": "V", "mutation": "S146V", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.09571, "ferret_sera_escape": null, "mature_H5_site": 142, "mouse_sera_escape": null, "mutant": "W", "mutation": "S146W", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.06193, "ferret_sera_escape": null, "mature_H5_site": 142, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S146Y", "reference_site": "146", "region": "region-A", "sequential_site": 158, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.062, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "A", "mutation": "F147A", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.923, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "C", "mutation": "F147C", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "D", "mutation": "F147D", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "E", "mutation": "F147E", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 143, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F147F", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.406, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "G", "mutation": "F147G", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.917, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "H", "mutation": "F147H", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.23, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "I", "mutation": "F147I", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "K", "mutation": "F147K", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.8665, "ferret_sera_escape": 0.03166, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "L", "mutation": "F147L", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": 0.7855, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.3293, "ferret_sera_escape": 0.2108, "mature_H5_site": 143, "mouse_sera_escape": 0.2277, "mutant": "M", "mutation": "F147M", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": 0.404, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.96, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "N", "mutation": "F147N", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -4.594, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F147Q", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "R", "mutation": "F147R", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.96, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "T", "mutation": "F147T", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 143, "mouse_sera_escape": null, "mutant": "V", "mutation": "F147V", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.869, "ferret_sera_escape": -0.9702, "mature_H5_site": 143, "mouse_sera_escape": -0.5048, "mutant": "W", "mutation": "F147W", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.4321, "ferret_sera_escape": -0.892, "mature_H5_site": 143, "mouse_sera_escape": -0.5806, "mutant": "Y", "mutation": "F147Y", "reference_site": "147", "region": "HA1", "sequential_site": 159, "stability": -0.08845, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.8727, "ferret_sera_escape": -0.8373, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "A", "mutation": "F148A", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -4.377, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "C", "mutation": "F148C", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "D", "mutation": "F148D", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "E", "mutation": "F148E", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 144, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F148F", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.903, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "I", "mutation": "F148I", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.088, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "L", "mutation": "F148L", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.4523, "ferret_sera_escape": -0.05893, "mature_H5_site": 144, "mouse_sera_escape": -0.05586, "mutant": "M", "mutation": "F148M", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": -0.2404, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.9477, "ferret_sera_escape": 0.1189, "mature_H5_site": 144, "mouse_sera_escape": 0.1007, "mutant": "N", "mutation": "F148N", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": -0.1383, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.419, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "P", "mutation": "F148P", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.119, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F148Q", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 144, "mouse_sera_escape": null, "mutant": "R", "mutation": "F148R", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.186, "ferret_sera_escape": -0.2934, "mature_H5_site": 144, "mouse_sera_escape": -0.3038, "mutant": "V", "mutation": "F148V", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": -0.1564, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.278, "ferret_sera_escape": -0.3204, "mature_H5_site": 144, "mouse_sera_escape": -0.1203, "mutant": "W", "mutation": "F148W", "reference_site": "148", "region": "HA1", "sequential_site": 160, "stability": 0.08889, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.03205, "ferret_sera_escape": -0.03991, "mature_H5_site": 145, "mouse_sera_escape": -0.008117, "mutant": "A", "mutation": "R149A", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.7812, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1535, "ferret_sera_escape": -0.2572, "mature_H5_site": 145, "mouse_sera_escape": 0.04478, "mutant": "C", "mutation": "R149C", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.2421, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.815, "ferret_sera_escape": null, "mature_H5_site": 145, "mouse_sera_escape": null, "mutant": "E", "mutation": "R149E", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2118, "ferret_sera_escape": -0.001517, "mature_H5_site": 145, "mouse_sera_escape": -0.1786, "mutant": "F", "mutation": "R149F", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.2478, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.007755, "ferret_sera_escape": -0.1254, "mature_H5_site": 145, "mouse_sera_escape": -0.05685, "mutant": "G", "mutation": "R149G", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.7705, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.03546, "ferret_sera_escape": -0.1015, "mature_H5_site": 145, "mouse_sera_escape": -0.1752, "mutant": "I", "mutation": "R149I", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.162, "ferret_sera_escape": 0.01409, "mature_H5_site": 145, "mouse_sera_escape": 0.3304, "mutant": "K", "mutation": "R149K", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 1.358, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.07247, "ferret_sera_escape": -0.1603, "mature_H5_site": 145, "mouse_sera_escape": -0.1386, "mutant": "M", "mutation": "R149M", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.1503, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.832, "ferret_sera_escape": null, "mature_H5_site": 145, "mouse_sera_escape": null, "mutant": "P", "mutation": "R149P", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.07749, "ferret_sera_escape": -0.09731, "mature_H5_site": 145, "mouse_sera_escape": -0.09567, "mutant": "Q", "mutation": "R149Q", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.86, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 145, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R149R", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.03075, "ferret_sera_escape": null, "mature_H5_site": 145, "mouse_sera_escape": null, "mutant": "S", "mutation": "R149S", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.07515, "ferret_sera_escape": -0.003597, "mature_H5_site": 145, "mouse_sera_escape": 0.02727, "mutant": "T", "mutation": "R149T", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.4314, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.04122, "ferret_sera_escape": -0.1301, "mature_H5_site": 145, "mouse_sera_escape": -0.1892, "mutant": "W", "mutation": "R149W", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.3159, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.07486, "ferret_sera_escape": -0.00353, "mature_H5_site": 145, "mouse_sera_escape": -0.3294, "mutant": "Y", "mutation": "R149Y", "reference_site": "149", "region": "HA1", "sequential_site": 161, "stability": 0.2602, "wildtype": "R"}, {"a26_usage": null, "cell_entry": -2.282, "ferret_sera_escape": 0.03153, "mature_H5_site": 5, "mouse_sera_escape": 0.2836, "mutant": "A", "mutation": "I15A", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2574, "ferret_sera_escape": -0.01815, "mature_H5_site": 5, "mouse_sera_escape": 0.08141, "mutant": "C", "mutation": "I15C", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": -0.2632, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "D", "mutation": "I15D", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.771, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "E", "mutation": "I15E", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "F", "mutation": "I15F", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "G", "mutation": "I15G", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.981, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "H", "mutation": "I15H", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 5, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I15I", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.994, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "K", "mutation": "I15K", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.427, "ferret_sera_escape": -0.2667, "mature_H5_site": 5, "mouse_sera_escape": -0.0613, "mutant": "L", "mutation": "I15L", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": -0.1269, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.721, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "M", "mutation": "I15M", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "N", "mutation": "I15N", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "P", "mutation": "I15P", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I15Q", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "R", "mutation": "I15R", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.794, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "S", "mutation": "I15S", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3174, "ferret_sera_escape": -0.03984, "mature_H5_site": 5, "mouse_sera_escape": 0.1127, "mutant": "T", "mutation": "I15T", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": -0.1527, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.155, "ferret_sera_escape": 0.05616, "mature_H5_site": 5, "mouse_sera_escape": 0.06288, "mutant": "V", "mutation": "I15V", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": 0.05382, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.347, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "W", "mutation": "I15W", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 5, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I15Y", "reference_site": "15", "region": "HA1", "sequential_site": 21, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.366, "ferret_sera_escape": 0.01041, "mature_H5_site": 146, "mouse_sera_escape": -0.04731, "mutant": "A", "mutation": "N150A", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2597, "ferret_sera_escape": null, "mature_H5_site": 146, "mouse_sera_escape": null, "mutant": "C", "mutation": "N150C", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4099, "ferret_sera_escape": 0.003281, "mature_H5_site": 146, "mouse_sera_escape": -0.01063, "mutant": "I", "mutation": "N150I", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": 1.616, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.977, "ferret_sera_escape": null, "mature_H5_site": 146, "mouse_sera_escape": null, "mutant": "K", "mutation": "N150K", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": null, "wildtype": "N"}, {"a26_usage": 0.2103, "cell_entry": 0.04587, "ferret_sera_escape": 0.07867, "mature_H5_site": 146, "mouse_sera_escape": -0.1279, "mutant": "L", "mutation": "N150L", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": 0.6457, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 146, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N150N", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1182, "ferret_sera_escape": null, "mature_H5_site": 146, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N150Q", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04971, "ferret_sera_escape": 0.08317, "mature_H5_site": 146, "mouse_sera_escape": 0.05935, "mutant": "S", "mutation": "N150S", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": -0.1277, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.06692, "ferret_sera_escape": -0.1282, "mature_H5_site": 146, "mouse_sera_escape": 0.02148, "mutant": "V", "mutation": "N150V", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": 0.424, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.708, "ferret_sera_escape": null, "mature_H5_site": 146, "mouse_sera_escape": null, "mutant": "W", "mutation": "N150W", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.254, "ferret_sera_escape": 0.05911, "mature_H5_site": 146, "mouse_sera_escape": 0.2478, "mutant": "Y", "mutation": "N150Y", "reference_site": "150", "region": "HA1", "sequential_site": 162, "stability": 1.306, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3052, "ferret_sera_escape": null, "mature_H5_site": 147, "mouse_sera_escape": null, "mutant": "A", "mutation": "V151A", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.05337, "cell_entry": 0.0663, "ferret_sera_escape": 0.1043, "mature_H5_site": 147, "mouse_sera_escape": 0.1032, "mutant": "C", "mutation": "V151C", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": -0.2014, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 147, "mouse_sera_escape": null, "mutant": "D", "mutation": "V151D", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.163, "ferret_sera_escape": -0.2195, "mature_H5_site": 147, "mouse_sera_escape": null, "mutant": "E", "mutation": "V151E", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.05281, "ferret_sera_escape": -0.07202, "mature_H5_site": 147, "mouse_sera_escape": -0.1005, "mutant": "G", "mutation": "V151G", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": -0.02074, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.332, "ferret_sera_escape": 0.09342, "mature_H5_site": 147, "mouse_sera_escape": 0.295, "mutant": "H", "mutation": "V151H", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": 0.3483, "wildtype": "V"}, {"a26_usage": 0.08605, "cell_entry": -0.0214, "ferret_sera_escape": 0.03834, "mature_H5_site": 147, "mouse_sera_escape": 0.01509, "mutant": "I", "mutation": "V151I", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": -0.1986, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.773, "ferret_sera_escape": null, "mature_H5_site": 147, "mouse_sera_escape": null, "mutant": "K", "mutation": "V151K", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.06077, "cell_entry": 0.03836, "ferret_sera_escape": -0.09348, "mature_H5_site": 147, "mouse_sera_escape": 0.003199, "mutant": "L", "mutation": "V151L", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": -0.1017, "wildtype": "V"}, {"a26_usage": 0.02176, "cell_entry": -0.03176, "ferret_sera_escape": 0.04356, "mature_H5_site": 147, "mouse_sera_escape": 0.1994, "mutant": "M", "mutation": "V151M", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": 0.3531, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 147, "mouse_sera_escape": null, "mutant": "P", "mutation": "V151P", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4025, "ferret_sera_escape": -0.09462, "mature_H5_site": 147, "mouse_sera_escape": 0.2096, "mutant": "Q", "mutation": "V151Q", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": 0.2618, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 147, "mouse_sera_escape": null, "mutant": "R", "mutation": "V151R", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.02103, "ferret_sera_escape": -0.01438, "mature_H5_site": 147, "mouse_sera_escape": 0.069, "mutant": "S", "mutation": "V151S", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": -0.09947, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.07132, "ferret_sera_escape": 0.04828, "mature_H5_site": 147, "mouse_sera_escape": -0.2424, "mutant": "T", "mutation": "V151T", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 147, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V151V", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.268, "ferret_sera_escape": null, "mature_H5_site": 147, "mouse_sera_escape": null, "mutant": "W", "mutation": "V151W", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.954, "ferret_sera_escape": 0.1162, "mature_H5_site": 147, "mouse_sera_escape": 0.374, "mutant": "Y", "mutation": "V151Y", "reference_site": "151", "region": "HA1", "sequential_site": 163, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5331, "ferret_sera_escape": -0.303, "mature_H5_site": 148, "mouse_sera_escape": -0.00645, "mutant": "A", "mutation": "V152A", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": -0.1364, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.02353, "ferret_sera_escape": -0.04594, "mature_H5_site": 148, "mouse_sera_escape": -0.1146, "mutant": "D", "mutation": "V152D", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": -0.2145, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.536, "ferret_sera_escape": -0.7071, "mature_H5_site": 148, "mouse_sera_escape": -0.1293, "mutant": "E", "mutation": "V152E", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2452, "ferret_sera_escape": -0.1069, "mature_H5_site": 148, "mouse_sera_escape": 0.04345, "mutant": "G", "mutation": "V152G", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": -0.04286, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.00141, "ferret_sera_escape": 0.01524, "mature_H5_site": 148, "mouse_sera_escape": -0.1038, "mutant": "L", "mutation": "V152L", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": 0.005031, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.06008, "ferret_sera_escape": -0.1654, "mature_H5_site": 148, "mouse_sera_escape": 0.1656, "mutant": "M", "mutation": "V152M", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": -0.116, "wildtype": "V"}, {"a26_usage": 0.01973, "cell_entry": 0.07074, "ferret_sera_escape": -0.208, "mature_H5_site": 148, "mouse_sera_escape": -0.09026, "mutant": "N", "mutation": "V152N", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": -0.1058, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.851, "ferret_sera_escape": null, "mature_H5_site": 148, "mouse_sera_escape": null, "mutant": "P", "mutation": "V152P", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.305, "ferret_sera_escape": -0.4045, "mature_H5_site": 148, "mouse_sera_escape": -0.1815, "mutant": "Q", "mutation": "V152Q", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": -0.2555, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.867, "ferret_sera_escape": null, "mature_H5_site": 148, "mouse_sera_escape": null, "mutant": "S", "mutation": "V152S", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 148, "mouse_sera_escape": null, "mutant": "T", "mutation": "V152T", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 148, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V152V", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7711, "ferret_sera_escape": -0.6712, "mature_H5_site": 148, "mouse_sera_escape": 0.5575, "mutant": "W", "mutation": "V152W", "reference_site": "152", "region": "HA1", "sequential_site": 164, "stability": -0.07291, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "A", "mutation": "W153A", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -6.034, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "C", "mutation": "W153C", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "D", "mutation": "W153D", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "E", "mutation": "W153E", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.603, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "F", "mutation": "W153F", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.608, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "H", "mutation": "W153H", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "I", "mutation": "W153I", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "K", "mutation": "W153K", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.46, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "L", "mutation": "W153L", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.005, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "M", "mutation": "W153M", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.844, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "N", "mutation": "W153N", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.74, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "P", "mutation": "W153P", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.149, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W153Q", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.764, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "R", "mutation": "W153R", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.725, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "S", "mutation": "W153S", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.981, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "T", "mutation": "W153T", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.999, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "V", "mutation": "W153V", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 149, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W153W", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 149, "mouse_sera_escape": null, "mutant": "Y", "mutation": "W153Y", "reference_site": "153", "region": "HA1", "sequential_site": 165, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.3185, "ferret_sera_escape": 0.1871, "mature_H5_site": 150, "mouse_sera_escape": 0.2445, "mutant": "A", "mutation": "L154A", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": -0.2974, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.113, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "C", "mutation": "L154C", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "D", "mutation": "L154D", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "E", "mutation": "L154E", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.522, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "G", "mutation": "L154G", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.1441, "cell_entry": -0.01898, "ferret_sera_escape": 0.04931, "mature_H5_site": 150, "mouse_sera_escape": 0.1685, "mutant": "I", "mutation": "L154I", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": -0.1071, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.44, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "K", "mutation": "L154K", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 150, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L154L", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2172, "ferret_sera_escape": 0.4043, "mature_H5_site": 150, "mouse_sera_escape": 0.1933, "mutant": "M", "mutation": "L154M", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": -0.07408, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "N", "mutation": "L154N", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.543, "ferret_sera_escape": -0.1417, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "P", "mutation": "L154P", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L154Q", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "S", "mutation": "L154S", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7226, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "T", "mutation": "L154T", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.08693, "ferret_sera_escape": -0.2049, "mature_H5_site": 150, "mouse_sera_escape": -0.1363, "mutant": "V", "mutation": "L154V", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": -0.2442, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.299, "ferret_sera_escape": null, "mature_H5_site": 150, "mouse_sera_escape": null, "mutant": "W", "mutation": "L154W", "reference_site": "154", "region": "HA1", "sequential_site": 166, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9856, "ferret_sera_escape": -0.8799, "mature_H5_site": 151, "mouse_sera_escape": -0.8503, "mutant": "A", "mutation": "I155A", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": -0.2274, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.06386, "ferret_sera_escape": -0.8719, "mature_H5_site": 151, "mouse_sera_escape": -0.705, "mutant": "C", "mutation": "I155C", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": -0.2249, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.276, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "E", "mutation": "I155E", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.692, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "F", "mutation": "I155F", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.435, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "H", "mutation": "I155H", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 151, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I155I", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.728, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "K", "mutation": "I155K", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06906, "ferret_sera_escape": -0.6441, "mature_H5_site": 151, "mouse_sera_escape": -0.6382, "mutant": "L", "mutation": "I155L", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": -0.03891, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.283, "ferret_sera_escape": -1.104, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "M", "mutation": "I155M", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1159, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": -0.7482, "mutant": "N", "mutation": "I155N", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": -0.2618, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "P", "mutation": "I155P", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.163, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I155Q", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.106, "ferret_sera_escape": -0.8789, "mature_H5_site": 151, "mouse_sera_escape": -0.4626, "mutant": "S", "mutation": "I155S", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": -0.1167, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0539, "ferret_sera_escape": -0.1447, "mature_H5_site": 151, "mouse_sera_escape": -0.07585, "mutant": "V", "mutation": "I155V", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": 0.01685, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.889, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "W", "mutation": "I155W", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.572, "ferret_sera_escape": null, "mature_H5_site": 151, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I155Y", "reference_site": "155", "region": "region-B", "sequential_site": 167, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06617, "ferret_sera_escape": 0.5269, "mature_H5_site": 152, "mouse_sera_escape": 0.3731, "mutant": "C", "mutation": "K156C", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.1208, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.791, "ferret_sera_escape": null, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "D", "mutation": "K156D", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": null, "wildtype": "K"}, {"a26_usage": 1.779, "cell_entry": -1.55, "ferret_sera_escape": null, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "E", "mutation": "K156E", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": null, "wildtype": "K"}, {"a26_usage": 0.03762, "cell_entry": -1.347, "ferret_sera_escape": 0.3123, "mature_H5_site": 152, "mouse_sera_escape": 0.1644, "mutant": "G", "mutation": "K156G", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.05262, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.00381, "ferret_sera_escape": null, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "H", "mutation": "K156H", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7739, "ferret_sera_escape": null, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "I", "mutation": "K156I", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 152, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K156K", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": 0.0, "wildtype": "K"}, {"a26_usage": null, "cell_entry": 0.06815, "ferret_sera_escape": null, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "L", "mutation": "K156L", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.1229, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04545, "ferret_sera_escape": 0.5128, "mature_H5_site": 152, "mouse_sera_escape": 0.2622, "mutant": "M", "mutation": "K156M", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.1777, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1758, "ferret_sera_escape": 0.3426, "mature_H5_site": 152, "mouse_sera_escape": 0.04971, "mutant": "N", "mutation": "K156N", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.1173, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.327, "ferret_sera_escape": null, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "P", "mutation": "K156P", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1166, "ferret_sera_escape": 0.5552, "mature_H5_site": 152, "mouse_sera_escape": 0.5613, "mutant": "Q", "mutation": "K156Q", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.02488, "wildtype": "K"}, {"a26_usage": 0.6295, "cell_entry": -0.05433, "ferret_sera_escape": 0.6093, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "R", "mutation": "K156R", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.0636, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04606, "ferret_sera_escape": 0.5339, "mature_H5_site": 152, "mouse_sera_escape": 0.3498, "mutant": "S", "mutation": "K156S", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.1609, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5045, "ferret_sera_escape": 0.5706, "mature_H5_site": 152, "mouse_sera_escape": 0.1814, "mutant": "T", "mutation": "K156T", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.1945, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4253, "ferret_sera_escape": 0.3315, "mature_H5_site": 152, "mouse_sera_escape": 0.1523, "mutant": "V", "mutation": "K156V", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.1901, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.45, "ferret_sera_escape": null, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "W", "mutation": "K156W", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4169, "ferret_sera_escape": 0.3003, "mature_H5_site": 152, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K156Y", "reference_site": "156", "region": "region-B", "sequential_site": 168, "stability": -0.1913, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.00304, "ferret_sera_escape": 0.6839, "mature_H5_site": 153, "mouse_sera_escape": 0.9152, "mutant": "A", "mutation": "K157A", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.09654, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4119, "ferret_sera_escape": 0.7463, "mature_H5_site": 153, "mouse_sera_escape": 0.7924, "mutant": "C", "mutation": "K157C", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.1508, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.752, "ferret_sera_escape": 0.3418, "mature_H5_site": 153, "mouse_sera_escape": 0.7354, "mutant": "D", "mutation": "K157D", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.1146, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04705, "ferret_sera_escape": 0.381, "mature_H5_site": 153, "mouse_sera_escape": 0.7894, "mutant": "E", "mutation": "K157E", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.3104, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05504, "ferret_sera_escape": 0.8934, "mature_H5_site": 153, "mouse_sera_escape": 1.057, "mutant": "F", "mutation": "K157F", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.1515, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4621, "ferret_sera_escape": 0.0893, "mature_H5_site": 153, "mouse_sera_escape": null, "mutant": "G", "mutation": "K157G", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.01434, "ferret_sera_escape": 0.8405, "mature_H5_site": 153, "mouse_sera_escape": 0.9309, "mutant": "H", "mutation": "K157H", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.1852, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 153, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K157K", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7618, "ferret_sera_escape": 0.5266, "mature_H5_site": 153, "mouse_sera_escape": 0.7113, "mutant": "M", "mutation": "K157M", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.1323, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3925, "ferret_sera_escape": 0.6051, "mature_H5_site": 153, "mouse_sera_escape": 0.9299, "mutant": "N", "mutation": "K157N", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.2589, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 153, "mouse_sera_escape": null, "mutant": "P", "mutation": "K157P", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.00357, "ferret_sera_escape": null, "mature_H5_site": 153, "mouse_sera_escape": null, "mutant": "R", "mutation": "K157R", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6924, "ferret_sera_escape": null, "mature_H5_site": 153, "mouse_sera_escape": null, "mutant": "S", "mutation": "K157S", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1694, "ferret_sera_escape": 0.9899, "mature_H5_site": 153, "mouse_sera_escape": 0.9115, "mutant": "T", "mutation": "K157T", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.7676, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.251, "ferret_sera_escape": 0.9234, "mature_H5_site": 153, "mouse_sera_escape": 1.155, "mutant": "V", "mutation": "K157V", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6327, "ferret_sera_escape": 0.9695, "mature_H5_site": 153, "mouse_sera_escape": 1.234, "mutant": "W", "mutation": "K157W", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.2319, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03411, "ferret_sera_escape": 0.5362, "mature_H5_site": 153, "mouse_sera_escape": 0.9323, "mutant": "Y", "mutation": "K157Y", "reference_site": "157", "region": "region-B", "sequential_site": 169, "stability": -0.1552, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2676, "ferret_sera_escape": 0.6228, "mature_H5_site": 154, "mouse_sera_escape": 0.6694, "mutant": "A", "mutation": "N158A", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.06027, "wildtype": "N"}, {"a26_usage": null, "cell_entry": -2.035, "ferret_sera_escape": null, "mature_H5_site": 154, "mouse_sera_escape": null, "mutant": "C", "mutation": "N158C", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.00687, "ferret_sera_escape": 0.5473, "mature_H5_site": 154, "mouse_sera_escape": 0.6269, "mutant": "D", "mutation": "N158D", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.08352, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02899, "ferret_sera_escape": 1.309, "mature_H5_site": 154, "mouse_sera_escape": 1.112, "mutant": "E", "mutation": "N158E", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": 0.004055, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.0964, "ferret_sera_escape": 0.7561, "mature_H5_site": 154, "mouse_sera_escape": 0.5103, "mutant": "F", "mutation": "N158F", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.08931, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0458, "ferret_sera_escape": 0.6113, "mature_H5_site": 154, "mouse_sera_escape": 0.6711, "mutant": "G", "mutation": "N158G", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.0586, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1074, "ferret_sera_escape": 0.8923, "mature_H5_site": 154, "mouse_sera_escape": 0.6799, "mutant": "H", "mutation": "N158H", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.01561, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2683, "ferret_sera_escape": 0.7223, "mature_H5_site": 154, "mouse_sera_escape": 0.7313, "mutant": "I", "mutation": "N158I", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.1269, "wildtype": "N"}, {"a26_usage": 0.4997, "cell_entry": -0.133, "ferret_sera_escape": 0.8485, "mature_H5_site": 154, "mouse_sera_escape": 0.6897, "mutant": "K", "mutation": "N158K", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.08678, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.08541, "ferret_sera_escape": 1.012, "mature_H5_site": 154, "mouse_sera_escape": 0.8163, "mutant": "L", "mutation": "N158L", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.07008, "wildtype": "N"}, {"a26_usage": 0.000125, "cell_entry": -0.1076, "ferret_sera_escape": null, "mature_H5_site": 154, "mouse_sera_escape": null, "mutant": "M", "mutation": "N158M", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 154, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N158N", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.82, "ferret_sera_escape": 0.918, "mature_H5_site": 154, "mouse_sera_escape": 0.8069, "mutant": "P", "mutation": "N158P", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.1945, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1511, "ferret_sera_escape": 1.033, "mature_H5_site": 154, "mouse_sera_escape": 0.7507, "mutant": "Q", "mutation": "N158Q", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.02848, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2995, "ferret_sera_escape": 1.307, "mature_H5_site": 154, "mouse_sera_escape": 1.187, "mutant": "R", "mutation": "N158R", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.004643, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.00284, "ferret_sera_escape": 0.6082, "mature_H5_site": 154, "mouse_sera_escape": 0.5004, "mutant": "S", "mutation": "N158S", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.05661, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.08715, "ferret_sera_escape": null, "mature_H5_site": 154, "mouse_sera_escape": null, "mutant": "V", "mutation": "N158V", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.01745, "ferret_sera_escape": 0.8337, "mature_H5_site": 154, "mouse_sera_escape": 0.7289, "mutant": "W", "mutation": "N158W", "reference_site": "158", "region": "region-B", "sequential_site": 170, "stability": -0.08638, "wildtype": "N"}, {"a26_usage": 0.4066, "cell_entry": 0.05149, "ferret_sera_escape": 1.076, "mature_H5_site": 155, "mouse_sera_escape": 0.1702, "mutant": "A", "mutation": "D159A", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": -0.1, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 155, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D159D", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7079, "ferret_sera_escape": 1.173, "mature_H5_site": 155, "mouse_sera_escape": 0.1081, "mutant": "F", "mutation": "D159F", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": -0.05204, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2637, "ferret_sera_escape": 1.026, "mature_H5_site": 155, "mouse_sera_escape": 0.2836, "mutant": "G", "mutation": "D159G", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.756, "ferret_sera_escape": null, "mature_H5_site": 155, "mouse_sera_escape": null, "mutant": "I", "mutation": "D159I", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.345, "ferret_sera_escape": null, "mature_H5_site": 155, "mouse_sera_escape": null, "mutant": "K", "mutation": "D159K", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.346, "ferret_sera_escape": 0.8219, "mature_H5_site": 155, "mouse_sera_escape": 0.04847, "mutant": "L", "mutation": "D159L", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": -0.208, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5137, "ferret_sera_escape": 0.5399, "mature_H5_site": 155, "mouse_sera_escape": 0.1222, "mutant": "N", "mutation": "D159N", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": 0.01406, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3926, "ferret_sera_escape": 0.7015, "mature_H5_site": 155, "mouse_sera_escape": -0.3731, "mutant": "Q", "mutation": "D159Q", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": -0.05668, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.422, "ferret_sera_escape": null, "mature_H5_site": 155, "mouse_sera_escape": null, "mutant": "R", "mutation": "D159R", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.887, "ferret_sera_escape": 0.8069, "mature_H5_site": 155, "mouse_sera_escape": 1.111, "mutant": "S", "mutation": "D159S", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.791, "ferret_sera_escape": 0.9006, "mature_H5_site": 155, "mouse_sera_escape": 0.1808, "mutant": "T", "mutation": "D159T", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.181, "ferret_sera_escape": null, "mature_H5_site": 155, "mouse_sera_escape": null, "mutant": "V", "mutation": "D159V", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.594, "ferret_sera_escape": 1.265, "mature_H5_site": 155, "mouse_sera_escape": 0.191, "mutant": "W", "mutation": "D159W", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": -0.1361, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8296, "ferret_sera_escape": 1.095, "mature_H5_site": 155, "mouse_sera_escape": 0.1231, "mutant": "Y", "mutation": "D159Y", "reference_site": "159", "region": "region-B", "sequential_site": 171, "stability": -0.1029, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.501, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "A", "mutation": "G16A", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "C", "mutation": "G16C", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.008, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "D", "mutation": "G16D", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "E", "mutation": "G16E", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 6, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G16G", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "H", "mutation": "G16H", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.183, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "I", "mutation": "G16I", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "K", "mutation": "G16K", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "L", "mutation": "G16L", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.486, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "M", "mutation": "G16M", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "P", "mutation": "G16P", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.553, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G16Q", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "R", "mutation": "G16R", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": -0.2747, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "S", "mutation": "G16S", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.666, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "T", "mutation": "G16T", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.978, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "V", "mutation": "G16V", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.66, "ferret_sera_escape": null, "mature_H5_site": 6, "mouse_sera_escape": null, "mutant": "W", "mutation": "G16W", "reference_site": "16", "region": "HA1", "sequential_site": 22, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 156, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A160A", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.495, "ferret_sera_escape": 0.9954, "mature_H5_site": 156, "mouse_sera_escape": 0.4418, "mutant": "C", "mutation": "A160C", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.08036, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.04906, "ferret_sera_escape": 0.9352, "mature_H5_site": 156, "mouse_sera_escape": -0.2718, "mutant": "D", "mutation": "A160D", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4254, "ferret_sera_escape": 0.6771, "mature_H5_site": 156, "mouse_sera_escape": -0.2799, "mutant": "E", "mutation": "A160E", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.06171, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1028, "ferret_sera_escape": 0.6945, "mature_H5_site": 156, "mouse_sera_escape": 0.01412, "mutant": "F", "mutation": "A160F", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.08626, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.01629, "ferret_sera_escape": 0.7049, "mature_H5_site": 156, "mouse_sera_escape": 0.07536, "mutant": "H", "mutation": "A160H", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.03205, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.06469, "ferret_sera_escape": 1.224, "mature_H5_site": 156, "mouse_sera_escape": 0.323, "mutant": "I", "mutation": "A160I", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5497, "ferret_sera_escape": 1.304, "mature_H5_site": 156, "mouse_sera_escape": 0.532, "mutant": "K", "mutation": "A160K", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": 0.05874, "wildtype": "A"}, {"a26_usage": null, "cell_entry": -1.8, "ferret_sera_escape": 1.446, "mature_H5_site": 156, "mouse_sera_escape": 0.3156, "mutant": "L", "mutation": "A160L", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.07211, "ferret_sera_escape": 0.7294, "mature_H5_site": 156, "mouse_sera_escape": 0.08381, "mutant": "M", "mutation": "A160M", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": 0.002653, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3024, "ferret_sera_escape": 0.8939, "mature_H5_site": 156, "mouse_sera_escape": 0.1555, "mutant": "N", "mutation": "A160N", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.0137, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.864, "ferret_sera_escape": null, "mature_H5_site": 156, "mouse_sera_escape": null, "mutant": "P", "mutation": "A160P", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1073, "ferret_sera_escape": 0.75, "mature_H5_site": 156, "mouse_sera_escape": 0.1423, "mutant": "Q", "mutation": "A160Q", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.06077, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.0654, "ferret_sera_escape": null, "mature_H5_site": 156, "mouse_sera_escape": 0.9653, "mutant": "S", "mutation": "A160S", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.2048, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.03709, "ferret_sera_escape": 2.257, "mature_H5_site": 156, "mouse_sera_escape": 0.8809, "mutant": "T", "mutation": "A160T", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.0805, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2059, "ferret_sera_escape": 1.018, "mature_H5_site": 156, "mouse_sera_escape": 0.4591, "mutant": "V", "mutation": "A160V", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.0571, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.03065, "ferret_sera_escape": 0.8196, "mature_H5_site": 156, "mouse_sera_escape": -0.1612, "mutant": "W", "mutation": "A160W", "reference_site": "160", "region": "region-B", "sequential_site": 172, "stability": -0.1941, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.907, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y161A", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y161C", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.709, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y161D", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y161E", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y161G", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.323, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": 0.3904, "mutant": "H", "mutation": "Y161H", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y161I", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y161K", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.983, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y161L", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.824, "ferret_sera_escape": 1.015, "mature_H5_site": 157, "mouse_sera_escape": 1.166, "mutant": "M", "mutation": "Y161M", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.395, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y161N", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y161P", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.993, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y161R", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.996, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y161S", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.845, "ferret_sera_escape": null, "mature_H5_site": 157, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y161T", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.179, "ferret_sera_escape": 0.2804, "mature_H5_site": 157, "mouse_sera_escape": 0.005442, "mutant": "W", "mutation": "Y161W", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": -0.1493, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 157, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y161Y", "reference_site": "161", "region": "HA1", "sequential_site": 173, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.00162, "cell_entry": -0.414, "ferret_sera_escape": 0.5494, "mature_H5_site": 158, "mouse_sera_escape": 0.2839, "mutant": "A", "mutation": "P162A", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.09098, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.077, "ferret_sera_escape": null, "mature_H5_site": 158, "mouse_sera_escape": null, "mutant": "C", "mutation": "P162C", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5694, "ferret_sera_escape": 1.791, "mature_H5_site": 158, "mouse_sera_escape": 0.6792, "mutant": "E", "mutation": "P162E", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.2498, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.2397, "ferret_sera_escape": 1.052, "mature_H5_site": 158, "mouse_sera_escape": 0.5343, "mutant": "G", "mutation": "P162G", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.1838, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5207, "ferret_sera_escape": 1.228, "mature_H5_site": 158, "mouse_sera_escape": 0.4704, "mutant": "H", "mutation": "P162H", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.2141, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.02312, "ferret_sera_escape": 1.42, "mature_H5_site": 158, "mouse_sera_escape": 0.6862, "mutant": "K", "mutation": "P162K", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.2018, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.568, "ferret_sera_escape": null, "mature_H5_site": 158, "mouse_sera_escape": null, "mutant": "L", "mutation": "P162L", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.4015, "ferret_sera_escape": 1.041, "mature_H5_site": 158, "mouse_sera_escape": 0.4592, "mutant": "M", "mutation": "P162M", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.2043, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.02878, "ferret_sera_escape": 1.599, "mature_H5_site": 158, "mouse_sera_escape": 0.723, "mutant": "N", "mutation": "P162N", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": 0.001949, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 158, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P162P", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.3668, "cell_entry": -0.3115, "ferret_sera_escape": 1.559, "mature_H5_site": 158, "mouse_sera_escape": 0.543, "mutant": "Q", "mutation": "P162Q", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.1631, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3961, "ferret_sera_escape": 0.9104, "mature_H5_site": 158, "mouse_sera_escape": 0.5815, "mutant": "R", "mutation": "P162R", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.2041, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1376, "ferret_sera_escape": 0.9374, "mature_H5_site": 158, "mouse_sera_escape": 0.4456, "mutant": "S", "mutation": "P162S", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.2022, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.6296, "ferret_sera_escape": 1.239, "mature_H5_site": 158, "mouse_sera_escape": 0.5125, "mutant": "T", "mutation": "P162T", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.09889, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5012, "ferret_sera_escape": 0.6577, "mature_H5_site": 158, "mouse_sera_escape": 0.4012, "mutant": "V", "mutation": "P162V", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": -0.2655, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.165, "ferret_sera_escape": null, "mature_H5_site": 158, "mouse_sera_escape": null, "mutant": "W", "mutation": "P162W", "reference_site": "162", "region": "HA1", "sequential_site": 174, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3744, "ferret_sera_escape": -0.02211, "mature_H5_site": 159, "mouse_sera_escape": -0.109, "mutant": "A", "mutation": "T163A", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.211, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.06918, "ferret_sera_escape": 0.2852, "mature_H5_site": 159, "mouse_sera_escape": -0.07306, "mutant": "D", "mutation": "T163D", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2873, "wildtype": "T"}, {"a26_usage": 0.3155, "cell_entry": -1.032, "ferret_sera_escape": 0.02261, "mature_H5_site": 159, "mouse_sera_escape": -0.1816, "mutant": "E", "mutation": "T163E", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2351, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4447, "ferret_sera_escape": -0.04837, "mature_H5_site": 159, "mouse_sera_escape": -0.1618, "mutant": "G", "mutation": "T163G", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2326, "wildtype": "T"}, {"a26_usage": 0.08335, "cell_entry": -0.1646, "ferret_sera_escape": 0.4113, "mature_H5_site": 159, "mouse_sera_escape": -0.121, "mutant": "H", "mutation": "T163H", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2413, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.01755, "ferret_sera_escape": 0.2953, "mature_H5_site": 159, "mouse_sera_escape": 0.1689, "mutant": "I", "mutation": "T163I", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.009311, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.06674, "ferret_sera_escape": 0.4562, "mature_H5_site": 159, "mouse_sera_escape": -0.05427, "mutant": "K", "mutation": "T163K", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.03687, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.03057, "ferret_sera_escape": 0.1804, "mature_H5_site": 159, "mouse_sera_escape": 0.07446, "mutant": "M", "mutation": "T163M", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.002277, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1049, "ferret_sera_escape": 0.07733, "mature_H5_site": 159, "mouse_sera_escape": -0.06645, "mutant": "N", "mutation": "T163N", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.07433, "ferret_sera_escape": -0.6038, "mature_H5_site": 159, "mouse_sera_escape": -0.09846, "mutant": "P", "mutation": "T163P", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2193, "wildtype": "T"}, {"a26_usage": 0.07712, "cell_entry": -0.09958, "ferret_sera_escape": 0.2192, "mature_H5_site": 159, "mouse_sera_escape": 0.003765, "mutant": "Q", "mutation": "T163Q", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2177, "wildtype": "T"}, {"a26_usage": null, "cell_entry": -0.05301, "ferret_sera_escape": 0.03847, "mature_H5_site": 159, "mouse_sera_escape": -0.08677, "mutant": "R", "mutation": "T163R", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 159, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T163T", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.01879, "ferret_sera_escape": 0.2908, "mature_H5_site": 159, "mouse_sera_escape": 0.01255, "mutant": "V", "mutation": "T163V", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.0123, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.01324, "ferret_sera_escape": 0.04127, "mature_H5_site": 159, "mouse_sera_escape": -0.1848, "mutant": "W", "mutation": "T163W", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": -0.2085, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1734, "ferret_sera_escape": 0.1211, "mature_H5_site": 159, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T163Y", "reference_site": "163", "region": "HA1", "sequential_site": 175, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.06499, "ferret_sera_escape": 0.07144, "mature_H5_site": 160, "mouse_sera_escape": 0.2219, "mutant": "A", "mutation": "I164A", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": -0.2212, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2772, "ferret_sera_escape": null, "mature_H5_site": 160, "mouse_sera_escape": null, "mutant": "C", "mutation": "I164C", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.316, "ferret_sera_escape": null, "mature_H5_site": 160, "mouse_sera_escape": null, "mutant": "D", "mutation": "I164D", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.329, "ferret_sera_escape": 0.1718, "mature_H5_site": 160, "mouse_sera_escape": 0.8442, "mutant": "E", "mutation": "I164E", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.07838, "ferret_sera_escape": -0.3422, "mature_H5_site": 160, "mouse_sera_escape": -0.01459, "mutant": "F", "mutation": "I164F", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.303, "ferret_sera_escape": null, "mature_H5_site": 160, "mouse_sera_escape": null, "mutant": "G", "mutation": "I164G", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1712, "ferret_sera_escape": -0.5242, "mature_H5_site": 160, "mouse_sera_escape": -0.1238, "mutant": "H", "mutation": "I164H", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": -0.3458, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 160, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I164I", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.936, "ferret_sera_escape": 0.08734, "mature_H5_site": 160, "mouse_sera_escape": 0.0555, "mutant": "K", "mutation": "I164K", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.167, "ferret_sera_escape": null, "mature_H5_site": 160, "mouse_sera_escape": null, "mutant": "N", "mutation": "I164N", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.945, "ferret_sera_escape": null, "mature_H5_site": 160, "mouse_sera_escape": null, "mutant": "P", "mutation": "I164P", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.674, "ferret_sera_escape": 0.06604, "mature_H5_site": 160, "mouse_sera_escape": 0.02297, "mutant": "Q", "mutation": "I164Q", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.295, "ferret_sera_escape": null, "mature_H5_site": 160, "mouse_sera_escape": null, "mutant": "R", "mutation": "I164R", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6368, "ferret_sera_escape": null, "mature_H5_site": 160, "mouse_sera_escape": null, "mutant": "T", "mutation": "I164T", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6973, "ferret_sera_escape": -0.1434, "mature_H5_site": 160, "mouse_sera_escape": -0.1621, "mutant": "W", "mutation": "I164W", "reference_site": "164", "region": "HA1", "sequential_site": 176, "stability": -0.6107, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.667, "ferret_sera_escape": 0.2362, "mature_H5_site": 161, "mouse_sera_escape": -0.206, "mutant": "A", "mutation": "K165A", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.1865, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3008, "ferret_sera_escape": -0.1999, "mature_H5_site": 161, "mouse_sera_escape": -0.153, "mutant": "C", "mutation": "K165C", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": null, "wildtype": "K"}, {"a26_usage": 0.1989, "cell_entry": 0.0386, "ferret_sera_escape": -0.1349, "mature_H5_site": 161, "mouse_sera_escape": -0.5527, "mutant": "D", "mutation": "K165D", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.279, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1588, "ferret_sera_escape": -0.1098, "mature_H5_site": 161, "mouse_sera_escape": -0.4628, "mutant": "E", "mutation": "K165E", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.1858, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.01622, "ferret_sera_escape": 0.005283, "mature_H5_site": 161, "mouse_sera_escape": -0.4205, "mutant": "F", "mutation": "K165F", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.1384, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3926, "ferret_sera_escape": -0.06418, "mature_H5_site": 161, "mouse_sera_escape": -0.3506, "mutant": "G", "mutation": "K165G", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.3726, "wildtype": "K"}, {"a26_usage": 0.04977, "cell_entry": -0.01079, "ferret_sera_escape": 0.1971, "mature_H5_site": 161, "mouse_sera_escape": -0.3415, "mutant": "H", "mutation": "K165H", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.01703, "wildtype": "K"}, {"a26_usage": 0.0464, "cell_entry": 0.04642, "ferret_sera_escape": 0.05038, "mature_H5_site": 161, "mouse_sera_escape": -0.379, "mutant": "I", "mutation": "K165I", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.163, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 161, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K165K", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7407, "ferret_sera_escape": 0.1628, "mature_H5_site": 161, "mouse_sera_escape": -0.3493, "mutant": "M", "mutation": "K165M", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.1191, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05429, "ferret_sera_escape": -0.2081, "mature_H5_site": 161, "mouse_sera_escape": -0.5565, "mutant": "N", "mutation": "K165N", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.4939, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.242, "ferret_sera_escape": null, "mature_H5_site": 161, "mouse_sera_escape": null, "mutant": "P", "mutation": "K165P", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07213, "ferret_sera_escape": 0.03513, "mature_H5_site": 161, "mouse_sera_escape": -0.3964, "mutant": "Q", "mutation": "K165Q", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.2112, "wildtype": "K"}, {"a26_usage": 0.01222, "cell_entry": 0.07884, "ferret_sera_escape": -0.09317, "mature_H5_site": 161, "mouse_sera_escape": -0.05732, "mutant": "R", "mutation": "K165R", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.02349, "wildtype": "K"}, {"a26_usage": null, "cell_entry": -1.7, "ferret_sera_escape": -0.1891, "mature_H5_site": 161, "mouse_sera_escape": null, "mutant": "S", "mutation": "K165S", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04617, "ferret_sera_escape": 0.1435, "mature_H5_site": 161, "mouse_sera_escape": -0.3486, "mutant": "V", "mutation": "K165V", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.1436, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5598, "ferret_sera_escape": null, "mature_H5_site": 161, "mouse_sera_escape": null, "mutant": "W", "mutation": "K165W", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0739, "ferret_sera_escape": 0.2782, "mature_H5_site": 161, "mouse_sera_escape": -0.2974, "mutant": "Y", "mutation": "K165Y", "reference_site": "165", "region": "HA1", "sequential_site": 177, "stability": -0.1365, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.235, "ferret_sera_escape": 0.1057, "mature_H5_site": 162, "mouse_sera_escape": 0.1153, "mutant": "A", "mutation": "I166A", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": -0.09841, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.01314, "ferret_sera_escape": -0.1672, "mature_H5_site": 162, "mouse_sera_escape": null, "mutant": "C", "mutation": "I166C", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 162, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I166I", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.03416, "ferret_sera_escape": 0.06387, "mature_H5_site": 162, "mouse_sera_escape": 0.01819, "mutant": "L", "mutation": "I166L", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": 0.1887, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.04372, "ferret_sera_escape": 0.009895, "mature_H5_site": 162, "mouse_sera_escape": 0.1206, "mutant": "M", "mutation": "I166M", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.05155, "ferret_sera_escape": null, "mature_H5_site": 162, "mouse_sera_escape": null, "mutant": "N", "mutation": "I166N", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.866, "ferret_sera_escape": null, "mature_H5_site": 162, "mouse_sera_escape": null, "mutant": "P", "mutation": "I166P", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03975, "ferret_sera_escape": -0.01186, "mature_H5_site": 162, "mouse_sera_escape": 0.03153, "mutant": "S", "mutation": "I166S", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": -0.1656, "wildtype": "I"}, {"a26_usage": null, "cell_entry": 0.0727, "ferret_sera_escape": null, "mature_H5_site": 162, "mouse_sera_escape": -0.04089, "mutant": "T", "mutation": "I166T", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.105, "ferret_sera_escape": -0.1138, "mature_H5_site": 162, "mouse_sera_escape": 0.04174, "mutant": "V", "mutation": "I166V", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.06066, "ferret_sera_escape": 0.08912, "mature_H5_site": 162, "mouse_sera_escape": 0.1097, "mutant": "W", "mutation": "I166W", "reference_site": "166", "region": "HA1", "sequential_site": 178, "stability": -0.06538, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.01236, "ferret_sera_escape": -0.05659, "mature_H5_site": 163, "mouse_sera_escape": 0.002162, "mutant": "A", "mutation": "S167A", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.09579, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6672, "ferret_sera_escape": 0.1898, "mature_H5_site": 163, "mouse_sera_escape": 0.05593, "mutant": "C", "mutation": "S167C", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.2096, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.01852, "ferret_sera_escape": -0.1991, "mature_H5_site": 163, "mouse_sera_escape": -0.1834, "mutant": "D", "mutation": "S167D", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.2467, "wildtype": "S"}, {"a26_usage": 0.114, "cell_entry": 0.00225, "ferret_sera_escape": -0.1936, "mature_H5_site": 163, "mouse_sera_escape": -0.3681, "mutant": "E", "mutation": "S167E", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.04089, "wildtype": "S"}, {"a26_usage": 0.05252, "cell_entry": -0.495, "ferret_sera_escape": -0.1233, "mature_H5_site": 163, "mouse_sera_escape": -0.06811, "mutant": "F", "mutation": "S167F", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.162, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1599, "ferret_sera_escape": -0.0789, "mature_H5_site": 163, "mouse_sera_escape": 0.02432, "mutant": "G", "mutation": "S167G", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.05972, "wildtype": "S"}, {"a26_usage": 0.09237, "cell_entry": 0.07393, "ferret_sera_escape": -0.2162, "mature_H5_site": 163, "mouse_sera_escape": -0.1052, "mutant": "H", "mutation": "S167H", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6193, "ferret_sera_escape": 0.05962, "mature_H5_site": 163, "mouse_sera_escape": -0.05059, "mutant": "I", "mutation": "S167I", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.05342, "wildtype": "S"}, {"a26_usage": 1.753, "cell_entry": -0.1715, "ferret_sera_escape": 0.2321, "mature_H5_site": 163, "mouse_sera_escape": 0.2421, "mutant": "K", "mutation": "S167K", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": 0.04683, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1144, "ferret_sera_escape": -0.1469, "mature_H5_site": 163, "mouse_sera_escape": -0.05289, "mutant": "L", "mutation": "S167L", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.1434, "wildtype": "S"}, {"a26_usage": 0.1464, "cell_entry": -0.05107, "ferret_sera_escape": 0.02701, "mature_H5_site": 163, "mouse_sera_escape": -0.4168, "mutant": "M", "mutation": "S167M", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.02662, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1458, "ferret_sera_escape": 0.006297, "mature_H5_site": 163, "mouse_sera_escape": -0.01862, "mutant": "N", "mutation": "S167N", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.05605, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.718, "ferret_sera_escape": 0.01305, "mature_H5_site": 163, "mouse_sera_escape": 0.2542, "mutant": "P", "mutation": "S167P", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": null, "wildtype": "S"}, {"a26_usage": 0.06023, "cell_entry": 0.01687, "ferret_sera_escape": -0.0002467, "mature_H5_site": 163, "mouse_sera_escape": -0.05768, "mutant": "Q", "mutation": "S167Q", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.0358, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3122, "ferret_sera_escape": -0.04527, "mature_H5_site": 163, "mouse_sera_escape": 0.09775, "mutant": "R", "mutation": "S167R", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.005479, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 163, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S167S", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1629, "ferret_sera_escape": -0.02258, "mature_H5_site": 163, "mouse_sera_escape": 0.05395, "mutant": "T", "mutation": "S167T", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.009375, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.00976, "ferret_sera_escape": 0.03602, "mature_H5_site": 163, "mouse_sera_escape": -0.06302, "mutant": "V", "mutation": "S167V", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.07212, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1233, "ferret_sera_escape": null, "mature_H5_site": 163, "mouse_sera_escape": -0.1506, "mutant": "W", "mutation": "S167W", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.1027, "wildtype": "S"}, {"a26_usage": 0.06689, "cell_entry": -0.03838, "ferret_sera_escape": -0.1863, "mature_H5_site": 163, "mouse_sera_escape": -0.1862, "mutant": "Y", "mutation": "S167Y", "reference_site": "167", "region": "HA1", "sequential_site": 179, "stability": -0.1772, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y168D", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.533, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y168G", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.116, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y168K", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.2135, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y168L", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y168N", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.773, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y168Q", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.543, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y168R", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.242, "ferret_sera_escape": null, "mature_H5_site": 164, "mouse_sera_escape": 0.2936, "mutant": "T", "mutation": "Y168T", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.04275, "ferret_sera_escape": 0.008316, "mature_H5_site": 164, "mouse_sera_escape": -0.004664, "mutant": "W", "mutation": "Y168W", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": -0.07622, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 164, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y168Y", "reference_site": "168", "region": "HA1", "sequential_site": 180, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1239, "ferret_sera_escape": 0.3203, "mature_H5_site": 165, "mouse_sera_escape": 0.02164, "mutant": "A", "mutation": "N169A", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.0268, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4773, "ferret_sera_escape": 0.1517, "mature_H5_site": 165, "mouse_sera_escape": null, "mutant": "C", "mutation": "N169C", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8375, "ferret_sera_escape": 0.0556, "mature_H5_site": 165, "mouse_sera_escape": 0.005089, "mutant": "D", "mutation": "N169D", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.1534, "wildtype": "N"}, {"a26_usage": 0.562, "cell_entry": -1.044, "ferret_sera_escape": 0.1866, "mature_H5_site": 165, "mouse_sera_escape": 0.06771, "mutant": "E", "mutation": "N169E", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.0699, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8632, "ferret_sera_escape": 0.3308, "mature_H5_site": 165, "mouse_sera_escape": 0.01366, "mutant": "F", "mutation": "N169F", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.0919, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6752, "ferret_sera_escape": 0.1528, "mature_H5_site": 165, "mouse_sera_escape": 0.006806, "mutant": "G", "mutation": "N169G", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.1923, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3942, "ferret_sera_escape": 0.2325, "mature_H5_site": 165, "mouse_sera_escape": 0.04409, "mutant": "H", "mutation": "N169H", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.01155, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5725, "ferret_sera_escape": 0.1767, "mature_H5_site": 165, "mouse_sera_escape": -0.06636, "mutant": "I", "mutation": "N169I", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.002381, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5608, "ferret_sera_escape": 0.1622, "mature_H5_site": 165, "mouse_sera_escape": -0.02267, "mutant": "K", "mutation": "N169K", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.09381, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1149, "ferret_sera_escape": 0.1518, "mature_H5_site": 165, "mouse_sera_escape": -0.2403, "mutant": "L", "mutation": "N169L", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.1013, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.62, "ferret_sera_escape": 0.1987, "mature_H5_site": 165, "mouse_sera_escape": -0.07931, "mutant": "M", "mutation": "N169M", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.007434, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 165, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N169N", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9624, "ferret_sera_escape": 0.3603, "mature_H5_site": 165, "mouse_sera_escape": -0.3962, "mutant": "P", "mutation": "N169P", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.004168, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4913, "ferret_sera_escape": 0.1981, "mature_H5_site": 165, "mouse_sera_escape": -0.02213, "mutant": "Q", "mutation": "N169Q", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.004183, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8052, "ferret_sera_escape": 0.2264, "mature_H5_site": 165, "mouse_sera_escape": 0.003825, "mutant": "R", "mutation": "N169R", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.06424, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3594, "ferret_sera_escape": 0.2862, "mature_H5_site": 165, "mouse_sera_escape": 0.1053, "mutant": "S", "mutation": "N169S", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.02601, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.203, "ferret_sera_escape": -0.01131, "mature_H5_site": 165, "mouse_sera_escape": 0.01684, "mutant": "T", "mutation": "N169T", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.1139, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.061, "ferret_sera_escape": 0.3044, "mature_H5_site": 165, "mouse_sera_escape": -0.02194, "mutant": "V", "mutation": "N169V", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.01005, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.636, "ferret_sera_escape": 0.245, "mature_H5_site": 165, "mouse_sera_escape": 0.103, "mutant": "W", "mutation": "N169W", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": -0.00184, "wildtype": "N"}, {"a26_usage": 0.4512, "cell_entry": -0.1939, "ferret_sera_escape": 0.041, "mature_H5_site": 165, "mouse_sera_escape": 0.1008, "mutant": "Y", "mutation": "N169Y", "reference_site": "169", "region": "HA1", "sequential_site": 181, "stability": 0.005351, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.573, "ferret_sera_escape": -0.1707, "mature_H5_site": 7, "mouse_sera_escape": 0.5134, "mutant": "C", "mutation": "Y17C", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": 1.06, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y17D", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y17E", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.0, "ferret_sera_escape": -0.0588, "mature_H5_site": 7, "mouse_sera_escape": 0.07518, "mutant": "F", "mutation": "Y17F", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": 1.153, "wildtype": "Y"}, {"a26_usage": null, "cell_entry": -5.897, "ferret_sera_escape": null, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y17G", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.171, "ferret_sera_escape": 0.03577, "mature_H5_site": 7, "mouse_sera_escape": 0.07871, "mutant": "H", "mutation": "Y17H", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.561, "ferret_sera_escape": null, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y17L", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.2625, "ferret_sera_escape": -0.1929, "mature_H5_site": 7, "mouse_sera_escape": 0.2087, "mutant": "M", "mutation": "Y17M", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": 1.779, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.609, "ferret_sera_escape": null, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y17N", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y17P", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.791, "ferret_sera_escape": -0.4558, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y17Q", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.508, "ferret_sera_escape": null, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y17R", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.694, "ferret_sera_escape": null, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y17S", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.212, "ferret_sera_escape": -0.2496, "mature_H5_site": 7, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y17T", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": 1.609, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.9518, "ferret_sera_escape": 0.01583, "mature_H5_site": 7, "mouse_sera_escape": 0.4351, "mutant": "W", "mutation": "Y17W", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": 1.08, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 7, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y17Y", "reference_site": "17", "region": "HA1", "sequential_site": 23, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.859, "ferret_sera_escape": null, "mature_H5_site": 166, "mouse_sera_escape": null, "mutant": "D", "mutation": "N170D", "reference_site": "170", "region": "HA1", "sequential_site": 182, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 166, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N170N", "reference_site": "170", "region": "HA1", "sequential_site": 182, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2983, "ferret_sera_escape": 0.2701, "mature_H5_site": 167, "mouse_sera_escape": 0.02445, "mutant": "A", "mutation": "T171A", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.09637, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.056, "ferret_sera_escape": 0.07308, "mature_H5_site": 167, "mouse_sera_escape": 0.1993, "mutant": "D", "mutation": "T171D", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.09455, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5969, "ferret_sera_escape": null, "mature_H5_site": 167, "mouse_sera_escape": null, "mutant": "E", "mutation": "T171E", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.197, "ferret_sera_escape": 0.2418, "mature_H5_site": 167, "mouse_sera_escape": -0.1285, "mutant": "F", "mutation": "T171F", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.09649, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4069, "ferret_sera_escape": 0.2481, "mature_H5_site": 167, "mouse_sera_escape": -0.07925, "mutant": "G", "mutation": "T171G", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.1058, "wildtype": "T"}, {"a26_usage": null, "cell_entry": -0.8943, "ferret_sera_escape": 0.2478, "mature_H5_site": 167, "mouse_sera_escape": null, "mutant": "H", "mutation": "T171H", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4696, "ferret_sera_escape": 0.2607, "mature_H5_site": 167, "mouse_sera_escape": 0.3925, "mutant": "I", "mutation": "T171I", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.06396, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.103, "ferret_sera_escape": 0.4282, "mature_H5_site": 167, "mouse_sera_escape": 0.1438, "mutant": "K", "mutation": "T171K", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": 0.01693, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.549, "ferret_sera_escape": 0.33, "mature_H5_site": 167, "mouse_sera_escape": -0.01351, "mutant": "L", "mutation": "T171L", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.05591, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5026, "ferret_sera_escape": 0.2229, "mature_H5_site": 167, "mouse_sera_escape": 0.03059, "mutant": "N", "mutation": "T171N", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.05, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7733, "ferret_sera_escape": 0.1796, "mature_H5_site": 167, "mouse_sera_escape": -0.1433, "mutant": "P", "mutation": "T171P", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.1724, "wildtype": "T"}, {"a26_usage": 0.4895, "cell_entry": -0.2303, "ferret_sera_escape": 0.2752, "mature_H5_site": 167, "mouse_sera_escape": 0.1957, "mutant": "Q", "mutation": "T171Q", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.008205, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.8508, "ferret_sera_escape": 0.2267, "mature_H5_site": 167, "mouse_sera_escape": 0.1032, "mutant": "R", "mutation": "T171R", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.01106, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.929, "ferret_sera_escape": null, "mature_H5_site": 167, "mouse_sera_escape": null, "mutant": "S", "mutation": "T171S", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 167, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T171T", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.9328, "ferret_sera_escape": null, "mature_H5_site": 167, "mouse_sera_escape": null, "mutant": "V", "mutation": "T171V", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.8176, "ferret_sera_escape": 0.2958, "mature_H5_site": 167, "mouse_sera_escape": -0.06192, "mutant": "W", "mutation": "T171W", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.3096, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3792, "ferret_sera_escape": 0.2414, "mature_H5_site": 167, "mouse_sera_escape": -0.0194, "mutant": "Y", "mutation": "T171Y", "reference_site": "171", "region": "HA1", "sequential_site": 183, "stability": -0.06889, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.01337, "ferret_sera_escape": 0.2236, "mature_H5_site": 168, "mouse_sera_escape": -0.08415, "mutant": "A", "mutation": "N172A", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": -0.04478, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9611, "ferret_sera_escape": 0.02685, "mature_H5_site": 168, "mouse_sera_escape": 0.288, "mutant": "C", "mutation": "N172C", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2963, "ferret_sera_escape": -0.2969, "mature_H5_site": 168, "mouse_sera_escape": -0.2148, "mutant": "D", "mutation": "N172D", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": null, "wildtype": "N"}, {"a26_usage": 0.6679, "cell_entry": -0.1689, "ferret_sera_escape": -0.3221, "mature_H5_site": 168, "mouse_sera_escape": 0.1622, "mutant": "E", "mutation": "N172E", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": -0.002466, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2781, "ferret_sera_escape": -0.01008, "mature_H5_site": 168, "mouse_sera_escape": 0.1778, "mutant": "F", "mutation": "N172F", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.1274, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07768, "ferret_sera_escape": null, "mature_H5_site": 168, "mouse_sera_escape": null, "mutant": "G", "mutation": "N172G", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07389, "ferret_sera_escape": -0.3148, "mature_H5_site": 168, "mouse_sera_escape": 0.008718, "mutant": "I", "mutation": "N172I", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.421, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07534, "ferret_sera_escape": -0.02003, "mature_H5_site": 168, "mouse_sera_escape": 0.5226, "mutant": "K", "mutation": "N172K", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.2524, "wildtype": "N"}, {"a26_usage": 0.1364, "cell_entry": -0.05631, "ferret_sera_escape": -0.09923, "mature_H5_site": 168, "mouse_sera_escape": -0.1085, "mutant": "L", "mutation": "N172L", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.06923, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1514, "ferret_sera_escape": -0.2337, "mature_H5_site": 168, "mouse_sera_escape": -0.066, "mutant": "M", "mutation": "N172M", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": -0.02846, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 168, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N172N", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 168, "mouse_sera_escape": null, "mutant": "P", "mutation": "N172P", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2112, "ferret_sera_escape": -0.2501, "mature_H5_site": 168, "mouse_sera_escape": 0.2512, "mutant": "Q", "mutation": "N172Q", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1487, "ferret_sera_escape": -0.06362, "mature_H5_site": 168, "mouse_sera_escape": 0.2336, "mutant": "R", "mutation": "N172R", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": -0.02646, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3085, "ferret_sera_escape": -0.2898, "mature_H5_site": 168, "mouse_sera_escape": -0.196, "mutant": "S", "mutation": "N172S", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.851, "ferret_sera_escape": null, "mature_H5_site": 168, "mouse_sera_escape": null, "mutant": "T", "mutation": "N172T", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1809, "ferret_sera_escape": -0.2453, "mature_H5_site": 168, "mouse_sera_escape": 0.05441, "mutant": "V", "mutation": "N172V", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.0662, "wildtype": "N"}, {"a26_usage": 0.1049, "cell_entry": 0.00201, "ferret_sera_escape": -0.155, "mature_H5_site": 168, "mouse_sera_escape": 0.3009, "mutant": "W", "mutation": "N172W", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.1994, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07883, "ferret_sera_escape": -0.2529, "mature_H5_site": 168, "mouse_sera_escape": 0.5559, "mutant": "Y", "mutation": "N172Y", "reference_site": "172", "region": "HA1", "sequential_site": 184, "stability": 0.3851, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1192, "ferret_sera_escape": -0.05476, "mature_H5_site": 169, "mouse_sera_escape": 0.0102, "mutant": "A", "mutation": "R173A", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.04628, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.05112, "ferret_sera_escape": null, "mature_H5_site": 169, "mouse_sera_escape": null, "mutant": "C", "mutation": "R173C", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.8701, "ferret_sera_escape": -0.05081, "mature_H5_site": 169, "mouse_sera_escape": 0.0706, "mutant": "D", "mutation": "R173D", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.335, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.01784, "ferret_sera_escape": -0.04108, "mature_H5_site": 169, "mouse_sera_escape": -0.01077, "mutant": "E", "mutation": "R173E", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.1345, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.00217, "ferret_sera_escape": -0.1136, "mature_H5_site": 169, "mouse_sera_escape": -0.008103, "mutant": "F", "mutation": "R173F", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.09475, "wildtype": "R"}, {"a26_usage": 0.1851, "cell_entry": -0.4831, "ferret_sera_escape": -0.08098, "mature_H5_site": 169, "mouse_sera_escape": 0.2034, "mutant": "G", "mutation": "R173G", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.264, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.09069, "ferret_sera_escape": 0.01925, "mature_H5_site": 169, "mouse_sera_escape": 0.05204, "mutant": "I", "mutation": "R173I", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.1311, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.03937, "ferret_sera_escape": 0.073, "mature_H5_site": 169, "mouse_sera_escape": 0.02946, "mutant": "K", "mutation": "R173K", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": -0.005191, "wildtype": "R"}, {"a26_usage": 0.06454, "cell_entry": -0.214, "ferret_sera_escape": -0.07804, "mature_H5_site": 169, "mouse_sera_escape": 0.003801, "mutant": "M", "mutation": "R173M", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.06981, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3454, "ferret_sera_escape": -0.09467, "mature_H5_site": 169, "mouse_sera_escape": 0.06375, "mutant": "N", "mutation": "R173N", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.1003, "wildtype": "R"}, {"a26_usage": 0.1102, "cell_entry": -0.1161, "ferret_sera_escape": -0.04076, "mature_H5_site": 169, "mouse_sera_escape": -0.003677, "mutant": "P", "mutation": "R173P", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": -0.1617, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.196, "ferret_sera_escape": -0.03601, "mature_H5_site": 169, "mouse_sera_escape": -0.05003, "mutant": "Q", "mutation": "R173Q", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.003862, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 169, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R173R", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.05164, "ferret_sera_escape": -0.1974, "mature_H5_site": 169, "mouse_sera_escape": 0.0421, "mutant": "S", "mutation": "R173S", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.03646, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.499, "ferret_sera_escape": -0.162, "mature_H5_site": 169, "mouse_sera_escape": -0.1028, "mutant": "T", "mutation": "R173T", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.07099, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1727, "ferret_sera_escape": -0.03062, "mature_H5_site": 169, "mouse_sera_escape": -0.008879, "mutant": "V", "mutation": "R173V", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.09207, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.02192, "ferret_sera_escape": -0.05799, "mature_H5_site": 169, "mouse_sera_escape": -0.1572, "mutant": "W", "mutation": "R173W", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": 0.2482, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0249, "ferret_sera_escape": 0.0199, "mature_H5_site": 169, "mouse_sera_escape": 0.03356, "mutant": "Y", "mutation": "R173Y", "reference_site": "173", "region": "HA1", "sequential_site": 185, "stability": -0.1068, "wildtype": "R"}, {"a26_usage": 0.1214, "cell_entry": 0.07123, "ferret_sera_escape": 0.02115, "mature_H5_site": 170, "mouse_sera_escape": 0.05337, "mutant": "D", "mutation": "E174D", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.3127, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 170, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E174E", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06942, "ferret_sera_escape": 0.09974, "mature_H5_site": 170, "mouse_sera_escape": 0.03997, "mutant": "F", "mutation": "E174F", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.1865, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5007, "ferret_sera_escape": 0.1117, "mature_H5_site": 170, "mouse_sera_escape": 0.4344, "mutant": "G", "mutation": "E174G", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.1179, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1451, "ferret_sera_escape": 0.2307, "mature_H5_site": 170, "mouse_sera_escape": 0.1005, "mutant": "H", "mutation": "E174H", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.322, "wildtype": "E"}, {"a26_usage": null, "cell_entry": -0.663, "ferret_sera_escape": null, "mature_H5_site": 170, "mouse_sera_escape": null, "mutant": "I", "mutation": "E174I", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.00608, "ferret_sera_escape": 0.05935, "mature_H5_site": 170, "mouse_sera_escape": 0.2376, "mutant": "K", "mutation": "E174K", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.2544, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.02964, "ferret_sera_escape": 0.07709, "mature_H5_site": 170, "mouse_sera_escape": 0.1252, "mutant": "L", "mutation": "E174L", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.06789, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4166, "ferret_sera_escape": 0.006627, "mature_H5_site": 170, "mouse_sera_escape": 0.2988, "mutant": "M", "mutation": "E174M", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": 1.559, "wildtype": "E"}, {"a26_usage": 0.1209, "cell_entry": -0.2261, "ferret_sera_escape": 0.07548, "mature_H5_site": 170, "mouse_sera_escape": 0.2062, "mutant": "N", "mutation": "E174N", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.2823, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.605, "ferret_sera_escape": null, "mature_H5_site": 170, "mouse_sera_escape": null, "mutant": "P", "mutation": "E174P", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02478, "ferret_sera_escape": -0.04029, "mature_H5_site": 170, "mouse_sera_escape": 0.118, "mutant": "Q", "mutation": "E174Q", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.09024, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2184, "ferret_sera_escape": 0.1043, "mature_H5_site": 170, "mouse_sera_escape": 0.2598, "mutant": "R", "mutation": "E174R", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.472, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.07085, "ferret_sera_escape": 0.2168, "mature_H5_site": 170, "mouse_sera_escape": 0.3969, "mutant": "S", "mutation": "E174S", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": -0.1071, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.62, "ferret_sera_escape": 0.3792, "mature_H5_site": 170, "mouse_sera_escape": 0.8269, "mutant": "T", "mutation": "E174T", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": 0.2447, "wildtype": "E"}, {"a26_usage": null, "cell_entry": -0.2008, "ferret_sera_escape": 0.2321, "mature_H5_site": 170, "mouse_sera_escape": 0.267, "mutant": "V", "mutation": "E174V", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": 0.04798, "wildtype": "E"}, {"a26_usage": 0.2123, "cell_entry": -0.4203, "ferret_sera_escape": null, "mature_H5_site": 170, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E174Y", "reference_site": "174", "region": "HA1", "sequential_site": 186, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.01863, "ferret_sera_escape": 0.009104, "mature_H5_site": 171, "mouse_sera_escape": -0.03883, "mutant": "A", "mutation": "D175A", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 0.751, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 171, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D175D", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.1249, "cell_entry": -0.501, "ferret_sera_escape": -0.1347, "mature_H5_site": 171, "mouse_sera_escape": -0.149, "mutant": "E", "mutation": "D175E", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": -0.1798, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1506, "ferret_sera_escape": 0.1095, "mature_H5_site": 171, "mouse_sera_escape": 0.08514, "mutant": "F", "mutation": "D175F", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": -0.03241, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4955, "ferret_sera_escape": 0.057, "mature_H5_site": 171, "mouse_sera_escape": -0.2018, "mutant": "G", "mutation": "D175G", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 0.2863, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.157, "ferret_sera_escape": null, "mature_H5_site": 171, "mouse_sera_escape": null, "mutant": "H", "mutation": "D175H", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.07175, "ferret_sera_escape": 0.01746, "mature_H5_site": 171, "mouse_sera_escape": 0.2082, "mutant": "K", "mutation": "D175K", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 1.733, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1011, "ferret_sera_escape": -0.02987, "mature_H5_site": 171, "mouse_sera_escape": 0.1499, "mutant": "L", "mutation": "D175L", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 0.5159, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.02339, "ferret_sera_escape": -0.02074, "mature_H5_site": 171, "mouse_sera_escape": 0.219, "mutant": "M", "mutation": "D175M", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 1.426, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.995, "ferret_sera_escape": -0.03059, "mature_H5_site": 171, "mouse_sera_escape": 0.3295, "mutant": "N", "mutation": "D175N", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 1.575, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.05921, "ferret_sera_escape": -0.01679, "mature_H5_site": 171, "mouse_sera_escape": 0.06982, "mutant": "Q", "mutation": "D175Q", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 0.7819, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.877, "ferret_sera_escape": -0.03632, "mature_H5_site": 171, "mouse_sera_escape": 0.1616, "mutant": "R", "mutation": "D175R", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 1.482, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.05575, "ferret_sera_escape": -0.09201, "mature_H5_site": 171, "mouse_sera_escape": -0.08841, "mutant": "S", "mutation": "D175S", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 0.95, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.05895, "ferret_sera_escape": 0.1043, "mature_H5_site": 171, "mouse_sera_escape": 0.1483, "mutant": "T", "mutation": "D175T", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3582, "ferret_sera_escape": -0.07807, "mature_H5_site": 171, "mouse_sera_escape": 0.1036, "mutant": "V", "mutation": "D175V", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": 0.9092, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.685, "ferret_sera_escape": -0.03313, "mature_H5_site": 171, "mouse_sera_escape": 0.1949, "mutant": "W", "mutation": "D175W", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1897, "ferret_sera_escape": -0.01229, "mature_H5_site": 171, "mouse_sera_escape": 0.06416, "mutant": "Y", "mutation": "D175Y", "reference_site": "175", "region": "HA1", "sequential_site": 187, "stability": -0.1275, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.828, "ferret_sera_escape": 0.01138, "mature_H5_site": 172, "mouse_sera_escape": 0.3178, "mutant": "C", "mutation": "L176C", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": -0.2393, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "D", "mutation": "L176D", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.806, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "E", "mutation": "L176E", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.455, "ferret_sera_escape": 0.4976, "mature_H5_site": 172, "mouse_sera_escape": 0.04095, "mutant": "F", "mutation": "L176F", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.545, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "H", "mutation": "L176H", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4143, "ferret_sera_escape": -0.04867, "mature_H5_site": 172, "mouse_sera_escape": 0.03309, "mutant": "I", "mutation": "L176I", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": -0.2138, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.681, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "K", "mutation": "L176K", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 172, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L176L", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.3014, "cell_entry": -0.09796, "ferret_sera_escape": 0.1412, "mature_H5_site": 172, "mouse_sera_escape": 0.05206, "mutant": "M", "mutation": "L176M", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": -0.1098, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7219, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "N", "mutation": "L176N", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "P", "mutation": "L176P", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.311, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L176Q", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": null, "mutant": "R", "mutation": "L176R", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.134, "ferret_sera_escape": -0.08808, "mature_H5_site": 172, "mouse_sera_escape": 0.48, "mutant": "S", "mutation": "L176S", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06912, "ferret_sera_escape": -0.02395, "mature_H5_site": 172, "mouse_sera_escape": 0.0316, "mutant": "V", "mutation": "L176V", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": -0.1792, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.134, "ferret_sera_escape": null, "mature_H5_site": 172, "mouse_sera_escape": 0.111, "mutant": "Y", "mutation": "L176Y", "reference_site": "176", "region": "HA1", "sequential_site": 188, "stability": null, "wildtype": "L"}, {"a26_usage": null, "cell_entry": -1.957, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "A", "mutation": "L177A", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.8057, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "C", "mutation": "L177C", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "D", "mutation": "L177D", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "E", "mutation": "L177E", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.161, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "F", "mutation": "L177F", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.847, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "G", "mutation": "L177G", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1164, "ferret_sera_escape": -0.1717, "mature_H5_site": 173, "mouse_sera_escape": -0.02231, "mutant": "I", "mutation": "L177I", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": -0.1773, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "K", "mutation": "L177K", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 173, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L177L", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.79, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "P", "mutation": "L177P", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.657, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L177Q", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.745, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "R", "mutation": "L177R", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.024, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "S", "mutation": "L177S", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06807, "ferret_sera_escape": 0.08619, "mature_H5_site": 173, "mouse_sera_escape": 0.1302, "mutant": "V", "mutation": "L177V", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": -0.2152, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.945, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "W", "mutation": "L177W", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.09, "ferret_sera_escape": null, "mature_H5_site": 173, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L177Y", "reference_site": "177", "region": "HA1", "sequential_site": 189, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.656, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "C", "mutation": "I178C", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "D", "mutation": "I178D", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "E", "mutation": "I178E", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.24, "ferret_sera_escape": -0.3071, "mature_H5_site": 174, "mouse_sera_escape": -0.2078, "mutant": "F", "mutation": "I178F", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": 0.04503, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "G", "mutation": "I178G", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.977, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "H", "mutation": "I178H", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 174, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I178I", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "K", "mutation": "I178K", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.373, "ferret_sera_escape": -0.09354, "mature_H5_site": 174, "mouse_sera_escape": -0.05568, "mutant": "M", "mutation": "I178M", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": -0.04447, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "P", "mutation": "I178P", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -5.748, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I178Q", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "R", "mutation": "I178R", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "S", "mutation": "I178S", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.285, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "T", "mutation": "I178T", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4272, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "V", "mutation": "I178V", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.728, "ferret_sera_escape": -0.3298, "mature_H5_site": 174, "mouse_sera_escape": 0.05702, "mutant": "W", "mutation": "I178W", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": 0.4048, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 174, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I178Y", "reference_site": "178", "region": "HA1", "sequential_site": 190, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03488, "ferret_sera_escape": -0.1308, "mature_H5_site": 175, "mouse_sera_escape": 0.01245, "mutant": "A", "mutation": "L179A", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": -0.003845, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 175, "mouse_sera_escape": null, "mutant": "D", "mutation": "L179D", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.229, "ferret_sera_escape": null, "mature_H5_site": 175, "mouse_sera_escape": null, "mutant": "E", "mutation": "L179E", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.889, "ferret_sera_escape": -0.1965, "mature_H5_site": 175, "mouse_sera_escape": -0.2149, "mutant": "F", "mutation": "L179F", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": -0.7407, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.203, "ferret_sera_escape": null, "mature_H5_site": 175, "mouse_sera_escape": null, "mutant": "G", "mutation": "L179G", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.869, "ferret_sera_escape": -0.1079, "mature_H5_site": 175, "mouse_sera_escape": -0.0281, "mutant": "H", "mutation": "L179H", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.2397, "cell_entry": -0.4528, "ferret_sera_escape": 0.05773, "mature_H5_site": 175, "mouse_sera_escape": 0.02409, "mutant": "I", "mutation": "L179I", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": 0.08892, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 175, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L179L", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.02475, "ferret_sera_escape": 0.1025, "mature_H5_site": 175, "mouse_sera_escape": -0.05598, "mutant": "M", "mutation": "L179M", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": -0.2714, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.542, "ferret_sera_escape": -0.3792, "mature_H5_site": 175, "mouse_sera_escape": -0.1166, "mutant": "N", "mutation": "L179N", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": 0.4598, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.047, "ferret_sera_escape": -0.05963, "mature_H5_site": 175, "mouse_sera_escape": -0.05192, "mutant": "P", "mutation": "L179P", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": 0.06633, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7952, "ferret_sera_escape": -0.3079, "mature_H5_site": 175, "mouse_sera_escape": -0.1477, "mutant": "Q", "mutation": "L179Q", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": -0.2748, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 175, "mouse_sera_escape": null, "mutant": "R", "mutation": "L179R", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06563, "ferret_sera_escape": 0.07781, "mature_H5_site": 175, "mouse_sera_escape": -0.07206, "mutant": "S", "mutation": "L179S", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": -0.1657, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6379, "ferret_sera_escape": -0.2147, "mature_H5_site": 175, "mouse_sera_escape": -0.02911, "mutant": "T", "mutation": "L179T", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2922, "ferret_sera_escape": null, "mature_H5_site": 175, "mouse_sera_escape": null, "mutant": "V", "mutation": "L179V", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.619, "ferret_sera_escape": -0.3976, "mature_H5_site": 175, "mouse_sera_escape": null, "mutant": "W", "mutation": "L179W", "reference_site": "179", "region": "HA1", "sequential_site": 191, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.272, "ferret_sera_escape": null, "mature_H5_site": 8, "mouse_sera_escape": null, "mutant": "A", "mutation": "H18A", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3407, "ferret_sera_escape": 0.01539, "mature_H5_site": 8, "mouse_sera_escape": 0.0468, "mutant": "C", "mutation": "H18C", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": 0.001073, "wildtype": "H"}, {"a26_usage": null, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 8, "mouse_sera_escape": null, "mutant": "D", "mutation": "H18D", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.2797, "ferret_sera_escape": -0.002957, "mature_H5_site": 8, "mouse_sera_escape": 0.1216, "mutant": "F", "mutation": "H18F", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": 1.068, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.165, "ferret_sera_escape": -0.05145, "mature_H5_site": 8, "mouse_sera_escape": -0.1817, "mutant": "G", "mutation": "H18G", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": -0.1583, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 8, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H18H", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5484, "ferret_sera_escape": 0.07955, "mature_H5_site": 8, "mouse_sera_escape": 0.01151, "mutant": "I", "mutation": "H18I", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.02036, "ferret_sera_escape": -0.2388, "mature_H5_site": 8, "mouse_sera_escape": -0.06804, "mutant": "K", "mutation": "H18K", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.253, "ferret_sera_escape": 0.03133, "mature_H5_site": 8, "mouse_sera_escape": null, "mutant": "L", "mutation": "H18L", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.227, "ferret_sera_escape": 0.2191, "mature_H5_site": 8, "mouse_sera_escape": 0.145, "mutant": "M", "mutation": "H18M", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": 0.7004, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.2332, "ferret_sera_escape": 0.01203, "mature_H5_site": 8, "mouse_sera_escape": -0.01388, "mutant": "N", "mutation": "H18N", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": -0.02016, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.751, "ferret_sera_escape": 0.07359, "mature_H5_site": 8, "mouse_sera_escape": 0.196, "mutant": "Q", "mutation": "H18Q", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": 0.6954, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3651, "ferret_sera_escape": 0.07273, "mature_H5_site": 8, "mouse_sera_escape": -0.08267, "mutant": "R", "mutation": "H18R", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": -0.1622, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.04067, "ferret_sera_escape": -0.03843, "mature_H5_site": 8, "mouse_sera_escape": 0.09591, "mutant": "S", "mutation": "H18S", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": -0.2308, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.0621, "ferret_sera_escape": -0.06642, "mature_H5_site": 8, "mouse_sera_escape": 0.04733, "mutant": "T", "mutation": "H18T", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": 0.1048, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.109, "ferret_sera_escape": null, "mature_H5_site": 8, "mouse_sera_escape": null, "mutant": "V", "mutation": "H18V", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.495, "ferret_sera_escape": null, "mature_H5_site": 8, "mouse_sera_escape": null, "mutant": "W", "mutation": "H18W", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.355, "ferret_sera_escape": -0.1429, "mature_H5_site": 8, "mouse_sera_escape": -0.07471, "mutant": "Y", "mutation": "H18Y", "reference_site": "18", "region": "HA1", "sequential_site": 24, "stability": 0.4552, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.964, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "C", "mutation": "W180C", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "D", "mutation": "W180D", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "E", "mutation": "W180E", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.894, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "G", "mutation": "W180G", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.986, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "H", "mutation": "W180H", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "I", "mutation": "W180I", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": null, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "K", "mutation": "W180K", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "L", "mutation": "W180L", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "M", "mutation": "W180M", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.977, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "N", "mutation": "W180N", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.928, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "P", "mutation": "W180P", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W180Q", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.766, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "R", "mutation": "W180R", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -6.024, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "S", "mutation": "W180S", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 176, "mouse_sera_escape": null, "mutant": "T", "mutation": "W180T", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 176, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W180W", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.9538, "ferret_sera_escape": 0.01951, "mature_H5_site": 176, "mouse_sera_escape": 0.02281, "mutant": "Y", "mutation": "W180Y", "reference_site": "180", "region": "HA1", "sequential_site": 192, "stability": -0.0317, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.04537, "ferret_sera_escape": -0.2169, "mature_H5_site": 177, "mouse_sera_escape": -0.1166, "mutant": "A", "mutation": "G181A", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": 0.8074, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.004, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "C", "mutation": "G181C", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.821, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "D", "mutation": "G181D", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.984, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "E", "mutation": "G181E", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "F", "mutation": "G181F", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 177, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G181G", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.039, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "H", "mutation": "G181H", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "I", "mutation": "G181I", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.724, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "K", "mutation": "G181K", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.811, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "L", "mutation": "G181L", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.246, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "M", "mutation": "G181M", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "N", "mutation": "G181N", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "P", "mutation": "G181P", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": null, "cell_entry": -5.635, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "R", "mutation": "G181R", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "S", "mutation": "G181S", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.658, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "T", "mutation": "G181T", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.812, "ferret_sera_escape": null, "mature_H5_site": 177, "mouse_sera_escape": null, "mutant": "W", "mutation": "G181W", "reference_site": "181", "region": "HA1", "sequential_site": 193, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.9902, "ferret_sera_escape": -0.5719, "mature_H5_site": 178, "mouse_sera_escape": -0.1073, "mutant": "A", "mutation": "I182A", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.07884, "ferret_sera_escape": -0.3295, "mature_H5_site": 178, "mouse_sera_escape": -0.1597, "mutant": "C", "mutation": "I182C", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": -0.2143, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.742, "ferret_sera_escape": null, "mature_H5_site": 178, "mouse_sera_escape": null, "mutant": "D", "mutation": "I182D", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.806, "ferret_sera_escape": -0.2813, "mature_H5_site": 178, "mouse_sera_escape": -0.05419, "mutant": "E", "mutation": "I182E", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": -0.1926, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.622, "ferret_sera_escape": null, "mature_H5_site": 178, "mouse_sera_escape": null, "mutant": "G", "mutation": "I182G", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.7576, "ferret_sera_escape": null, "mature_H5_site": 178, "mouse_sera_escape": null, "mutant": "H", "mutation": "I182H", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 178, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I182I", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 178, "mouse_sera_escape": null, "mutant": "K", "mutation": "I182K", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06189, "ferret_sera_escape": -0.1636, "mature_H5_site": 178, "mouse_sera_escape": -0.01692, "mutant": "L", "mutation": "I182L", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": -0.09195, "wildtype": "I"}, {"a26_usage": 0.06279, "cell_entry": 0.07634, "ferret_sera_escape": -0.2152, "mature_H5_site": 178, "mouse_sera_escape": -0.1293, "mutant": "M", "mutation": "I182M", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": -0.2088, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 178, "mouse_sera_escape": null, "mutant": "P", "mutation": "I182P", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2174, "ferret_sera_escape": -0.1946, "mature_H5_site": 178, "mouse_sera_escape": -0.09341, "mutant": "Q", "mutation": "I182Q", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": -0.2523, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.643, "ferret_sera_escape": null, "mature_H5_site": 178, "mouse_sera_escape": null, "mutant": "S", "mutation": "I182S", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5711, "ferret_sera_escape": -0.519, "mature_H5_site": 178, "mouse_sera_escape": -0.2576, "mutant": "T", "mutation": "I182T", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": -0.3219, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.01915, "ferret_sera_escape": -0.1276, "mature_H5_site": 178, "mouse_sera_escape": -0.135, "mutant": "V", "mutation": "I182V", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 178, "mouse_sera_escape": null, "mutant": "W", "mutation": "I182W", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.126, "ferret_sera_escape": -0.392, "mature_H5_site": 178, "mouse_sera_escape": -0.2656, "mutant": "Y", "mutation": "I182Y", "reference_site": "182", "region": "HA1", "sequential_site": 194, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.861, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "E", "mutation": "H183E", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.132, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "F", "mutation": "H183F", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "G", "mutation": "H183G", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 179, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H183H", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "I", "mutation": "H183I", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.861, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "K", "mutation": "H183K", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "L", "mutation": "H183L", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.7515, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": -0.6247, "mutant": "M", "mutation": "H183M", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": -0.09854, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "N", "mutation": "H183N", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.411, "ferret_sera_escape": -0.923, "mature_H5_site": 179, "mouse_sera_escape": -0.4123, "mutant": "Q", "mutation": "H183Q", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": -0.1774, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.016, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "S", "mutation": "H183S", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.986, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "V", "mutation": "H183V", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "W", "mutation": "H183W", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.614, "ferret_sera_escape": null, "mature_H5_site": 179, "mouse_sera_escape": null, "mutant": "Y", "mutation": "H183Y", "reference_site": "183", "region": "HA1", "sequential_site": 195, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.806, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "A", "mutation": "H184A", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.633, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "C", "mutation": "H184C", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.371, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "D", "mutation": "H184D", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.731, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "E", "mutation": "H184E", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "F", "mutation": "H184F", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "G", "mutation": "H184G", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 180, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H184H", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "I", "mutation": "H184I", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "K", "mutation": "H184K", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "L", "mutation": "H184L", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "M", "mutation": "H184M", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.6389, "ferret_sera_escape": -0.5426, "mature_H5_site": 180, "mouse_sera_escape": -0.6153, "mutant": "N", "mutation": "H184N", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.2, "ferret_sera_escape": -0.5873, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "Q", "mutation": "H184Q", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "R", "mutation": "H184R", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.213, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "S", "mutation": "H184S", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.939, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "V", "mutation": "H184V", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "W", "mutation": "H184W", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.187, "ferret_sera_escape": null, "mature_H5_site": 180, "mouse_sera_escape": null, "mutant": "Y", "mutation": "H184Y", "reference_site": "184", "region": "HA1", "sequential_site": 196, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3085, "ferret_sera_escape": -1.075, "mature_H5_site": 181, "mouse_sera_escape": -1.008, "mutant": "C", "mutation": "S185C", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "D", "mutation": "S185D", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.853, "ferret_sera_escape": null, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "E", "mutation": "S185E", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.62, "ferret_sera_escape": null, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "F", "mutation": "S185F", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.86, "ferret_sera_escape": -0.6334, "mature_H5_site": 181, "mouse_sera_escape": -0.4934, "mutant": "G", "mutation": "S185G", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": -0.07411, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.7509, "ferret_sera_escape": -1.458, "mature_H5_site": 181, "mouse_sera_escape": -1.014, "mutant": "I", "mutation": "S185I", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": 0.8878, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.776, "ferret_sera_escape": null, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "L", "mutation": "S185L", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6169, "ferret_sera_escape": -1.299, "mature_H5_site": 181, "mouse_sera_escape": -0.8221, "mutant": "N", "mutation": "S185N", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": 0.06389, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.09438, "ferret_sera_escape": -1.283, "mature_H5_site": 181, "mouse_sera_escape": -0.6445, "mutant": "Q", "mutation": "S185Q", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "R", "mutation": "S185R", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 181, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S185S", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4204, "ferret_sera_escape": -1.701, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "V", "mutation": "S185V", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": 0.04737, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "W", "mutation": "S185W", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 181, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S185Y", "reference_site": "185", "region": "HA1", "sequential_site": 197, "stability": null, "wildtype": "S"}, {"a26_usage": 0.3623, "cell_entry": -0.8998, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "A", "mutation": "N186A", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.398, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "D", "mutation": "N186D", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.595, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "E", "mutation": "N186E", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.116, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "F", "mutation": "N186F", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.27, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "I", "mutation": "N186I", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.41, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "K", "mutation": "N186K", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "L", "mutation": "N186L", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.724, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "M", "mutation": "N186M", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 182, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N186N", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.118, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "P", "mutation": "N186P", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.444, "ferret_sera_escape": -1.162, "mature_H5_site": 182, "mouse_sera_escape": -0.337, "mutant": "Q", "mutation": "N186Q", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.49, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "R", "mutation": "N186R", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.07026, "cell_entry": -0.01905, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "S", "mutation": "N186S", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3488, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "T", "mutation": "N186T", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": null, "cell_entry": -1.577, "ferret_sera_escape": null, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "V", "mutation": "N186V", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.564, "ferret_sera_escape": -0.7961, "mature_H5_site": 182, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N186Y", "reference_site": "186", "region": "region-B", "sequential_site": 198, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.205, "ferret_sera_escape": -0.5518, "mature_H5_site": 183, "mouse_sera_escape": -0.4276, "mutant": "A", "mutation": "N187A", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.1883, "wildtype": "N"}, {"a26_usage": 0.1554, "cell_entry": -0.1002, "ferret_sera_escape": -0.1155, "mature_H5_site": 183, "mouse_sera_escape": -0.4269, "mutant": "C", "mutation": "N187C", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.05238, "wildtype": "N"}, {"a26_usage": 0.02048, "cell_entry": -0.2446, "ferret_sera_escape": -0.6811, "mature_H5_site": 183, "mouse_sera_escape": -0.6013, "mutant": "D", "mutation": "N187D", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.2622, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07847, "ferret_sera_escape": -1.252, "mature_H5_site": 183, "mouse_sera_escape": -0.8497, "mutant": "E", "mutation": "N187E", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.23, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.136, "ferret_sera_escape": 0.09549, "mature_H5_site": 183, "mouse_sera_escape": 0.01992, "mutant": "F", "mutation": "N187F", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": null, "wildtype": "N"}, {"a26_usage": 0.01962, "cell_entry": 0.06036, "ferret_sera_escape": -0.8259, "mature_H5_site": 183, "mouse_sera_escape": -0.6419, "mutant": "G", "mutation": "N187G", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.1047, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.08441, "ferret_sera_escape": -0.1079, "mature_H5_site": 183, "mouse_sera_escape": -0.07595, "mutant": "H", "mutation": "N187H", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.1368, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4657, "ferret_sera_escape": 0.02345, "mature_H5_site": 183, "mouse_sera_escape": -0.1386, "mutant": "K", "mutation": "N187K", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.1836, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2213, "ferret_sera_escape": -0.747, "mature_H5_site": 183, "mouse_sera_escape": -0.791, "mutant": "M", "mutation": "N187M", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 183, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N187N", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.031, "ferret_sera_escape": 0.3054, "mature_H5_site": 183, "mouse_sera_escape": 0.8416, "mutant": "P", "mutation": "N187P", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8596, "ferret_sera_escape": null, "mature_H5_site": 183, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N187Q", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.098, "ferret_sera_escape": -0.1052, "mature_H5_site": 183, "mouse_sera_escape": 0.02999, "mutant": "R", "mutation": "N187R", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.145, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07217, "ferret_sera_escape": 0.237, "mature_H5_site": 183, "mouse_sera_escape": 0.0547, "mutant": "T", "mutation": "N187T", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": 0.06224, "wildtype": "N"}, {"a26_usage": 0.752, "cell_entry": -0.4867, "ferret_sera_escape": -0.7585, "mature_H5_site": 183, "mouse_sera_escape": -0.7501, "mutant": "V", "mutation": "N187V", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.239, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3038, "ferret_sera_escape": -0.7448, "mature_H5_site": 183, "mouse_sera_escape": -0.238, "mutant": "W", "mutation": "N187W", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.2089, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.01341, "ferret_sera_escape": -0.142, "mature_H5_site": 183, "mouse_sera_escape": -0.1573, "mutant": "Y", "mutation": "N187Y", "reference_site": "187", "region": "region-B", "sequential_site": 199, "stability": -0.08976, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 184, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A188A", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.009199, "ferret_sera_escape": 0.052, "mature_H5_site": 184, "mouse_sera_escape": -0.06557, "mutant": "C", "mutation": "A188C", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": -0.1235, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.03025, "ferret_sera_escape": 0.1706, "mature_H5_site": 184, "mouse_sera_escape": 0.07211, "mutant": "D", "mutation": "A188D", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": -0.2786, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.06724, "ferret_sera_escape": 0.1694, "mature_H5_site": 184, "mouse_sera_escape": 0.04745, "mutant": "E", "mutation": "A188E", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": -0.07991, "wildtype": "A"}, {"a26_usage": 0.1472, "cell_entry": -0.1551, "ferret_sera_escape": -0.02706, "mature_H5_site": 184, "mouse_sera_escape": -0.1803, "mutant": "F", "mutation": "A188F", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": -0.03935, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.06618, "ferret_sera_escape": 0.03375, "mature_H5_site": 184, "mouse_sera_escape": -0.05123, "mutant": "G", "mutation": "A188G", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.004294, "wildtype": "A"}, {"a26_usage": 0.241, "cell_entry": -0.01178, "ferret_sera_escape": 0.1061, "mature_H5_site": 184, "mouse_sera_escape": -0.02621, "mutant": "H", "mutation": "A188H", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.03205, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.002775, "ferret_sera_escape": -0.00921, "mature_H5_site": 184, "mouse_sera_escape": -0.09913, "mutant": "I", "mutation": "A188I", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.09838, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5312, "ferret_sera_escape": 0.3149, "mature_H5_site": 184, "mouse_sera_escape": 0.2426, "mutant": "K", "mutation": "A188K", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.1917, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1761, "ferret_sera_escape": -0.2715, "mature_H5_site": 184, "mouse_sera_escape": -0.1304, "mutant": "M", "mutation": "A188M", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": -0.03421, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.04956, "ferret_sera_escape": 0.2428, "mature_H5_site": 184, "mouse_sera_escape": 0.08836, "mutant": "N", "mutation": "A188N", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": -0.01085, "wildtype": "A"}, {"a26_usage": 0.172, "cell_entry": -0.09303, "ferret_sera_escape": 0.09481, "mature_H5_site": 184, "mouse_sera_escape": -0.003613, "mutant": "P", "mutation": "A188P", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.05893, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.06341, "ferret_sera_escape": -0.04367, "mature_H5_site": 184, "mouse_sera_escape": 0.005798, "mutant": "Q", "mutation": "A188Q", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.1225, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.05409, "ferret_sera_escape": 0.4485, "mature_H5_site": 184, "mouse_sera_escape": 0.1141, "mutant": "R", "mutation": "A188R", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.06571, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.067, "ferret_sera_escape": null, "mature_H5_site": 184, "mouse_sera_escape": null, "mutant": "S", "mutation": "A188S", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.383, "ferret_sera_escape": null, "mature_H5_site": 184, "mouse_sera_escape": null, "mutant": "T", "mutation": "A188T", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.01764, "ferret_sera_escape": -0.1279, "mature_H5_site": 184, "mouse_sera_escape": 0.001258, "mutant": "V", "mutation": "A188V", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.06581, "wildtype": "A"}, {"a26_usage": null, "cell_entry": -2.187, "ferret_sera_escape": -0.1581, "mature_H5_site": 184, "mouse_sera_escape": -0.2297, "mutant": "W", "mutation": "A188W", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": null, "wildtype": "A"}, {"a26_usage": 0.03191, "cell_entry": 0.006285, "ferret_sera_escape": -0.02487, "mature_H5_site": 184, "mouse_sera_escape": 0.004347, "mutant": "Y", "mutation": "A188Y", "reference_site": "188", "region": "region-B", "sequential_site": 200, "stability": 0.08506, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.441, "ferret_sera_escape": 0.3734, "mature_H5_site": 185, "mouse_sera_escape": 0.1881, "mutant": "A", "mutation": "E189A", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1052, "ferret_sera_escape": 0.1036, "mature_H5_site": 185, "mouse_sera_escape": 0.06786, "mutant": "D", "mutation": "E189D", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": -0.04327, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 185, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E189E", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7629, "ferret_sera_escape": 0.4981, "mature_H5_site": 185, "mouse_sera_escape": 0.2864, "mutant": "G", "mutation": "E189G", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": 0.03169, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5244, "ferret_sera_escape": 0.04687, "mature_H5_site": 185, "mouse_sera_escape": 0.03085, "mutant": "H", "mutation": "E189H", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": 0.1252, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.341, "ferret_sera_escape": 0.5784, "mature_H5_site": 185, "mouse_sera_escape": 0.4274, "mutant": "K", "mutation": "E189K", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": 0.01372, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.232, "ferret_sera_escape": 0.2569, "mature_H5_site": 185, "mouse_sera_escape": 0.1549, "mutant": "L", "mutation": "E189L", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.0163, "ferret_sera_escape": 0.3405, "mature_H5_site": 185, "mouse_sera_escape": 0.2533, "mutant": "M", "mutation": "E189M", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": 0.03054, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7946, "ferret_sera_escape": 0.3788, "mature_H5_site": 185, "mouse_sera_escape": 0.143, "mutant": "N", "mutation": "E189N", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": 0.007499, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7278, "ferret_sera_escape": 0.487, "mature_H5_site": 185, "mouse_sera_escape": 0.2311, "mutant": "P", "mutation": "E189P", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": -0.04613, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.635, "ferret_sera_escape": null, "mature_H5_site": 185, "mouse_sera_escape": 0.1184, "mutant": "R", "mutation": "E189R", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.363, "ferret_sera_escape": -0.7539, "mature_H5_site": 185, "mouse_sera_escape": -0.1924, "mutant": "S", "mutation": "E189S", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1914, "ferret_sera_escape": 0.1772, "mature_H5_site": 185, "mouse_sera_escape": 0.1439, "mutant": "V", "mutation": "E189V", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": 0.1054, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.276, "ferret_sera_escape": null, "mature_H5_site": 185, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E189Y", "reference_site": "189", "region": "region-B", "sequential_site": 201, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 9, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A19A", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7371, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "C", "mutation": "A19C", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.758, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "D", "mutation": "A19D", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.9811, "ferret_sera_escape": -0.2707, "mature_H5_site": 9, "mouse_sera_escape": -0.1378, "mutant": "E", "mutation": "A19E", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": -0.3152, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "F", "mutation": "A19F", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.6456, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "G", "mutation": "A19G", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.291, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "H", "mutation": "A19H", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.147, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "I", "mutation": "A19I", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.9955, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "K", "mutation": "A19K", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.06347, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "M", "mutation": "A19M", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.8216, "ferret_sera_escape": -0.05663, "mature_H5_site": 9, "mouse_sera_escape": 0.6575, "mutant": "N", "mutation": "A19N", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": 1.431, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "P", "mutation": "A19P", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.07206, "ferret_sera_escape": -0.09182, "mature_H5_site": 9, "mouse_sera_escape": 0.09182, "mutant": "Q", "mutation": "A19Q", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": 0.7691, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.454, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "R", "mutation": "A19R", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.02567, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "S", "mutation": "A19S", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7174, "ferret_sera_escape": -0.09924, "mature_H5_site": 9, "mouse_sera_escape": -0.003144, "mutant": "T", "mutation": "A19T", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": -0.4482, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.204, "ferret_sera_escape": -0.2603, "mature_H5_site": 9, "mouse_sera_escape": 0.09815, "mutant": "W", "mutation": "A19W", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": 0.8972, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.699, "ferret_sera_escape": null, "mature_H5_site": 9, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A19Y", "reference_site": "19", "region": "HA1", "sequential_site": 25, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.351, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "A", "mutation": "E190A", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.901, "ferret_sera_escape": -0.5848, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "C", "mutation": "E190C", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 186, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E190E", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.876, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "F", "mutation": "E190F", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 2.219, "cell_entry": -0.9957, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "G", "mutation": "E190G", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.236, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "H", "mutation": "E190H", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": null, "cell_entry": -4.085, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "I", "mutation": "E190I", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.883, "ferret_sera_escape": -0.1258, "mature_H5_site": 186, "mouse_sera_escape": -0.002602, "mutant": "K", "mutation": "E190K", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 4.892, "cell_entry": -4.434, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "N", "mutation": "E190N", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.876, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "P", "mutation": "E190P", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 2.537, "cell_entry": -1.825, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": -0.07207, "mutant": "Q", "mutation": "E190Q", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 2.372, "cell_entry": -3.242, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "V", "mutation": "E190V", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.955, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "W", "mutation": "E190W", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.95, "ferret_sera_escape": null, "mature_H5_site": 186, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E190Y", "reference_site": "190", "region": "region-B", "sequential_site": 202, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "C", "mutation": "Q191C", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.868, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "D", "mutation": "Q191D", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.575, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "E", "mutation": "Q191E", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "F", "mutation": "Q191F", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.319, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "G", "mutation": "Q191G", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.102, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "I", "mutation": "Q191I", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "K", "mutation": "Q191K", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": null, "cell_entry": -5.964, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "L", "mutation": "Q191L", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.859, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "M", "mutation": "Q191M", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.004065, "ferret_sera_escape": 0.09331, "mature_H5_site": 187, "mouse_sera_escape": -0.4166, "mutant": "N", "mutation": "Q191N", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": 0.001378, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q191P", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 187, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q191Q", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "R", "mutation": "Q191R", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.361, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "S", "mutation": "Q191S", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.473, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "V", "mutation": "Q191V", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "W", "mutation": "Q191W", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 187, "mouse_sera_escape": null, "mutant": "Y", "mutation": "Q191Y", "reference_site": "191", "region": "region-B", "sequential_site": 203, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.01022, "ferret_sera_escape": -0.1913, "mature_H5_site": 188, "mouse_sera_escape": -0.06092, "mutant": "A", "mutation": "T192A", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.0178, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.289, "ferret_sera_escape": -0.00647, "mature_H5_site": 188, "mouse_sera_escape": -0.002782, "mutant": "C", "mutation": "T192C", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": 0.03059, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.07811, "ferret_sera_escape": -0.6769, "mature_H5_site": 188, "mouse_sera_escape": -0.2095, "mutant": "D", "mutation": "T192D", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.1501, "wildtype": "T"}, {"a26_usage": 0.7691, "cell_entry": 0.05019, "ferret_sera_escape": null, "mature_H5_site": 188, "mouse_sera_escape": null, "mutant": "F", "mutation": "T192F", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": null, "wildtype": "T"}, {"a26_usage": 0.06496, "cell_entry": -0.05183, "ferret_sera_escape": 0.09152, "mature_H5_site": 188, "mouse_sera_escape": 0.2292, "mutant": "G", "mutation": "T192G", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.03511, "ferret_sera_escape": -0.2323, "mature_H5_site": 188, "mouse_sera_escape": -0.07476, "mutant": "H", "mutation": "T192H", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.1041, "wildtype": "T"}, {"a26_usage": 0.03627, "cell_entry": 0.03367, "ferret_sera_escape": 0.1872, "mature_H5_site": 188, "mouse_sera_escape": 0.0586, "mutant": "I", "mutation": "T192I", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": 0.1702, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7805, "ferret_sera_escape": 0.5586, "mature_H5_site": 188, "mouse_sera_escape": 0.3087, "mutant": "K", "mutation": "T192K", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.003926, "wildtype": "T"}, {"a26_usage": null, "cell_entry": -0.03453, "ferret_sera_escape": 0.3617, "mature_H5_site": 188, "mouse_sera_escape": null, "mutant": "L", "mutation": "T192L", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.05107, "ferret_sera_escape": 0.07559, "mature_H5_site": 188, "mouse_sera_escape": 0.00494, "mutant": "M", "mutation": "T192M", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.007249, "wildtype": "T"}, {"a26_usage": 0.04052, "cell_entry": 0.03194, "ferret_sera_escape": -0.2255, "mature_H5_site": 188, "mouse_sera_escape": -0.1745, "mutant": "N", "mutation": "T192N", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.009294, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.03218, "ferret_sera_escape": 0.0703, "mature_H5_site": 188, "mouse_sera_escape": 0.02403, "mutant": "Q", "mutation": "T192Q", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": 0.05031, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.154, "ferret_sera_escape": 0.4215, "mature_H5_site": 188, "mouse_sera_escape": 0.09231, "mutant": "R", "mutation": "T192R", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": 0.025, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.0295, "ferret_sera_escape": -0.4007, "mature_H5_site": 188, "mouse_sera_escape": -0.2293, "mutant": "S", "mutation": "T192S", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.02185, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 188, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T192T", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.3955, "cell_entry": -0.3159, "ferret_sera_escape": 0.1918, "mature_H5_site": 188, "mouse_sera_escape": 0.02617, "mutant": "V", "mutation": "T192V", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": 0.03059, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2659, "ferret_sera_escape": 0.05345, "mature_H5_site": 188, "mouse_sera_escape": -0.03944, "mutant": "W", "mutation": "T192W", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.03779, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.002195, "ferret_sera_escape": -0.1966, "mature_H5_site": 188, "mouse_sera_escape": 0.1462, "mutant": "Y", "mutation": "T192Y", "reference_site": "192", "region": "region-B", "sequential_site": 204, "stability": -0.09272, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.03588, "ferret_sera_escape": 0.08359, "mature_H5_site": 189, "mouse_sera_escape": 0.1325, "mutant": "A", "mutation": "N193A", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": 0.01061, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3964, "ferret_sera_escape": null, "mature_H5_site": 189, "mouse_sera_escape": null, "mutant": "D", "mutation": "N193D", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": null, "wildtype": "N"}, {"a26_usage": 0.1896, "cell_entry": -0.3979, "ferret_sera_escape": -0.3286, "mature_H5_site": 189, "mouse_sera_escape": -0.3024, "mutant": "F", "mutation": "N193F", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": -0.1505, "wildtype": "N"}, {"a26_usage": 0.214, "cell_entry": -0.7438, "ferret_sera_escape": null, "mature_H5_site": 189, "mouse_sera_escape": null, "mutant": "G", "mutation": "N193G", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2481, "ferret_sera_escape": 0.5183, "mature_H5_site": 189, "mouse_sera_escape": 0.4621, "mutant": "K", "mutation": "N193K", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": -0.0002146, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.007055, "ferret_sera_escape": null, "mature_H5_site": 189, "mouse_sera_escape": null, "mutant": "L", "mutation": "N193L", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1422, "ferret_sera_escape": 0.1292, "mature_H5_site": 189, "mouse_sera_escape": 0.12, "mutant": "M", "mutation": "N193M", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": 0.08702, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 189, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N193N", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.01775, "ferret_sera_escape": 0.1603, "mature_H5_site": 189, "mouse_sera_escape": 0.1673, "mutant": "Q", "mutation": "N193Q", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": 0.06642, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.397, "ferret_sera_escape": 0.345, "mature_H5_site": 189, "mouse_sera_escape": 0.1694, "mutant": "R", "mutation": "N193R", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": -0.01494, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07625, "ferret_sera_escape": -0.1134, "mature_H5_site": 189, "mouse_sera_escape": -0.03392, "mutant": "S", "mutation": "N193S", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": -0.02832, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0722, "ferret_sera_escape": -0.5167, "mature_H5_site": 189, "mouse_sera_escape": -0.2643, "mutant": "V", "mutation": "N193V", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": 0.01241, "wildtype": "N"}, {"a26_usage": 2.11, "cell_entry": -0.2069, "ferret_sera_escape": -0.2756, "mature_H5_site": 189, "mouse_sera_escape": -0.1186, "mutant": "W", "mutation": "N193W", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": 0.01802, "wildtype": "N"}, {"a26_usage": 0.1032, "cell_entry": -0.4655, "ferret_sera_escape": -0.3188, "mature_H5_site": 189, "mouse_sera_escape": -0.1476, "mutant": "Y", "mutation": "N193Y", "reference_site": "193", "region": "region-B", "sequential_site": 205, "stability": -0.1316, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.07, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "C", "mutation": "L194C", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.98, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "D", "mutation": "L194D", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "E", "mutation": "L194E", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.476, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "F", "mutation": "L194F", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "G", "mutation": "L194G", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.619, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "H", "mutation": "L194H", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.383, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "K", "mutation": "L194K", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 190, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L194L", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1717, "ferret_sera_escape": -1.344, "mature_H5_site": 190, "mouse_sera_escape": -0.7348, "mutant": "M", "mutation": "L194M", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": -0.1652, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.869, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "N", "mutation": "L194N", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "P", "mutation": "L194P", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.59, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L194Q", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.306, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "R", "mutation": "L194R", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.216, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "S", "mutation": "L194S", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.23, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "T", "mutation": "L194T", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3064, "ferret_sera_escape": null, "mature_H5_site": 190, "mouse_sera_escape": null, "mutant": "V", "mutation": "L194V", "reference_site": "194", "region": "region-B", "sequential_site": 206, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.582, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y195C", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y195D", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y195E", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.636, "ferret_sera_escape": 0.08324, "mature_H5_site": 191, "mouse_sera_escape": -0.1447, "mutant": "F", "mutation": "Y195F", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y195I", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y195K", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y195L", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y195M", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.01, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y195N", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y195P", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y195Q", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.037, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y195R", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.288, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y195S", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y195T", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y195V", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.825, "ferret_sera_escape": null, "mature_H5_site": 191, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y195W", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 191, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y195Y", "reference_site": "195", "region": "region-B", "sequential_site": 207, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.08088, "ferret_sera_escape": 0.2056, "mature_H5_site": 192, "mouse_sera_escape": 0.1514, "mutant": "A", "mutation": "K196A", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05601, "ferret_sera_escape": 0.5091, "mature_H5_site": 192, "mouse_sera_escape": 0.126, "mutant": "C", "mutation": "K196C", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": 0.07479, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2559, "ferret_sera_escape": 0.8063, "mature_H5_site": 192, "mouse_sera_escape": 0.1059, "mutant": "D", "mutation": "K196D", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.04622, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3713, "ferret_sera_escape": 0.4882, "mature_H5_site": 192, "mouse_sera_escape": 0.3209, "mutant": "E", "mutation": "K196E", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.007365, "ferret_sera_escape": 0.5122, "mature_H5_site": 192, "mouse_sera_escape": 0.1861, "mutant": "F", "mutation": "K196F", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07444, "ferret_sera_escape": 0.3501, "mature_H5_site": 192, "mouse_sera_escape": 0.1724, "mutant": "H", "mutation": "K196H", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.02333, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 192, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K196K", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07812, "ferret_sera_escape": 0.6195, "mature_H5_site": 192, "mouse_sera_escape": 0.1202, "mutant": "L", "mutation": "K196L", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.1136, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.02107, "ferret_sera_escape": 0.3728, "mature_H5_site": 192, "mouse_sera_escape": 0.2573, "mutant": "M", "mutation": "K196M", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.05403, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.01249, "ferret_sera_escape": 0.3399, "mature_H5_site": 192, "mouse_sera_escape": 0.1411, "mutant": "N", "mutation": "K196N", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.1051, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07326, "ferret_sera_escape": -0.04565, "mature_H5_site": 192, "mouse_sera_escape": 0.2884, "mutant": "Q", "mutation": "K196Q", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.04808, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.09238, "ferret_sera_escape": -0.008822, "mature_H5_site": 192, "mouse_sera_escape": 0.1116, "mutant": "R", "mutation": "K196R", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.0592, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.06693, "ferret_sera_escape": 0.4781, "mature_H5_site": 192, "mouse_sera_escape": 0.1488, "mutant": "S", "mutation": "K196S", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": 0.04075, "wildtype": "K"}, {"a26_usage": 0.07515, "cell_entry": 0.07787, "ferret_sera_escape": 1.104, "mature_H5_site": 192, "mouse_sera_escape": 0.4541, "mutant": "V", "mutation": "K196V", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": 0.0767, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.05117, "ferret_sera_escape": 0.6124, "mature_H5_site": 192, "mouse_sera_escape": 0.2142, "mutant": "W", "mutation": "K196W", "reference_site": "196", "region": "region-B", "sequential_site": 208, "stability": -0.1273, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5802, "ferret_sera_escape": null, "mature_H5_site": 193, "mouse_sera_escape": null, "mutant": "D", "mutation": "N197D", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04911, "ferret_sera_escape": 0.3136, "mature_H5_site": 193, "mouse_sera_escape": -0.002119, "mutant": "E", "mutation": "N197E", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.1331, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7059, "ferret_sera_escape": 0.1696, "mature_H5_site": 193, "mouse_sera_escape": -0.09793, "mutant": "F", "mutation": "N197F", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8245, "ferret_sera_escape": 0.1203, "mature_H5_site": 193, "mouse_sera_escape": -0.2292, "mutant": "G", "mutation": "N197G", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.08882, "wildtype": "N"}, {"a26_usage": 0.05041, "cell_entry": -0.0681, "ferret_sera_escape": 0.1999, "mature_H5_site": 193, "mouse_sera_escape": null, "mutant": "H", "mutation": "N197H", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.06992, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7363, "ferret_sera_escape": 0.1644, "mature_H5_site": 193, "mouse_sera_escape": -0.329, "mutant": "K", "mutation": "N197K", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.08806, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04824, "ferret_sera_escape": null, "mature_H5_site": 193, "mouse_sera_escape": null, "mutant": "L", "mutation": "N197L", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1396, "ferret_sera_escape": 0.1748, "mature_H5_site": 193, "mouse_sera_escape": -0.2698, "mutant": "M", "mutation": "N197M", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.1385, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 193, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N197N", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.01682, "cell_entry": 0.03522, "ferret_sera_escape": 0.4659, "mature_H5_site": 193, "mouse_sera_escape": 0.1115, "mutant": "Q", "mutation": "N197Q", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.02697, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.02481, "ferret_sera_escape": 0.1059, "mature_H5_site": 193, "mouse_sera_escape": -0.07357, "mutant": "R", "mutation": "N197R", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.01479, "ferret_sera_escape": 0.357, "mature_H5_site": 193, "mouse_sera_escape": -0.007594, "mutant": "S", "mutation": "N197S", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.04635, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.219, "ferret_sera_escape": 0.3178, "mature_H5_site": 193, "mouse_sera_escape": -0.04718, "mutant": "T", "mutation": "N197T", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.08826, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.439, "ferret_sera_escape": 0.1678, "mature_H5_site": 193, "mouse_sera_escape": -0.2652, "mutant": "V", "mutation": "N197V", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.1902, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.0356, "ferret_sera_escape": 0.5977, "mature_H5_site": 193, "mouse_sera_escape": 0.1613, "mutant": "W", "mutation": "N197W", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.09866, "ferret_sera_escape": 0.5507, "mature_H5_site": 193, "mouse_sera_escape": 0.1048, "mutant": "Y", "mutation": "N197Y", "reference_site": "197", "region": "region-B", "sequential_site": 209, "stability": -0.1224, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4095, "ferret_sera_escape": 0.2783, "mature_H5_site": 194, "mouse_sera_escape": -0.3596, "mutant": "D", "mutation": "P198D", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.076, "ferret_sera_escape": 0.4202, "mature_H5_site": 194, "mouse_sera_escape": -0.1571, "mutant": "E", "mutation": "P198E", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.1019, "wildtype": "P"}, {"a26_usage": 0.04939, "cell_entry": 0.037, "ferret_sera_escape": null, "mature_H5_site": 194, "mouse_sera_escape": null, "mutant": "F", "mutation": "P198F", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.2687, "ferret_sera_escape": 0.4967, "mature_H5_site": 194, "mouse_sera_escape": -0.1075, "mutant": "G", "mutation": "P198G", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.04776, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3047, "ferret_sera_escape": 0.3173, "mature_H5_site": 194, "mouse_sera_escape": -0.274, "mutant": "H", "mutation": "P198H", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.1406, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3696, "ferret_sera_escape": 0.6792, "mature_H5_site": 194, "mouse_sera_escape": -0.3129, "mutant": "I", "mutation": "P198I", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.03493, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.459, "ferret_sera_escape": 0.626, "mature_H5_site": 194, "mouse_sera_escape": -0.0989, "mutant": "L", "mutation": "P198L", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.04215, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.02524, "ferret_sera_escape": -0.06573, "mature_H5_site": 194, "mouse_sera_escape": -0.4877, "mutant": "M", "mutation": "P198M", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.1501, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 194, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P198P", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.06929, "cell_entry": 0.0473, "ferret_sera_escape": 0.367, "mature_H5_site": 194, "mouse_sera_escape": -0.206, "mutant": "Q", "mutation": "P198Q", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.06342, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.281, "ferret_sera_escape": 0.7673, "mature_H5_site": 194, "mouse_sera_escape": 0.01955, "mutant": "R", "mutation": "P198R", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.05373, "ferret_sera_escape": 0.2756, "mature_H5_site": 194, "mouse_sera_escape": -0.3024, "mutant": "S", "mutation": "P198S", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.02385, "wildtype": "P"}, {"a26_usage": 0.4298, "cell_entry": -0.5757, "ferret_sera_escape": 0.3379, "mature_H5_site": 194, "mouse_sera_escape": -0.1912, "mutant": "T", "mutation": "P198T", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": 0.04321, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.09659, "ferret_sera_escape": 0.4351, "mature_H5_site": 194, "mouse_sera_escape": -0.1511, "mutant": "V", "mutation": "P198V", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.07904, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.539, "ferret_sera_escape": -0.07353, "mature_H5_site": 194, "mouse_sera_escape": -0.2521, "mutant": "W", "mutation": "P198W", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": -0.2287, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.03991, "ferret_sera_escape": 0.6442, "mature_H5_site": 194, "mouse_sera_escape": -0.073, "mutant": "Y", "mutation": "P198Y", "reference_site": "198", "region": "region-B", "sequential_site": 210, "stability": 0.04096, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.05763, "ferret_sera_escape": 0.0604, "mature_H5_site": 195, "mouse_sera_escape": -0.1723, "mutant": "A", "mutation": "T199A", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.07795, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.566, "ferret_sera_escape": -0.03389, "mature_H5_site": 195, "mouse_sera_escape": 0.0006675, "mutant": "C", "mutation": "T199C", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": 0.02651, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.05215, "ferret_sera_escape": 0.1401, "mature_H5_site": 195, "mouse_sera_escape": 0.1501, "mutant": "D", "mutation": "T199D", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.02936, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2546, "ferret_sera_escape": 0.05044, "mature_H5_site": 195, "mouse_sera_escape": -0.007077, "mutant": "F", "mutation": "T199F", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.027, "wildtype": "T"}, {"a26_usage": 0.05929, "cell_entry": -0.1286, "ferret_sera_escape": -0.005935, "mature_H5_site": 195, "mouse_sera_escape": 0.07855, "mutant": "G", "mutation": "T199G", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.07857, "wildtype": "T"}, {"a26_usage": 0.0721, "cell_entry": 0.03299, "ferret_sera_escape": -0.02455, "mature_H5_site": 195, "mouse_sera_escape": -0.0466, "mutant": "H", "mutation": "T199H", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": 0.01462, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1948, "ferret_sera_escape": -0.02639, "mature_H5_site": 195, "mouse_sera_escape": 0.03451, "mutant": "I", "mutation": "T199I", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.002265, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.03725, "ferret_sera_escape": -0.07949, "mature_H5_site": 195, "mouse_sera_escape": 0.04444, "mutant": "K", "mutation": "T199K", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": 0.05717, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.00957, "ferret_sera_escape": -0.1086, "mature_H5_site": 195, "mouse_sera_escape": 0.08204, "mutant": "L", "mutation": "T199L", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.04928, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2989, "ferret_sera_escape": 0.04022, "mature_H5_site": 195, "mouse_sera_escape": 0.04424, "mutant": "Q", "mutation": "T199Q", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.007199, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4187, "ferret_sera_escape": 0.2488, "mature_H5_site": 195, "mouse_sera_escape": null, "mutant": "R", "mutation": "T199R", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": null, "wildtype": "T"}, {"a26_usage": 0.004465, "cell_entry": 0.03191, "ferret_sera_escape": -0.085, "mature_H5_site": 195, "mouse_sera_escape": 0.08293, "mutant": "S", "mutation": "T199S", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.04285, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 195, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T199T", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.1363, "cell_entry": 0.07707, "ferret_sera_escape": 0.238, "mature_H5_site": 195, "mouse_sera_escape": -0.05187, "mutant": "V", "mutation": "T199V", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.02299, "wildtype": "T"}, {"a26_usage": 0.2122, "cell_entry": -1.08, "ferret_sera_escape": null, "mature_H5_site": 195, "mouse_sera_escape": null, "mutant": "W", "mutation": "T199W", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0692, "ferret_sera_escape": 0.1576, "mature_H5_site": 195, "mouse_sera_escape": 0.07476, "mutant": "Y", "mutation": "T199Y", "reference_site": "199", "region": "HA1", "sequential_site": 211, "stability": -0.0252, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1451, "ferret_sera_escape": -0.1646, "mature_H5_site": -9, "mouse_sera_escape": 0.006281, "mutant": "A", "mutation": "L2A", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.07435, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7826, "ferret_sera_escape": -0.0211, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "C", "mutation": "L2C", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "D", "mutation": "L2D", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.661, "ferret_sera_escape": null, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "E", "mutation": "L2E", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5433, "ferret_sera_escape": -0.03409, "mature_H5_site": -9, "mouse_sera_escape": 0.026, "mutant": "F", "mutation": "L2F", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.0255, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4676, "ferret_sera_escape": -0.1523, "mature_H5_site": -9, "mouse_sera_escape": 0.02082, "mutant": "G", "mutation": "L2G", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.08135, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.057, "ferret_sera_escape": -0.1215, "mature_H5_site": -9, "mouse_sera_escape": -0.13, "mutant": "H", "mutation": "L2H", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.1877, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5281, "ferret_sera_escape": -0.01377, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "I", "mutation": "L2I", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.02734, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.977, "ferret_sera_escape": null, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "K", "mutation": "L2K", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -9, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L2L", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06773, "ferret_sera_escape": 0.03233, "mature_H5_site": -9, "mouse_sera_escape": -0.02664, "mutant": "M", "mutation": "L2M", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.04311, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.091, "ferret_sera_escape": null, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "P", "mutation": "L2P", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.256, "ferret_sera_escape": 0.07717, "mature_H5_site": -9, "mouse_sera_escape": 0.1939, "mutant": "Q", "mutation": "L2Q", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "R", "mutation": "L2R", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.01022, "ferret_sera_escape": -0.3156, "mature_H5_site": -9, "mouse_sera_escape": -0.1273, "mutant": "S", "mutation": "L2S", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.1044, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.0171, "ferret_sera_escape": null, "mature_H5_site": -9, "mouse_sera_escape": null, "mutant": "T", "mutation": "L2T", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.608, "ferret_sera_escape": -0.1262, "mature_H5_site": -9, "mouse_sera_escape": 0.04939, "mutant": "V", "mutation": "L2V", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.04979, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2817, "ferret_sera_escape": -0.03422, "mature_H5_site": -9, "mouse_sera_escape": 0.03766, "mutant": "W", "mutation": "L2W", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.07587, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3166, "ferret_sera_escape": 0.1109, "mature_H5_site": -9, "mouse_sera_escape": 0.04438, "mutant": "Y", "mutation": "L2Y", "reference_site": "2", "region": "HA1", "sequential_site": 8, "stability": -0.08331, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.88, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "A", "mutation": "N20A", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": null, "cell_entry": -5.159, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "C", "mutation": "N20C", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.236, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "D", "mutation": "N20D", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": null, "cell_entry": -3.388, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "E", "mutation": "N20E", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "G", "mutation": "N20G", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "H", "mutation": "N20H", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "I", "mutation": "N20I", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.853, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "K", "mutation": "N20K", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "L", "mutation": "N20L", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.862, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "M", "mutation": "N20M", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 10, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N20N", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.751, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "P", "mutation": "N20P", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N20Q", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.276, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "R", "mutation": "N20R", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.403, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "S", "mutation": "N20S", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.053, "ferret_sera_escape": -0.206, "mature_H5_site": 10, "mouse_sera_escape": -0.05135, "mutant": "T", "mutation": "N20T", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": 0.1787, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "W", "mutation": "N20W", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 10, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N20Y", "reference_site": "20", "region": "HA1", "sequential_site": 26, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1878, "ferret_sera_escape": 0.2083, "mature_H5_site": 196, "mouse_sera_escape": 0.1149, "mutant": "A", "mutation": "T200A", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": -0.08473, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5365, "ferret_sera_escape": -0.1272, "mature_H5_site": 196, "mouse_sera_escape": 0.1469, "mutant": "C", "mutation": "T200C", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": -0.2043, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.452, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "D", "mutation": "T200D", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "E", "mutation": "T200E", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "F", "mutation": "T200F", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.03888, "ferret_sera_escape": 0.05122, "mature_H5_site": 196, "mouse_sera_escape": 0.1415, "mutant": "G", "mutation": "T200G", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": -0.2006, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.628, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "H", "mutation": "T200H", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.131, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "I", "mutation": "T200I", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "K", "mutation": "T200K", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "L", "mutation": "T200L", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "M", "mutation": "T200M", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.848, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "N", "mutation": "T200N", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.07342, "ferret_sera_escape": 0.02109, "mature_H5_site": 196, "mouse_sera_escape": 0.05194, "mutant": "P", "mutation": "T200P", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": -0.2693, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.694, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T200Q", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.71, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "R", "mutation": "T200R", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2367, "ferret_sera_escape": -0.1489, "mature_H5_site": 196, "mouse_sera_escape": 0.07291, "mutant": "S", "mutation": "T200S", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": 0.1553, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 196, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T200T", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.01604, "ferret_sera_escape": -0.05412, "mature_H5_site": 196, "mouse_sera_escape": -0.1203, "mutant": "V", "mutation": "T200V", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": -0.2295, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "W", "mutation": "T200W", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 196, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T200Y", "reference_site": "200", "region": "HA1", "sequential_site": 212, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.04903, "ferret_sera_escape": -0.1407, "mature_H5_site": 197, "mouse_sera_escape": -0.1168, "mutant": "A", "mutation": "Y201A", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.1668, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.773, "ferret_sera_escape": -0.3329, "mature_H5_site": 197, "mouse_sera_escape": -0.2085, "mutant": "C", "mutation": "Y201C", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.2277, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4882, "ferret_sera_escape": -0.4373, "mature_H5_site": 197, "mouse_sera_escape": -0.3363, "mutant": "D", "mutation": "Y201D", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.2351, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.04513, "ferret_sera_escape": -0.5301, "mature_H5_site": 197, "mouse_sera_escape": -0.2821, "mutant": "E", "mutation": "Y201E", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.2375, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1835, "ferret_sera_escape": -0.07776, "mature_H5_site": 197, "mouse_sera_escape": -0.06197, "mutant": "F", "mutation": "Y201F", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.04182, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4292, "ferret_sera_escape": -0.1551, "mature_H5_site": 197, "mouse_sera_escape": -0.2159, "mutant": "G", "mutation": "Y201G", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.1458, "wildtype": "Y"}, {"a26_usage": 0.1434, "cell_entry": -0.2328, "ferret_sera_escape": null, "mature_H5_site": 197, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y201H", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.923, "ferret_sera_escape": -0.3258, "mature_H5_site": 197, "mouse_sera_escape": -0.1761, "mutant": "I", "mutation": "Y201I", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.575, "ferret_sera_escape": -0.1775, "mature_H5_site": 197, "mouse_sera_escape": 0.09758, "mutant": "K", "mutation": "Y201K", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.01717, "ferret_sera_escape": -0.1888, "mature_H5_site": 197, "mouse_sera_escape": -0.06926, "mutant": "M", "mutation": "Y201M", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.1522, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.64, "ferret_sera_escape": -0.2887, "mature_H5_site": 197, "mouse_sera_escape": -0.1372, "mutant": "N", "mutation": "Y201N", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 197, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y201P", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.0749, "ferret_sera_escape": -0.1442, "mature_H5_site": 197, "mouse_sera_escape": -0.1126, "mutant": "R", "mutation": "Y201R", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.1231, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.07129, "ferret_sera_escape": -0.09344, "mature_H5_site": 197, "mouse_sera_escape": -0.2779, "mutant": "S", "mutation": "Y201S", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.0991, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3794, "ferret_sera_escape": -0.4735, "mature_H5_site": 197, "mouse_sera_escape": -0.2305, "mutant": "T", "mutation": "Y201T", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.4403, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.041, "ferret_sera_escape": null, "mature_H5_site": 197, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y201V", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.004945, "ferret_sera_escape": -0.1634, "mature_H5_site": 197, "mouse_sera_escape": -0.1536, "mutant": "W", "mutation": "Y201W", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": -0.06318, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 197, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y201Y", "reference_site": "201", "region": "region-D", "sequential_site": 213, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.325, "ferret_sera_escape": -0.09476, "mature_H5_site": 198, "mouse_sera_escape": 0.0637, "mutant": "C", "mutation": "I202C", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": -0.2826, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.907, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "D", "mutation": "I202D", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "E", "mutation": "I202E", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.998, "ferret_sera_escape": -0.1768, "mature_H5_site": 198, "mouse_sera_escape": 0.01593, "mutant": "F", "mutation": "I202F", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.455, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "G", "mutation": "I202G", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.661, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "H", "mutation": "I202H", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 198, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I202I", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "K", "mutation": "I202K", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4756, "ferret_sera_escape": 0.01978, "mature_H5_site": 198, "mouse_sera_escape": -0.08739, "mutant": "L", "mutation": "I202L", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": -0.2349, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03982, "ferret_sera_escape": -0.04557, "mature_H5_site": 198, "mouse_sera_escape": -0.09057, "mutant": "M", "mutation": "I202M", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": -0.3231, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.05, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "N", "mutation": "I202N", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "P", "mutation": "I202P", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "R", "mutation": "I202R", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.184, "ferret_sera_escape": -0.2552, "mature_H5_site": 198, "mouse_sera_escape": -0.1633, "mutant": "S", "mutation": "I202S", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.007615, "ferret_sera_escape": -0.07334, "mature_H5_site": 198, "mouse_sera_escape": 0.01249, "mutant": "T", "mutation": "I202T", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": -0.641, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.215, "ferret_sera_escape": -0.08365, "mature_H5_site": 198, "mouse_sera_escape": 3.875e-05, "mutant": "V", "mutation": "I202V", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": -0.1185, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "W", "mutation": "I202W", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 198, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I202Y", "reference_site": "202", "region": "region-D", "sequential_site": 214, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.208, "ferret_sera_escape": -0.3182, "mature_H5_site": 199, "mouse_sera_escape": -0.02213, "mutant": "C", "mutation": "S203C", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 199, "mouse_sera_escape": null, "mutant": "E", "mutation": "S203E", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.02631, "ferret_sera_escape": -1.061, "mature_H5_site": 199, "mouse_sera_escape": -0.662, "mutant": "F", "mutation": "S203F", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": -0.1419, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.5688, "ferret_sera_escape": 0.08372, "mature_H5_site": 199, "mouse_sera_escape": -0.00678, "mutant": "G", "mutation": "S203G", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": -0.2965, "wildtype": "S"}, {"a26_usage": 0.3472, "cell_entry": -0.3072, "ferret_sera_escape": -0.4085, "mature_H5_site": 199, "mouse_sera_escape": -0.2393, "mutant": "H", "mutation": "S203H", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": 0.06095, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.499, "ferret_sera_escape": -0.6158, "mature_H5_site": 199, "mouse_sera_escape": -0.3182, "mutant": "I", "mutation": "S203I", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.796, "ferret_sera_escape": null, "mature_H5_site": 199, "mouse_sera_escape": null, "mutant": "K", "mutation": "S203K", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.05166, "ferret_sera_escape": -0.4077, "mature_H5_site": 199, "mouse_sera_escape": -0.2549, "mutant": "L", "mutation": "S203L", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": 0.1718, "wildtype": "S"}, {"a26_usage": 0.7484, "cell_entry": -0.4317, "ferret_sera_escape": -0.3333, "mature_H5_site": 199, "mouse_sera_escape": -0.2471, "mutant": "N", "mutation": "S203N", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 199, "mouse_sera_escape": null, "mutant": "P", "mutation": "S203P", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.09187, "ferret_sera_escape": -0.5438, "mature_H5_site": 199, "mouse_sera_escape": -0.3312, "mutant": "Q", "mutation": "S203Q", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": 0.4665, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.768, "ferret_sera_escape": null, "mature_H5_site": 199, "mouse_sera_escape": null, "mutant": "R", "mutation": "S203R", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 199, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S203S", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8307, "ferret_sera_escape": null, "mature_H5_site": 199, "mouse_sera_escape": null, "mutant": "T", "mutation": "S203T", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6649, "ferret_sera_escape": -0.4297, "mature_H5_site": 199, "mouse_sera_escape": -0.3018, "mutant": "V", "mutation": "S203V", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": -0.08441, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.995, "ferret_sera_escape": null, "mature_H5_site": 199, "mouse_sera_escape": null, "mutant": "W", "mutation": "S203W", "reference_site": "203", "region": "region-D", "sequential_site": 215, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.02779, "ferret_sera_escape": -0.1286, "mature_H5_site": 200, "mouse_sera_escape": -0.2445, "mutant": "A", "mutation": "V204A", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": -0.1122, "wildtype": "V"}, {"a26_usage": 0.3008, "cell_entry": -0.9364, "ferret_sera_escape": 0.04848, "mature_H5_site": 200, "mouse_sera_escape": 0.06913, "mutant": "C", "mutation": "V204C", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": -0.1929, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "D", "mutation": "V204D", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "E", "mutation": "V204E", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.667, "ferret_sera_escape": -0.1316, "mature_H5_site": 200, "mouse_sera_escape": -0.167, "mutant": "F", "mutation": "V204F", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": -0.225, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.056, "ferret_sera_escape": -0.1201, "mature_H5_site": 200, "mouse_sera_escape": 0.03496, "mutant": "G", "mutation": "V204G", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": -0.2507, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "H", "mutation": "V204H", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": null, "cell_entry": 0.04156, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "I", "mutation": "V204I", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "K", "mutation": "V204K", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.628, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "L", "mutation": "V204L", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.649, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "M", "mutation": "V204M", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "N", "mutation": "V204N", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "P", "mutation": "V204P", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.033, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V204Q", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "R", "mutation": "V204R", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3403, "ferret_sera_escape": 0.01786, "mature_H5_site": 200, "mouse_sera_escape": -0.09793, "mutant": "S", "mutation": "V204S", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": -0.2865, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.06503, "ferret_sera_escape": -0.1947, "mature_H5_site": 200, "mouse_sera_escape": -0.07021, "mutant": "T", "mutation": "V204T", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": -0.1817, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 200, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V204V", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.938, "ferret_sera_escape": -0.1872, "mature_H5_site": 200, "mouse_sera_escape": -0.1709, "mutant": "W", "mutation": "V204W", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": -0.2413, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.572, "ferret_sera_escape": null, "mature_H5_site": 200, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V204Y", "reference_site": "204", "region": "region-D", "sequential_site": 216, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.9708, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "A", "mutation": "G205A", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.07951, "cell_entry": -1.012, "ferret_sera_escape": -0.9203, "mature_H5_site": 201, "mouse_sera_escape": -0.625, "mutant": "C", "mutation": "G205C", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": -0.2158, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.837, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "E", "mutation": "G205E", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.004, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "F", "mutation": "G205F", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 201, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G205G", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "I", "mutation": "G205I", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "K", "mutation": "G205K", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.926, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "M", "mutation": "G205M", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.884, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "N", "mutation": "G205N", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "P", "mutation": "G205P", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8336, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G205Q", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "R", "mutation": "G205R", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.443, "ferret_sera_escape": -0.4773, "mature_H5_site": 201, "mouse_sera_escape": -0.4653, "mutant": "S", "mutation": "G205S", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": -0.2469, "wildtype": "G"}, {"a26_usage": 0.123, "cell_entry": -0.5742, "ferret_sera_escape": -0.5419, "mature_H5_site": 201, "mouse_sera_escape": -0.4582, "mutant": "T", "mutation": "G205T", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": 0.01387, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.404, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "V", "mutation": "G205V", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "W", "mutation": "G205W", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.907, "ferret_sera_escape": null, "mature_H5_site": 201, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G205Y", "reference_site": "205", "region": "region-D", "sequential_site": 217, "stability": null, "wildtype": "G"}, {"a26_usage": 0.1464, "cell_entry": -0.01796, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "A", "mutation": "T206A", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.1, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "C", "mutation": "T206C", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": null, "cell_entry": -0.2888, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "D", "mutation": "T206D", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "E", "mutation": "T206E", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.745, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "F", "mutation": "T206F", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1915, "ferret_sera_escape": 0.2798, "mature_H5_site": 202, "mouse_sera_escape": 0.1541, "mutant": "G", "mutation": "T206G", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": -0.1614, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2482, "ferret_sera_escape": -0.02183, "mature_H5_site": 202, "mouse_sera_escape": -0.1166, "mutant": "H", "mutation": "T206H", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": -0.6223, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "I", "mutation": "T206I", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "K", "mutation": "T206K", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.774, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "L", "mutation": "T206L", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "M", "mutation": "T206M", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.994, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "N", "mutation": "T206N", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "P", "mutation": "T206P", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T206Q", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.824, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "R", "mutation": "T206R", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 202, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T206T", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "V", "mutation": "T206V", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "W", "mutation": "T206W", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 202, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T206Y", "reference_site": "206", "region": "region-D", "sequential_site": 218, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7795, "ferret_sera_escape": 0.09651, "mature_H5_site": 203, "mouse_sera_escape": 0.06762, "mutant": "A", "mutation": "S207A", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": 0.2105, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.002705, "ferret_sera_escape": -0.1106, "mature_H5_site": 203, "mouse_sera_escape": 0.05027, "mutant": "C", "mutation": "S207C", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.2497, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1294, "ferret_sera_escape": 0.01857, "mature_H5_site": 203, "mouse_sera_escape": 0.0346, "mutant": "D", "mutation": "S207D", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.2327, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06497, "ferret_sera_escape": 0.04028, "mature_H5_site": 203, "mouse_sera_escape": 0.08865, "mutant": "E", "mutation": "S207E", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.2128, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3525, "ferret_sera_escape": -0.1754, "mature_H5_site": 203, "mouse_sera_escape": -0.1478, "mutant": "G", "mutation": "S207G", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.1085, "wildtype": "S"}, {"a26_usage": 0.06748, "cell_entry": -0.02117, "ferret_sera_escape": -0.07502, "mature_H5_site": 203, "mouse_sera_escape": 0.03052, "mutant": "I", "mutation": "S207I", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.275, "wildtype": "S"}, {"a26_usage": 0.01931, "cell_entry": 0.06246, "ferret_sera_escape": 0.1008, "mature_H5_site": 203, "mouse_sera_escape": 0.1268, "mutant": "K", "mutation": "S207K", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": 0.003042, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -0.1935, "ferret_sera_escape": -0.3676, "mature_H5_site": 203, "mouse_sera_escape": -0.1398, "mutant": "L", "mutation": "S207L", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": null, "wildtype": "S"}, {"a26_usage": 0.1138, "cell_entry": -0.02478, "ferret_sera_escape": 0.1504, "mature_H5_site": 203, "mouse_sera_escape": -0.06857, "mutant": "N", "mutation": "S207N", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.2213, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.836, "ferret_sera_escape": null, "mature_H5_site": 203, "mouse_sera_escape": 0.06558, "mutant": "P", "mutation": "S207P", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2801, "ferret_sera_escape": 0.198, "mature_H5_site": 203, "mouse_sera_escape": 0.1212, "mutant": "Q", "mutation": "S207Q", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.02432, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 203, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S207S", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.2453, "cell_entry": -0.1829, "ferret_sera_escape": 0.2023, "mature_H5_site": 203, "mouse_sera_escape": 0.0546, "mutant": "T", "mutation": "S207T", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": -0.3701, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.9663, "ferret_sera_escape": -0.1251, "mature_H5_site": 203, "mouse_sera_escape": -0.03154, "mutant": "W", "mutation": "S207W", "reference_site": "207", "region": "region-D", "sequential_site": 219, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4106, "ferret_sera_escape": null, "mature_H5_site": 204, "mouse_sera_escape": null, "mutant": "A", "mutation": "T208A", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4845, "ferret_sera_escape": 0.1013, "mature_H5_site": 204, "mouse_sera_escape": -0.04432, "mutant": "C", "mutation": "T208C", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.2496, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.04, "ferret_sera_escape": -0.1051, "mature_H5_site": 204, "mouse_sera_escape": -0.1179, "mutant": "D", "mutation": "T208D", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.2982, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.07075, "ferret_sera_escape": -0.001634, "mature_H5_site": 204, "mouse_sera_escape": -0.09234, "mutant": "E", "mutation": "T208E", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.4408, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4355, "ferret_sera_escape": 0.01159, "mature_H5_site": 204, "mouse_sera_escape": null, "mutant": "F", "mutation": "T208F", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.03211, "ferret_sera_escape": -0.1036, "mature_H5_site": 204, "mouse_sera_escape": -0.06654, "mutant": "G", "mutation": "T208G", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.3017, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.05084, "ferret_sera_escape": 0.1363, "mature_H5_site": 204, "mouse_sera_escape": 0.07224, "mutant": "I", "mutation": "T208I", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.1458, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.00554, "ferret_sera_escape": 0.08899, "mature_H5_site": 204, "mouse_sera_escape": 0.07916, "mutant": "K", "mutation": "T208K", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.1308, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.0802, "ferret_sera_escape": -0.0915, "mature_H5_site": 204, "mouse_sera_escape": 0.0522, "mutant": "L", "mutation": "T208L", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.1567, "wildtype": "T"}, {"a26_usage": 0.3494, "cell_entry": -0.3923, "ferret_sera_escape": -0.07218, "mature_H5_site": 204, "mouse_sera_escape": 0.01846, "mutant": "M", "mutation": "T208M", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.08901, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5868, "ferret_sera_escape": null, "mature_H5_site": 204, "mouse_sera_escape": null, "mutant": "N", "mutation": "T208N", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 204, "mouse_sera_escape": null, "mutant": "P", "mutation": "T208P", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.04968, "ferret_sera_escape": 0.1154, "mature_H5_site": 204, "mouse_sera_escape": 0.03734, "mutant": "Q", "mutation": "T208Q", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.1804, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2482, "ferret_sera_escape": -0.009407, "mature_H5_site": 204, "mouse_sera_escape": 0.02496, "mutant": "R", "mutation": "T208R", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.2438, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2978, "ferret_sera_escape": -0.07459, "mature_H5_site": 204, "mouse_sera_escape": 0.002721, "mutant": "S", "mutation": "T208S", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.1938, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 204, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T208T", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5021, "ferret_sera_escape": 0.04161, "mature_H5_site": 204, "mouse_sera_escape": 0.08205, "mutant": "V", "mutation": "T208V", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": null, "wildtype": "T"}, {"a26_usage": 0.08724, "cell_entry": 0.0459, "ferret_sera_escape": 0.1716, "mature_H5_site": 204, "mouse_sera_escape": 0.04573, "mutant": "W", "mutation": "T208W", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.2331, "wildtype": "T"}, {"a26_usage": 0.4689, "cell_entry": -0.4254, "ferret_sera_escape": -0.05105, "mature_H5_site": 204, "mouse_sera_escape": -0.03363, "mutant": "Y", "mutation": "T208Y", "reference_site": "208", "region": "region-D", "sequential_site": 220, "stability": -0.1661, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.06468, "ferret_sera_escape": 0.02097, "mature_H5_site": 205, "mouse_sera_escape": 0.01013, "mutant": "C", "mutation": "L209C", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": 0.08321, "wildtype": "L"}, {"a26_usage": 0.01079, "cell_entry": -0.2622, "ferret_sera_escape": 0.01404, "mature_H5_site": 205, "mouse_sera_escape": 0.09776, "mutant": "E", "mutation": "L209E", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": 0.008546, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.991, "ferret_sera_escape": null, "mature_H5_site": 205, "mouse_sera_escape": null, "mutant": "F", "mutation": "L209F", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.869, "ferret_sera_escape": null, "mature_H5_site": 205, "mouse_sera_escape": null, "mutant": "G", "mutation": "L209G", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.696, "ferret_sera_escape": null, "mature_H5_site": 205, "mouse_sera_escape": null, "mutant": "K", "mutation": "L209K", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 205, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L209L", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1419, "ferret_sera_escape": -0.04456, "mature_H5_site": 205, "mouse_sera_escape": 0.05669, "mutant": "M", "mutation": "L209M", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": -0.1727, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 205, "mouse_sera_escape": null, "mutant": "P", "mutation": "L209P", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6816, "ferret_sera_escape": -0.3307, "mature_H5_site": 205, "mouse_sera_escape": -0.1644, "mutant": "Q", "mutation": "L209Q", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.728, "ferret_sera_escape": null, "mature_H5_site": 205, "mouse_sera_escape": null, "mutant": "R", "mutation": "L209R", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.821, "ferret_sera_escape": null, "mature_H5_site": 205, "mouse_sera_escape": null, "mutant": "S", "mutation": "L209S", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2147, "ferret_sera_escape": -0.1465, "mature_H5_site": 205, "mouse_sera_escape": -0.06417, "mutant": "T", "mutation": "L209T", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": -0.04456, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.382, "ferret_sera_escape": 0.129, "mature_H5_site": 205, "mouse_sera_escape": 0.03634, "mutant": "V", "mutation": "L209V", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": 0.4008, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.629, "ferret_sera_escape": null, "mature_H5_site": 205, "mouse_sera_escape": null, "mutant": "W", "mutation": "L209W", "reference_site": "209", "region": "region-D", "sequential_site": 221, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.633, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "C", "mutation": "N21C", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.22, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "D", "mutation": "N21D", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6686, "ferret_sera_escape": -0.05557, "mature_H5_site": 11, "mouse_sera_escape": -0.03642, "mutant": "G", "mutation": "N21G", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": -0.05949, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.693, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "H", "mutation": "N21H", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.993, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "I", "mutation": "N21I", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.355, "ferret_sera_escape": 0.01568, "mature_H5_site": 11, "mouse_sera_escape": 0.1385, "mutant": "K", "mutation": "N21K", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": -0.04842, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05349, "ferret_sera_escape": -0.1143, "mature_H5_site": 11, "mouse_sera_escape": 0.1369, "mutant": "L", "mutation": "N21L", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": -0.1696, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.958, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "M", "mutation": "N21M", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 11, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N21N", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8727, "ferret_sera_escape": -0.1176, "mature_H5_site": 11, "mouse_sera_escape": 0.1049, "mutant": "Q", "mutation": "N21Q", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.184, "ferret_sera_escape": -0.01805, "mature_H5_site": 11, "mouse_sera_escape": 0.4196, "mutant": "R", "mutation": "N21R", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.204, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "S", "mutation": "N21S", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9196, "ferret_sera_escape": -0.0873, "mature_H5_site": 11, "mouse_sera_escape": 0.3256, "mutant": "T", "mutation": "N21T", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "V", "mutation": "N21V", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.732, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "W", "mutation": "N21W", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.398, "ferret_sera_escape": null, "mature_H5_site": 11, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N21Y", "reference_site": "21", "region": "HA1", "sequential_site": 27, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.794, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "A", "mutation": "N210A", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.659, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "D", "mutation": "N210D", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.76, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "E", "mutation": "N210E", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.798, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "F", "mutation": "N210F", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.665, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "H", "mutation": "N210H", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.511, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "I", "mutation": "N210I", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "K", "mutation": "N210K", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.708, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "L", "mutation": "N210L", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.263, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "M", "mutation": "N210M", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 206, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N210N", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.93, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "P", "mutation": "N210P", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.646, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N210Q", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "R", "mutation": "N210R", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.767, "ferret_sera_escape": -0.1756, "mature_H5_site": 206, "mouse_sera_escape": -0.02884, "mutant": "S", "mutation": "N210S", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.603, "ferret_sera_escape": -0.5212, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "T", "mutation": "N210T", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": -0.1609, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "V", "mutation": "N210V", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.175, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "W", "mutation": "N210W", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.693, "ferret_sera_escape": null, "mature_H5_site": 206, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N210Y", "reference_site": "210", "region": "region-D", "sequential_site": 222, "stability": null, "wildtype": "N"}, {"a26_usage": 0.5204, "cell_entry": -0.372, "ferret_sera_escape": null, "mature_H5_site": 207, "mouse_sera_escape": null, "mutant": "A", "mutation": "Q211A", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1783, "ferret_sera_escape": 0.119, "mature_H5_site": 207, "mouse_sera_escape": 0.03715, "mutant": "C", "mutation": "Q211C", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.111, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1263, "ferret_sera_escape": -0.02441, "mature_H5_site": 207, "mouse_sera_escape": 0.02827, "mutant": "D", "mutation": "Q211D", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.5599, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.06217, "ferret_sera_escape": 0.09265, "mature_H5_site": 207, "mouse_sera_escape": -0.05058, "mutant": "E", "mutation": "Q211E", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.3173, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.061, "ferret_sera_escape": -0.231, "mature_H5_site": 207, "mouse_sera_escape": -0.03894, "mutant": "F", "mutation": "Q211F", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.1603, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.219, "ferret_sera_escape": -0.01257, "mature_H5_site": 207, "mouse_sera_escape": 0.005562, "mutant": "G", "mutation": "Q211G", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.2506, "wildtype": "Q"}, {"a26_usage": 0.0197, "cell_entry": 0.06265, "ferret_sera_escape": 0.0845, "mature_H5_site": 207, "mouse_sera_escape": -0.01952, "mutant": "H", "mutation": "Q211H", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.4032, "wildtype": "Q"}, {"a26_usage": 0.001446, "cell_entry": -0.01455, "ferret_sera_escape": null, "mature_H5_site": 207, "mouse_sera_escape": null, "mutant": "I", "mutation": "Q211I", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.7477, "ferret_sera_escape": -0.08039, "mature_H5_site": 207, "mouse_sera_escape": -0.2052, "mutant": "K", "mutation": "Q211K", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.2086, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1064, "ferret_sera_escape": -0.095, "mature_H5_site": 207, "mouse_sera_escape": -0.1192, "mutant": "L", "mutation": "Q211L", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.1564, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.06665, "ferret_sera_escape": 0.02265, "mature_H5_site": 207, "mouse_sera_escape": -0.04052, "mutant": "N", "mutation": "Q211N", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.3773, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.669, "ferret_sera_escape": null, "mature_H5_site": 207, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q211P", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 207, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q211Q", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1399, "ferret_sera_escape": -0.1183, "mature_H5_site": 207, "mouse_sera_escape": -0.1399, "mutant": "R", "mutation": "Q211R", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.3531, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.04676, "ferret_sera_escape": -0.03933, "mature_H5_site": 207, "mouse_sera_escape": -0.09986, "mutant": "S", "mutation": "Q211S", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.354, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.475, "ferret_sera_escape": -0.3415, "mature_H5_site": 207, "mouse_sera_escape": -0.06318, "mutant": "T", "mutation": "Q211T", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.4775, "ferret_sera_escape": 0.065, "mature_H5_site": 207, "mouse_sera_escape": 0.03089, "mutant": "V", "mutation": "Q211V", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.2548, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.04648, "ferret_sera_escape": -0.249, "mature_H5_site": 207, "mouse_sera_escape": -0.09529, "mutant": "W", "mutation": "Q211W", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.06918, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1633, "ferret_sera_escape": -0.07702, "mature_H5_site": 207, "mouse_sera_escape": -0.06302, "mutant": "Y", "mutation": "Q211Y", "reference_site": "211", "region": "region-D", "sequential_site": 223, "stability": -0.1589, "wildtype": "Q"}, {"a26_usage": 0.00196, "cell_entry": 0.05157, "ferret_sera_escape": -0.1934, "mature_H5_site": 208, "mouse_sera_escape": -0.14, "mutant": "A", "mutation": "R212A", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": -0.158, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1094, "ferret_sera_escape": -0.3191, "mature_H5_site": 208, "mouse_sera_escape": -0.1618, "mutant": "C", "mutation": "R212C", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": -0.21, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.756, "ferret_sera_escape": null, "mature_H5_site": 208, "mouse_sera_escape": null, "mutant": "D", "mutation": "R212D", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.009905, "ferret_sera_escape": -0.3961, "mature_H5_site": 208, "mouse_sera_escape": -0.2991, "mutant": "F", "mutation": "R212F", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": -0.2355, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4338, "ferret_sera_escape": -0.2689, "mature_H5_site": 208, "mouse_sera_escape": null, "mutant": "H", "mutation": "R212H", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": null, "wildtype": "R"}, {"a26_usage": 0.01618, "cell_entry": 0.0764, "ferret_sera_escape": -0.1515, "mature_H5_site": 208, "mouse_sera_escape": -0.1688, "mutant": "I", "mutation": "R212I", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": 0.3405, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.351, "ferret_sera_escape": -0.2088, "mature_H5_site": 208, "mouse_sera_escape": -0.05484, "mutant": "K", "mutation": "R212K", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": 0.03514, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.001365, "ferret_sera_escape": -0.134, "mature_H5_site": 208, "mouse_sera_escape": -0.1827, "mutant": "N", "mutation": "R212N", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": -0.08621, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 208, "mouse_sera_escape": null, "mutant": "P", "mutation": "R212P", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3394, "ferret_sera_escape": -0.1911, "mature_H5_site": 208, "mouse_sera_escape": -0.04824, "mutant": "Q", "mutation": "R212Q", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": -0.03155, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 208, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R212R", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.86, "ferret_sera_escape": -0.1914, "mature_H5_site": 208, "mouse_sera_escape": -0.1391, "mutant": "S", "mutation": "R212S", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": -0.2268, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.745, "ferret_sera_escape": null, "mature_H5_site": 208, "mouse_sera_escape": null, "mutant": "T", "mutation": "R212T", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.8722, "ferret_sera_escape": null, "mature_H5_site": 208, "mouse_sera_escape": null, "mutant": "W", "mutation": "R212W", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.06514, "ferret_sera_escape": -0.4964, "mature_H5_site": 208, "mouse_sera_escape": -0.4613, "mutant": "Y", "mutation": "R212Y", "reference_site": "212", "region": "region-D", "sequential_site": 224, "stability": -0.2718, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.01018, "ferret_sera_escape": null, "mature_H5_site": 209, "mouse_sera_escape": null, "mutant": "A", "mutation": "L213A", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": null, "wildtype": "L"}, {"a26_usage": 0.1463, "cell_entry": 0.03875, "ferret_sera_escape": -0.06493, "mature_H5_site": 209, "mouse_sera_escape": -0.03196, "mutant": "C", "mutation": "L213C", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.2067, "wildtype": "L"}, {"a26_usage": 0.2251, "cell_entry": -0.4933, "ferret_sera_escape": -0.09064, "mature_H5_site": 209, "mouse_sera_escape": null, "mutant": "D", "mutation": "L213D", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2292, "ferret_sera_escape": -0.2278, "mature_H5_site": 209, "mouse_sera_escape": -0.1614, "mutant": "E", "mutation": "L213E", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.2289, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.855, "ferret_sera_escape": -0.3583, "mature_H5_site": 209, "mouse_sera_escape": -0.2054, "mutant": "G", "mutation": "L213G", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.1579, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.006395, "ferret_sera_escape": -0.1397, "mature_H5_site": 209, "mouse_sera_escape": -0.1507, "mutant": "H", "mutation": "L213H", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.3982, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6634, "ferret_sera_escape": -0.2119, "mature_H5_site": 209, "mouse_sera_escape": -0.01093, "mutant": "I", "mutation": "L213I", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.07551, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9553, "ferret_sera_escape": -0.07762, "mature_H5_site": 209, "mouse_sera_escape": -0.03552, "mutant": "K", "mutation": "L213K", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 209, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L213L", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06624, "ferret_sera_escape": null, "mature_H5_site": 209, "mouse_sera_escape": null, "mutant": "M", "mutation": "L213M", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 209, "mouse_sera_escape": null, "mutant": "P", "mutation": "L213P", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1603, "ferret_sera_escape": -0.1891, "mature_H5_site": 209, "mouse_sera_escape": -0.09999, "mutant": "Q", "mutation": "L213Q", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.3292, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.638, "ferret_sera_escape": -0.02025, "mature_H5_site": 209, "mouse_sera_escape": 0.0131, "mutant": "R", "mutation": "L213R", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.2638, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1492, "ferret_sera_escape": -0.0989, "mature_H5_site": 209, "mouse_sera_escape": -0.1182, "mutant": "S", "mutation": "L213S", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.2729, "wildtype": "L"}, {"a26_usage": 0.376, "cell_entry": -1.061, "ferret_sera_escape": 0.02541, "mature_H5_site": 209, "mouse_sera_escape": null, "mutant": "T", "mutation": "L213T", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.03, "ferret_sera_escape": 0.07158, "mature_H5_site": 209, "mouse_sera_escape": -0.04966, "mutant": "V", "mutation": "L213V", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.1879, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.302, "ferret_sera_escape": -0.2164, "mature_H5_site": 209, "mouse_sera_escape": -0.1726, "mutant": "W", "mutation": "L213W", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.2252, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.002795, "ferret_sera_escape": -0.1371, "mature_H5_site": 209, "mouse_sera_escape": -0.07714, "mutant": "Y", "mutation": "L213Y", "reference_site": "213", "region": "region-D", "sequential_site": 225, "stability": -0.2108, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 210, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A214A", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.07426, "ferret_sera_escape": -0.01519, "mature_H5_site": 210, "mouse_sera_escape": -0.03486, "mutant": "C", "mutation": "A214C", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": -0.07378, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.02426, "ferret_sera_escape": -0.1886, "mature_H5_site": 210, "mouse_sera_escape": -0.07832, "mutant": "D", "mutation": "A214D", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": -0.1229, "wildtype": "A"}, {"a26_usage": 0.2028, "cell_entry": -0.01068, "ferret_sera_escape": 0.04924, "mature_H5_site": 210, "mouse_sera_escape": 0.1379, "mutant": "E", "mutation": "A214E", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": -0.01961, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.00549, "ferret_sera_escape": null, "mature_H5_site": 210, "mouse_sera_escape": null, "mutant": "F", "mutation": "A214F", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.003955, "ferret_sera_escape": -0.06434, "mature_H5_site": 210, "mouse_sera_escape": -0.03472, "mutant": "I", "mutation": "A214I", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": null, "wildtype": "A"}, {"a26_usage": 0.3148, "cell_entry": 0.05656, "ferret_sera_escape": 0.02207, "mature_H5_site": 210, "mouse_sera_escape": 0.1015, "mutant": "K", "mutation": "A214K", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": 0.184, "wildtype": "A"}, {"a26_usage": 0.04296, "cell_entry": 0.06172, "ferret_sera_escape": -0.08259, "mature_H5_site": 210, "mouse_sera_escape": -0.07201, "mutant": "L", "mutation": "A214L", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": -0.03536, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.02643, "ferret_sera_escape": -0.01686, "mature_H5_site": 210, "mouse_sera_escape": -0.03036, "mutant": "M", "mutation": "A214M", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": -0.0006739, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.01319, "ferret_sera_escape": 0.1016, "mature_H5_site": 210, "mouse_sera_escape": 0.1127, "mutant": "N", "mutation": "A214N", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": -0.0008743, "wildtype": "A"}, {"a26_usage": 0.3676, "cell_entry": -0.1523, "ferret_sera_escape": 0.08474, "mature_H5_site": 210, "mouse_sera_escape": 0.05708, "mutant": "Q", "mutation": "A214Q", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": 0.05546, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.6893, "ferret_sera_escape": 0.1919, "mature_H5_site": 210, "mouse_sera_escape": 0.00668, "mutant": "R", "mutation": "A214R", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": 0.06067, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3456, "ferret_sera_escape": 0.01961, "mature_H5_site": 210, "mouse_sera_escape": -0.1283, "mutant": "S", "mutation": "A214S", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": -0.02598, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.0005658, "ferret_sera_escape": -0.2371, "mature_H5_site": 210, "mouse_sera_escape": -0.02958, "mutant": "T", "mutation": "A214T", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": 0.1316, "wildtype": "A"}, {"a26_usage": 0.4213, "cell_entry": -0.1736, "ferret_sera_escape": -0.0642, "mature_H5_site": 210, "mouse_sera_escape": -0.1015, "mutant": "V", "mutation": "A214V", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": 0.07261, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.245, "ferret_sera_escape": null, "mature_H5_site": 210, "mouse_sera_escape": null, "mutant": "W", "mutation": "A214W", "reference_site": "214", "region": "region-D", "sequential_site": 226, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.584, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "A", "mutation": "P215A", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.634, "ferret_sera_escape": -0.09007, "mature_H5_site": 211, "mouse_sera_escape": -0.04602, "mutant": "C", "mutation": "P215C", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": -0.2576, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "D", "mutation": "P215D", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "E", "mutation": "P215E", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "F", "mutation": "P215F", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "G", "mutation": "P215G", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": null, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "I", "mutation": "P215I", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "K", "mutation": "P215K", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.853, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "L", "mutation": "P215L", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "M", "mutation": "P215M", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.523, "ferret_sera_escape": -0.3085, "mature_H5_site": 211, "mouse_sera_escape": -0.1512, "mutant": "N", "mutation": "P215N", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 211, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P215P", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P215Q", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.881, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "R", "mutation": "P215R", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.959, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "S", "mutation": "P215S", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.431, "ferret_sera_escape": -0.5554, "mature_H5_site": 211, "mouse_sera_escape": -0.1376, "mutant": "V", "mutation": "P215V", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.88, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "W", "mutation": "P215W", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.409, "ferret_sera_escape": null, "mature_H5_site": 211, "mouse_sera_escape": null, "mutant": "Y", "mutation": "P215Y", "reference_site": "215", "region": "region-D", "sequential_site": 227, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0329, "ferret_sera_escape": -0.2303, "mature_H5_site": 212, "mouse_sera_escape": -0.2051, "mutant": "C", "mutation": "K216C", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": -0.2786, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.749, "ferret_sera_escape": null, "mature_H5_site": 212, "mouse_sera_escape": null, "mutant": "E", "mutation": "K216E", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.08566, "ferret_sera_escape": -0.8109, "mature_H5_site": 212, "mouse_sera_escape": -0.589, "mutant": "F", "mutation": "K216F", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": -0.2543, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 212, "mouse_sera_escape": null, "mutant": "G", "mutation": "K216G", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03417, "ferret_sera_escape": -0.7372, "mature_H5_site": 212, "mouse_sera_escape": -0.5455, "mutant": "H", "mutation": "K216H", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": 0.09082, "wildtype": "K"}, {"a26_usage": null, "cell_entry": -0.3852, "ferret_sera_escape": -0.4322, "mature_H5_site": 212, "mouse_sera_escape": -0.1907, "mutant": "I", "mutation": "K216I", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": 0.063, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 212, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K216K", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.1195, "cell_entry": 0.07761, "ferret_sera_escape": -0.2492, "mature_H5_site": 212, "mouse_sera_escape": -0.3991, "mutant": "L", "mutation": "K216L", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": 0.08161, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.02587, "ferret_sera_escape": -0.4992, "mature_H5_site": 212, "mouse_sera_escape": -0.3919, "mutant": "M", "mutation": "K216M", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": -0.2978, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.257, "ferret_sera_escape": -0.8952, "mature_H5_site": 212, "mouse_sera_escape": -0.5546, "mutant": "N", "mutation": "K216N", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": -0.01479, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 212, "mouse_sera_escape": null, "mutant": "P", "mutation": "K216P", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.06986, "ferret_sera_escape": -0.3744, "mature_H5_site": 212, "mouse_sera_escape": -0.2542, "mutant": "Q", "mutation": "K216Q", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.04816, "ferret_sera_escape": -0.08764, "mature_H5_site": 212, "mouse_sera_escape": 0.09474, "mutant": "R", "mutation": "K216R", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": -0.02283, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05051, "ferret_sera_escape": -0.5087, "mature_H5_site": 212, "mouse_sera_escape": -0.4646, "mutant": "S", "mutation": "K216S", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": -0.3009, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.366, "ferret_sera_escape": -0.08445, "mature_H5_site": 212, "mouse_sera_escape": 0.05237, "mutant": "T", "mutation": "K216T", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07996, "ferret_sera_escape": null, "mature_H5_site": 212, "mouse_sera_escape": null, "mutant": "V", "mutation": "K216V", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": null, "wildtype": "K"}, {"a26_usage": 0.03124, "cell_entry": 0.0742, "ferret_sera_escape": -0.6386, "mature_H5_site": 212, "mouse_sera_escape": -0.4792, "mutant": "Y", "mutation": "K216Y", "reference_site": "216", "region": "region-D", "sequential_site": 228, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3187, "ferret_sera_escape": -0.5743, "mature_H5_site": 213, "mouse_sera_escape": -0.2584, "mutant": "A", "mutation": "I217A", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": 0.002562, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4126, "ferret_sera_escape": -0.1698, "mature_H5_site": 213, "mouse_sera_escape": -0.05478, "mutant": "C", "mutation": "I217C", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": -0.09418, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.181, "ferret_sera_escape": null, "mature_H5_site": 213, "mouse_sera_escape": null, "mutant": "D", "mutation": "I217D", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2592, "ferret_sera_escape": -0.1704, "mature_H5_site": 213, "mouse_sera_escape": -0.2555, "mutant": "E", "mutation": "I217E", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": 0.06025, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06098, "ferret_sera_escape": -0.2035, "mature_H5_site": 213, "mouse_sera_escape": -0.04748, "mutant": "F", "mutation": "I217F", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": 0.491, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.256, "ferret_sera_escape": null, "mature_H5_site": 213, "mouse_sera_escape": null, "mutant": "G", "mutation": "I217G", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1569, "ferret_sera_escape": -0.6872, "mature_H5_site": 213, "mouse_sera_escape": -0.4768, "mutant": "H", "mutation": "I217H", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": -0.02071, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 213, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I217I", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3126, "ferret_sera_escape": -0.5184, "mature_H5_site": 213, "mouse_sera_escape": -0.2505, "mutant": "K", "mutation": "I217K", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": 0.09923, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1902, "ferret_sera_escape": null, "mature_H5_site": 213, "mouse_sera_escape": null, "mutant": "L", "mutation": "I217L", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3976, "ferret_sera_escape": -0.09219, "mature_H5_site": 213, "mouse_sera_escape": -0.08106, "mutant": "M", "mutation": "I217M", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": 0.0574, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.245, "ferret_sera_escape": null, "mature_H5_site": 213, "mouse_sera_escape": null, "mutant": "N", "mutation": "I217N", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": null, "wildtype": "I"}, {"a26_usage": 0.03477, "cell_entry": -0.001815, "ferret_sera_escape": null, "mature_H5_site": 213, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I217Q", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6056, "ferret_sera_escape": -0.668, "mature_H5_site": 213, "mouse_sera_escape": -0.3882, "mutant": "R", "mutation": "I217R", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.04, "ferret_sera_escape": -0.4569, "mature_H5_site": 213, "mouse_sera_escape": null, "mutant": "S", "mutation": "I217S", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4957, "ferret_sera_escape": -0.167, "mature_H5_site": 213, "mouse_sera_escape": -0.3386, "mutant": "T", "mutation": "I217T", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": -0.08986, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.216, "ferret_sera_escape": 0.1014, "mature_H5_site": 213, "mouse_sera_escape": 0.02819, "mutant": "V", "mutation": "I217V", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": -0.1128, "wildtype": "I"}, {"a26_usage": 0.04316, "cell_entry": -0.0001195, "ferret_sera_escape": -0.8643, "mature_H5_site": 213, "mouse_sera_escape": -0.6126, "mutant": "W", "mutation": "I217W", "reference_site": "217", "region": "region-D", "sequential_site": 229, "stability": 0.08844, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 214, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A218A", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2463, "ferret_sera_escape": 0.02494, "mature_H5_site": 214, "mouse_sera_escape": 0.08144, "mutant": "C", "mutation": "A218C", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": -0.2005, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 214, "mouse_sera_escape": null, "mutant": "D", "mutation": "A218D", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.795, "ferret_sera_escape": null, "mature_H5_site": 214, "mouse_sera_escape": null, "mutant": "E", "mutation": "A218E", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.0487, "ferret_sera_escape": -1.488, "mature_H5_site": 214, "mouse_sera_escape": -1.045, "mutant": "F", "mutation": "A218F", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": -0.2455, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2427, "ferret_sera_escape": -0.1297, "mature_H5_site": 214, "mouse_sera_escape": -0.1262, "mutant": "G", "mutation": "A218G", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": -0.2151, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.29, "ferret_sera_escape": -0.7139, "mature_H5_site": 214, "mouse_sera_escape": -0.3204, "mutant": "H", "mutation": "A218H", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": -0.08482, "wildtype": "A"}, {"a26_usage": 1.52, "cell_entry": -2.991, "ferret_sera_escape": -0.08003, "mature_H5_site": 214, "mouse_sera_escape": -0.002649, "mutant": "I", "mutation": "A218I", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.8935, "ferret_sera_escape": 0.2182, "mature_H5_site": 214, "mouse_sera_escape": 0.1224, "mutant": "L", "mutation": "A218L", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": 0.7351, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.8063, "ferret_sera_escape": -0.07864, "mature_H5_site": 214, "mouse_sera_escape": 0.02083, "mutant": "M", "mutation": "A218M", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": 0.4078, "wildtype": "A"}, {"a26_usage": 0.3516, "cell_entry": -0.03717, "ferret_sera_escape": -0.6349, "mature_H5_site": 214, "mouse_sera_escape": -0.1997, "mutant": "N", "mutation": "A218N", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": -0.1485, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.851, "ferret_sera_escape": null, "mature_H5_site": 214, "mouse_sera_escape": null, "mutant": "P", "mutation": "A218P", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": null, "wildtype": "A"}, {"a26_usage": 0.1369, "cell_entry": -0.1621, "ferret_sera_escape": null, "mature_H5_site": 214, "mouse_sera_escape": null, "mutant": "S", "mutation": "A218S", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3872, "ferret_sera_escape": -0.01529, "mature_H5_site": 214, "mouse_sera_escape": 0.07621, "mutant": "T", "mutation": "A218T", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": -0.01731, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.6792, "ferret_sera_escape": 0.3371, "mature_H5_site": 214, "mouse_sera_escape": 0.2002, "mutant": "V", "mutation": "A218V", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": 0.3192, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 214, "mouse_sera_escape": null, "mutant": "W", "mutation": "A218W", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.5, "ferret_sera_escape": null, "mature_H5_site": 214, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A218Y", "reference_site": "218", "region": "region-D", "sequential_site": 230, "stability": null, "wildtype": "A"}, {"a26_usage": 0.1385, "cell_entry": 0.01311, "ferret_sera_escape": -0.5565, "mature_H5_site": 215, "mouse_sera_escape": -0.374, "mutant": "A", "mutation": "T219A", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.01521, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.02908, "ferret_sera_escape": -0.2806, "mature_H5_site": 215, "mouse_sera_escape": -0.2303, "mutant": "C", "mutation": "T219C", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.2097, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.07375, "ferret_sera_escape": -1.393, "mature_H5_site": 215, "mouse_sera_escape": -1.006, "mutant": "D", "mutation": "T219D", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.5488, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.06439, "ferret_sera_escape": -1.559, "mature_H5_site": 215, "mouse_sera_escape": -1.096, "mutant": "E", "mutation": "T219E", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.326, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0208, "ferret_sera_escape": -0.1344, "mature_H5_site": 215, "mouse_sera_escape": -0.05307, "mutant": "F", "mutation": "T219F", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.1963, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1026, "ferret_sera_escape": null, "mature_H5_site": 215, "mouse_sera_escape": null, "mutant": "G", "mutation": "T219G", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.298, "ferret_sera_escape": 0.05218, "mature_H5_site": 215, "mouse_sera_escape": -0.06727, "mutant": "I", "mutation": "T219I", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.6563, "ferret_sera_escape": -0.03793, "mature_H5_site": 215, "mouse_sera_escape": 0.108, "mutant": "K", "mutation": "T219K", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": 0.36, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.01552, "ferret_sera_escape": 0.2677, "mature_H5_site": 215, "mouse_sera_escape": 0.1019, "mutant": "L", "mutation": "T219L", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": 0.3671, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3844, "ferret_sera_escape": -0.182, "mature_H5_site": 215, "mouse_sera_escape": -0.01435, "mutant": "M", "mutation": "T219M", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": 0.05533, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.06996, "ferret_sera_escape": null, "mature_H5_site": 215, "mouse_sera_escape": null, "mutant": "N", "mutation": "T219N", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.01061, "ferret_sera_escape": null, "mature_H5_site": 215, "mouse_sera_escape": -0.237, "mutant": "P", "mutation": "T219P", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.09164, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1603, "ferret_sera_escape": -0.2141, "mature_H5_site": 215, "mouse_sera_escape": 0.2711, "mutant": "R", "mutation": "T219R", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": 0.3164, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1901, "ferret_sera_escape": -0.7719, "mature_H5_site": 215, "mouse_sera_escape": -0.3435, "mutant": "S", "mutation": "T219S", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 215, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T219T", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0449, "ferret_sera_escape": -0.3117, "mature_H5_site": 215, "mouse_sera_escape": -0.1514, "mutant": "W", "mutation": "T219W", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.1596, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.02245, "ferret_sera_escape": -0.1349, "mature_H5_site": 215, "mouse_sera_escape": -0.01025, "mutant": "Y", "mutation": "T219Y", "reference_site": "219", "region": "region-D", "sequential_site": 231, "stability": -0.05556, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7403, "ferret_sera_escape": -0.09005, "mature_H5_site": 12, "mouse_sera_escape": -0.07347, "mutant": "A", "mutation": "S22A", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.1412, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.473, "ferret_sera_escape": null, "mature_H5_site": 12, "mouse_sera_escape": null, "mutant": "C", "mutation": "S22C", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.298, "ferret_sera_escape": null, "mature_H5_site": 12, "mouse_sera_escape": null, "mutant": "D", "mutation": "S22D", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.261, "ferret_sera_escape": -0.1848, "mature_H5_site": 12, "mouse_sera_escape": null, "mutant": "E", "mutation": "S22E", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.06257, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.65, "ferret_sera_escape": null, "mature_H5_site": 12, "mouse_sera_escape": null, "mutant": "F", "mutation": "S22F", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.01645, "ferret_sera_escape": -0.04008, "mature_H5_site": 12, "mouse_sera_escape": 0.04432, "mutant": "G", "mutation": "S22G", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.2292, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.0678, "ferret_sera_escape": -0.1343, "mature_H5_site": 12, "mouse_sera_escape": -0.1169, "mutant": "H", "mutation": "S22H", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.1486, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.093, "ferret_sera_escape": -0.126, "mature_H5_site": 12, "mouse_sera_escape": 0.02657, "mutant": "K", "mutation": "S22K", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.2112, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.482, "ferret_sera_escape": 0.2402, "mature_H5_site": 12, "mouse_sera_escape": null, "mutant": "L", "mutation": "S22L", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3824, "ferret_sera_escape": 0.00546, "mature_H5_site": 12, "mouse_sera_escape": 0.02734, "mutant": "N", "mutation": "S22N", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.07566, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 12, "mouse_sera_escape": null, "mutant": "P", "mutation": "S22P", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2029, "ferret_sera_escape": 0.002535, "mature_H5_site": 12, "mouse_sera_escape": 0.05955, "mutant": "Q", "mutation": "S22Q", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.2415, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8081, "ferret_sera_escape": null, "mature_H5_site": 12, "mouse_sera_escape": -0.1007, "mutant": "R", "mutation": "S22R", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 12, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S22S", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6728, "ferret_sera_escape": -0.1396, "mature_H5_site": 12, "mouse_sera_escape": -0.06145, "mutant": "T", "mutation": "S22T", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.199, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1991, "ferret_sera_escape": -0.08009, "mature_H5_site": 12, "mouse_sera_escape": 0.1298, "mutant": "V", "mutation": "S22V", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": -0.04232, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.66, "ferret_sera_escape": null, "mature_H5_site": 12, "mouse_sera_escape": null, "mutant": "W", "mutation": "S22W", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": null, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -1.416, "ferret_sera_escape": null, "mature_H5_site": 12, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S22Y", "reference_site": "22", "region": "HA1", "sequential_site": 28, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.365, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "C", "mutation": "R220C", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.886, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "E", "mutation": "R220E", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "F", "mutation": "R220F", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.991, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "G", "mutation": "R220G", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "H", "mutation": "R220H", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "I", "mutation": "R220I", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "K", "mutation": "R220K", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.077, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "L", "mutation": "R220L", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.733, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "M", "mutation": "R220M", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.753, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "N", "mutation": "R220N", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.048, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "Q", "mutation": "R220Q", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 216, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R220R", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": 0.0, "wildtype": "R"}, {"a26_usage": null, "cell_entry": -4.63, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "S", "mutation": "R220S", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "T", "mutation": "R220T", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "V", "mutation": "R220V", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 216, "mouse_sera_escape": null, "mutant": "W", "mutation": "R220W", "reference_site": "220", "region": "HA1", "sequential_site": 232, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4744, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "A", "mutation": "S221A", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.891, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "D", "mutation": "S221D", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.61, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "E", "mutation": "S221E", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "F", "mutation": "S221F", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06865, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "G", "mutation": "S221G", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.615, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "I", "mutation": "S221I", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "K", "mutation": "S221K", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.308, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "M", "mutation": "S221M", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3714, "ferret_sera_escape": 0.07971, "mature_H5_site": 217, "mouse_sera_escape": 0.0147, "mutant": "N", "mutation": "S221N", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": -0.5074, "wildtype": "S"}, {"a26_usage": null, "cell_entry": 0.04364, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "P", "mutation": "S221P", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.726, "ferret_sera_escape": -0.4027, "mature_H5_site": 217, "mouse_sera_escape": -0.1413, "mutant": "Q", "mutation": "S221Q", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 217, "mouse_sera_escape": null, "mutant": "R", "mutation": "S221R", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 217, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S221S", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06572, "ferret_sera_escape": -0.04877, "mature_H5_site": 217, "mouse_sera_escape": 0.04643, "mutant": "T", "mutation": "S221T", "reference_site": "221", "region": "HA1", "sequential_site": 233, "stability": -0.08297, "wildtype": "S"}, {"a26_usage": 0.09434, "cell_entry": -0.2128, "ferret_sera_escape": 0.1477, "mature_H5_site": 218, "mouse_sera_escape": 0.05529, "mutant": "A", "mutation": "Q222A", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.1939, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0449, "ferret_sera_escape": -0.6391, "mature_H5_site": 218, "mouse_sera_escape": -0.1862, "mutant": "C", "mutation": "Q222C", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.093, "wildtype": "Q"}, {"a26_usage": 0.3028, "cell_entry": -0.2266, "ferret_sera_escape": -0.9053, "mature_H5_site": 218, "mouse_sera_escape": -0.7421, "mutant": "D", "mutation": "Q222D", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.2898, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.052, "ferret_sera_escape": -0.437, "mature_H5_site": 218, "mouse_sera_escape": -0.3326, "mutant": "E", "mutation": "Q222E", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.05751, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.4377, "ferret_sera_escape": -0.403, "mature_H5_site": 218, "mouse_sera_escape": -0.2165, "mutant": "G", "mutation": "Q222G", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.158, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1208, "ferret_sera_escape": -0.2643, "mature_H5_site": 218, "mouse_sera_escape": -0.3418, "mutant": "I", "mutation": "Q222I", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.03094, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.164, "ferret_sera_escape": -0.2123, "mature_H5_site": 218, "mouse_sera_escape": -0.004055, "mutant": "K", "mutation": "Q222K", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.02896, "wildtype": "Q"}, {"a26_usage": 0.1462, "cell_entry": -0.3618, "ferret_sera_escape": -0.5265, "mature_H5_site": 218, "mouse_sera_escape": -0.3361, "mutant": "L", "mutation": "Q222L", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.01573, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.00794, "ferret_sera_escape": -0.1538, "mature_H5_site": 218, "mouse_sera_escape": -0.1007, "mutant": "M", "mutation": "Q222M", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.07025, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.7274, "ferret_sera_escape": -0.3954, "mature_H5_site": 218, "mouse_sera_escape": null, "mutant": "N", "mutation": "Q222N", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2373, "ferret_sera_escape": 0.1726, "mature_H5_site": 218, "mouse_sera_escape": 0.1333, "mutant": "P", "mutation": "Q222P", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.1116, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 218, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q222Q", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.6401, "ferret_sera_escape": -0.02869, "mature_H5_site": 218, "mouse_sera_escape": -0.0107, "mutant": "R", "mutation": "Q222R", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.03895, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.05038, "ferret_sera_escape": -0.06632, "mature_H5_site": 218, "mouse_sera_escape": -0.1312, "mutant": "S", "mutation": "Q222S", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.01621, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.3952, "ferret_sera_escape": -0.4742, "mature_H5_site": 218, "mouse_sera_escape": -0.1787, "mutant": "T", "mutation": "Q222T", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.1112, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.04258, "ferret_sera_escape": -0.1424, "mature_H5_site": 218, "mouse_sera_escape": -0.1701, "mutant": "V", "mutation": "Q222V", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": 0.01724, "wildtype": "Q"}, {"a26_usage": 0.1996, "cell_entry": 0.07365, "ferret_sera_escape": -1.101, "mature_H5_site": 218, "mouse_sera_escape": -0.803, "mutant": "W", "mutation": "Q222W", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.2866, "wildtype": "Q"}, {"a26_usage": 0.3241, "cell_entry": -0.7141, "ferret_sera_escape": -0.3427, "mature_H5_site": 218, "mouse_sera_escape": -0.252, "mutant": "Y", "mutation": "Q222Y", "reference_site": "222", "region": "HA1", "sequential_site": 234, "stability": -0.1722, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5974, "ferret_sera_escape": null, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "A", "mutation": "V223A", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4831, "ferret_sera_escape": 0.0842, "mature_H5_site": 219, "mouse_sera_escape": 0.1618, "mutant": "C", "mutation": "V223C", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": -0.1575, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "D", "mutation": "V223D", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "E", "mutation": "V223E", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7263, "ferret_sera_escape": -0.1481, "mature_H5_site": 219, "mouse_sera_escape": 0.005881, "mutant": "F", "mutation": "V223F", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": -0.2377, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "G", "mutation": "V223G", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.585, "ferret_sera_escape": -0.06337, "mature_H5_site": 219, "mouse_sera_escape": 0.2251, "mutant": "H", "mutation": "V223H", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.31, "ferret_sera_escape": null, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "I", "mutation": "V223I", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.511, "ferret_sera_escape": 0.317, "mature_H5_site": 219, "mouse_sera_escape": 0.2829, "mutant": "K", "mutation": "V223K", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.119, "ferret_sera_escape": -0.1478, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "L", "mutation": "V223L", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6187, "ferret_sera_escape": 0.04259, "mature_H5_site": 219, "mouse_sera_escape": 0.04489, "mutant": "M", "mutation": "V223M", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": -0.2714, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.577, "ferret_sera_escape": -0.09891, "mature_H5_site": 219, "mouse_sera_escape": 0.06929, "mutant": "N", "mutation": "V223N", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": 0.003194, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "P", "mutation": "V223P", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5101, "ferret_sera_escape": -0.09471, "mature_H5_site": 219, "mouse_sera_escape": 0.08428, "mutant": "Q", "mutation": "V223Q", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": -0.2294, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2131, "ferret_sera_escape": 0.2835, "mature_H5_site": 219, "mouse_sera_escape": 0.1993, "mutant": "R", "mutation": "V223R", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": -0.2536, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.241, "ferret_sera_escape": 0.2733, "mature_H5_site": 219, "mouse_sera_escape": 0.0001, "mutant": "S", "mutation": "V223S", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 219, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V223V", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6693, "ferret_sera_escape": 0.2773, "mature_H5_site": 219, "mouse_sera_escape": 0.04137, "mutant": "W", "mutation": "V223W", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": -0.2484, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5668, "ferret_sera_escape": null, "mature_H5_site": 219, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V223Y", "reference_site": "223", "region": "HA1", "sequential_site": 235, "stability": null, "wildtype": "V"}, {"a26_usage": 0.2415, "cell_entry": 0.02828, "ferret_sera_escape": -0.2993, "mature_H5_site": 220, "mouse_sera_escape": -0.1993, "mutant": "A", "mutation": "N224A", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.2993, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6787, "ferret_sera_escape": -0.474, "mature_H5_site": 220, "mouse_sera_escape": -0.202, "mutant": "C", "mutation": "N224C", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.2602, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.039, "ferret_sera_escape": -0.8281, "mature_H5_site": 220, "mouse_sera_escape": null, "mutant": "D", "mutation": "N224D", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.381, "ferret_sera_escape": null, "mature_H5_site": 220, "mouse_sera_escape": null, "mutant": "E", "mutation": "N224E", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6112, "ferret_sera_escape": -0.4127, "mature_H5_site": 220, "mouse_sera_escape": 0.1018, "mutant": "F", "mutation": "N224F", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.1275, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1535, "ferret_sera_escape": -0.6747, "mature_H5_site": 220, "mouse_sera_escape": -0.4148, "mutant": "G", "mutation": "N224G", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.2461, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02618, "ferret_sera_escape": null, "mature_H5_site": 220, "mouse_sera_escape": null, "mutant": "H", "mutation": "N224H", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.008507, "ferret_sera_escape": -0.1161, "mature_H5_site": 220, "mouse_sera_escape": -0.02828, "mutant": "K", "mutation": "N224K", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.2226, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0627, "ferret_sera_escape": -0.5809, "mature_H5_site": 220, "mouse_sera_escape": -0.3291, "mutant": "M", "mutation": "N224M", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.1597, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 220, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N224N", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9023, "ferret_sera_escape": 0.2657, "mature_H5_site": 220, "mouse_sera_escape": 0.1561, "mutant": "R", "mutation": "N224R", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": 0.1458, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1981, "ferret_sera_escape": 0.01102, "mature_H5_site": 220, "mouse_sera_escape": 0.0731, "mutant": "S", "mutation": "N224S", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.1863, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.689, "ferret_sera_escape": -0.2669, "mature_H5_site": 220, "mouse_sera_escape": -0.005915, "mutant": "T", "mutation": "N224T", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.811, "ferret_sera_escape": null, "mature_H5_site": 220, "mouse_sera_escape": null, "mutant": "V", "mutation": "N224V", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": null, "wildtype": "N"}, {"a26_usage": 0.5336, "cell_entry": -0.3341, "ferret_sera_escape": -0.3009, "mature_H5_site": 220, "mouse_sera_escape": -0.1131, "mutant": "Y", "mutation": "N224Y", "reference_site": "224", "region": "HA1", "sequential_site": 236, "stability": -0.2167, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5885, "ferret_sera_escape": -1.047, "mature_H5_site": 221, "mouse_sera_escape": -0.4954, "mutant": "A", "mutation": "G225A", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.1788, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7007, "ferret_sera_escape": null, "mature_H5_site": 221, "mouse_sera_escape": null, "mutant": "C", "mutation": "G225C", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": null, "wildtype": "G"}, {"a26_usage": null, "cell_entry": -1.467, "ferret_sera_escape": null, "mature_H5_site": 221, "mouse_sera_escape": null, "mutant": "D", "mutation": "G225D", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.563, "ferret_sera_escape": -1.283, "mature_H5_site": 221, "mouse_sera_escape": -0.4694, "mutant": "E", "mutation": "G225E", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.2525, "wildtype": "G"}, {"a26_usage": 1.188, "cell_entry": -0.4221, "ferret_sera_escape": -1.01, "mature_H5_site": 221, "mouse_sera_escape": -0.7881, "mutant": "F", "mutation": "G225F", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.2722, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 221, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G225G", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.01002, "ferret_sera_escape": -0.8638, "mature_H5_site": 221, "mouse_sera_escape": -0.6327, "mutant": "H", "mutation": "G225H", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.291, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 221, "mouse_sera_escape": null, "mutant": "I", "mutation": "G225I", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8743, "ferret_sera_escape": null, "mature_H5_site": 221, "mouse_sera_escape": null, "mutant": "K", "mutation": "G225K", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": null, "wildtype": "G"}, {"a26_usage": 0.9447, "cell_entry": 0.00201, "ferret_sera_escape": null, "mature_H5_site": 221, "mouse_sera_escape": null, "mutant": "L", "mutation": "G225L", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": null, "wildtype": "G"}, {"a26_usage": null, "cell_entry": -2.366, "ferret_sera_escape": null, "mature_H5_site": 221, "mouse_sera_escape": null, "mutant": "M", "mutation": "G225M", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": null, "wildtype": "G"}, {"a26_usage": 1.507, "cell_entry": -0.3914, "ferret_sera_escape": -0.8954, "mature_H5_site": 221, "mouse_sera_escape": -0.5696, "mutant": "N", "mutation": "G225N", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.2273, "wildtype": "G"}, {"a26_usage": null, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 221, "mouse_sera_escape": null, "mutant": "P", "mutation": "G225P", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": null, "wildtype": "G"}, {"a26_usage": 1.222, "cell_entry": -0.9766, "ferret_sera_escape": -0.9984, "mature_H5_site": 221, "mouse_sera_escape": -0.6598, "mutant": "Q", "mutation": "G225Q", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.1937, "wildtype": "G"}, {"a26_usage": 1.778, "cell_entry": -0.2233, "ferret_sera_escape": -0.5916, "mature_H5_site": 221, "mouse_sera_escape": -0.2428, "mutant": "R", "mutation": "G225R", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.09189, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2021, "ferret_sera_escape": -0.1947, "mature_H5_site": 221, "mouse_sera_escape": -0.08515, "mutant": "S", "mutation": "G225S", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.3339, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.603, "ferret_sera_escape": 0.08312, "mature_H5_site": 221, "mouse_sera_escape": null, "mutant": "T", "mutation": "G225T", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.655, "ferret_sera_escape": null, "mature_H5_site": 221, "mouse_sera_escape": null, "mutant": "V", "mutation": "G225V", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.234, "ferret_sera_escape": -0.929, "mature_H5_site": 221, "mouse_sera_escape": -0.7199, "mutant": "W", "mutation": "G225W", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.2183, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.221, "ferret_sera_escape": -1.213, "mature_H5_site": 221, "mouse_sera_escape": -0.8184, "mutant": "Y", "mutation": "G225Y", "reference_site": "225", "region": "HA1", "sequential_site": 237, "stability": -0.2603, "wildtype": "G"}, {"a26_usage": 2.071, "cell_entry": -1.655, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "A", "mutation": "Q226A", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.44, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "E", "mutation": "Q226E", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 4.2, "cell_entry": -3.1, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "F", "mutation": "Q226F", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "G", "mutation": "Q226G", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.691, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "H", "mutation": "Q226H", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": null, "cell_entry": -5.09, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "I", "mutation": "Q226I", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.784, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "K", "mutation": "Q226K", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 5.592, "cell_entry": -3.317, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": 0.2132, "mutant": "L", "mutation": "Q226L", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 5.028, "cell_entry": -3.296, "ferret_sera_escape": -1.399, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "M", "mutation": "Q226M", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 3.59, "cell_entry": -3.575, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "N", "mutation": "Q226N", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -6.025, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q226P", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 222, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q226Q", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 4.155, "cell_entry": -2.333, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "R", "mutation": "Q226R", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.762, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "S", "mutation": "Q226S", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.026, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "T", "mutation": "Q226T", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 5.652, "cell_entry": -2.708, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "V", "mutation": "Q226V", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.331, "ferret_sera_escape": null, "mature_H5_site": 222, "mouse_sera_escape": null, "mutant": "W", "mutation": "Q226W", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 4.577, "cell_entry": -4.382, "ferret_sera_escape": -1.048, "mature_H5_site": 222, "mouse_sera_escape": -0.3304, "mutant": "Y", "mutation": "Q226Y", "reference_site": "226", "region": "HA1", "sequential_site": 238, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.005089, "ferret_sera_escape": -0.4027, "mature_H5_site": 223, "mouse_sera_escape": -0.393, "mutant": "A", "mutation": "R227A", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.1938, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.438, "ferret_sera_escape": null, "mature_H5_site": 223, "mouse_sera_escape": null, "mutant": "D", "mutation": "R227D", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.914, "ferret_sera_escape": -0.7016, "mature_H5_site": 223, "mouse_sera_escape": -0.3125, "mutant": "E", "mutation": "R227E", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.2489, "wildtype": "R"}, {"a26_usage": 0.1427, "cell_entry": -0.062, "ferret_sera_escape": -1.357, "mature_H5_site": 223, "mouse_sera_escape": -1.056, "mutant": "G", "mutation": "R227G", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.3275, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.045, "ferret_sera_escape": null, "mature_H5_site": 223, "mouse_sera_escape": null, "mutant": "H", "mutation": "R227H", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.2877, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.934, "ferret_sera_escape": null, "mature_H5_site": 223, "mouse_sera_escape": null, "mutant": "I", "mutation": "R227I", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.08733, "ferret_sera_escape": -0.3162, "mature_H5_site": 223, "mouse_sera_escape": -0.329, "mutant": "K", "mutation": "R227K", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.1246, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.373, "ferret_sera_escape": null, "mature_H5_site": 223, "mouse_sera_escape": null, "mutant": "L", "mutation": "R227L", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.03078, "ferret_sera_escape": -1.377, "mature_H5_site": 223, "mouse_sera_escape": -0.8241, "mutant": "M", "mutation": "R227M", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.1655, "wildtype": "R"}, {"a26_usage": null, "cell_entry": -0.9092, "ferret_sera_escape": null, "mature_H5_site": 223, "mouse_sera_escape": null, "mutant": "P", "mutation": "R227P", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.07086, "ferret_sera_escape": -1.431, "mature_H5_site": 223, "mouse_sera_escape": -1.048, "mutant": "Q", "mutation": "R227Q", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.2402, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 223, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R227R", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3811, "ferret_sera_escape": -0.341, "mature_H5_site": 223, "mouse_sera_escape": -0.3463, "mutant": "S", "mutation": "R227S", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.2286, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.03982, "ferret_sera_escape": -1.296, "mature_H5_site": 223, "mouse_sera_escape": -1.073, "mutant": "T", "mutation": "R227T", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.3445, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.965, "ferret_sera_escape": null, "mature_H5_site": 223, "mouse_sera_escape": -0.2614, "mutant": "V", "mutation": "R227V", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.308, "ferret_sera_escape": -1.096, "mature_H5_site": 223, "mouse_sera_escape": -0.4979, "mutant": "W", "mutation": "R227W", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": -0.02307, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.449, "ferret_sera_escape": null, "mature_H5_site": 223, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R227Y", "reference_site": "227", "region": "HA1", "sequential_site": 239, "stability": null, "wildtype": "R"}, {"a26_usage": 3.058, "cell_entry": -0.7881, "ferret_sera_escape": -0.4738, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "A", "mutation": "G228A", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": -0.144, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.607, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "C", "mutation": "G228C", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.805, "ferret_sera_escape": -0.8486, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "D", "mutation": "G228D", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.438, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "E", "mutation": "G228E", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 224, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G228G", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.87, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "H", "mutation": "G228H", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.78, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "I", "mutation": "G228I", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.775, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "M", "mutation": "G228M", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "N", "mutation": "G228N", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.904, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "P", "mutation": "G228P", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.762, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G228Q", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.022, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "R", "mutation": "G228R", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.09, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "S", "mutation": "G228S", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.319, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "T", "mutation": "G228T", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.71, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "V", "mutation": "G228V", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "W", "mutation": "G228W", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 224, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G228Y", "reference_site": "228", "region": "HA1", "sequential_site": 240, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.717, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "A", "mutation": "R229A", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "C", "mutation": "R229C", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.809, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "D", "mutation": "R229D", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "E", "mutation": "R229E", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "F", "mutation": "R229F", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "G", "mutation": "R229G", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "H", "mutation": "R229H", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "I", "mutation": "R229I", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "K", "mutation": "R229K", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "L", "mutation": "R229L", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -6.017, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "N", "mutation": "R229N", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "P", "mutation": "R229P", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 225, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R229R", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "S", "mutation": "R229S", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.752, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "T", "mutation": "R229T", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "V", "mutation": "R229V", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 225, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R229Y", "reference_site": "229", "region": "HA1", "sequential_site": 241, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.447, "ferret_sera_escape": -0.0251, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "A", "mutation": "T23A", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.331, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "C", "mutation": "T23C", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.221, "ferret_sera_escape": -0.3885, "mature_H5_site": 13, "mouse_sera_escape": 0.03647, "mutant": "D", "mutation": "T23D", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": -0.1464, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.112, "ferret_sera_escape": -0.1245, "mature_H5_site": 13, "mouse_sera_escape": 0.05135, "mutant": "E", "mutation": "T23E", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": -0.1004, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.566, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "F", "mutation": "T23F", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.699, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "H", "mutation": "T23H", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.534, "ferret_sera_escape": -0.09034, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "I", "mutation": "T23I", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.042, "ferret_sera_escape": -0.1936, "mature_H5_site": 13, "mouse_sera_escape": 0.03777, "mutant": "K", "mutation": "T23K", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": -0.1018, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.558, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "L", "mutation": "T23L", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.851, "ferret_sera_escape": -0.05099, "mature_H5_site": 13, "mouse_sera_escape": 0.009154, "mutant": "N", "mutation": "T23N", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": -0.2389, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.673, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "P", "mutation": "T23P", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1549, "ferret_sera_escape": 0.1059, "mature_H5_site": 13, "mouse_sera_escape": 0.2046, "mutant": "Q", "mutation": "T23Q", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.788, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "R", "mutation": "T23R", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.02638, "ferret_sera_escape": -0.1816, "mature_H5_site": 13, "mouse_sera_escape": -0.1009, "mutant": "S", "mutation": "T23S", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": 0.05048, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 13, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T23T", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "W", "mutation": "T23W", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.892, "ferret_sera_escape": null, "mature_H5_site": 13, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T23Y", "reference_site": "23", "region": "HA1", "sequential_site": 29, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "D", "mutation": "M230D", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.858, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "E", "mutation": "M230E", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.867, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "G", "mutation": "M230G", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.3338, "ferret_sera_escape": -1.193, "mature_H5_site": 226, "mouse_sera_escape": -0.7731, "mutant": "H", "mutation": "M230H", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": -0.08124, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.6565, "ferret_sera_escape": 0.1029, "mature_H5_site": 226, "mouse_sera_escape": 0.06581, "mutant": "I", "mutation": "M230I", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": 0.9118, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "K", "mutation": "M230K", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.801, "ferret_sera_escape": -0.3903, "mature_H5_site": 226, "mouse_sera_escape": -0.2194, "mutant": "L", "mutation": "M230L", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 226, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M230M", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "P", "mutation": "M230P", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.9438, "ferret_sera_escape": -0.8504, "mature_H5_site": 226, "mouse_sera_escape": -0.5225, "mutant": "Q", "mutation": "M230Q", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "R", "mutation": "M230R", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.3396, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "T", "mutation": "M230T", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.02679, "cell_entry": 0.05557, "ferret_sera_escape": 0.1169, "mature_H5_site": 226, "mouse_sera_escape": 0.02995, "mutant": "V", "mutation": "M230V", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": 0.7284, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.688, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "W", "mutation": "M230W", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 226, "mouse_sera_escape": null, "mutant": "Y", "mutation": "M230Y", "reference_site": "230", "region": "HA1", "sequential_site": 242, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.441, "ferret_sera_escape": -0.4896, "mature_H5_site": 227, "mouse_sera_escape": -0.2077, "mutant": "A", "mutation": "D231A", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": -0.1728, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.9362, "ferret_sera_escape": -0.4671, "mature_H5_site": 227, "mouse_sera_escape": -0.4794, "mutant": "C", "mutation": "D231C", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 227, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D231D", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.05072, "ferret_sera_escape": -0.5872, "mature_H5_site": 227, "mouse_sera_escape": -0.5048, "mutant": "E", "mutation": "D231E", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": 0.3984, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.06255, "ferret_sera_escape": null, "mature_H5_site": 227, "mouse_sera_escape": null, "mutant": "F", "mutation": "D231F", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.178, "ferret_sera_escape": null, "mature_H5_site": 227, "mouse_sera_escape": null, "mutant": "I", "mutation": "D231I", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4206, "ferret_sera_escape": -0.2701, "mature_H5_site": 227, "mouse_sera_escape": -0.06516, "mutant": "K", "mutation": "D231K", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": 0.5584, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.748, "ferret_sera_escape": null, "mature_H5_site": 227, "mouse_sera_escape": -0.06413, "mutant": "L", "mutation": "D231L", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": -0.1471, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.682, "ferret_sera_escape": -0.4149, "mature_H5_site": 227, "mouse_sera_escape": null, "mutant": "M", "mutation": "D231M", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": -0.1751, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.03781, "ferret_sera_escape": -0.1009, "mature_H5_site": 227, "mouse_sera_escape": 0.02961, "mutant": "N", "mutation": "D231N", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": 0.04732, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1689, "ferret_sera_escape": -0.07624, "mature_H5_site": 227, "mouse_sera_escape": -0.08539, "mutant": "R", "mutation": "D231R", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": 0.06917, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.06307, "ferret_sera_escape": 0.03704, "mature_H5_site": 227, "mouse_sera_escape": 0.03003, "mutant": "S", "mutation": "D231S", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": -0.01518, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3806, "ferret_sera_escape": 0.3076, "mature_H5_site": 227, "mouse_sera_escape": 0.07347, "mutant": "T", "mutation": "D231T", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": -0.2266, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1447, "ferret_sera_escape": null, "mature_H5_site": 227, "mouse_sera_escape": null, "mutant": "V", "mutation": "D231V", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6277, "ferret_sera_escape": -0.4709, "mature_H5_site": 227, "mouse_sera_escape": -0.2271, "mutant": "W", "mutation": "D231W", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": -0.2304, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2985, "ferret_sera_escape": -0.7497, "mature_H5_site": 227, "mouse_sera_escape": -0.5486, "mutant": "Y", "mutation": "D231Y", "reference_site": "231", "region": "HA1", "sequential_site": 243, "stability": -0.3001, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "A", "mutation": "F232A", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.737, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "C", "mutation": "F232C", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.712, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "D", "mutation": "F232D", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "E", "mutation": "F232E", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 228, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F232F", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": 0.0, "wildtype": "F"}, {"a26_usage": null, "cell_entry": -5.964, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "G", "mutation": "F232G", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.305, "ferret_sera_escape": -0.1843, "mature_H5_site": 228, "mouse_sera_escape": -0.1974, "mutant": "H", "mutation": "F232H", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.02291, "ferret_sera_escape": -0.098, "mature_H5_site": 228, "mouse_sera_escape": -0.03926, "mutant": "I", "mutation": "F232I", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": -0.06531, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "K", "mutation": "F232K", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.1306, "ferret_sera_escape": -0.2291, "mature_H5_site": 228, "mouse_sera_escape": -0.161, "mutant": "L", "mutation": "F232L", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": -0.3048, "wildtype": "F"}, {"a26_usage": null, "cell_entry": 0.02847, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "M", "mutation": "F232M", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F232Q", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "R", "mutation": "F232R", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.655, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "S", "mutation": "F232S", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.8159, "ferret_sera_escape": null, "mature_H5_site": 228, "mouse_sera_escape": null, "mutant": "V", "mutation": "F232V", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.01892, "ferret_sera_escape": -0.1706, "mature_H5_site": 228, "mouse_sera_escape": -0.06363, "mutant": "W", "mutation": "F232W", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": 0.4987, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.03671, "ferret_sera_escape": -0.1514, "mature_H5_site": 228, "mouse_sera_escape": -0.1662, "mutant": "Y", "mutation": "F232Y", "reference_site": "232", "region": "HA1", "sequential_site": 244, "stability": -0.09844, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.3993, "ferret_sera_escape": -0.4083, "mature_H5_site": 229, "mouse_sera_escape": -0.1288, "mutant": "A", "mutation": "F233A", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.1559, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.809, "ferret_sera_escape": -0.03511, "mature_H5_site": 229, "mouse_sera_escape": 0.144, "mutant": "C", "mutation": "F233C", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.2944, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.486, "ferret_sera_escape": -0.6494, "mature_H5_site": 229, "mouse_sera_escape": -0.07992, "mutant": "D", "mutation": "F233D", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.2181, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.9423, "ferret_sera_escape": -0.3177, "mature_H5_site": 229, "mouse_sera_escape": -0.03266, "mutant": "E", "mutation": "F233E", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.3058, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 229, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F233F", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.196, "ferret_sera_escape": -0.2632, "mature_H5_site": 229, "mouse_sera_escape": -0.05426, "mutant": "G", "mutation": "F233G", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.06187, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.1909, "ferret_sera_escape": -0.2085, "mature_H5_site": 229, "mouse_sera_escape": -0.06913, "mutant": "H", "mutation": "F233H", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.06949, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.5708, "ferret_sera_escape": 0.004106, "mature_H5_site": 229, "mouse_sera_escape": -0.01993, "mutant": "I", "mutation": "F233I", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.075, "ferret_sera_escape": -0.1788, "mature_H5_site": 229, "mouse_sera_escape": -0.08002, "mutant": "K", "mutation": "F233K", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.2687, "ferret_sera_escape": -0.1036, "mature_H5_site": 229, "mouse_sera_escape": -0.03815, "mutant": "L", "mutation": "F233L", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.1407, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.07083, "ferret_sera_escape": -0.01039, "mature_H5_site": 229, "mouse_sera_escape": -0.06706, "mutant": "M", "mutation": "F233M", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.1548, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.857, "ferret_sera_escape": null, "mature_H5_site": 229, "mouse_sera_escape": null, "mutant": "N", "mutation": "F233N", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 229, "mouse_sera_escape": null, "mutant": "P", "mutation": "F233P", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.5644, "ferret_sera_escape": -0.1578, "mature_H5_site": 229, "mouse_sera_escape": 0.08844, "mutant": "Q", "mutation": "F233Q", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.2733, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.2455, "ferret_sera_escape": -0.2618, "mature_H5_site": 229, "mouse_sera_escape": -0.007862, "mutant": "R", "mutation": "F233R", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.183, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.9978, "ferret_sera_escape": -0.1373, "mature_H5_site": 229, "mouse_sera_escape": -0.09639, "mutant": "S", "mutation": "F233S", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.03267, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.6983, "ferret_sera_escape": -0.1967, "mature_H5_site": 229, "mouse_sera_escape": null, "mutant": "T", "mutation": "F233T", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": null, "wildtype": "F"}, {"a26_usage": 0.002745, "cell_entry": 0.07132, "ferret_sera_escape": null, "mature_H5_site": 229, "mouse_sera_escape": null, "mutant": "W", "mutation": "F233W", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": null, "wildtype": "F"}, {"a26_usage": 0.03024, "cell_entry": 0.01381, "ferret_sera_escape": -0.01718, "mature_H5_site": 229, "mouse_sera_escape": -0.004482, "mutant": "Y", "mutation": "F233Y", "reference_site": "233", "region": "HA1", "sequential_site": 245, "stability": -0.001134, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "A", "mutation": "W234A", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "C", "mutation": "W234C", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "E", "mutation": "W234E", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.4576, "ferret_sera_escape": -0.276, "mature_H5_site": 230, "mouse_sera_escape": -0.03125, "mutant": "F", "mutation": "W234F", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": -0.271, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.853, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "G", "mutation": "W234G", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.624, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "H", "mutation": "W234H", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "I", "mutation": "W234I", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.034, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "K", "mutation": "W234K", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.138, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "L", "mutation": "W234L", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.85, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "M", "mutation": "W234M", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "N", "mutation": "W234N", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.503, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "P", "mutation": "W234P", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.604, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W234Q", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "R", "mutation": "W234R", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.141, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "S", "mutation": "W234S", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.872, "ferret_sera_escape": null, "mature_H5_site": 230, "mouse_sera_escape": null, "mutant": "T", "mutation": "W234T", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 230, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W234W", "reference_site": "234", "region": "HA1", "sequential_site": 246, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.05031, "ferret_sera_escape": null, "mature_H5_site": 231, "mouse_sera_escape": null, "mutant": "I", "mutation": "T235I", "reference_site": "235", "region": "HA1", "sequential_site": 247, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 231, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T235T", "reference_site": "235", "region": "HA1", "sequential_site": 247, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.6301, "ferret_sera_escape": -0.1662, "mature_H5_site": 232, "mouse_sera_escape": -0.1365, "mutant": "A", "mutation": "I236A", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": -0.2357, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.394, "ferret_sera_escape": 0.1031, "mature_H5_site": 232, "mouse_sera_escape": null, "mutant": "D", "mutation": "I236D", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 232, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I236I", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4227, "ferret_sera_escape": null, "mature_H5_site": 232, "mouse_sera_escape": null, "mutant": "K", "mutation": "I236K", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4466, "ferret_sera_escape": null, "mature_H5_site": 232, "mouse_sera_escape": null, "mutant": "M", "mutation": "I236M", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.7793, "ferret_sera_escape": null, "mature_H5_site": 232, "mouse_sera_escape": null, "mutant": "N", "mutation": "I236N", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.054, "ferret_sera_escape": -0.4124, "mature_H5_site": 232, "mouse_sera_escape": -0.08092, "mutant": "S", "mutation": "I236S", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": -0.2204, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.0821, "ferret_sera_escape": 0.02314, "mature_H5_site": 232, "mouse_sera_escape": 0.06088, "mutant": "T", "mutation": "I236T", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": -0.08194, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4451, "ferret_sera_escape": -0.03558, "mature_H5_site": 232, "mouse_sera_escape": -0.05706, "mutant": "V", "mutation": "I236V", "reference_site": "236", "region": "HA1", "sequential_site": 248, "stability": -0.02245, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 233, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L237L", "reference_site": "237", "region": "HA1", "sequential_site": 249, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7486, "ferret_sera_escape": 0.009093, "mature_H5_site": 233, "mouse_sera_escape": 0.131, "mutant": "M", "mutation": "L237M", "reference_site": "237", "region": "HA1", "sequential_site": 249, "stability": -0.1185, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.749, "ferret_sera_escape": null, "mature_H5_site": 233, "mouse_sera_escape": null, "mutant": "P", "mutation": "L237P", "reference_site": "237", "region": "HA1", "sequential_site": 249, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.06227, "ferret_sera_escape": 0.1389, "mature_H5_site": 235, "mouse_sera_escape": -0.04479, "mutant": "A", "mutation": "P239A", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": -0.1802, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.00035, "ferret_sera_escape": 0.00119, "mature_H5_site": 235, "mouse_sera_escape": -0.1928, "mutant": "C", "mutation": "P239C", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": -0.4255, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.2724, "ferret_sera_escape": -0.2899, "mature_H5_site": 235, "mouse_sera_escape": -0.1454, "mutant": "F", "mutation": "P239F", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": -0.5479, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1624, "ferret_sera_escape": -0.02143, "mature_H5_site": 235, "mouse_sera_escape": -0.03389, "mutant": "G", "mutation": "P239G", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.03368, "ferret_sera_escape": 0.03143, "mature_H5_site": 235, "mouse_sera_escape": -0.1197, "mutant": "H", "mutation": "P239H", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": -0.161, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1499, "ferret_sera_escape": 0.1002, "mature_H5_site": 235, "mouse_sera_escape": 0.1417, "mutant": "I", "mutation": "P239I", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": 0.7125, "wildtype": "P"}, {"a26_usage": 0.131, "cell_entry": -0.07137, "ferret_sera_escape": 0.1694, "mature_H5_site": 235, "mouse_sera_escape": 0.02328, "mutant": "K", "mutation": "P239K", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": -0.03087, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.7714, "ferret_sera_escape": null, "mature_H5_site": 235, "mouse_sera_escape": null, "mutant": "L", "mutation": "P239L", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1981, "ferret_sera_escape": null, "mature_H5_site": 235, "mouse_sera_escape": null, "mutant": "M", "mutation": "P239M", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": null, "wildtype": "P"}, {"a26_usage": null, "cell_entry": 0.03603, "ferret_sera_escape": -0.06565, "mature_H5_site": 235, "mouse_sera_escape": 0.0399, "mutant": "N", "mutation": "P239N", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 235, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P239P", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.05611, "ferret_sera_escape": null, "mature_H5_site": 235, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P239Q", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1848, "ferret_sera_escape": 0.04513, "mature_H5_site": 235, "mouse_sera_escape": 0.06152, "mutant": "R", "mutation": "P239R", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": -0.026, "wildtype": "P"}, {"a26_usage": 0.4268, "cell_entry": -0.00894, "ferret_sera_escape": 0.05737, "mature_H5_site": 235, "mouse_sera_escape": -0.03652, "mutant": "S", "mutation": "P239S", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.03696, "ferret_sera_escape": 0.08648, "mature_H5_site": 235, "mouse_sera_escape": -0.0524, "mutant": "T", "mutation": "P239T", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": -0.04912, "wildtype": "P"}, {"a26_usage": 0.2209, "cell_entry": 0.02009, "ferret_sera_escape": 0.03009, "mature_H5_site": 235, "mouse_sera_escape": 0.06778, "mutant": "V", "mutation": "P239V", "reference_site": "239", "region": "HA1", "sequential_site": 251, "stability": 0.3617, "wildtype": "P"}, {"a26_usage": 0.3302, "cell_entry": -0.3104, "ferret_sera_escape": 0.09226, "mature_H5_site": 14, "mouse_sera_escape": null, "mutant": "A", "mutation": "E24A", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.01662, "ferret_sera_escape": 0.05448, "mature_H5_site": 14, "mouse_sera_escape": 0.04583, "mutant": "C", "mutation": "E24C", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": 0.003614, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02677, "ferret_sera_escape": -0.1077, "mature_H5_site": 14, "mouse_sera_escape": -0.1688, "mutant": "D", "mutation": "E24D", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": -0.1131, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 14, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E24E", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.06868, "cell_entry": 0.06023, "ferret_sera_escape": null, "mature_H5_site": 14, "mouse_sera_escape": null, "mutant": "F", "mutation": "E24F", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4561, "ferret_sera_escape": null, "mature_H5_site": 14, "mouse_sera_escape": -0.07045, "mutant": "H", "mutation": "E24H", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.00755, "ferret_sera_escape": -0.01779, "mature_H5_site": 14, "mouse_sera_escape": 0.04133, "mutant": "I", "mutation": "E24I", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": 1.15, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07343, "ferret_sera_escape": 0.06065, "mature_H5_site": 14, "mouse_sera_escape": 0.01666, "mutant": "K", "mutation": "E24K", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": -0.05592, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0424, "ferret_sera_escape": 0.03603, "mature_H5_site": 14, "mouse_sera_escape": null, "mutant": "M", "mutation": "E24M", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": -0.1613, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1671, "ferret_sera_escape": 0.06741, "mature_H5_site": 14, "mouse_sera_escape": 0.1451, "mutant": "N", "mutation": "E24N", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": -0.1363, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.03681, "ferret_sera_escape": null, "mature_H5_site": 14, "mouse_sera_escape": null, "mutant": "Q", "mutation": "E24Q", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.952, "ferret_sera_escape": null, "mature_H5_site": 14, "mouse_sera_escape": null, "mutant": "R", "mutation": "E24R", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": null, "wildtype": "E"}, {"a26_usage": 0.1246, "cell_entry": 0.03423, "ferret_sera_escape": null, "mature_H5_site": 14, "mouse_sera_escape": null, "mutant": "S", "mutation": "E24S", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06496, "ferret_sera_escape": 0.06355, "mature_H5_site": 14, "mouse_sera_escape": 0.1321, "mutant": "T", "mutation": "E24T", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": 0.7043, "wildtype": "E"}, {"a26_usage": 0.03704, "cell_entry": -0.09474, "ferret_sera_escape": 0.04995, "mature_H5_site": 14, "mouse_sera_escape": 0.07178, "mutant": "V", "mutation": "E24V", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": 0.6342, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.02058, "ferret_sera_escape": -0.06466, "mature_H5_site": 14, "mouse_sera_escape": -0.02694, "mutant": "W", "mutation": "E24W", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": -0.2076, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.07234, "ferret_sera_escape": -0.06959, "mature_H5_site": 14, "mouse_sera_escape": 0.00568, "mutant": "Y", "mutation": "E24Y", "reference_site": "24", "region": "HA1", "sequential_site": 30, "stability": -0.2595, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.05736, "ferret_sera_escape": 0.216, "mature_H5_site": 236, "mouse_sera_escape": 0.2058, "mutant": "A", "mutation": "D240A", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.002062, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.06234, "ferret_sera_escape": 0.1887, "mature_H5_site": 236, "mouse_sera_escape": 0.04144, "mutant": "C", "mutation": "D240C", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.04186, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 236, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D240D", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.00056, "ferret_sera_escape": 0.05763, "mature_H5_site": 236, "mouse_sera_escape": 0.04452, "mutant": "E", "mutation": "D240E", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.08076, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.713, "ferret_sera_escape": null, "mature_H5_site": 236, "mouse_sera_escape": null, "mutant": "F", "mutation": "D240F", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4038, "ferret_sera_escape": 0.1375, "mature_H5_site": 236, "mouse_sera_escape": 0.03998, "mutant": "H", "mutation": "D240H", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.1367, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.01827, "ferret_sera_escape": 0.01361, "mature_H5_site": 236, "mouse_sera_escape": 0.05204, "mutant": "I", "mutation": "D240I", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": -0.04009, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1773, "ferret_sera_escape": 0.1431, "mature_H5_site": 236, "mouse_sera_escape": 0.05483, "mutant": "K", "mutation": "D240K", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.1851, "wildtype": "D"}, {"a26_usage": 0.1471, "cell_entry": -0.162, "ferret_sera_escape": 0.232, "mature_H5_site": 236, "mouse_sera_escape": 0.00455, "mutant": "L", "mutation": "D240L", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.1543, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.06425, "ferret_sera_escape": -0.08253, "mature_H5_site": 236, "mouse_sera_escape": -0.04052, "mutant": "N", "mutation": "D240N", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.1642, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2, "ferret_sera_escape": 0.1305, "mature_H5_site": 236, "mouse_sera_escape": 0.09361, "mutant": "Q", "mutation": "D240Q", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.04812, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.375, "ferret_sera_escape": 0.1224, "mature_H5_site": 236, "mouse_sera_escape": 0.01792, "mutant": "S", "mutation": "D240S", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.05509, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.03591, "ferret_sera_escape": 0.1679, "mature_H5_site": 236, "mouse_sera_escape": 0.1279, "mutant": "T", "mutation": "D240T", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.1892, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2345, "ferret_sera_escape": 0.1354, "mature_H5_site": 236, "mouse_sera_escape": 0.04489, "mutant": "V", "mutation": "D240V", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": -0.005921, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2791, "ferret_sera_escape": 0.1395, "mature_H5_site": 236, "mouse_sera_escape": 0.02093, "mutant": "W", "mutation": "D240W", "reference_site": "240", "region": "HA1", "sequential_site": 252, "stability": 0.2244, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.638, "ferret_sera_escape": 0.07179, "mature_H5_site": 237, "mouse_sera_escape": 0.437, "mutant": "A", "mutation": "D241A", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": -0.05809, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.736, "ferret_sera_escape": 0.04203, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "C", "mutation": "D241C", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 237, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D241D", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.06689, "ferret_sera_escape": -0.1001, "mature_H5_site": 237, "mouse_sera_escape": 0.02125, "mutant": "E", "mutation": "D241E", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": -0.3047, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.873, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "F", "mutation": "D241F", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.9867, "ferret_sera_escape": -0.02812, "mature_H5_site": 237, "mouse_sera_escape": 0.1093, "mutant": "G", "mutation": "D241G", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": -0.3476, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.079, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": 0.2262, "mutant": "H", "mutation": "D241H", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": null, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "I", "mutation": "D241I", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.161, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "K", "mutation": "D241K", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.324, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "L", "mutation": "D241L", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.777, "ferret_sera_escape": 0.1632, "mature_H5_site": 237, "mouse_sera_escape": 0.3649, "mutant": "N", "mutation": "D241N", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "P", "mutation": "D241P", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.401, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "R", "mutation": "D241R", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.91, "ferret_sera_escape": -0.1153, "mature_H5_site": 237, "mouse_sera_escape": 0.04219, "mutant": "S", "mutation": "D241S", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "T", "mutation": "D241T", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.544, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "V", "mutation": "D241V", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.602, "ferret_sera_escape": null, "mature_H5_site": 237, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D241Y", "reference_site": "241", "region": "HA1", "sequential_site": 253, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 238, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A242A", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.1163, "cell_entry": -0.127, "ferret_sera_escape": -0.02698, "mature_H5_site": 238, "mouse_sera_escape": 0.05726, "mutant": "C", "mutation": "A242C", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": 0.09766, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.00228, "ferret_sera_escape": -0.3542, "mature_H5_site": 238, "mouse_sera_escape": -0.3824, "mutant": "D", "mutation": "A242D", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": -0.2282, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.06975, "ferret_sera_escape": -0.1704, "mature_H5_site": 238, "mouse_sera_escape": -0.3469, "mutant": "E", "mutation": "A242E", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": -0.0114, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3154, "ferret_sera_escape": 0.0869, "mature_H5_site": 238, "mouse_sera_escape": 0.2935, "mutant": "F", "mutation": "A242F", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": -0.2098, "wildtype": "A"}, {"a26_usage": 0.07632, "cell_entry": 0.05014, "ferret_sera_escape": -0.5408, "mature_H5_site": 238, "mouse_sera_escape": -0.3704, "mutant": "G", "mutation": "A242G", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": -0.1516, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7801, "ferret_sera_escape": 0.0669, "mature_H5_site": 238, "mouse_sera_escape": 0.1303, "mutant": "H", "mutation": "A242H", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": -0.2035, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3109, "ferret_sera_escape": -0.2727, "mature_H5_site": 238, "mouse_sera_escape": 0.09171, "mutant": "K", "mutation": "A242K", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.898, "ferret_sera_escape": -0.4984, "mature_H5_site": 238, "mouse_sera_escape": -0.1485, "mutant": "N", "mutation": "A242N", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": -0.2723, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5513, "ferret_sera_escape": -0.4171, "mature_H5_site": 238, "mouse_sera_escape": 0.06911, "mutant": "P", "mutation": "A242P", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2068, "ferret_sera_escape": -0.4169, "mature_H5_site": 238, "mouse_sera_escape": 0.07131, "mutant": "R", "mutation": "A242R", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": 0.001137, "wildtype": "A"}, {"a26_usage": 0.1668, "cell_entry": 0.02188, "ferret_sera_escape": -0.1314, "mature_H5_site": 238, "mouse_sera_escape": -0.07154, "mutant": "S", "mutation": "A242S", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": -0.00523, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.03773, "ferret_sera_escape": -0.07625, "mature_H5_site": 238, "mouse_sera_escape": -0.09673, "mutant": "T", "mutation": "A242T", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": 0.0627, "wildtype": "A"}, {"a26_usage": 0.2991, "cell_entry": 0.01979, "ferret_sera_escape": -0.293, "mature_H5_site": 238, "mouse_sera_escape": 0.05035, "mutant": "V", "mutation": "A242V", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": 0.04462, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.447, "ferret_sera_escape": null, "mature_H5_site": 238, "mouse_sera_escape": null, "mutant": "W", "mutation": "A242W", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.23, "ferret_sera_escape": -0.1379, "mature_H5_site": 238, "mouse_sera_escape": 0.2621, "mutant": "Y", "mutation": "A242Y", "reference_site": "242", "region": "HA1", "sequential_site": 254, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.6236, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "A", "mutation": "I243A", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.368, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "C", "mutation": "I243C", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.845, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "D", "mutation": "I243D", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "E", "mutation": "I243E", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.596, "ferret_sera_escape": -0.2647, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "F", "mutation": "I243F", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "G", "mutation": "I243G", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 239, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I243I", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.964, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "K", "mutation": "I243K", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.04473, "ferret_sera_escape": -0.4844, "mature_H5_site": 239, "mouse_sera_escape": -0.1419, "mutant": "L", "mutation": "I243L", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": -0.2257, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06378, "ferret_sera_escape": -0.0733, "mature_H5_site": 239, "mouse_sera_escape": -0.1851, "mutant": "M", "mutation": "I243M", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": -0.256, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "N", "mutation": "I243N", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.994, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "P", "mutation": "I243P", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.975, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I243Q", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "R", "mutation": "I243R", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.79, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "T", "mutation": "I243T", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1009, "ferret_sera_escape": -0.08271, "mature_H5_site": 239, "mouse_sera_escape": -0.02461, "mutant": "V", "mutation": "I243V", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": -0.08073, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.034, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "W", "mutation": "I243W", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 239, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I243Y", "reference_site": "243", "region": "HA1", "sequential_site": 255, "stability": null, "wildtype": "I"}, {"a26_usage": null, "cell_entry": 0.0762, "ferret_sera_escape": -0.4869, "mature_H5_site": 240, "mouse_sera_escape": -0.4367, "mutant": "C", "mutation": "H244C", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.2284, "ferret_sera_escape": null, "mature_H5_site": 240, "mouse_sera_escape": null, "mutant": "D", "mutation": "H244D", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.352, "ferret_sera_escape": -0.5213, "mature_H5_site": 240, "mouse_sera_escape": -0.368, "mutant": "E", "mutation": "H244E", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": -0.1212, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.005, "ferret_sera_escape": -0.2408, "mature_H5_site": 240, "mouse_sera_escape": -0.07896, "mutant": "F", "mutation": "H244F", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": 0.1406, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.223, "ferret_sera_escape": null, "mature_H5_site": 240, "mouse_sera_escape": null, "mutant": "G", "mutation": "H244G", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 240, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H244H", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.03123, "ferret_sera_escape": -0.4985, "mature_H5_site": 240, "mouse_sera_escape": -0.4556, "mutant": "I", "mutation": "H244I", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": -0.1149, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.975, "ferret_sera_escape": null, "mature_H5_site": 240, "mouse_sera_escape": null, "mutant": "K", "mutation": "H244K", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1735, "ferret_sera_escape": -0.885, "mature_H5_site": 240, "mouse_sera_escape": -0.691, "mutant": "L", "mutation": "H244L", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": -0.2299, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.21, "ferret_sera_escape": -0.06246, "mature_H5_site": 240, "mouse_sera_escape": -0.1529, "mutant": "N", "mutation": "H244N", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5471, "ferret_sera_escape": -0.4883, "mature_H5_site": 240, "mouse_sera_escape": -0.3926, "mutant": "Q", "mutation": "H244Q", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": -0.2293, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 240, "mouse_sera_escape": null, "mutant": "R", "mutation": "H244R", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.8379, "ferret_sera_escape": null, "mature_H5_site": 240, "mouse_sera_escape": null, "mutant": "S", "mutation": "H244S", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4743, "ferret_sera_escape": -0.1897, "mature_H5_site": 240, "mouse_sera_escape": -0.1471, "mutant": "T", "mutation": "H244T", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": -0.06742, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5613, "ferret_sera_escape": -0.7372, "mature_H5_site": 240, "mouse_sera_escape": -0.7262, "mutant": "V", "mutation": "H244V", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.02739, "ferret_sera_escape": -0.4389, "mature_H5_site": 240, "mouse_sera_escape": -0.1231, "mutant": "Y", "mutation": "H244Y", "reference_site": "244", "region": "HA1", "sequential_site": 256, "stability": 0.1168, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.7, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "A", "mutation": "F245A", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "D", "mutation": "F245D", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 241, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F245F", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "G", "mutation": "F245G", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "H", "mutation": "F245H", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.107, "ferret_sera_escape": -0.1245, "mature_H5_site": 241, "mouse_sera_escape": -0.1252, "mutant": "I", "mutation": "F245I", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.1846, "ferret_sera_escape": -0.1816, "mature_H5_site": 241, "mouse_sera_escape": -0.1254, "mutant": "L", "mutation": "F245L", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": -0.1906, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "N", "mutation": "F245N", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "P", "mutation": "F245P", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F245Q", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "R", "mutation": "F245R", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "S", "mutation": "F245S", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 241, "mouse_sera_escape": null, "mutant": "T", "mutation": "F245T", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.06792, "ferret_sera_escape": -0.01378, "mature_H5_site": 241, "mouse_sera_escape": -0.1283, "mutant": "V", "mutation": "F245V", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": -0.2019, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.2588, "ferret_sera_escape": 0.2052, "mature_H5_site": 241, "mouse_sera_escape": 0.03014, "mutant": "W", "mutation": "F245W", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": -0.0936, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.05965, "ferret_sera_escape": -0.0269, "mature_H5_site": 241, "mouse_sera_escape": 0.04218, "mutant": "Y", "mutation": "F245Y", "reference_site": "245", "region": "HA1", "sequential_site": 257, "stability": -0.2329, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.4036, "ferret_sera_escape": 0.0423, "mature_H5_site": 242, "mouse_sera_escape": 0.02874, "mutant": "A", "mutation": "E246A", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.1928, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2044, "ferret_sera_escape": 0.1265, "mature_H5_site": 242, "mouse_sera_escape": 0.134, "mutant": "C", "mutation": "E246C", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.1816, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.8272, "ferret_sera_escape": 0.4246, "mature_H5_site": 242, "mouse_sera_escape": 0.07429, "mutant": "D", "mutation": "E246D", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.2427, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 242, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E246E", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.01, "ferret_sera_escape": null, "mature_H5_site": 242, "mouse_sera_escape": null, "mutant": "G", "mutation": "E246G", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07021, "ferret_sera_escape": 0.1577, "mature_H5_site": 242, "mouse_sera_escape": 0.3386, "mutant": "H", "mutation": "E246H", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.2088, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1924, "ferret_sera_escape": 0.2655, "mature_H5_site": 242, "mouse_sera_escape": 0.3416, "mutant": "I", "mutation": "E246I", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.228, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.639, "ferret_sera_escape": 0.304, "mature_H5_site": 242, "mouse_sera_escape": 0.537, "mutant": "K", "mutation": "E246K", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.1059, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5186, "ferret_sera_escape": 0.4351, "mature_H5_site": 242, "mouse_sera_escape": 0.4095, "mutant": "L", "mutation": "E246L", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.2192, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.03527, "ferret_sera_escape": 0.1542, "mature_H5_site": 242, "mouse_sera_escape": 0.1125, "mutant": "M", "mutation": "E246M", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.09783, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1961, "ferret_sera_escape": 0.2623, "mature_H5_site": 242, "mouse_sera_escape": 0.2574, "mutant": "N", "mutation": "E246N", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.729, "ferret_sera_escape": null, "mature_H5_site": 242, "mouse_sera_escape": null, "mutant": "P", "mutation": "E246P", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.953, "ferret_sera_escape": 0.2545, "mature_H5_site": 242, "mouse_sera_escape": 0.2084, "mutant": "R", "mutation": "E246R", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.1849, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.02232, "ferret_sera_escape": 0.08748, "mature_H5_site": 242, "mouse_sera_escape": 0.1166, "mutant": "S", "mutation": "E246S", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.2049, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4647, "ferret_sera_escape": 0.246, "mature_H5_site": 242, "mouse_sera_escape": 0.2403, "mutant": "V", "mutation": "E246V", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.3154, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1823, "ferret_sera_escape": 0.1499, "mature_H5_site": 242, "mouse_sera_escape": 0.3093, "mutant": "W", "mutation": "E246W", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": -0.2856, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9304, "ferret_sera_escape": -0.08033, "mature_H5_site": 242, "mouse_sera_escape": 0.1512, "mutant": "Y", "mutation": "E246Y", "reference_site": "246", "region": "HA1", "sequential_site": 258, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.04611, "ferret_sera_escape": -0.1512, "mature_H5_site": 243, "mouse_sera_escape": -0.05387, "mutant": "A", "mutation": "S247A", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": -0.1075, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -1.39, "ferret_sera_escape": -0.09742, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "C", "mutation": "S247C", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.822, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "D", "mutation": "S247D", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.998, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "E", "mutation": "S247E", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.9194, "ferret_sera_escape": -0.2277, "mature_H5_site": 243, "mouse_sera_escape": -0.0722, "mutant": "F", "mutation": "S247F", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.05672, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "G", "mutation": "S247G", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -6.01, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "I", "mutation": "S247I", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "K", "mutation": "S247K", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.05, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "M", "mutation": "S247M", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "P", "mutation": "S247P", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.497, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "Q", "mutation": "S247Q", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 243, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S247S", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.2745, "cell_entry": -0.5357, "ferret_sera_escape": 0.007003, "mature_H5_site": 243, "mouse_sera_escape": 0.146, "mutant": "T", "mutation": "S247T", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 243, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S247Y", "reference_site": "247", "region": "HA1", "sequential_site": 259, "stability": null, "wildtype": "S"}, {"a26_usage": 0.5594, "cell_entry": 0.07866, "ferret_sera_escape": -0.4604, "mature_H5_site": 244, "mouse_sera_escape": -0.2813, "mutant": "A", "mutation": "N248A", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": -0.2432, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.775, "ferret_sera_escape": null, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "C", "mutation": "N248C", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": -0.2445, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02962, "ferret_sera_escape": -0.1505, "mature_H5_site": 244, "mouse_sera_escape": -0.1077, "mutant": "D", "mutation": "N248D", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": -0.1704, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4819, "ferret_sera_escape": -0.07821, "mature_H5_site": 244, "mouse_sera_escape": -0.1357, "mutant": "E", "mutation": "N248E", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": -0.1397, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.632, "ferret_sera_escape": null, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "H", "mutation": "N248H", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.067, "ferret_sera_escape": 0.1096, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "I", "mutation": "N248I", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": -0.1088, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7208, "ferret_sera_escape": -0.2551, "mature_H5_site": 244, "mouse_sera_escape": -0.1105, "mutant": "K", "mutation": "N248K", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.151, "ferret_sera_escape": null, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "L", "mutation": "N248L", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9711, "ferret_sera_escape": null, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "M", "mutation": "N248M", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 244, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N248N", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.55, "ferret_sera_escape": -0.08175, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "P", "mutation": "N248P", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.0659, "ferret_sera_escape": -0.2364, "mature_H5_site": 244, "mouse_sera_escape": -0.2122, "mutant": "Q", "mutation": "N248Q", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": -0.2157, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.615, "ferret_sera_escape": -0.5953, "mature_H5_site": 244, "mouse_sera_escape": -0.09622, "mutant": "R", "mutation": "N248R", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.1766, "cell_entry": -0.04235, "ferret_sera_escape": -0.2726, "mature_H5_site": 244, "mouse_sera_escape": -0.1428, "mutant": "S", "mutation": "N248S", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1701, "ferret_sera_escape": -0.08497, "mature_H5_site": 244, "mouse_sera_escape": -0.04253, "mutant": "T", "mutation": "N248T", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.119, "ferret_sera_escape": null, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "V", "mutation": "N248V", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.289, "ferret_sera_escape": null, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "W", "mutation": "N248W", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.128, "ferret_sera_escape": null, "mature_H5_site": 244, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N248Y", "reference_site": "248", "region": "HA1", "sequential_site": 260, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.997, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "D", "mutation": "G249D", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.986, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "E", "mutation": "G249E", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 245, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G249G", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "H", "mutation": "G249H", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "K", "mutation": "G249K", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "L", "mutation": "G249L", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.255, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "M", "mutation": "G249M", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "N", "mutation": "G249N", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.047, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "P", "mutation": "G249P", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G249Q", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "R", "mutation": "G249R", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "S", "mutation": "G249S", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.073, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "T", "mutation": "G249T", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.646, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "V", "mutation": "G249V", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "W", "mutation": "G249W", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 245, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G249Y", "reference_site": "249", "region": "HA1", "sequential_site": 261, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.07544, "ferret_sera_escape": null, "mature_H5_site": 15, "mouse_sera_escape": null, "mutant": "A", "mutation": "Q25A", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1791, "ferret_sera_escape": -0.09862, "mature_H5_site": 15, "mouse_sera_escape": -0.04204, "mutant": "C", "mutation": "Q25C", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": -0.2701, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2037, "ferret_sera_escape": -0.05114, "mature_H5_site": 15, "mouse_sera_escape": 0.01503, "mutant": "E", "mutation": "Q25E", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": -0.05458, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2308, "ferret_sera_escape": -0.08462, "mature_H5_site": 15, "mouse_sera_escape": 0.02062, "mutant": "F", "mutation": "Q25F", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.639, "ferret_sera_escape": -0.04697, "mature_H5_site": 15, "mouse_sera_escape": -0.07533, "mutant": "H", "mutation": "Q25H", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": null, "wildtype": "Q"}, {"a26_usage": null, "cell_entry": -0.9915, "ferret_sera_escape": 0.004575, "mature_H5_site": 15, "mouse_sera_escape": null, "mutant": "I", "mutation": "Q25I", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": 0.165, "wildtype": "Q"}, {"a26_usage": 0.02609, "cell_entry": 0.05322, "ferret_sera_escape": -0.01323, "mature_H5_site": 15, "mouse_sera_escape": 0.07796, "mutant": "K", "mutation": "Q25K", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": 0.03919, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.4802, "ferret_sera_escape": 0.0494, "mature_H5_site": 15, "mouse_sera_escape": null, "mutant": "L", "mutation": "Q25L", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": 0.0473, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.0263, "ferret_sera_escape": 0.1439, "mature_H5_site": 15, "mouse_sera_escape": 0.06586, "mutant": "N", "mutation": "Q25N", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.15, "ferret_sera_escape": null, "mature_H5_site": 15, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q25P", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 15, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q25Q", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2161, "ferret_sera_escape": -0.06133, "mature_H5_site": 15, "mouse_sera_escape": -0.06627, "mutant": "R", "mutation": "Q25R", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": 0.05167, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.28, "ferret_sera_escape": null, "mature_H5_site": 15, "mouse_sera_escape": null, "mutant": "S", "mutation": "Q25S", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.04558, "ferret_sera_escape": -0.06248, "mature_H5_site": 15, "mouse_sera_escape": 0.02389, "mutant": "T", "mutation": "Q25T", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": -0.2598, "wildtype": "Q"}, {"a26_usage": 0.001975, "cell_entry": -0.06474, "ferret_sera_escape": null, "mature_H5_site": 15, "mouse_sera_escape": -0.04064, "mutant": "V", "mutation": "Q25V", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": -0.06342, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.05477, "ferret_sera_escape": -0.2498, "mature_H5_site": 15, "mouse_sera_escape": -0.0885, "mutant": "W", "mutation": "Q25W", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": 1.069, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5637, "ferret_sera_escape": 0.06546, "mature_H5_site": 15, "mouse_sera_escape": 0.0702, "mutant": "Y", "mutation": "Q25Y", "reference_site": "25", "region": "HA1", "sequential_site": 31, "stability": 0.1322, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.4829, "ferret_sera_escape": 0.03767, "mature_H5_site": 246, "mouse_sera_escape": -0.04664, "mutant": "A", "mutation": "N250A", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.236, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "C", "mutation": "N250C", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "D", "mutation": "N250D", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.991, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "F", "mutation": "N250F", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3624, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "G", "mutation": "N250G", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "H", "mutation": "N250H", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "I", "mutation": "N250I", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -6.058, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "K", "mutation": "N250K", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.73, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "M", "mutation": "N250M", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 246, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N250N", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N250Q", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "R", "mutation": "N250R", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2077, "ferret_sera_escape": 0.4757, "mature_H5_site": 246, "mouse_sera_escape": -0.09096, "mutant": "S", "mutation": "N250S", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": -0.2198, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 246, "mouse_sera_escape": null, "mutant": "V", "mutation": "N250V", "reference_site": "250", "region": "HA1", "sequential_site": 262, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.157, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "A", "mutation": "F251A", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "D", "mutation": "F251D", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 247, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F251F", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.008, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "G", "mutation": "F251G", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "H", "mutation": "F251H", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.04736, "ferret_sera_escape": 0.0954, "mature_H5_site": 247, "mouse_sera_escape": 0.02678, "mutant": "I", "mutation": "F251I", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": -0.0836, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "K", "mutation": "F251K", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.03755, "cell_entry": -0.3646, "ferret_sera_escape": 0.1421, "mature_H5_site": 247, "mouse_sera_escape": -0.05454, "mutant": "L", "mutation": "F251L", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": -0.1824, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.06907, "ferret_sera_escape": -0.07375, "mature_H5_site": 247, "mouse_sera_escape": -0.0694, "mutant": "M", "mutation": "F251M", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": -0.1653, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "N", "mutation": "F251N", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F251Q", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.973, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "R", "mutation": "F251R", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "S", "mutation": "F251S", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "T", "mutation": "F251T", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.595, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "V", "mutation": "F251V", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.2702, "ferret_sera_escape": 0.02749, "mature_H5_site": 247, "mouse_sera_escape": 0.1186, "mutant": "W", "mutation": "F251W", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": 0.02186, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.917, "ferret_sera_escape": null, "mature_H5_site": 247, "mouse_sera_escape": null, "mutant": "Y", "mutation": "F251Y", "reference_site": "251", "region": "HA1", "sequential_site": 263, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.291, "ferret_sera_escape": -0.1503, "mature_H5_site": 248, "mouse_sera_escape": -0.01071, "mutant": "A", "mutation": "I252A", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "C", "mutation": "I252C", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "D", "mutation": "I252D", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "E", "mutation": "I252E", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.771, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "F", "mutation": "I252F", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.558, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "G", "mutation": "I252G", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "H", "mutation": "I252H", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 248, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I252I", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1505, "ferret_sera_escape": -0.3759, "mature_H5_site": 248, "mouse_sera_escape": -0.2856, "mutant": "L", "mutation": "I252L", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": -0.2731, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2476, "ferret_sera_escape": -0.6723, "mature_H5_site": 248, "mouse_sera_escape": -0.6913, "mutant": "M", "mutation": "I252M", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": -0.25, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.898, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "N", "mutation": "I252N", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.141, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I252Q", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "R", "mutation": "I252R", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "S", "mutation": "I252S", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1272, "ferret_sera_escape": 0.07598, "mature_H5_site": 248, "mouse_sera_escape": 0.03064, "mutant": "V", "mutation": "I252V", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": -0.05327, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "W", "mutation": "I252W", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 248, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I252Y", "reference_site": "252", "region": "HA1", "sequential_site": 264, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 249, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A253A", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.02496, "ferret_sera_escape": 0.3854, "mature_H5_site": 249, "mouse_sera_escape": -0.0416, "mutant": "C", "mutation": "A253C", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": -0.05824, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.659, "ferret_sera_escape": null, "mature_H5_site": 249, "mouse_sera_escape": null, "mutant": "D", "mutation": "A253D", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.831, "ferret_sera_escape": null, "mature_H5_site": 249, "mouse_sera_escape": null, "mutant": "E", "mutation": "A253E", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.832, "ferret_sera_escape": 0.1293, "mature_H5_site": 249, "mouse_sera_escape": -0.3473, "mutant": "F", "mutation": "A253F", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.00855, "ferret_sera_escape": -0.2506, "mature_H5_site": 249, "mouse_sera_escape": 0.000635, "mutant": "G", "mutation": "A253G", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.9725, "ferret_sera_escape": 0.6793, "mature_H5_site": 249, "mouse_sera_escape": 0.2404, "mutant": "I", "mutation": "A253I", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": -0.08341, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 249, "mouse_sera_escape": null, "mutant": "K", "mutation": "A253K", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7596, "ferret_sera_escape": 0.3332, "mature_H5_site": 249, "mouse_sera_escape": 0.08721, "mutant": "L", "mutation": "A253L", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": 0.08129, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.121, "ferret_sera_escape": null, "mature_H5_site": 249, "mouse_sera_escape": null, "mutant": "M", "mutation": "A253M", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 249, "mouse_sera_escape": null, "mutant": "N", "mutation": "A253N", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.0624, "ferret_sera_escape": 0.1094, "mature_H5_site": 249, "mouse_sera_escape": 0.09268, "mutant": "P", "mutation": "A253P", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": -0.1698, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.873, "ferret_sera_escape": null, "mature_H5_site": 249, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A253Q", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.004725, "cell_entry": -0.1116, "ferret_sera_escape": 0.2776, "mature_H5_site": 249, "mouse_sera_escape": 0.03513, "mutant": "S", "mutation": "A253S", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": -0.00916, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3065, "ferret_sera_escape": 0.1346, "mature_H5_site": 249, "mouse_sera_escape": -0.2323, "mutant": "T", "mutation": "A253T", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": -0.1918, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.08648, "ferret_sera_escape": 0.3043, "mature_H5_site": 249, "mouse_sera_escape": 0.03359, "mutant": "V", "mutation": "A253V", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": 0.0555, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 249, "mouse_sera_escape": null, "mutant": "W", "mutation": "A253W", "reference_site": "253", "region": "HA1", "sequential_site": 265, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.442, "ferret_sera_escape": -0.1442, "mature_H5_site": 250, "mouse_sera_escape": 0.06816, "mutant": "A", "mutation": "P254A", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": -0.08427, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.29, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "C", "mutation": "P254C", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "D", "mutation": "P254D", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "E", "mutation": "P254E", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": null, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "F", "mutation": "P254F", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "G", "mutation": "P254G", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.046, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "H", "mutation": "P254H", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "K", "mutation": "P254K", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.007, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "L", "mutation": "P254L", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.607, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "M", "mutation": "P254M", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "N", "mutation": "P254N", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 250, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P254P", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.718, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P254Q", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.032, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "R", "mutation": "P254R", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.545, "ferret_sera_escape": -0.0874, "mature_H5_site": 250, "mouse_sera_escape": -0.03787, "mutant": "S", "mutation": "P254S", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": 0.01251, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.219, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "T", "mutation": "P254T", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.056, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "W", "mutation": "P254W", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 250, "mouse_sera_escape": null, "mutant": "Y", "mutation": "P254Y", "reference_site": "254", "region": "HA1", "sequential_site": 266, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.08652, "ferret_sera_escape": -0.1015, "mature_H5_site": 251, "mouse_sera_escape": 0.467, "mutant": "A", "mutation": "E255A", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.06867, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.707, "ferret_sera_escape": 0.247, "mature_H5_site": 251, "mouse_sera_escape": 0.4594, "mutant": "D", "mutation": "E255D", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.1846, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 251, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E255E", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.06212, "cell_entry": -0.05388, "ferret_sera_escape": 0.3503, "mature_H5_site": 251, "mouse_sera_escape": 1.022, "mutant": "F", "mutation": "E255F", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.06339, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.03479, "ferret_sera_escape": null, "mature_H5_site": 251, "mouse_sera_escape": null, "mutant": "G", "mutation": "E255G", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.114, "ferret_sera_escape": -0.07302, "mature_H5_site": 251, "mouse_sera_escape": 0.6545, "mutant": "H", "mutation": "E255H", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.195, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.057, "ferret_sera_escape": -0.08771, "mature_H5_site": 251, "mouse_sera_escape": 0.4395, "mutant": "I", "mutation": "E255I", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": 0.3155, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4098, "ferret_sera_escape": 0.09833, "mature_H5_site": 251, "mouse_sera_escape": 1.047, "mutant": "K", "mutation": "E255K", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.1786, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01654, "ferret_sera_escape": 0.1057, "mature_H5_site": 251, "mouse_sera_escape": 1.044, "mutant": "M", "mutation": "E255M", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.3627, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0449, "ferret_sera_escape": -0.01985, "mature_H5_site": 251, "mouse_sera_escape": 0.5439, "mutant": "Q", "mutation": "E255Q", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.07128, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.04152, "ferret_sera_escape": 0.0009233, "mature_H5_site": 251, "mouse_sera_escape": 1.079, "mutant": "R", "mutation": "E255R", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.2459, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07055, "ferret_sera_escape": -0.02589, "mature_H5_site": 251, "mouse_sera_escape": null, "mutant": "S", "mutation": "E255S", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2516, "ferret_sera_escape": -0.245, "mature_H5_site": 251, "mouse_sera_escape": 0.4315, "mutant": "T", "mutation": "E255T", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": 0.0482, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.05987, "ferret_sera_escape": -0.013, "mature_H5_site": 251, "mouse_sera_escape": 0.5909, "mutant": "V", "mutation": "E255V", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.04528, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.03663, "ferret_sera_escape": 0.2831, "mature_H5_site": 251, "mouse_sera_escape": 0.9031, "mutant": "W", "mutation": "E255W", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.06046, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02599, "ferret_sera_escape": 0.2873, "mature_H5_site": 251, "mouse_sera_escape": 0.7836, "mutant": "Y", "mutation": "E255Y", "reference_site": "255", "region": "HA1", "sequential_site": 267, "stability": -0.1072, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1794, "ferret_sera_escape": 0.1892, "mature_H5_site": 252, "mouse_sera_escape": 0.2842, "mutant": "A", "mutation": "Y256A", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.03823, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7673, "ferret_sera_escape": 0.2567, "mature_H5_site": 252, "mouse_sera_escape": 0.3809, "mutant": "C", "mutation": "Y256C", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.1592, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.649, "ferret_sera_escape": null, "mature_H5_site": 252, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y256D", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.645, "ferret_sera_escape": 0.2082, "mature_H5_site": 252, "mouse_sera_escape": 0.4523, "mutant": "E", "mutation": "Y256E", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.2013, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3248, "ferret_sera_escape": 0.09901, "mature_H5_site": 252, "mouse_sera_escape": -0.01165, "mutant": "F", "mutation": "Y256F", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": 0.0184, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1096, "ferret_sera_escape": 0.1346, "mature_H5_site": 252, "mouse_sera_escape": 0.2227, "mutant": "H", "mutation": "Y256H", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.158, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.2811, "ferret_sera_escape": 0.2879, "mature_H5_site": 252, "mouse_sera_escape": 0.01939, "mutant": "I", "mutation": "Y256I", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.3211, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.5509, "ferret_sera_escape": 0.198, "mature_H5_site": 252, "mouse_sera_escape": 0.4509, "mutant": "K", "mutation": "Y256K", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.08562, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1837, "ferret_sera_escape": -0.05464, "mature_H5_site": 252, "mouse_sera_escape": -0.02275, "mutant": "L", "mutation": "Y256L", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.2543, "wildtype": "Y"}, {"a26_usage": 0.6918, "cell_entry": -0.8669, "ferret_sera_escape": 0.07145, "mature_H5_site": 252, "mouse_sera_escape": 0.2994, "mutant": "N", "mutation": "Y256N", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.128, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 252, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y256P", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.07612, "ferret_sera_escape": 0.1773, "mature_H5_site": 252, "mouse_sera_escape": 0.3632, "mutant": "Q", "mutation": "Y256Q", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.1919, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.052, "ferret_sera_escape": null, "mature_H5_site": 252, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y256R", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.04036, "ferret_sera_escape": 0.2159, "mature_H5_site": 252, "mouse_sera_escape": 0.2444, "mutant": "S", "mutation": "Y256S", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.268, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7166, "ferret_sera_escape": 0.04814, "mature_H5_site": 252, "mouse_sera_escape": 0.05686, "mutant": "T", "mutation": "Y256T", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.2306, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.03938, "ferret_sera_escape": 0.3626, "mature_H5_site": 252, "mouse_sera_escape": 0.07486, "mutant": "V", "mutation": "Y256V", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.1821, "wildtype": "Y"}, {"a26_usage": 0.03293, "cell_entry": 0.0641, "ferret_sera_escape": 0.1762, "mature_H5_site": 252, "mouse_sera_escape": 0.5, "mutant": "W", "mutation": "Y256W", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": -0.296, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 252, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y256Y", "reference_site": "256", "region": "HA1", "sequential_site": 268, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 253, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A257A", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.8768, "ferret_sera_escape": 0.008647, "mature_H5_site": 253, "mouse_sera_escape": 0.2867, "mutant": "C", "mutation": "A257C", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": -0.2924, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "D", "mutation": "A257D", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.849, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "E", "mutation": "A257E", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.787, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "F", "mutation": "A257F", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.735, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "H", "mutation": "A257H", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.337, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "I", "mutation": "A257I", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "K", "mutation": "A257K", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "L", "mutation": "A257L", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.378, "ferret_sera_escape": 0.05713, "mature_H5_site": 253, "mouse_sera_escape": 0.2777, "mutant": "M", "mutation": "A257M", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.021, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "N", "mutation": "A257N", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "P", "mutation": "A257P", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A257Q", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.88, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "R", "mutation": "A257R", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4608, "ferret_sera_escape": -0.1845, "mature_H5_site": 253, "mouse_sera_escape": 0.1016, "mutant": "S", "mutation": "A257S", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": -0.1716, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "T", "mutation": "A257T", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7475, "ferret_sera_escape": 0.06482, "mature_H5_site": 253, "mouse_sera_escape": 0.1677, "mutant": "V", "mutation": "A257V", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": -0.2181, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "W", "mutation": "A257W", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.765, "ferret_sera_escape": null, "mature_H5_site": 253, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A257Y", "reference_site": "257", "region": "HA1", "sequential_site": 269, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.768, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y258C", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y258D", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.989, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y258E", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.191, "ferret_sera_escape": 0.02218, "mature_H5_site": 254, "mouse_sera_escape": 0.02426, "mutant": "F", "mutation": "Y258F", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": 0.6354, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.011, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y258G", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.466, "ferret_sera_escape": -0.4243, "mature_H5_site": 254, "mouse_sera_escape": 0.1736, "mutant": "H", "mutation": "Y258H", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.2232, "ferret_sera_escape": -0.0429, "mature_H5_site": 254, "mouse_sera_escape": 0.06653, "mutant": "I", "mutation": "Y258I", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": 1.452, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y258K", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.03454, "ferret_sera_escape": -0.01583, "mature_H5_site": 254, "mouse_sera_escape": -0.08054, "mutant": "M", "mutation": "Y258M", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": -0.2858, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.687, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y258N", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.876, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y258Q", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y258R", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.287, "ferret_sera_escape": -0.14, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y258S", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.772, "ferret_sera_escape": null, "mature_H5_site": 254, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y258T", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.331, "ferret_sera_escape": 0.006823, "mature_H5_site": 254, "mouse_sera_escape": 0.1353, "mutant": "V", "mutation": "Y258V", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": 2.246, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.625, "ferret_sera_escape": 0.1288, "mature_H5_site": 254, "mouse_sera_escape": 0.129, "mutant": "W", "mutation": "Y258W", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 254, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y258Y", "reference_site": "258", "region": "HA1", "sequential_site": 270, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.07852, "ferret_sera_escape": -0.06888, "mature_H5_site": 255, "mouse_sera_escape": 0.2156, "mutant": "A", "mutation": "K259A", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": -0.1745, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.766, "ferret_sera_escape": 0.01057, "mature_H5_site": 255, "mouse_sera_escape": 0.4015, "mutant": "C", "mutation": "K259C", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 255, "mouse_sera_escape": null, "mutant": "D", "mutation": "K259D", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.027, "ferret_sera_escape": 0.001104, "mature_H5_site": 255, "mouse_sera_escape": 0.4122, "mutant": "E", "mutation": "K259E", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 0.8847, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.286, "ferret_sera_escape": -0.05196, "mature_H5_site": 255, "mouse_sera_escape": -0.2445, "mutant": "F", "mutation": "K259F", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 0.9224, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.102, "ferret_sera_escape": 0.03456, "mature_H5_site": 255, "mouse_sera_escape": 0.6524, "mutant": "G", "mutation": "K259G", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 0.6986, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6033, "ferret_sera_escape": 0.3681, "mature_H5_site": 255, "mouse_sera_escape": 0.1407, "mutant": "H", "mutation": "K259H", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": -0.1431, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 255, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K259K", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.07437, "cell_entry": -0.3481, "ferret_sera_escape": 0.05584, "mature_H5_site": 255, "mouse_sera_escape": 0.09044, "mutant": "L", "mutation": "K259L", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2186, "ferret_sera_escape": 0.1455, "mature_H5_site": 255, "mouse_sera_escape": 0.2921, "mutant": "M", "mutation": "K259M", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 0.2436, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.324, "ferret_sera_escape": null, "mature_H5_site": 255, "mouse_sera_escape": null, "mutant": "N", "mutation": "K259N", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.929, "ferret_sera_escape": null, "mature_H5_site": 255, "mouse_sera_escape": null, "mutant": "P", "mutation": "K259P", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.182, "ferret_sera_escape": -0.03091, "mature_H5_site": 255, "mouse_sera_escape": 0.3285, "mutant": "Q", "mutation": "K259Q", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 0.01785, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3963, "ferret_sera_escape": -0.05077, "mature_H5_site": 255, "mouse_sera_escape": 0.08262, "mutant": "R", "mutation": "K259R", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": -0.3385, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03081, "ferret_sera_escape": 0.03872, "mature_H5_site": 255, "mouse_sera_escape": 0.2492, "mutant": "S", "mutation": "K259S", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 0.191, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.098, "ferret_sera_escape": -0.1222, "mature_H5_site": 255, "mouse_sera_escape": 0.6, "mutant": "T", "mutation": "K259T", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2181, "ferret_sera_escape": 0.08231, "mature_H5_site": 255, "mouse_sera_escape": 0.1779, "mutant": "V", "mutation": "K259V", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": 1.291, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.004, "ferret_sera_escape": null, "mature_H5_site": 255, "mouse_sera_escape": null, "mutant": "W", "mutation": "K259W", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6905, "ferret_sera_escape": null, "mature_H5_site": 255, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K259Y", "reference_site": "259", "region": "HA1", "sequential_site": 271, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.595, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "A", "mutation": "V26A", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.604, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "D", "mutation": "V26D", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -6.043, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "E", "mutation": "V26E", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "G", "mutation": "V26G", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "H", "mutation": "V26H", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5995, "ferret_sera_escape": 0.02191, "mature_H5_site": 16, "mouse_sera_escape": -0.003472, "mutant": "I", "mutation": "V26I", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": 0.02324, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.209, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "L", "mutation": "V26L", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.986, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "M", "mutation": "V26M", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "N", "mutation": "V26N", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.562, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "S", "mutation": "V26S", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "T", "mutation": "V26T", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 16, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V26V", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "W", "mutation": "V26W", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.279, "ferret_sera_escape": null, "mature_H5_site": 16, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V26Y", "reference_site": "26", "region": "HA1", "sequential_site": 32, "stability": null, "wildtype": "V"}, {"a26_usage": 0.3343, "cell_entry": 0.07074, "ferret_sera_escape": -0.05312, "mature_H5_site": 256, "mouse_sera_escape": 0.01897, "mutant": "A", "mutation": "I260A", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": -0.2199, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -1.12, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "C", "mutation": "I260C", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "D", "mutation": "I260D", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.562, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "E", "mutation": "I260E", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.88, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "F", "mutation": "I260F", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 256, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I260I", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.488, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "K", "mutation": "I260K", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.07275, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "L", "mutation": "I260L", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.361, "ferret_sera_escape": -0.2378, "mature_H5_site": 256, "mouse_sera_escape": 0.7909, "mutant": "M", "mutation": "I260M", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.716, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "N", "mutation": "I260N", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.804, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I260Q", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.726, "ferret_sera_escape": -0.3145, "mature_H5_site": 256, "mouse_sera_escape": 0.06047, "mutant": "S", "mutation": "I260S", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": -0.0895, "wildtype": "I"}, {"a26_usage": 0.007265, "cell_entry": -0.1632, "ferret_sera_escape": -0.02395, "mature_H5_site": 256, "mouse_sera_escape": -0.05158, "mutant": "V", "mutation": "I260V", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": 0.7054, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.751, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "W", "mutation": "I260W", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 256, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I260Y", "reference_site": "260", "region": "region-E", "sequential_site": 272, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.8537, "ferret_sera_escape": 0.0358, "mature_H5_site": 257, "mouse_sera_escape": 0.03377, "mutant": "A", "mutation": "V261A", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.04576, "ferret_sera_escape": 0.2122, "mature_H5_site": 257, "mouse_sera_escape": 0.1037, "mutant": "C", "mutation": "V261C", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": -0.1032, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3668, "ferret_sera_escape": null, "mature_H5_site": 257, "mouse_sera_escape": null, "mutant": "D", "mutation": "V261D", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8042, "ferret_sera_escape": 0.01995, "mature_H5_site": 257, "mouse_sera_escape": 0.2383, "mutant": "E", "mutation": "V261E", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": 1.719, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7212, "ferret_sera_escape": -0.02336, "mature_H5_site": 257, "mouse_sera_escape": 0.2025, "mutant": "F", "mutation": "V261F", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": 0.3216, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.09323, "ferret_sera_escape": null, "mature_H5_site": 257, "mouse_sera_escape": null, "mutant": "I", "mutation": "V261I", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4881, "ferret_sera_escape": 0.04454, "mature_H5_site": 257, "mouse_sera_escape": 0.1707, "mutant": "K", "mutation": "V261K", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": -0.08384, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.01508, "ferret_sera_escape": 0.2457, "mature_H5_site": 257, "mouse_sera_escape": 0.06511, "mutant": "M", "mutation": "V261M", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": -0.7935, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.05874, "ferret_sera_escape": -0.1593, "mature_H5_site": 257, "mouse_sera_escape": 0.01018, "mutant": "N", "mutation": "V261N", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": 0.2352, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 257, "mouse_sera_escape": null, "mutant": "P", "mutation": "V261P", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.04909, "ferret_sera_escape": null, "mature_H5_site": 257, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V261Q", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3833, "ferret_sera_escape": 0.09215, "mature_H5_site": 257, "mouse_sera_escape": 0.1564, "mutant": "S", "mutation": "V261S", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": 0.4557, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.06115, "ferret_sera_escape": -0.2332, "mature_H5_site": 257, "mouse_sera_escape": -0.1587, "mutant": "T", "mutation": "V261T", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": -0.2244, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 257, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V261V", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.533, "ferret_sera_escape": -0.5013, "mature_H5_site": 257, "mouse_sera_escape": 0.2012, "mutant": "W", "mutation": "V261W", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": 0.4339, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7603, "ferret_sera_escape": -0.09924, "mature_H5_site": 257, "mouse_sera_escape": 0.1107, "mutant": "Y", "mutation": "V261Y", "reference_site": "261", "region": "region-E", "sequential_site": 273, "stability": 0.4908, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.901, "ferret_sera_escape": -0.09232, "mature_H5_site": 258, "mouse_sera_escape": 0.1812, "mutant": "A", "mutation": "K262A", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 1.947, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.608, "ferret_sera_escape": 0.1036, "mature_H5_site": 258, "mouse_sera_escape": 0.01458, "mutant": "C", "mutation": "K262C", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.151, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -6.012, "ferret_sera_escape": null, "mature_H5_site": 258, "mouse_sera_escape": null, "mutant": "D", "mutation": "K262D", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.525, "ferret_sera_escape": -0.121, "mature_H5_site": 258, "mouse_sera_escape": null, "mutant": "E", "mutation": "K262E", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.27, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 258, "mouse_sera_escape": null, "mutant": "F", "mutation": "K262F", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.677, "ferret_sera_escape": null, "mature_H5_site": 258, "mouse_sera_escape": null, "mutant": "G", "mutation": "K262G", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.688, "ferret_sera_escape": -0.2173, "mature_H5_site": 258, "mouse_sera_escape": 0.1194, "mutant": "I", "mutation": "K262I", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.377, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 258, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K262K", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.933, "ferret_sera_escape": 0.0376, "mature_H5_site": 258, "mouse_sera_escape": -0.005449, "mutant": "L", "mutation": "K262L", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.085, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.799, "ferret_sera_escape": -0.1374, "mature_H5_site": 258, "mouse_sera_escape": 0.1407, "mutant": "M", "mutation": "K262M", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.165, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.393, "ferret_sera_escape": -0.0407, "mature_H5_site": 258, "mouse_sera_escape": 0.1942, "mutant": "N", "mutation": "K262N", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.135, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.766, "ferret_sera_escape": null, "mature_H5_site": 258, "mouse_sera_escape": null, "mutant": "P", "mutation": "K262P", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.325, "ferret_sera_escape": -0.1007, "mature_H5_site": 258, "mouse_sera_escape": 0.03139, "mutant": "Q", "mutation": "K262Q", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.9813, "ferret_sera_escape": -0.03578, "mature_H5_site": 258, "mouse_sera_escape": 0.02821, "mutant": "R", "mutation": "K262R", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 0.8004, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.583, "ferret_sera_escape": 0.08168, "mature_H5_site": 258, "mouse_sera_escape": 0.3504, "mutant": "T", "mutation": "K262T", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.204, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.643, "ferret_sera_escape": -0.02572, "mature_H5_site": 258, "mouse_sera_escape": 0.3371, "mutant": "V", "mutation": "K262V", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": 2.25, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.121, "ferret_sera_escape": null, "mature_H5_site": 258, "mouse_sera_escape": null, "mutant": "W", "mutation": "K262W", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.858, "ferret_sera_escape": -0.1091, "mature_H5_site": 258, "mouse_sera_escape": 0.06184, "mutant": "Y", "mutation": "K262Y", "reference_site": "262", "region": "region-E", "sequential_site": 274, "stability": null, "wildtype": "K"}, {"a26_usage": 0.00515, "cell_entry": -0.9504, "ferret_sera_escape": -0.383, "mature_H5_site": 259, "mouse_sera_escape": -0.01416, "mutant": "A", "mutation": "K262aA", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": 1.106, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5241, "ferret_sera_escape": 0.02116, "mature_H5_site": 259, "mouse_sera_escape": 0.04064, "mutant": "C", "mutation": "K262aC", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": -0.03637, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.638, "ferret_sera_escape": null, "mature_H5_site": 259, "mouse_sera_escape": null, "mutant": "D", "mutation": "K262aD", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.08961, "ferret_sera_escape": -0.1146, "mature_H5_site": 259, "mouse_sera_escape": 0.01892, "mutant": "E", "mutation": "K262aE", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": 0.4741, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7404, "ferret_sera_escape": -0.116, "mature_H5_site": 259, "mouse_sera_escape": 0.1355, "mutant": "F", "mutation": "K262aF", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": -0.1989, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.624, "ferret_sera_escape": null, "mature_H5_site": 259, "mouse_sera_escape": null, "mutant": "G", "mutation": "K262aG", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3484, "ferret_sera_escape": -0.02185, "mature_H5_site": 259, "mouse_sera_escape": null, "mutant": "H", "mutation": "K262aH", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.779, "ferret_sera_escape": -0.06106, "mature_H5_site": 259, "mouse_sera_escape": -0.02779, "mutant": "I", "mutation": "K262aI", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": -0.04011, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 259, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K262aK", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.05808, "cell_entry": -0.601, "ferret_sera_escape": -0.08929, "mature_H5_site": 259, "mouse_sera_escape": -0.03224, "mutant": "L", "mutation": "K262aL", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": 0.06836, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1283, "ferret_sera_escape": -0.1787, "mature_H5_site": 259, "mouse_sera_escape": -0.1108, "mutant": "M", "mutation": "K262aM", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": -0.1775, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5621, "ferret_sera_escape": -0.06674, "mature_H5_site": 259, "mouse_sera_escape": 0.2158, "mutant": "N", "mutation": "K262aN", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": 1.468, "wildtype": "K"}, {"a26_usage": 0.1842, "cell_entry": -0.08908, "ferret_sera_escape": -0.1144, "mature_H5_site": 259, "mouse_sera_escape": -0.001779, "mutant": "P", "mutation": "K262aP", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": -0.1915, "wildtype": "K"}, {"a26_usage": 0.2778, "cell_entry": -0.1121, "ferret_sera_escape": -0.00797, "mature_H5_site": 259, "mouse_sera_escape": -0.004093, "mutant": "Q", "mutation": "K262aQ", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": 0.05337, "wildtype": "K"}, {"a26_usage": 0.2227, "cell_entry": -0.06869, "ferret_sera_escape": 0.0413, "mature_H5_site": 259, "mouse_sera_escape": -0.02132, "mutant": "R", "mutation": "K262aR", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": -0.2976, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7108, "ferret_sera_escape": null, "mature_H5_site": 259, "mouse_sera_escape": null, "mutant": "S", "mutation": "K262aS", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3274, "ferret_sera_escape": 0.05512, "mature_H5_site": 259, "mouse_sera_escape": 0.08803, "mutant": "T", "mutation": "K262aT", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": 0.5546, "wildtype": "K"}, {"a26_usage": 0.03311, "cell_entry": -0.05537, "ferret_sera_escape": 0.008367, "mature_H5_site": 259, "mouse_sera_escape": -0.01474, "mutant": "V", "mutation": "K262aV", "reference_site": "262a", "region": "region-E", "sequential_site": 275, "stability": -0.1082, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.379, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "A", "mutation": "G263A", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "C", "mutation": "G263C", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.787, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "D", "mutation": "G263D", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.167, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "E", "mutation": "G263E", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.845, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "F", "mutation": "G263F", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 260, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G263G", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.227, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "H", "mutation": "G263H", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8941, "ferret_sera_escape": 0.1993, "mature_H5_site": 260, "mouse_sera_escape": 0.2731, "mutant": "K", "mutation": "G263K", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": 1.478, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.857, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "L", "mutation": "G263L", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.641, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": 1.132, "mutant": "M", "mutation": "G263M", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": 0.6156, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4806, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "N", "mutation": "G263N", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.038, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "P", "mutation": "G263P", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.971, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G263Q", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.737, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "S", "mutation": "G263S", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.476, "ferret_sera_escape": null, "mature_H5_site": 260, "mouse_sera_escape": null, "mutant": "T", "mutation": "G263T", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.199, "ferret_sera_escape": -0.1036, "mature_H5_site": 260, "mouse_sera_escape": 0.628, "mutant": "V", "mutation": "G263V", "reference_site": "263", "region": "region-E", "sequential_site": 276, "stability": 1.351, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5123, "ferret_sera_escape": -0.09823, "mature_H5_site": 261, "mouse_sera_escape": -0.05711, "mutant": "A", "mutation": "D264A", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.345, "ferret_sera_escape": -0.488, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "C", "mutation": "D264C", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 261, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D264D", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.3426, "cell_entry": -0.04274, "ferret_sera_escape": -0.1211, "mature_H5_site": 261, "mouse_sera_escape": -0.128, "mutant": "E", "mutation": "D264E", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": -0.2822, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.05635, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "F", "mutation": "D264F", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.207, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "H", "mutation": "D264H", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "I", "mutation": "D264I", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "K", "mutation": "D264K", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "N", "mutation": "D264N", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.258, "ferret_sera_escape": -0.0922, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "P", "mutation": "D264P", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.678, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "Q", "mutation": "D264Q", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "R", "mutation": "D264R", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4896, "ferret_sera_escape": -0.04748, "mature_H5_site": 261, "mouse_sera_escape": -0.1166, "mutant": "S", "mutation": "D264S", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": -0.1568, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.99, "ferret_sera_escape": null, "mature_H5_site": 261, "mouse_sera_escape": null, "mutant": "V", "mutation": "D264V", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": null, "wildtype": "D"}, {"a26_usage": 0.4098, "cell_entry": -0.04174, "ferret_sera_escape": -0.1047, "mature_H5_site": 261, "mouse_sera_escape": -0.07178, "mutant": "W", "mutation": "D264W", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": -0.2757, "wildtype": "D"}, {"a26_usage": 0.1675, "cell_entry": 0.07162, "ferret_sera_escape": -0.01084, "mature_H5_site": 261, "mouse_sera_escape": 0.03811, "mutant": "Y", "mutation": "D264Y", "reference_site": "264", "region": "region-E", "sequential_site": 277, "stability": -0.2313, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1721, "ferret_sera_escape": -0.1197, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "C", "mutation": "S265C", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "E", "mutation": "S265E", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.129, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "H", "mutation": "S265H", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "I", "mutation": "S265I", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "L", "mutation": "S265L", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "M", "mutation": "S265M", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "N", "mutation": "S265N", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "R", "mutation": "S265R", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 262, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S265S", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.004765, "ferret_sera_escape": -0.01864, "mature_H5_site": 262, "mouse_sera_escape": -0.04802, "mutant": "T", "mutation": "S265T", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": -0.05784, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "V", "mutation": "S265V", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "W", "mutation": "S265W", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 262, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S265Y", "reference_site": "265", "region": "region-E", "sequential_site": 278, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1485, "ferret_sera_escape": -0.09588, "mature_H5_site": 263, "mouse_sera_escape": 0.1406, "mutant": "A", "mutation": "T266A", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": 0.1355, "wildtype": "T"}, {"a26_usage": null, "cell_entry": -0.2516, "ferret_sera_escape": null, "mature_H5_site": 263, "mouse_sera_escape": null, "mutant": "C", "mutation": "T266C", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.704, "ferret_sera_escape": -0.08942, "mature_H5_site": 263, "mouse_sera_escape": 0.1003, "mutant": "D", "mutation": "T266D", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": 0.2438, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.08722, "ferret_sera_escape": -0.154, "mature_H5_site": 263, "mouse_sera_escape": -0.02452, "mutant": "E", "mutation": "T266E", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": 0.02018, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.817, "ferret_sera_escape": -0.117, "mature_H5_site": 263, "mouse_sera_escape": 0.5276, "mutant": "G", "mutation": "T266G", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": 1.117, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.965, "ferret_sera_escape": null, "mature_H5_site": 263, "mouse_sera_escape": null, "mutant": "I", "mutation": "T266I", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": null, "wildtype": "T"}, {"a26_usage": null, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 263, "mouse_sera_escape": null, "mutant": "K", "mutation": "T266K", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.729, "ferret_sera_escape": null, "mature_H5_site": 263, "mouse_sera_escape": null, "mutant": "L", "mutation": "T266L", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.275, "ferret_sera_escape": null, "mature_H5_site": 263, "mouse_sera_escape": null, "mutant": "M", "mutation": "T266M", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.09486, "ferret_sera_escape": 0.1062, "mature_H5_site": 263, "mouse_sera_escape": -0.0005669, "mutant": "N", "mutation": "T266N", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": 0.04793, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 263, "mouse_sera_escape": null, "mutant": "R", "mutation": "T266R", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.989, "ferret_sera_escape": -0.1128, "mature_H5_site": 263, "mouse_sera_escape": 0.2256, "mutant": "S", "mutation": "T266S", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": 1.675, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 263, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T266T", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2074, "ferret_sera_escape": -0.2811, "mature_H5_site": 263, "mouse_sera_escape": -0.2288, "mutant": "V", "mutation": "T266V", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": -0.2479, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 263, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T266Y", "reference_site": "266", "region": "region-E", "sequential_site": 279, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "A", "mutation": "I267A", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.235, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "C", "mutation": "I267C", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "D", "mutation": "I267D", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.516, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "E", "mutation": "I267E", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "G", "mutation": "I267G", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 264, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I267I", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.151, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "L", "mutation": "I267L", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.7231, "ferret_sera_escape": -0.1472, "mature_H5_site": 264, "mouse_sera_escape": -0.1038, "mutant": "M", "mutation": "I267M", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": -0.03202, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.219, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "N", "mutation": "I267N", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.787, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "P", "mutation": "I267P", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.265, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "S", "mutation": "I267S", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.305, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "T", "mutation": "I267T", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3549, "ferret_sera_escape": -0.1571, "mature_H5_site": 264, "mouse_sera_escape": 0.1085, "mutant": "V", "mutation": "I267V", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": 1.597, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -5.904, "ferret_sera_escape": null, "mature_H5_site": 264, "mouse_sera_escape": null, "mutant": "W", "mutation": "I267W", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0026, "ferret_sera_escape": -0.2024, "mature_H5_site": 264, "mouse_sera_escape": -0.08939, "mutant": "Y", "mutation": "I267Y", "reference_site": "267", "region": "region-E", "sequential_site": 280, "stability": 0.883, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.715, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "A", "mutation": "M268A", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.739, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "C", "mutation": "M268C", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -6.024, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "D", "mutation": "M268D", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.671, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "E", "mutation": "M268E", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.9476, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "F", "mutation": "M268F", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -6.019, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "G", "mutation": "M268G", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.814, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "H", "mutation": "M268H", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.04886, "ferret_sera_escape": 0.08174, "mature_H5_site": 265, "mouse_sera_escape": 0.1201, "mutant": "I", "mutation": "M268I", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": 0.1481, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "K", "mutation": "M268K", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.6561, "ferret_sera_escape": 0.1577, "mature_H5_site": 265, "mouse_sera_escape": 0.09768, "mutant": "L", "mutation": "M268L", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": 0.3783, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 265, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M268M", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "N", "mutation": "M268N", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "P", "mutation": "M268P", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "R", "mutation": "M268R", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.888, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "T", "mutation": "M268T", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.809, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": null, "mutant": "W", "mutation": "M268W", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.97, "ferret_sera_escape": null, "mature_H5_site": 265, "mouse_sera_escape": -0.04414, "mutant": "Y", "mutation": "M268Y", "reference_site": "268", "region": "region-E", "sequential_site": 281, "stability": -0.1465, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.06521, "ferret_sera_escape": -0.1155, "mature_H5_site": 266, "mouse_sera_escape": -0.03005, "mutant": "A", "mutation": "K269A", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 1.476, "wildtype": "K"}, {"a26_usage": null, "cell_entry": -0.07142, "ferret_sera_escape": -0.1438, "mature_H5_site": 266, "mouse_sera_escape": -0.06887, "mutant": "C", "mutation": "K269C", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.05252, "ferret_sera_escape": -0.1879, "mature_H5_site": 266, "mouse_sera_escape": -0.004454, "mutant": "E", "mutation": "K269E", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 1.579, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1037, "ferret_sera_escape": -0.2299, "mature_H5_site": 266, "mouse_sera_escape": -0.1134, "mutant": "F", "mutation": "K269F", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 0.863, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1979, "ferret_sera_escape": -0.1978, "mature_H5_site": 266, "mouse_sera_escape": -0.04479, "mutant": "G", "mutation": "K269G", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 0.5144, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7659, "ferret_sera_escape": null, "mature_H5_site": 266, "mouse_sera_escape": null, "mutant": "H", "mutation": "K269H", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0247, "cell_entry": -0.2601, "ferret_sera_escape": -0.02281, "mature_H5_site": 266, "mouse_sera_escape": 0.02381, "mutant": "I", "mutation": "K269I", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 2.055, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 266, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K269K", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3771, "ferret_sera_escape": null, "mature_H5_site": 266, "mouse_sera_escape": null, "mutant": "L", "mutation": "K269L", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05869, "ferret_sera_escape": -0.1596, "mature_H5_site": 266, "mouse_sera_escape": 0.06044, "mutant": "N", "mutation": "K269N", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 1.689, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3809, "ferret_sera_escape": -0.2953, "mature_H5_site": 266, "mouse_sera_escape": 0.0712, "mutant": "P", "mutation": "K269P", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": -0.09833, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.0735, "ferret_sera_escape": 0.02423, "mature_H5_site": 266, "mouse_sera_escape": 0.03181, "mutant": "Q", "mutation": "K269Q", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2058, "ferret_sera_escape": 0.07617, "mature_H5_site": 266, "mouse_sera_escape": -0.05208, "mutant": "R", "mutation": "K269R", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": -0.06978, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.548, "ferret_sera_escape": -0.1296, "mature_H5_site": 266, "mouse_sera_escape": -0.01991, "mutant": "S", "mutation": "K269S", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 0.8763, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2104, "ferret_sera_escape": -0.007491, "mature_H5_site": 266, "mouse_sera_escape": 0.1075, "mutant": "W", "mutation": "K269W", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": 0.9908, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03421, "ferret_sera_escape": -0.1937, "mature_H5_site": 266, "mouse_sera_escape": -0.08209, "mutant": "Y", "mutation": "K269Y", "reference_site": "269", "region": "HA1", "sequential_site": 282, "stability": -0.009141, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.163, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "A", "mutation": "D27A", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "C", "mutation": "D27C", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 17, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D27D", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3213, "ferret_sera_escape": -0.04761, "mature_H5_site": 17, "mouse_sera_escape": -0.08281, "mutant": "E", "mutation": "D27E", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": -0.05211, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "F", "mutation": "D27F", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.476, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "G", "mutation": "D27G", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7211, "ferret_sera_escape": -0.2459, "mature_H5_site": 17, "mouse_sera_escape": -0.1303, "mutant": "H", "mutation": "D27H", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": 0.1139, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.829, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "I", "mutation": "D27I", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "K", "mutation": "D27K", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.794, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "M", "mutation": "D27M", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.124, "ferret_sera_escape": -0.2566, "mature_H5_site": 17, "mouse_sera_escape": 0.06368, "mutant": "N", "mutation": "D27N", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": 0.3326, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "R", "mutation": "D27R", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.137, "ferret_sera_escape": -0.00492, "mature_H5_site": 17, "mouse_sera_escape": 0.1627, "mutant": "S", "mutation": "D27S", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": -0.02505, "wildtype": "D"}, {"a26_usage": null, "cell_entry": -5.679, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "T", "mutation": "D27T", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.863, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "V", "mutation": "D27V", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "W", "mutation": "D27W", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 17, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D27Y", "reference_site": "27", "region": "HA1", "sequential_site": 33, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.01864, "ferret_sera_escape": 0.02026, "mature_H5_site": 267, "mouse_sera_escape": 0.2078, "mutant": "A", "mutation": "S270A", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": 0.2899, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.03212, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "C", "mutation": "S270C", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.997, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "D", "mutation": "S270D", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.444, "ferret_sera_escape": -0.1633, "mature_H5_site": 267, "mouse_sera_escape": 0.3259, "mutant": "E", "mutation": "S270E", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": 0.3675, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.636, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "F", "mutation": "S270F", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8488, "ferret_sera_escape": -0.1488, "mature_H5_site": 267, "mouse_sera_escape": 0.2435, "mutant": "G", "mutation": "S270G", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": 0.2279, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.365, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "H", "mutation": "S270H", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.128, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "L", "mutation": "S270L", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2355, "ferret_sera_escape": -0.05635, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "M", "mutation": "S270M", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.827, "ferret_sera_escape": -0.1365, "mature_H5_site": 267, "mouse_sera_escape": 0.3303, "mutant": "N", "mutation": "S270N", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": 0.5994, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.244, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "P", "mutation": "S270P", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "R", "mutation": "S270R", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 267, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S270S", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.04222, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "T", "mutation": "S270T", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.998, "ferret_sera_escape": null, "mature_H5_site": 267, "mouse_sera_escape": null, "mutant": "W", "mutation": "S270W", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.09, "ferret_sera_escape": -0.4258, "mature_H5_site": 267, "mouse_sera_escape": -0.02105, "mutant": "Y", "mutation": "S270Y", "reference_site": "270", "region": "HA1", "sequential_site": 283, "stability": -0.01774, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1557, "ferret_sera_escape": 0.007901, "mature_H5_site": 268, "mouse_sera_escape": 0.08481, "mutant": "C", "mutation": "G271C", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.0001654, "wildtype": "G"}, {"a26_usage": 0.1521, "cell_entry": -0.1137, "ferret_sera_escape": 0.03679, "mature_H5_site": 268, "mouse_sera_escape": 0.06421, "mutant": "D", "mutation": "G271D", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": -0.1425, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.01537, "ferret_sera_escape": -0.03559, "mature_H5_site": 268, "mouse_sera_escape": 0.1023, "mutant": "E", "mutation": "G271E", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.09551, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 268, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G271G", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4224, "ferret_sera_escape": -0.054, "mature_H5_site": 268, "mouse_sera_escape": 0.1655, "mutant": "H", "mutation": "G271H", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1898, "ferret_sera_escape": -0.07203, "mature_H5_site": 268, "mouse_sera_escape": 0.01507, "mutant": "I", "mutation": "G271I", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": -0.01489, "wildtype": "G"}, {"a26_usage": 0.05401, "cell_entry": -0.07054, "ferret_sera_escape": 0.05085, "mature_H5_site": 268, "mouse_sera_escape": 0.2087, "mutant": "L", "mutation": "G271L", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.349, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.009605, "ferret_sera_escape": -0.1802, "mature_H5_site": 268, "mouse_sera_escape": 0.03843, "mutant": "M", "mutation": "G271M", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.105, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2581, "ferret_sera_escape": -0.04592, "mature_H5_site": 268, "mouse_sera_escape": 0.02322, "mutant": "N", "mutation": "G271N", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": -0.2279, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.03999, "ferret_sera_escape": -0.1406, "mature_H5_site": 268, "mouse_sera_escape": 0.04004, "mutant": "Q", "mutation": "G271Q", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.02278, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1469, "ferret_sera_escape": 0.0332, "mature_H5_site": 268, "mouse_sera_escape": 0.0978, "mutant": "R", "mutation": "G271R", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.1376, "wildtype": "G"}, {"a26_usage": 0.02778, "cell_entry": -0.02725, "ferret_sera_escape": 0.1186, "mature_H5_site": 268, "mouse_sera_escape": 0.1136, "mutant": "S", "mutation": "G271S", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": -0.00492, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0728, "ferret_sera_escape": 0.04292, "mature_H5_site": 268, "mouse_sera_escape": 0.07658, "mutant": "T", "mutation": "G271T", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.2334, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.07468, "ferret_sera_escape": -0.02198, "mature_H5_site": 268, "mouse_sera_escape": null, "mutant": "V", "mutation": "G271V", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8843, "ferret_sera_escape": -0.02638, "mature_H5_site": 268, "mouse_sera_escape": 0.03788, "mutant": "Y", "mutation": "G271Y", "reference_site": "271", "region": "HA1", "sequential_site": 284, "stability": 0.1104, "wildtype": "G"}, {"a26_usage": 0.1393, "cell_entry": -0.2633, "ferret_sera_escape": -0.05949, "mature_H5_site": 269, "mouse_sera_escape": 0.1077, "mutant": "A", "mutation": "V272A", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": -0.1205, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.08906, "ferret_sera_escape": 0.01119, "mature_H5_site": 269, "mouse_sera_escape": 0.08193, "mutant": "C", "mutation": "V272C", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": -0.08458, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3006, "ferret_sera_escape": 0.0987, "mature_H5_site": 269, "mouse_sera_escape": 0.3021, "mutant": "E", "mutation": "V272E", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": 0.4036, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.05965, "ferret_sera_escape": 0.01044, "mature_H5_site": 269, "mouse_sera_escape": -0.04419, "mutant": "L", "mutation": "V272L", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": 0.6907, "wildtype": "V"}, {"a26_usage": 0.3021, "cell_entry": -0.8292, "ferret_sera_escape": 0.07857, "mature_H5_site": 269, "mouse_sera_escape": 0.09085, "mutant": "M", "mutation": "V272M", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": 0.3187, "wildtype": "V"}, {"a26_usage": 0.3462, "cell_entry": -0.8411, "ferret_sera_escape": 0.1119, "mature_H5_site": 269, "mouse_sera_escape": 0.09782, "mutant": "N", "mutation": "V272N", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": 0.02924, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.227, "ferret_sera_escape": null, "mature_H5_site": 269, "mouse_sera_escape": null, "mutant": "P", "mutation": "V272P", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.07754, "ferret_sera_escape": -0.1082, "mature_H5_site": 269, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V272Q", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3126, "ferret_sera_escape": null, "mature_H5_site": 269, "mouse_sera_escape": null, "mutant": "R", "mutation": "V272R", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.01186, "ferret_sera_escape": 0.05093, "mature_H5_site": 269, "mouse_sera_escape": 0.1503, "mutant": "S", "mutation": "V272S", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": -0.1195, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2572, "ferret_sera_escape": -0.01784, "mature_H5_site": 269, "mouse_sera_escape": 0.08651, "mutant": "T", "mutation": "V272T", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": -0.1437, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 269, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V272V", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.896, "ferret_sera_escape": null, "mature_H5_site": 269, "mouse_sera_escape": null, "mutant": "W", "mutation": "V272W", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.205, "ferret_sera_escape": -0.1297, "mature_H5_site": 269, "mouse_sera_escape": 0.1203, "mutant": "Y", "mutation": "V272Y", "reference_site": "272", "region": "HA1", "sequential_site": 285, "stability": 0.05758, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.04307, "ferret_sera_escape": -0.01675, "mature_H5_site": 270, "mouse_sera_escape": 0.06675, "mutant": "D", "mutation": "E273D", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": 0.03856, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 270, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E273E", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.008185, "ferret_sera_escape": 0.2729, "mature_H5_site": 270, "mouse_sera_escape": 0.1976, "mutant": "F", "mutation": "E273F", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.1247, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7489, "ferret_sera_escape": 0.09807, "mature_H5_site": 270, "mouse_sera_escape": null, "mutant": "G", "mutation": "E273G", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.003823, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.89, "ferret_sera_escape": 0.06296, "mature_H5_site": 270, "mouse_sera_escape": 0.09128, "mutant": "H", "mutation": "E273H", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.1138, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.09874, "ferret_sera_escape": 0.09984, "mature_H5_site": 270, "mouse_sera_escape": 0.2181, "mutant": "I", "mutation": "E273I", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.05892, "ferret_sera_escape": 0.159, "mature_H5_site": 270, "mouse_sera_escape": 0.1807, "mutant": "K", "mutation": "E273K", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.579, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07617, "ferret_sera_escape": -0.07928, "mature_H5_site": 270, "mouse_sera_escape": 0.1341, "mutant": "L", "mutation": "E273L", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.1249, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5956, "ferret_sera_escape": -0.01489, "mature_H5_site": 270, "mouse_sera_escape": 0.06254, "mutant": "N", "mutation": "E273N", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.04821, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.05613, "ferret_sera_escape": 0.05113, "mature_H5_site": 270, "mouse_sera_escape": 0.02606, "mutant": "P", "mutation": "E273P", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.06852, "wildtype": "E"}, {"a26_usage": 0.02691, "cell_entry": -0.1911, "ferret_sera_escape": null, "mature_H5_site": 270, "mouse_sera_escape": null, "mutant": "Q", "mutation": "E273Q", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4189, "ferret_sera_escape": 0.08283, "mature_H5_site": 270, "mouse_sera_escape": 0.1385, "mutant": "R", "mutation": "E273R", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.2215, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.264, "ferret_sera_escape": 0.07872, "mature_H5_site": 270, "mouse_sera_escape": 0.1337, "mutant": "S", "mutation": "E273S", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.02958, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07145, "ferret_sera_escape": 0.1031, "mature_H5_site": 270, "mouse_sera_escape": 0.1236, "mutant": "V", "mutation": "E273V", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.04884, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.213, "ferret_sera_escape": 0.1005, "mature_H5_site": 270, "mouse_sera_escape": 0.1506, "mutant": "W", "mutation": "E273W", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.2233, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1791, "ferret_sera_escape": -0.04212, "mature_H5_site": 270, "mouse_sera_escape": 0.1404, "mutant": "Y", "mutation": "E273Y", "reference_site": "273", "region": "region-C", "sequential_site": 286, "stability": -0.1853, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 271, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y274C", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.233, "ferret_sera_escape": null, "mature_H5_site": 271, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y274D", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6571, "ferret_sera_escape": null, "mature_H5_site": 271, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y274E", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1473, "ferret_sera_escape": -0.1678, "mature_H5_site": 271, "mouse_sera_escape": 0.03334, "mutant": "F", "mutation": "Y274F", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.2171, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.9315, "ferret_sera_escape": -0.06037, "mature_H5_site": 271, "mouse_sera_escape": 0.07831, "mutant": "H", "mutation": "Y274H", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.1531, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.004, "ferret_sera_escape": -0.2251, "mature_H5_site": 271, "mouse_sera_escape": 0.02939, "mutant": "I", "mutation": "Y274I", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7471, "ferret_sera_escape": -0.1415, "mature_H5_site": 271, "mouse_sera_escape": -0.09017, "mutant": "K", "mutation": "Y274K", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.1608, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.5867, "ferret_sera_escape": -0.06246, "mature_H5_site": 271, "mouse_sera_escape": 0.2086, "mutant": "L", "mutation": "Y274L", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.03466, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3086, "ferret_sera_escape": -0.2127, "mature_H5_site": 271, "mouse_sera_escape": -0.0169, "mutant": "M", "mutation": "Y274M", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.05645, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.674, "ferret_sera_escape": null, "mature_H5_site": 271, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y274N", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.9213, "ferret_sera_escape": -0.2864, "mature_H5_site": 271, "mouse_sera_escape": 0.1884, "mutant": "P", "mutation": "Y274P", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.5091, "ferret_sera_escape": -0.1276, "mature_H5_site": 271, "mouse_sera_escape": 0.08142, "mutant": "Q", "mutation": "Y274Q", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.03969, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3517, "ferret_sera_escape": -0.1047, "mature_H5_site": 271, "mouse_sera_escape": -0.06496, "mutant": "R", "mutation": "Y274R", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.1542, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.553, "ferret_sera_escape": null, "mature_H5_site": 271, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y274S", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": null, "wildtype": "Y"}, {"a26_usage": null, "cell_entry": -3.089, "ferret_sera_escape": null, "mature_H5_site": 271, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y274T", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.342, "ferret_sera_escape": -0.06022, "mature_H5_site": 271, "mouse_sera_escape": 0.1688, "mutant": "V", "mutation": "Y274V", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.1482, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.374, "ferret_sera_escape": -0.05142, "mature_H5_site": 271, "mouse_sera_escape": 0.1065, "mutant": "W", "mutation": "Y274W", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": -0.1287, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 271, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y274Y", "reference_site": "274", "region": "region-C", "sequential_site": 287, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3067, "ferret_sera_escape": 0.2261, "mature_H5_site": 272, "mouse_sera_escape": -0.01942, "mutant": "A", "mutation": "G275A", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.1921, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2103, "ferret_sera_escape": 0.1345, "mature_H5_site": 272, "mouse_sera_escape": 0.1888, "mutant": "C", "mutation": "G275C", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.3552, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1904, "ferret_sera_escape": -0.06979, "mature_H5_site": 272, "mouse_sera_escape": 0.04526, "mutant": "D", "mutation": "G275D", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.1064, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.00481, "ferret_sera_escape": 0.07898, "mature_H5_site": 272, "mouse_sera_escape": 0.08696, "mutant": "E", "mutation": "G275E", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.208, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.07922, "ferret_sera_escape": -0.0372, "mature_H5_site": 272, "mouse_sera_escape": -0.03573, "mutant": "F", "mutation": "G275F", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.2527, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 272, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G275G", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.05633, "ferret_sera_escape": 0.007223, "mature_H5_site": 272, "mouse_sera_escape": 0.09607, "mutant": "I", "mutation": "G275I", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.1721, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5344, "ferret_sera_escape": -0.1786, "mature_H5_site": 272, "mouse_sera_escape": 0.03781, "mutant": "L", "mutation": "G275L", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.2881, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1075, "ferret_sera_escape": 0.02666, "mature_H5_site": 272, "mouse_sera_escape": 0.1796, "mutant": "N", "mutation": "G275N", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.2779, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3611, "ferret_sera_escape": 0.0508, "mature_H5_site": 272, "mouse_sera_escape": 0.08306, "mutant": "Q", "mutation": "G275Q", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.1939, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.05761, "ferret_sera_escape": -0.004873, "mature_H5_site": 272, "mouse_sera_escape": 0.04978, "mutant": "R", "mutation": "G275R", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.4089, "wildtype": "G"}, {"a26_usage": 0.129, "cell_entry": 0.04569, "ferret_sera_escape": -0.07198, "mature_H5_site": 272, "mouse_sera_escape": -0.08362, "mutant": "S", "mutation": "G275S", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.1898, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.356, "ferret_sera_escape": 0.02419, "mature_H5_site": 272, "mouse_sera_escape": -0.01981, "mutant": "T", "mutation": "G275T", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.2316, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7538, "ferret_sera_escape": -0.001287, "mature_H5_site": 272, "mouse_sera_escape": 0.07425, "mutant": "V", "mutation": "G275V", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.4038, "wildtype": "G"}, {"a26_usage": 0.1788, "cell_entry": -0.06164, "ferret_sera_escape": 0.07118, "mature_H5_site": 272, "mouse_sera_escape": 0.1524, "mutant": "Y", "mutation": "G275Y", "reference_site": "275", "region": "region-C", "sequential_site": 288, "stability": -0.2143, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.04673, "ferret_sera_escape": -0.0237, "mature_H5_site": 273, "mouse_sera_escape": -0.0707, "mutant": "A", "mutation": "H276A", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.0003186, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.639, "ferret_sera_escape": 0.05069, "mature_H5_site": 273, "mouse_sera_escape": -0.01411, "mutant": "C", "mutation": "H276C", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.1807, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.03909, "ferret_sera_escape": -0.2438, "mature_H5_site": 273, "mouse_sera_escape": 0.02956, "mutant": "D", "mutation": "H276D", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.004831, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0575, "ferret_sera_escape": 0.08248, "mature_H5_site": 273, "mouse_sera_escape": 0.08209, "mutant": "E", "mutation": "H276E", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": 0.04955, "wildtype": "H"}, {"a26_usage": 0.01294, "cell_entry": -0.2528, "ferret_sera_escape": 0.02124, "mature_H5_site": 273, "mouse_sera_escape": 0.05663, "mutant": "F", "mutation": "H276F", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": 0.08427, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1948, "ferret_sera_escape": 0.1025, "mature_H5_site": 273, "mouse_sera_escape": 0.1527, "mutant": "G", "mutation": "H276G", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.04804, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 273, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H276H", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1161, "ferret_sera_escape": 0.1067, "mature_H5_site": 273, "mouse_sera_escape": 0.07931, "mutant": "I", "mutation": "H276I", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.003913, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.03018, "ferret_sera_escape": 0.03347, "mature_H5_site": 273, "mouse_sera_escape": 0.03368, "mutant": "L", "mutation": "H276L", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.00786, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4396, "ferret_sera_escape": 0.09672, "mature_H5_site": 273, "mouse_sera_escape": 0.0305, "mutant": "M", "mutation": "H276M", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": null, "wildtype": "H"}, {"a26_usage": 0.004055, "cell_entry": 0.06345, "ferret_sera_escape": 0.1041, "mature_H5_site": 273, "mouse_sera_escape": 0.03018, "mutant": "N", "mutation": "H276N", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": 0.04685, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.09073, "ferret_sera_escape": 0.02695, "mature_H5_site": 273, "mouse_sera_escape": 0.1123, "mutant": "P", "mutation": "H276P", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.07781, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.05824, "ferret_sera_escape": 0.09006, "mature_H5_site": 273, "mouse_sera_escape": 0.03579, "mutant": "Q", "mutation": "H276Q", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.004703, "wildtype": "H"}, {"a26_usage": 0.09592, "cell_entry": -0.2119, "ferret_sera_escape": 0.03128, "mature_H5_site": 273, "mouse_sera_escape": 0.004824, "mutant": "R", "mutation": "H276R", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.00706, "wildtype": "H"}, {"a26_usage": null, "cell_entry": 0.07586, "ferret_sera_escape": null, "mature_H5_site": 273, "mouse_sera_escape": null, "mutant": "S", "mutation": "H276S", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": null, "wildtype": "H"}, {"a26_usage": 0.3178, "cell_entry": -0.01836, "ferret_sera_escape": 0.06423, "mature_H5_site": 273, "mouse_sera_escape": -0.01813, "mutant": "V", "mutation": "H276V", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": 0.004314, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.05123, "ferret_sera_escape": 0.183, "mature_H5_site": 273, "mouse_sera_escape": 0.04031, "mutant": "Y", "mutation": "H276Y", "reference_site": "276", "region": "region-C", "sequential_site": 289, "stability": -0.02631, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 274, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C277C", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.105, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "D", "mutation": "C277D", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "E", "mutation": "C277E", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "F", "mutation": "C277F", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.945, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "G", "mutation": "C277G", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.887, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "H", "mutation": "C277H", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "I", "mutation": "C277I", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "K", "mutation": "C277K", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.029, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "L", "mutation": "C277L", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.059, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "M", "mutation": "C277M", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.091, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "N", "mutation": "C277N", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "P", "mutation": "C277P", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C277Q", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.683, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "R", "mutation": "C277R", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": null, "cell_entry": -5.515, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "S", "mutation": "C277S", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.897, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "T", "mutation": "C277T", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "V", "mutation": "C277V", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.861, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "W", "mutation": "C277W", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 274, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C277Y", "reference_site": "277", "region": "region-C", "sequential_site": 290, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.6703, "ferret_sera_escape": 0.03723, "mature_H5_site": 275, "mouse_sera_escape": 0.03367, "mutant": "A", "mutation": "N278A", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": 0.0613, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05209, "ferret_sera_escape": -0.04938, "mature_H5_site": 275, "mouse_sera_escape": 0.0549, "mutant": "C", "mutation": "N278C", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": null, "wildtype": "N"}, {"a26_usage": 0.02136, "cell_entry": -0.06275, "ferret_sera_escape": 0.01667, "mature_H5_site": 275, "mouse_sera_escape": 0.04618, "mutant": "D", "mutation": "N278D", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": 0.01978, "wildtype": "N"}, {"a26_usage": 0.003791, "cell_entry": -0.06308, "ferret_sera_escape": 0.02454, "mature_H5_site": 275, "mouse_sera_escape": 0.1046, "mutant": "E", "mutation": "N278E", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": -0.08861, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.03093, "ferret_sera_escape": -0.09605, "mature_H5_site": 275, "mouse_sera_escape": -0.04555, "mutant": "G", "mutation": "N278G", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": -0.06749, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07623, "ferret_sera_escape": null, "mature_H5_site": 275, "mouse_sera_escape": null, "mutant": "H", "mutation": "N278H", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.08326, "ferret_sera_escape": -0.07798, "mature_H5_site": 275, "mouse_sera_escape": 0.05913, "mutant": "I", "mutation": "N278I", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": -0.1164, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3997, "ferret_sera_escape": 0.04424, "mature_H5_site": 275, "mouse_sera_escape": 0.06751, "mutant": "K", "mutation": "N278K", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.117, "ferret_sera_escape": null, "mature_H5_site": 275, "mouse_sera_escape": null, "mutant": "L", "mutation": "N278L", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 275, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N278N", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.2, "ferret_sera_escape": -0.4398, "mature_H5_site": 275, "mouse_sera_escape": -0.0287, "mutant": "P", "mutation": "N278P", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": -0.2614, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04685, "ferret_sera_escape": -0.1211, "mature_H5_site": 275, "mouse_sera_escape": 0.01027, "mutant": "Q", "mutation": "N278Q", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": -0.05117, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.28, "ferret_sera_escape": null, "mature_H5_site": 275, "mouse_sera_escape": null, "mutant": "R", "mutation": "N278R", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": 0.06451, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.06859, "ferret_sera_escape": 0.01815, "mature_H5_site": 275, "mouse_sera_escape": -0.02269, "mutant": "V", "mutation": "N278V", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": -0.206, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1673, "ferret_sera_escape": -0.04927, "mature_H5_site": 275, "mouse_sera_escape": 0.03777, "mutant": "W", "mutation": "N278W", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": 0.01606, "wildtype": "N"}, {"a26_usage": 0.5753, "cell_entry": 0.02635, "ferret_sera_escape": null, "mature_H5_site": 275, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N278Y", "reference_site": "278", "region": "region-C", "sequential_site": 291, "stability": -0.1064, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.04979, "ferret_sera_escape": -0.1855, "mature_H5_site": 276, "mouse_sera_escape": -0.0147, "mutant": "A", "mutation": "T279A", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": 0.3921, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "D", "mutation": "T279D", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.6106, "ferret_sera_escape": -0.3421, "mature_H5_site": 276, "mouse_sera_escape": -0.1182, "mutant": "E", "mutation": "T279E", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": -0.2691, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7477, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "F", "mutation": "T279F", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.607, "ferret_sera_escape": -0.04797, "mature_H5_site": 276, "mouse_sera_escape": 0.2028, "mutant": "G", "mutation": "T279G", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": 0.5787, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3263, "ferret_sera_escape": -0.08865, "mature_H5_site": 276, "mouse_sera_escape": -0.01454, "mutant": "H", "mutation": "T279H", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.076, "ferret_sera_escape": -0.4149, "mature_H5_site": 276, "mouse_sera_escape": -0.1102, "mutant": "I", "mutation": "T279I", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": -0.1804, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.309, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "K", "mutation": "T279K", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.208, "ferret_sera_escape": -0.01019, "mature_H5_site": 276, "mouse_sera_escape": 0.03875, "mutant": "L", "mutation": "T279L", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": -0.2033, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1254, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "M", "mutation": "T279M", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.536, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "N", "mutation": "T279N", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.964, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "P", "mutation": "T279P", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.149, "ferret_sera_escape": 0.2241, "mature_H5_site": 276, "mouse_sera_escape": 0.1271, "mutant": "Q", "mutation": "T279Q", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": -0.2481, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.256, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "R", "mutation": "T279R", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.3247, "cell_entry": -0.1961, "ferret_sera_escape": -0.02985, "mature_H5_site": 276, "mouse_sera_escape": 0.104, "mutant": "S", "mutation": "T279S", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": 0.5185, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 276, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T279T", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.494, "ferret_sera_escape": 0.03353, "mature_H5_site": 276, "mouse_sera_escape": -0.0119, "mutant": "V", "mutation": "T279V", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": 0.5448, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 276, "mouse_sera_escape": null, "mutant": "W", "mutation": "T279W", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2367, "ferret_sera_escape": -0.1101, "mature_H5_site": 276, "mouse_sera_escape": 0.06911, "mutant": "Y", "mutation": "T279Y", "reference_site": "279", "region": "region-C", "sequential_site": 292, "stability": -0.05642, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.081, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "A", "mutation": "T28A", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.056, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "D", "mutation": "T28D", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.159, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "E", "mutation": "T28E", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.952, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "G", "mutation": "T28G", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "H", "mutation": "T28H", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -6.058, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "I", "mutation": "T28I", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.172, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "L", "mutation": "T28L", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "M", "mutation": "T28M", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "N", "mutation": "T28N", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.35, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T28Q", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "R", "mutation": "T28R", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.918, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "S", "mutation": "T28S", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 18, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T28T", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "V", "mutation": "T28V", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "W", "mutation": "T28W", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": null, "cell_entry": -3.037, "ferret_sera_escape": null, "mature_H5_site": 18, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T28Y", "reference_site": "28", "region": "HA1", "sequential_site": 34, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2911, "ferret_sera_escape": -0.02672, "mature_H5_site": 277, "mouse_sera_escape": 0.0735, "mutant": "A", "mutation": "K280A", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.07781, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4976, "ferret_sera_escape": 0.08109, "mature_H5_site": 277, "mouse_sera_escape": 0.04654, "mutant": "D", "mutation": "K280D", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.2803, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1043, "ferret_sera_escape": -0.1165, "mature_H5_site": 277, "mouse_sera_escape": -0.09801, "mutant": "E", "mutation": "K280E", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.957, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1471, "ferret_sera_escape": 0.02984, "mature_H5_site": 277, "mouse_sera_escape": 0.06815, "mutant": "F", "mutation": "K280F", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.2949, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.329, "ferret_sera_escape": null, "mature_H5_site": 277, "mouse_sera_escape": null, "mutant": "G", "mutation": "K280G", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2482, "ferret_sera_escape": 0.1476, "mature_H5_site": 277, "mouse_sera_escape": -0.1055, "mutant": "H", "mutation": "K280H", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.2088, "wildtype": "K"}, {"a26_usage": 0.4376, "cell_entry": -0.04782, "ferret_sera_escape": -0.1488, "mature_H5_site": 277, "mouse_sera_escape": -0.1339, "mutant": "I", "mutation": "K280I", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.1719, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 277, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K280K", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1948, "ferret_sera_escape": -0.2223, "mature_H5_site": 277, "mouse_sera_escape": -0.038, "mutant": "M", "mutation": "K280M", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.1558, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03372, "ferret_sera_escape": 0.07396, "mature_H5_site": 277, "mouse_sera_escape": -0.001291, "mutant": "N", "mutation": "K280N", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.3328, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3246, "ferret_sera_escape": -0.036, "mature_H5_site": 277, "mouse_sera_escape": 0.03633, "mutant": "R", "mutation": "K280R", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": 0.1622, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.008765, "ferret_sera_escape": -0.2168, "mature_H5_site": 277, "mouse_sera_escape": -0.05076, "mutant": "S", "mutation": "K280S", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.2159, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.239, "ferret_sera_escape": -0.1969, "mature_H5_site": 277, "mouse_sera_escape": null, "mutant": "T", "mutation": "K280T", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": null, "wildtype": "K"}, {"a26_usage": 0.2644, "cell_entry": 0.07706, "ferret_sera_escape": -0.01675, "mature_H5_site": 277, "mouse_sera_escape": -0.04124, "mutant": "V", "mutation": "K280V", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.336, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1321, "ferret_sera_escape": 0.05216, "mature_H5_site": 277, "mouse_sera_escape": 0.1124, "mutant": "W", "mutation": "K280W", "reference_site": "280", "region": "region-C", "sequential_site": 293, "stability": -0.2677, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "A", "mutation": "C281A", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 278, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C281C", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "D", "mutation": "C281D", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "E", "mutation": "C281E", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.692, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "F", "mutation": "C281F", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "G", "mutation": "C281G", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "H", "mutation": "C281H", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "I", "mutation": "C281I", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "K", "mutation": "C281K", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "M", "mutation": "C281M", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "N", "mutation": "C281N", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "P", "mutation": "C281P", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.632, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C281Q", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "S", "mutation": "C281S", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.786, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "T", "mutation": "C281T", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.299, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "V", "mutation": "C281V", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "W", "mutation": "C281W", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.731, "ferret_sera_escape": null, "mature_H5_site": 278, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C281Y", "reference_site": "281", "region": "HA1", "sequential_site": 294, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.711, "ferret_sera_escape": -0.08184, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "A", "mutation": "Q282A", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.01, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "C", "mutation": "Q282C", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "D", "mutation": "Q282D", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "E", "mutation": "Q282E", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "F", "mutation": "Q282F", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.838, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "G", "mutation": "Q282G", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "H", "mutation": "Q282H", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "I", "mutation": "Q282I", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "K", "mutation": "Q282K", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "L", "mutation": "Q282L", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": null, "cell_entry": -1.062, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "M", "mutation": "Q282M", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "N", "mutation": "Q282N", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q282P", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 279, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q282Q", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "R", "mutation": "Q282R", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.654, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "S", "mutation": "Q282S", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.691, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "T", "mutation": "Q282T", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.761, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "V", "mutation": "Q282V", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "W", "mutation": "Q282W", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.873, "ferret_sera_escape": null, "mature_H5_site": 279, "mouse_sera_escape": null, "mutant": "Y", "mutation": "Q282Y", "reference_site": "282", "region": "HA1", "sequential_site": 295, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.7026, "ferret_sera_escape": 0.08027, "mature_H5_site": 280, "mouse_sera_escape": 0.08478, "mutant": "A", "mutation": "T283A", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": 1.31, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.281, "ferret_sera_escape": 0.03785, "mature_H5_site": 280, "mouse_sera_escape": 0.05719, "mutant": "C", "mutation": "T283C", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": 0.06446, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.72, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "D", "mutation": "T283D", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -6.007, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "E", "mutation": "T283E", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "F", "mutation": "T283F", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.595, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "G", "mutation": "T283G", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "I", "mutation": "T283I", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "K", "mutation": "T283K", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.871, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "L", "mutation": "T283L", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "N", "mutation": "T283N", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "P", "mutation": "T283P", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T283Q", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.997, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "R", "mutation": "T283R", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.00089, "ferret_sera_escape": -0.03912, "mature_H5_site": 280, "mouse_sera_escape": 0.04799, "mutant": "S", "mutation": "T283S", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": 0.2691, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 280, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T283T", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "W", "mutation": "T283W", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.769, "ferret_sera_escape": null, "mature_H5_site": 280, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T283Y", "reference_site": "283", "region": "HA1", "sequential_site": 296, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.361, "ferret_sera_escape": -0.2317, "mature_H5_site": 281, "mouse_sera_escape": -0.01105, "mutant": "C", "mutation": "P284C", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.275, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.187, "ferret_sera_escape": -0.09688, "mature_H5_site": 281, "mouse_sera_escape": -0.05137, "mutant": "E", "mutation": "P284E", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.09062, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.564, "ferret_sera_escape": null, "mature_H5_site": 281, "mouse_sera_escape": null, "mutant": "F", "mutation": "P284F", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.044, "ferret_sera_escape": -0.3871, "mature_H5_site": 281, "mouse_sera_escape": -0.1486, "mutant": "G", "mutation": "P284G", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.925, "ferret_sera_escape": null, "mature_H5_site": 281, "mouse_sera_escape": null, "mutant": "H", "mutation": "P284H", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.278, "ferret_sera_escape": -0.07369, "mature_H5_site": 281, "mouse_sera_escape": 0.007541, "mutant": "I", "mutation": "P284I", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.07686, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.218, "ferret_sera_escape": -0.247, "mature_H5_site": 281, "mouse_sera_escape": 0.0447, "mutant": "K", "mutation": "P284K", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.0127, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.144, "ferret_sera_escape": -0.2048, "mature_H5_site": 281, "mouse_sera_escape": 0.02513, "mutant": "L", "mutation": "P284L", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.2265, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.03431, "ferret_sera_escape": null, "mature_H5_site": 281, "mouse_sera_escape": null, "mutant": "M", "mutation": "P284M", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.138, "ferret_sera_escape": -0.1696, "mature_H5_site": 281, "mouse_sera_escape": 0.02392, "mutant": "N", "mutation": "P284N", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.1878, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 281, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P284P", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3004, "ferret_sera_escape": -0.01239, "mature_H5_site": 281, "mouse_sera_escape": 0.02441, "mutant": "Q", "mutation": "P284Q", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.3203, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.617, "ferret_sera_escape": null, "mature_H5_site": 281, "mouse_sera_escape": null, "mutant": "R", "mutation": "P284R", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.8283, "ferret_sera_escape": -0.1357, "mature_H5_site": 281, "mouse_sera_escape": 0.004321, "mutant": "S", "mutation": "P284S", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.136, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.564, "ferret_sera_escape": 0.01739, "mature_H5_site": 281, "mouse_sera_escape": 0.1632, "mutant": "T", "mutation": "P284T", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.9163, "ferret_sera_escape": null, "mature_H5_site": 281, "mouse_sera_escape": null, "mutant": "V", "mutation": "P284V", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.185, "ferret_sera_escape": -0.1377, "mature_H5_site": 281, "mouse_sera_escape": 0.03857, "mutant": "W", "mutation": "P284W", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": -0.2216, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.066, "ferret_sera_escape": null, "mature_H5_site": 281, "mouse_sera_escape": null, "mutant": "Y", "mutation": "P284Y", "reference_site": "284", "region": "HA1", "sequential_site": 297, "stability": null, "wildtype": "P"}, {"a26_usage": null, "cell_entry": -0.6299, "ferret_sera_escape": 0.1131, "mature_H5_site": 282, "mouse_sera_escape": 0.2113, "mutant": "C", "mutation": "V285C", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.4524, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.04041, "ferret_sera_escape": 0.1049, "mature_H5_site": 282, "mouse_sera_escape": 0.05688, "mutant": "D", "mutation": "V285D", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.07515, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.134, "ferret_sera_escape": -0.04315, "mature_H5_site": 282, "mouse_sera_escape": 0.1699, "mutant": "E", "mutation": "V285E", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.2222, "wildtype": "V"}, {"a26_usage": 0.1619, "cell_entry": 0.04734, "ferret_sera_escape": 0.02198, "mature_H5_site": 282, "mouse_sera_escape": -0.1538, "mutant": "F", "mutation": "V285F", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.09773, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.849, "ferret_sera_escape": null, "mature_H5_site": 282, "mouse_sera_escape": null, "mutant": "G", "mutation": "V285G", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4318, "ferret_sera_escape": -0.01397, "mature_H5_site": 282, "mouse_sera_escape": -0.02244, "mutant": "H", "mutation": "V285H", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.2805, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5692, "ferret_sera_escape": 0.06895, "mature_H5_site": 282, "mouse_sera_escape": 0.06946, "mutant": "K", "mutation": "V285K", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.2427, "wildtype": "V"}, {"a26_usage": 0.1949, "cell_entry": 0.05529, "ferret_sera_escape": -0.03714, "mature_H5_site": 282, "mouse_sera_escape": -0.001371, "mutant": "L", "mutation": "V285L", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": 0.07216, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.02511, "ferret_sera_escape": 0.04114, "mature_H5_site": 282, "mouse_sera_escape": 0.01273, "mutant": "M", "mutation": "V285M", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.3497, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.03936, "ferret_sera_escape": 0.1164, "mature_H5_site": 282, "mouse_sera_escape": 0.06024, "mutant": "R", "mutation": "V285R", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.3218, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.141, "ferret_sera_escape": -0.002717, "mature_H5_site": 282, "mouse_sera_escape": 0.0113, "mutant": "T", "mutation": "V285T", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.2205, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 282, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V285V", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1219, "ferret_sera_escape": -0.07078, "mature_H5_site": 282, "mouse_sera_escape": -0.2958, "mutant": "Y", "mutation": "V285Y", "reference_site": "285", "region": "HA1", "sequential_site": 298, "stability": -0.3088, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.723, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "A", "mutation": "G286A", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.988, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "C", "mutation": "G286C", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.693, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "D", "mutation": "G286D", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.875, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "E", "mutation": "G286E", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.53, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "F", "mutation": "G286F", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 283, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G286G", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "H", "mutation": "G286H", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "I", "mutation": "G286I", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.645, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "K", "mutation": "G286K", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.112, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "L", "mutation": "G286L", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.897, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "M", "mutation": "G286M", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "N", "mutation": "G286N", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.454, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "P", "mutation": "G286P", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G286Q", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.878, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "R", "mutation": "G286R", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.566, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "S", "mutation": "G286S", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "T", "mutation": "G286T", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "V", "mutation": "G286V", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "W", "mutation": "G286W", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.89, "ferret_sera_escape": null, "mature_H5_site": 283, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G286Y", "reference_site": "286", "region": "HA1", "sequential_site": 299, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 284, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A287A", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.212, "ferret_sera_escape": -0.08981, "mature_H5_site": 284, "mouse_sera_escape": -0.03762, "mutant": "C", "mutation": "A287C", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": -0.2597, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.336, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "D", "mutation": "A287D", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.703, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "E", "mutation": "A287E", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.993, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "F", "mutation": "A287F", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.5327, "cell_entry": -0.03492, "ferret_sera_escape": -0.2037, "mature_H5_site": 284, "mouse_sera_escape": 0.1083, "mutant": "G", "mutation": "A287G", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": -0.1851, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "H", "mutation": "A287H", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.976, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "I", "mutation": "A287I", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.845, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "K", "mutation": "A287K", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.803, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "L", "mutation": "A287L", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.854, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "M", "mutation": "A287M", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "N", "mutation": "A287N", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "P", "mutation": "A287P", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A287Q", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.788, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "R", "mutation": "A287R", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3706, "ferret_sera_escape": -0.04319, "mature_H5_site": 284, "mouse_sera_escape": -0.01286, "mutant": "S", "mutation": "A287S", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": -0.1533, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.235, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "T", "mutation": "A287T", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "V", "mutation": "A287V", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.72, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "W", "mutation": "A287W", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.389, "ferret_sera_escape": null, "mature_H5_site": 284, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A287Y", "reference_site": "287", "region": "HA1", "sequential_site": 300, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "A", "mutation": "I288A", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.709, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "C", "mutation": "I288C", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "D", "mutation": "I288D", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.87, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "E", "mutation": "I288E", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1064, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "F", "mutation": "I288F", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "G", "mutation": "I288G", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.51, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "H", "mutation": "I288H", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 285, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I288I", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "K", "mutation": "I288K", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6565, "ferret_sera_escape": 0.07987, "mature_H5_site": 285, "mouse_sera_escape": 0.1212, "mutant": "L", "mutation": "I288L", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": 0.6465, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "N", "mutation": "I288N", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "P", "mutation": "I288P", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -4.435, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I288Q", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.891, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "R", "mutation": "I288R", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "S", "mutation": "I288S", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3081, "ferret_sera_escape": -0.3497, "mature_H5_site": 285, "mouse_sera_escape": 0.02295, "mutant": "T", "mutation": "I288T", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": 0.108, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.07299, "ferret_sera_escape": -0.09063, "mature_H5_site": 285, "mouse_sera_escape": -0.08816, "mutant": "V", "mutation": "I288V", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": 0.06439, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.008, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "W", "mutation": "I288W", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 285, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I288Y", "reference_site": "288", "region": "HA1", "sequential_site": 301, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2427, "ferret_sera_escape": -0.3116, "mature_H5_site": 286, "mouse_sera_escape": 0.02149, "mutant": "C", "mutation": "N289C", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.9475, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02386, "ferret_sera_escape": -0.254, "mature_H5_site": 286, "mouse_sera_escape": -0.1347, "mutant": "D", "mutation": "N289D", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.3916, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6729, "ferret_sera_escape": -0.2093, "mature_H5_site": 286, "mouse_sera_escape": -0.01829, "mutant": "E", "mutation": "N289E", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.2215, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5121, "ferret_sera_escape": -0.3577, "mature_H5_site": 286, "mouse_sera_escape": -0.05332, "mutant": "F", "mutation": "N289F", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.04747, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.476, "ferret_sera_escape": -0.05161, "mature_H5_site": 286, "mouse_sera_escape": 0.1958, "mutant": "H", "mutation": "N289H", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.5718, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8409, "ferret_sera_escape": 0.01423, "mature_H5_site": 286, "mouse_sera_escape": 0.1062, "mutant": "K", "mutation": "N289K", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.4782, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2793, "ferret_sera_escape": -0.2268, "mature_H5_site": 286, "mouse_sera_escape": 0.1043, "mutant": "L", "mutation": "N289L", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 1.692, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3157, "ferret_sera_escape": -0.3014, "mature_H5_site": 286, "mouse_sera_escape": 0.06817, "mutant": "M", "mutation": "N289M", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 1.621, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 286, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N289N", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7309, "ferret_sera_escape": -0.4279, "mature_H5_site": 286, "mouse_sera_escape": 0.06188, "mutant": "P", "mutation": "N289P", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 1.692, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05491, "ferret_sera_escape": -0.127, "mature_H5_site": 286, "mouse_sera_escape": 0.08962, "mutant": "Q", "mutation": "N289Q", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 1.451, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5173, "ferret_sera_escape": -0.3925, "mature_H5_site": 286, "mouse_sera_escape": -0.0874, "mutant": "R", "mutation": "N289R", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.6255, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2118, "ferret_sera_escape": -0.265, "mature_H5_site": 286, "mouse_sera_escape": -0.08385, "mutant": "S", "mutation": "N289S", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.415, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7815, "ferret_sera_escape": -0.1617, "mature_H5_site": 286, "mouse_sera_escape": 0.034, "mutant": "T", "mutation": "N289T", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.606, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.64, "ferret_sera_escape": -0.369, "mature_H5_site": 286, "mouse_sera_escape": -0.1767, "mutant": "V", "mutation": "N289V", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": 0.9676, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.375, "ferret_sera_escape": -0.2062, "mature_H5_site": 286, "mouse_sera_escape": -0.003586, "mutant": "Y", "mutation": "N289Y", "reference_site": "289", "region": "HA1", "sequential_site": 302, "stability": -0.1141, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.885, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "D", "mutation": "I29D", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "E", "mutation": "I29E", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.212, "ferret_sera_escape": 0.1104, "mature_H5_site": 19, "mouse_sera_escape": 0.1014, "mutant": "F", "mutation": "I29F", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": 0.3511, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.755, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "G", "mutation": "I29G", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.48, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "H", "mutation": "I29H", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 19, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I29I", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "K", "mutation": "I29K", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.556, "ferret_sera_escape": -0.346, "mature_H5_site": 19, "mouse_sera_escape": 0.2848, "mutant": "M", "mutation": "I29M", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": 2.168, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.404, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "N", "mutation": "I29N", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.274, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "P", "mutation": "I29P", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.142, "ferret_sera_escape": 0.1979, "mature_H5_site": 19, "mouse_sera_escape": 0.1473, "mutant": "Q", "mutation": "I29Q", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": 1.485, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.906, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "R", "mutation": "I29R", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.179, "ferret_sera_escape": -0.247, "mature_H5_site": 19, "mouse_sera_escape": 0.3462, "mutant": "S", "mutation": "I29S", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": 1.945, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.814, "ferret_sera_escape": null, "mature_H5_site": 19, "mouse_sera_escape": null, "mutant": "T", "mutation": "I29T", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3447, "ferret_sera_escape": -0.185, "mature_H5_site": 19, "mouse_sera_escape": 0.1044, "mutant": "V", "mutation": "I29V", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": -0.2337, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.062, "ferret_sera_escape": 0.2559, "mature_H5_site": 19, "mouse_sera_escape": 0.3026, "mutant": "W", "mutation": "I29W", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": 1.932, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.589, "ferret_sera_escape": -0.1007, "mature_H5_site": 19, "mouse_sera_escape": 0.5179, "mutant": "Y", "mutation": "I29Y", "reference_site": "29", "region": "HA1", "sequential_site": 35, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4521, "ferret_sera_escape": -0.1772, "mature_H5_site": 287, "mouse_sera_escape": 0.4033, "mutant": "A", "mutation": "S290A", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 1.99, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4881, "ferret_sera_escape": null, "mature_H5_site": 287, "mouse_sera_escape": null, "mutant": "C", "mutation": "S290C", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.79, "ferret_sera_escape": -0.1167, "mature_H5_site": 287, "mouse_sera_escape": 0.07669, "mutant": "D", "mutation": "S290D", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 0.9916, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8632, "ferret_sera_escape": -0.1507, "mature_H5_site": 287, "mouse_sera_escape": null, "mutant": "E", "mutation": "S290E", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4681, "ferret_sera_escape": -0.1415, "mature_H5_site": 287, "mouse_sera_escape": -0.01076, "mutant": "F", "mutation": "S290F", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": -0.0682, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -0.7972, "ferret_sera_escape": null, "mature_H5_site": 287, "mouse_sera_escape": null, "mutant": "G", "mutation": "S290G", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4433, "ferret_sera_escape": -0.06069, "mature_H5_site": 287, "mouse_sera_escape": 0.1903, "mutant": "H", "mutation": "S290H", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 1.249, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8901, "ferret_sera_escape": -0.1132, "mature_H5_site": 287, "mouse_sera_escape": 0.06578, "mutant": "I", "mutation": "S290I", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 0.1345, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.301, "ferret_sera_escape": 0.1277, "mature_H5_site": 287, "mouse_sera_escape": 0.07307, "mutant": "K", "mutation": "S290K", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.141, "ferret_sera_escape": null, "mature_H5_site": 287, "mouse_sera_escape": null, "mutant": "L", "mutation": "S290L", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 0.3945, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.687, "ferret_sera_escape": -0.1385, "mature_H5_site": 287, "mouse_sera_escape": 0.05307, "mutant": "M", "mutation": "S290M", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 0.5899, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.02721, "ferret_sera_escape": 0.008297, "mature_H5_site": 287, "mouse_sera_escape": 0.13, "mutant": "N", "mutation": "S290N", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 1.486, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.9476, "ferret_sera_escape": -0.8405, "mature_H5_site": 287, "mouse_sera_escape": -0.1753, "mutant": "P", "mutation": "S290P", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 287, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S290S", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1778, "ferret_sera_escape": 0.05753, "mature_H5_site": 287, "mouse_sera_escape": 0.06155, "mutant": "T", "mutation": "S290T", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 0.3642, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4178, "ferret_sera_escape": -0.09534, "mature_H5_site": 287, "mouse_sera_escape": 0.01692, "mutant": "V", "mutation": "S290V", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 1.57, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.708, "ferret_sera_escape": -0.425, "mature_H5_site": 287, "mouse_sera_escape": 0.6464, "mutant": "W", "mutation": "S290W", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": 1.29, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.034, "ferret_sera_escape": -0.1641, "mature_H5_site": 287, "mouse_sera_escape": 0.09876, "mutant": "Y", "mutation": "S290Y", "reference_site": "290", "region": "HA1", "sequential_site": 303, "stability": -0.01852, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -0.1991, "ferret_sera_escape": null, "mature_H5_site": 288, "mouse_sera_escape": 0.3862, "mutant": "C", "mutation": "S291C", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.512, "ferret_sera_escape": -0.4569, "mature_H5_site": 288, "mouse_sera_escape": -0.07216, "mutant": "D", "mutation": "S291D", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 0.4098, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.01435, "ferret_sera_escape": -0.3295, "mature_H5_site": 288, "mouse_sera_escape": -0.06144, "mutant": "E", "mutation": "S291E", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 0.6591, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3417, "ferret_sera_escape": -0.0554, "mature_H5_site": 288, "mouse_sera_escape": 0.1591, "mutant": "F", "mutation": "S291F", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.656, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1044, "ferret_sera_escape": -0.2727, "mature_H5_site": 288, "mouse_sera_escape": -0.0624, "mutant": "G", "mutation": "S291G", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.887, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -0.4173, "ferret_sera_escape": -0.5163, "mature_H5_site": 288, "mouse_sera_escape": 0.01958, "mutant": "H", "mutation": "S291H", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3105, "ferret_sera_escape": -0.0951, "mature_H5_site": 288, "mouse_sera_escape": 0.05407, "mutant": "I", "mutation": "S291I", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.831, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.9585, "ferret_sera_escape": -0.1788, "mature_H5_site": 288, "mouse_sera_escape": 0.2094, "mutant": "K", "mutation": "S291K", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.669, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.112, "ferret_sera_escape": -0.3014, "mature_H5_site": 288, "mouse_sera_escape": -0.03817, "mutant": "L", "mutation": "S291L", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.159, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1897, "ferret_sera_escape": -0.2697, "mature_H5_site": 288, "mouse_sera_escape": 0.03793, "mutant": "N", "mutation": "S291N", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.462, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4923, "ferret_sera_escape": -0.1806, "mature_H5_site": 288, "mouse_sera_escape": 0.1206, "mutant": "P", "mutation": "S291P", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.746, "wildtype": "S"}, {"a26_usage": 0.2896, "cell_entry": -0.2441, "ferret_sera_escape": -0.319, "mature_H5_site": 288, "mouse_sera_escape": -0.03134, "mutant": "Q", "mutation": "S291Q", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.345, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.539, "ferret_sera_escape": null, "mature_H5_site": 288, "mouse_sera_escape": null, "mutant": "R", "mutation": "S291R", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.627, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 288, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S291S", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.04824, "ferret_sera_escape": -0.0715, "mature_H5_site": 288, "mouse_sera_escape": -0.07146, "mutant": "T", "mutation": "S291T", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": -0.0677, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.512, "ferret_sera_escape": -0.3226, "mature_H5_site": 288, "mouse_sera_escape": 0.05679, "mutant": "W", "mutation": "S291W", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.724, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.921, "ferret_sera_escape": -0.3863, "mature_H5_site": 288, "mouse_sera_escape": -0.05003, "mutant": "Y", "mutation": "S291Y", "reference_site": "291", "region": "HA1", "sequential_site": 304, "stability": 1.93, "wildtype": "S"}, {"a26_usage": 0.2752, "cell_entry": -0.07493, "ferret_sera_escape": 0.03373, "mature_H5_site": 289, "mouse_sera_escape": -0.05005, "mutant": "A", "mutation": "M292A", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.1716, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.104, "ferret_sera_escape": -0.1082, "mature_H5_site": 289, "mouse_sera_escape": 0.01239, "mutant": "C", "mutation": "M292C", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.04196, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.468, "ferret_sera_escape": -0.0087, "mature_H5_site": 289, "mouse_sera_escape": -0.2808, "mutant": "D", "mutation": "M292D", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.4671, "ferret_sera_escape": -0.09103, "mature_H5_site": 289, "mouse_sera_escape": -0.08058, "mutant": "E", "mutation": "M292E", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.2931, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.3826, "ferret_sera_escape": 0.1501, "mature_H5_site": 289, "mouse_sera_escape": 0.01976, "mutant": "F", "mutation": "M292F", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": 1.627, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.628, "ferret_sera_escape": -0.1605, "mature_H5_site": 289, "mouse_sera_escape": -0.0507, "mutant": "G", "mutation": "M292G", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": 0.4799, "wildtype": "M"}, {"a26_usage": 0.5847, "cell_entry": -0.9509, "ferret_sera_escape": -0.2025, "mature_H5_site": 289, "mouse_sera_escape": -0.09097, "mutant": "H", "mutation": "M292H", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.3246, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.5777, "ferret_sera_escape": -0.05682, "mature_H5_site": 289, "mouse_sera_escape": 0.08203, "mutant": "I", "mutation": "M292I", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.7501, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.5759, "ferret_sera_escape": 0.09828, "mature_H5_site": 289, "mouse_sera_escape": -0.02135, "mutant": "K", "mutation": "M292K", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.2898, "wildtype": "M"}, {"a26_usage": 0.1227, "cell_entry": -0.1714, "ferret_sera_escape": 0.1847, "mature_H5_site": 289, "mouse_sera_escape": 0.1741, "mutant": "L", "mutation": "M292L", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": 1.161, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 289, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M292M", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.1027, "cell_entry": -0.2639, "ferret_sera_escape": -0.03065, "mature_H5_site": 289, "mouse_sera_escape": 0.06161, "mutant": "N", "mutation": "M292N", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": 1.817, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.4293, "ferret_sera_escape": -0.1141, "mature_H5_site": 289, "mouse_sera_escape": -0.0863, "mutant": "Q", "mutation": "M292Q", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.201, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.195, "ferret_sera_escape": -0.1076, "mature_H5_site": 289, "mouse_sera_escape": -0.04571, "mutant": "R", "mutation": "M292R", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.2516, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.9998, "ferret_sera_escape": null, "mature_H5_site": 289, "mouse_sera_escape": null, "mutant": "T", "mutation": "M292T", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.03645, "ferret_sera_escape": 0.006273, "mature_H5_site": 289, "mouse_sera_escape": 0.06246, "mutant": "V", "mutation": "M292V", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": -0.05052, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.593, "ferret_sera_escape": -0.2546, "mature_H5_site": 289, "mouse_sera_escape": 0.6581, "mutant": "W", "mutation": "M292W", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": 1.017, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.5862, "ferret_sera_escape": null, "mature_H5_site": 289, "mouse_sera_escape": null, "mutant": "Y", "mutation": "M292Y", "reference_site": "292", "region": "HA1", "sequential_site": 305, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.9639, "ferret_sera_escape": 0.00997, "mature_H5_site": 290, "mouse_sera_escape": -0.108, "mutant": "A", "mutation": "P293A", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": -0.248, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.275, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "C", "mutation": "P293C", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "D", "mutation": "P293D", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.808, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "E", "mutation": "P293E", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "F", "mutation": "P293F", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.669, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "G", "mutation": "P293G", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "H", "mutation": "P293H", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.288, "ferret_sera_escape": -0.105, "mature_H5_site": 290, "mouse_sera_escape": 0.2322, "mutant": "I", "mutation": "P293I", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.587, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "K", "mutation": "P293K", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "L", "mutation": "P293L", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "N", "mutation": "P293N", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 290, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P293P", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P293Q", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "R", "mutation": "P293R", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.104, "ferret_sera_escape": -0.1009, "mature_H5_site": 290, "mouse_sera_escape": -0.04982, "mutant": "S", "mutation": "P293S", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": -0.2894, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "T", "mutation": "P293T", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.036, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "V", "mutation": "P293V", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.997, "ferret_sera_escape": null, "mature_H5_site": 290, "mouse_sera_escape": null, "mutant": "W", "mutation": "P293W", "reference_site": "293", "region": "HA1", "sequential_site": 306, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.686, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "A", "mutation": "F294A", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.527, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "C", "mutation": "F294C", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "D", "mutation": "F294D", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "E", "mutation": "F294E", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 291, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F294F", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "G", "mutation": "F294G", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -4.228, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "H", "mutation": "F294H", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.756, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "I", "mutation": "F294I", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "K", "mutation": "F294K", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "L", "mutation": "F294L", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.223, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "M", "mutation": "F294M", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "N", "mutation": "F294N", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "P", "mutation": "F294P", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F294Q", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "R", "mutation": "F294R", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "S", "mutation": "F294S", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "T", "mutation": "F294T", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.56, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "V", "mutation": "F294V", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.006, "ferret_sera_escape": 0.03403, "mature_H5_site": 291, "mouse_sera_escape": -0.05495, "mutant": "W", "mutation": "F294W", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": 0.2094, "wildtype": "F"}, {"a26_usage": null, "cell_entry": -0.9853, "ferret_sera_escape": null, "mature_H5_site": 291, "mouse_sera_escape": null, "mutant": "Y", "mutation": "F294Y", "reference_site": "294", "region": "HA1", "sequential_site": 307, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.904, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "A", "mutation": "H295A", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "D", "mutation": "H295D", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.033, "ferret_sera_escape": 0.032, "mature_H5_site": 292, "mouse_sera_escape": 0.0319, "mutant": "E", "mutation": "H295E", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": -0.2013, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.009, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "F", "mutation": "H295F", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "G", "mutation": "H295G", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 292, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H295H", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.704, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "I", "mutation": "H295I", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "K", "mutation": "H295K", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -6.05, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "L", "mutation": "H295L", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1798, "ferret_sera_escape": 0.00771, "mature_H5_site": 292, "mouse_sera_escape": 0.08517, "mutant": "M", "mutation": "H295M", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": 0.8931, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.243, "ferret_sera_escape": -0.2186, "mature_H5_site": 292, "mouse_sera_escape": -0.1426, "mutant": "N", "mutation": "H295N", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "P", "mutation": "H295P", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5552, "ferret_sera_escape": 0.04153, "mature_H5_site": 292, "mouse_sera_escape": 0.06, "mutant": "Q", "mutation": "H295Q", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": 0.8473, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "R", "mutation": "H295R", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.692, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "S", "mutation": "H295S", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "V", "mutation": "H295V", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "W", "mutation": "H295W", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 292, "mouse_sera_escape": null, "mutant": "Y", "mutation": "H295Y", "reference_site": "295", "region": "HA1", "sequential_site": 308, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.2204, "ferret_sera_escape": 0.04048, "mature_H5_site": 293, "mouse_sera_escape": 0.06466, "mutant": "C", "mutation": "N296C", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": 0.06613, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.787, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "D", "mutation": "N296D", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.178, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "E", "mutation": "N296E", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.482, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "F", "mutation": "N296F", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.482, "ferret_sera_escape": -0.237, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "G", "mutation": "N296G", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.011, "ferret_sera_escape": -0.2419, "mature_H5_site": 293, "mouse_sera_escape": 0.009677, "mutant": "H", "mutation": "N296H", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": 0.8781, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9063, "ferret_sera_escape": -0.1602, "mature_H5_site": 293, "mouse_sera_escape": 0.1787, "mutant": "K", "mutation": "N296K", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": 0.8286, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "L", "mutation": "N296L", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.267, "ferret_sera_escape": -0.3433, "mature_H5_site": 293, "mouse_sera_escape": -0.1083, "mutant": "M", "mutation": "N296M", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 293, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N296N", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "P", "mutation": "N296P", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2041, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "S", "mutation": "N296S", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.678, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "V", "mutation": "N296V", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 293, "mouse_sera_escape": null, "mutant": "W", "mutation": "N296W", "reference_site": "296", "region": "HA1", "sequential_site": 309, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.692, "ferret_sera_escape": 0.2293, "mature_H5_site": 294, "mouse_sera_escape": 0.214, "mutant": "A", "mutation": "I297A", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.356, "ferret_sera_escape": 0.01811, "mature_H5_site": 294, "mouse_sera_escape": 0.3164, "mutant": "C", "mutation": "I297C", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.545, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "D", "mutation": "I297D", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "E", "mutation": "I297E", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "F", "mutation": "I297F", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.046, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "G", "mutation": "I297G", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "H", "mutation": "I297H", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 294, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I297I", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.307, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "M", "mutation": "I297M", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.418, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "N", "mutation": "I297N", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "P", "mutation": "I297P", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.755, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I297Q", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "R", "mutation": "I297R", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "S", "mutation": "I297S", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5858, "ferret_sera_escape": 0.09975, "mature_H5_site": 294, "mouse_sera_escape": 0.1556, "mutant": "V", "mutation": "I297V", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": 1.038, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "W", "mutation": "I297W", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 294, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I297Y", "reference_site": "297", "region": "HA1", "sequential_site": 310, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4859, "ferret_sera_escape": -0.08316, "mature_H5_site": 295, "mouse_sera_escape": 0.01797, "mutant": "A", "mutation": "H298A", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.1329, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1668, "ferret_sera_escape": -0.05349, "mature_H5_site": 295, "mouse_sera_escape": 0.1306, "mutant": "C", "mutation": "H298C", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": 0.0445, "wildtype": "H"}, {"a26_usage": 0.09162, "cell_entry": -0.3435, "ferret_sera_escape": null, "mature_H5_site": 295, "mouse_sera_escape": null, "mutant": "D", "mutation": "H298D", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.268, "ferret_sera_escape": -0.2734, "mature_H5_site": 295, "mouse_sera_escape": -0.04252, "mutant": "E", "mutation": "H298E", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.06522, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.212, "ferret_sera_escape": 0.02434, "mature_H5_site": 295, "mouse_sera_escape": 0.06479, "mutant": "F", "mutation": "H298F", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.242, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.829, "ferret_sera_escape": -0.1937, "mature_H5_site": 295, "mouse_sera_escape": 0.2928, "mutant": "G", "mutation": "H298G", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": 1.314, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 295, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H298H", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3204, "ferret_sera_escape": -0.07648, "mature_H5_site": 295, "mouse_sera_escape": -0.05537, "mutant": "I", "mutation": "H298I", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.1046, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 295, "mouse_sera_escape": null, "mutant": "K", "mutation": "H298K", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.464, "ferret_sera_escape": null, "mature_H5_site": 295, "mouse_sera_escape": null, "mutant": "L", "mutation": "H298L", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4391, "ferret_sera_escape": -0.06916, "mature_H5_site": 295, "mouse_sera_escape": -0.1563, "mutant": "M", "mutation": "H298M", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.08075, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.04058, "ferret_sera_escape": 0.08779, "mature_H5_site": 295, "mouse_sera_escape": 0.06207, "mutant": "N", "mutation": "H298N", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": 1.422, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.808, "ferret_sera_escape": null, "mature_H5_site": 295, "mouse_sera_escape": null, "mutant": "P", "mutation": "H298P", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.335, "ferret_sera_escape": null, "mature_H5_site": 295, "mouse_sera_escape": null, "mutant": "Q", "mutation": "H298Q", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.01038, "ferret_sera_escape": -0.06034, "mature_H5_site": 295, "mouse_sera_escape": 0.05529, "mutant": "S", "mutation": "H298S", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": 2.005, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.587, "ferret_sera_escape": null, "mature_H5_site": 295, "mouse_sera_escape": null, "mutant": "T", "mutation": "H298T", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5103, "ferret_sera_escape": -0.05852, "mature_H5_site": 295, "mouse_sera_escape": 0.05549, "mutant": "V", "mutation": "H298V", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.175, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.174, "ferret_sera_escape": 0.09348, "mature_H5_site": 295, "mouse_sera_escape": 0.06699, "mutant": "W", "mutation": "H298W", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.2662, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.371, "ferret_sera_escape": -0.1719, "mature_H5_site": 295, "mouse_sera_escape": 0.03531, "mutant": "Y", "mutation": "H298Y", "reference_site": "298", "region": "HA1", "sequential_site": 311, "stability": -0.69, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3082, "ferret_sera_escape": -0.01727, "mature_H5_site": 296, "mouse_sera_escape": 0.06702, "mutant": "A", "mutation": "P299A", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 0.8046, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.211, "ferret_sera_escape": null, "mature_H5_site": 296, "mouse_sera_escape": null, "mutant": "C", "mutation": "P299C", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.869, "ferret_sera_escape": null, "mature_H5_site": 296, "mouse_sera_escape": null, "mutant": "D", "mutation": "P299D", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 0.843, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.05282, "ferret_sera_escape": 0.05213, "mature_H5_site": 296, "mouse_sera_escape": 0.005645, "mutant": "E", "mutation": "P299E", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 0.6164, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5805, "ferret_sera_escape": 0.1922, "mature_H5_site": 296, "mouse_sera_escape": 0.1151, "mutant": "F", "mutation": "P299F", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": -0.1112, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.632, "ferret_sera_escape": null, "mature_H5_site": 296, "mouse_sera_escape": null, "mutant": "G", "mutation": "P299G", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.298, "ferret_sera_escape": 0.07482, "mature_H5_site": 296, "mouse_sera_escape": 0.03595, "mutant": "H", "mutation": "P299H", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 0.2025, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.895, "ferret_sera_escape": -0.5101, "mature_H5_site": 296, "mouse_sera_escape": null, "mutant": "I", "mutation": "P299I", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 1.071, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.6738, "ferret_sera_escape": 0.02725, "mature_H5_site": 296, "mouse_sera_escape": 0.05692, "mutant": "K", "mutation": "P299K", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": -0.2263, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.341, "ferret_sera_escape": -0.09982, "mature_H5_site": 296, "mouse_sera_escape": 0.3111, "mutant": "L", "mutation": "P299L", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 1.209, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1411, "ferret_sera_escape": -0.1128, "mature_H5_site": 296, "mouse_sera_escape": 0.09314, "mutant": "M", "mutation": "P299M", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 1.748, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.85, "ferret_sera_escape": 0.2721, "mature_H5_site": 296, "mouse_sera_escape": 0.3497, "mutant": "N", "mutation": "P299N", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 1.161, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 296, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P299P", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.006735, "ferret_sera_escape": 0.03192, "mature_H5_site": 296, "mouse_sera_escape": 0.2768, "mutant": "Q", "mutation": "P299Q", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 2.004, "wildtype": "P"}, {"a26_usage": 0.03544, "cell_entry": 0.02747, "ferret_sera_escape": -0.00777, "mature_H5_site": 296, "mouse_sera_escape": 0.07723, "mutant": "R", "mutation": "P299R", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": -0.1451, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3645, "ferret_sera_escape": -0.08346, "mature_H5_site": 296, "mouse_sera_escape": -0.004101, "mutant": "S", "mutation": "P299S", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 0.2178, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.923, "ferret_sera_escape": -0.1047, "mature_H5_site": 296, "mouse_sera_escape": 0.1181, "mutant": "T", "mutation": "P299T", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3982, "ferret_sera_escape": -0.1651, "mature_H5_site": 296, "mouse_sera_escape": 0.2796, "mutant": "V", "mutation": "P299V", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": 1.512, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.009955, "ferret_sera_escape": -0.005387, "mature_H5_site": 296, "mouse_sera_escape": 0.06501, "mutant": "W", "mutation": "P299W", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": -0.08597, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.274, "ferret_sera_escape": -0.01951, "mature_H5_site": 296, "mouse_sera_escape": 0.03394, "mutant": "Y", "mutation": "P299Y", "reference_site": "299", "region": "HA1", "sequential_site": 312, "stability": -0.226, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -8, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A3A", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.09102, "ferret_sera_escape": 0.05602, "mature_H5_site": -8, "mouse_sera_escape": 0.01006, "mutant": "C", "mutation": "A3C", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": -0.06029, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.952, "ferret_sera_escape": null, "mature_H5_site": -8, "mouse_sera_escape": null, "mutant": "D", "mutation": "A3D", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.523, "ferret_sera_escape": null, "mature_H5_site": -8, "mouse_sera_escape": null, "mutant": "E", "mutation": "A3E", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.04236, "ferret_sera_escape": -0.02124, "mature_H5_site": -8, "mouse_sera_escape": -0.08931, "mutant": "F", "mutation": "A3F", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": 0.01015, "wildtype": "A"}, {"a26_usage": 0.05199, "cell_entry": -0.115, "ferret_sera_escape": 0.1043, "mature_H5_site": -8, "mouse_sera_escape": -0.03008, "mutant": "G", "mutation": "A3G", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": -0.04024, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.638, "ferret_sera_escape": 0.123, "mature_H5_site": -8, "mouse_sera_escape": null, "mutant": "H", "mutation": "A3H", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1002, "ferret_sera_escape": -0.04215, "mature_H5_site": -8, "mouse_sera_escape": -0.02035, "mutant": "I", "mutation": "A3I", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": -0.04222, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.239, "ferret_sera_escape": null, "mature_H5_site": -8, "mouse_sera_escape": null, "mutant": "K", "mutation": "A3K", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.02632, "cell_entry": 0.01363, "ferret_sera_escape": 0.04169, "mature_H5_site": -8, "mouse_sera_escape": -0.04435, "mutant": "M", "mutation": "A3M", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": -0.007856, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1904, "ferret_sera_escape": null, "mature_H5_site": -8, "mouse_sera_escape": -0.2718, "mutant": "N", "mutation": "A3N", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.024, "ferret_sera_escape": -0.2432, "mature_H5_site": -8, "mouse_sera_escape": -0.1966, "mutant": "P", "mutation": "A3P", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": -0.1826, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": -8, "mouse_sera_escape": null, "mutant": "R", "mutation": "A3R", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.291, "ferret_sera_escape": null, "mature_H5_site": -8, "mouse_sera_escape": null, "mutant": "S", "mutation": "A3S", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.04197, "cell_entry": -0.1812, "ferret_sera_escape": 0.1271, "mature_H5_site": -8, "mouse_sera_escape": -0.001172, "mutant": "T", "mutation": "A3T", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": -0.008903, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2082, "ferret_sera_escape": 0.1009, "mature_H5_site": -8, "mouse_sera_escape": -0.1276, "mutant": "V", "mutation": "A3V", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1149, "ferret_sera_escape": 0.03544, "mature_H5_site": -8, "mouse_sera_escape": 0.007356, "mutant": "W", "mutation": "A3W", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": 0.05242, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.0315, "ferret_sera_escape": -0.04392, "mature_H5_site": -8, "mouse_sera_escape": -0.03145, "mutant": "Y", "mutation": "A3Y", "reference_site": "3", "region": "HA1", "sequential_site": 9, "stability": -0.03384, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.53, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "A", "mutation": "M30A", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.017, "ferret_sera_escape": -0.05731, "mature_H5_site": 20, "mouse_sera_escape": 0.05386, "mutant": "C", "mutation": "M30C", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "D", "mutation": "M30D", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -6.007, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "E", "mutation": "M30E", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.582, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "F", "mutation": "M30F", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.71, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "G", "mutation": "M30G", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.86, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "H", "mutation": "M30H", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.3399, "cell_entry": -0.3339, "ferret_sera_escape": -0.03065, "mature_H5_site": 20, "mouse_sera_escape": 0.02768, "mutant": "I", "mutation": "M30I", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": 1.069, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.547, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": 0.09687, "mutant": "K", "mutation": "M30K", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.05798, "ferret_sera_escape": 0.01288, "mature_H5_site": 20, "mouse_sera_escape": 0.06532, "mutant": "L", "mutation": "M30L", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": 1.769, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 20, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M30M", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "P", "mutation": "M30P", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.603, "ferret_sera_escape": null, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "Q", "mutation": "M30Q", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.01377, "ferret_sera_escape": -0.0774, "mature_H5_site": 20, "mouse_sera_escape": -0.06243, "mutant": "R", "mutation": "M30R", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": 0.2733, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.258, "ferret_sera_escape": -0.07364, "mature_H5_site": 20, "mouse_sera_escape": -0.01392, "mutant": "T", "mutation": "M30T", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": -0.1525, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.516, "ferret_sera_escape": -0.1263, "mature_H5_site": 20, "mouse_sera_escape": 0.02833, "mutant": "V", "mutation": "M30V", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": -0.07247, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.746, "ferret_sera_escape": -0.1262, "mature_H5_site": 20, "mouse_sera_escape": null, "mutant": "W", "mutation": "M30W", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.02554, "ferret_sera_escape": -0.07232, "mature_H5_site": 20, "mouse_sera_escape": 0.09304, "mutant": "Y", "mutation": "M30Y", "reference_site": "30", "region": "HA1", "sequential_site": 36, "stability": 1.4, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.2448, "ferret_sera_escape": -0.1122, "mature_H5_site": 297, "mouse_sera_escape": -0.04789, "mutant": "C", "mutation": "L300C", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.2636, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.7, "ferret_sera_escape": -0.151, "mature_H5_site": 297, "mouse_sera_escape": null, "mutant": "D", "mutation": "L300D", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.8145, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.087, "ferret_sera_escape": -0.1872, "mature_H5_site": 297, "mouse_sera_escape": 0.3159, "mutant": "E", "mutation": "L300E", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.7471, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.11, "ferret_sera_escape": 0.01205, "mature_H5_site": 297, "mouse_sera_escape": 0.2456, "mutant": "F", "mutation": "L300F", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.05542, "ferret_sera_escape": -0.3168, "mature_H5_site": 297, "mouse_sera_escape": 0.002527, "mutant": "G", "mutation": "L300G", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5598, "ferret_sera_escape": -0.0665, "mature_H5_site": 297, "mouse_sera_escape": -0.07754, "mutant": "H", "mutation": "L300H", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": -0.2875, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.324, "ferret_sera_escape": 0.04262, "mature_H5_site": 297, "mouse_sera_escape": 0.06093, "mutant": "I", "mutation": "L300I", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.2358, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6996, "ferret_sera_escape": null, "mature_H5_site": 297, "mouse_sera_escape": null, "mutant": "K", "mutation": "L300K", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 297, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L300L", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3473, "ferret_sera_escape": 0.08441, "mature_H5_site": 297, "mouse_sera_escape": 0.03404, "mutant": "M", "mutation": "L300M", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.01447, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06018, "ferret_sera_escape": 0.00878, "mature_H5_site": 297, "mouse_sera_escape": -0.01437, "mutant": "N", "mutation": "L300N", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": -0.2299, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.824, "ferret_sera_escape": null, "mature_H5_site": 297, "mouse_sera_escape": null, "mutant": "P", "mutation": "L300P", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.00903, "ferret_sera_escape": null, "mature_H5_site": 297, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L300Q", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5619, "ferret_sera_escape": 0.01152, "mature_H5_site": 297, "mouse_sera_escape": 0.1278, "mutant": "R", "mutation": "L300R", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2622, "ferret_sera_escape": -0.1623, "mature_H5_site": 297, "mouse_sera_escape": -0.001735, "mutant": "S", "mutation": "L300S", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.0909, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6339, "ferret_sera_escape": 0.1049, "mature_H5_site": 297, "mouse_sera_escape": 0.1896, "mutant": "T", "mutation": "L300T", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.5398, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9497, "ferret_sera_escape": null, "mature_H5_site": 297, "mouse_sera_escape": null, "mutant": "V", "mutation": "L300V", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.679, "ferret_sera_escape": -0.1296, "mature_H5_site": 297, "mouse_sera_escape": null, "mutant": "W", "mutation": "L300W", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 1.038, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.8056, "ferret_sera_escape": 0.2096, "mature_H5_site": 297, "mouse_sera_escape": 0.1057, "mutant": "Y", "mutation": "L300Y", "reference_site": "300", "region": "HA1", "sequential_site": 313, "stability": 0.4549, "wildtype": "L"}, {"a26_usage": 0.8482, "cell_entry": -1.639, "ferret_sera_escape": null, "mature_H5_site": 298, "mouse_sera_escape": null, "mutant": "A", "mutation": "T301A", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.6266, "ferret_sera_escape": null, "mature_H5_site": 298, "mouse_sera_escape": null, "mutant": "C", "mutation": "T301C", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": -0.06737, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.8886, "ferret_sera_escape": null, "mature_H5_site": 298, "mouse_sera_escape": null, "mutant": "E", "mutation": "T301E", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2488, "ferret_sera_escape": 0.09106, "mature_H5_site": 298, "mouse_sera_escape": 0.01404, "mutant": "G", "mutation": "T301G", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.264, "ferret_sera_escape": 0.1525, "mature_H5_site": 298, "mouse_sera_escape": null, "mutant": "H", "mutation": "T301H", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.795, "ferret_sera_escape": -0.1399, "mature_H5_site": 298, "mouse_sera_escape": 0.2562, "mutant": "I", "mutation": "T301I", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": 1.611, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.0938, "ferret_sera_escape": 0.2155, "mature_H5_site": 298, "mouse_sera_escape": 0.2235, "mutant": "L", "mutation": "T301L", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": 0.3446, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5401, "ferret_sera_escape": 0.002423, "mature_H5_site": 298, "mouse_sera_escape": 0.03477, "mutant": "M", "mutation": "T301M", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": -0.08384, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2265, "ferret_sera_escape": -0.0537, "mature_H5_site": 298, "mouse_sera_escape": 0.03904, "mutant": "N", "mutation": "T301N", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": -0.2728, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.01294, "ferret_sera_escape": -0.09327, "mature_H5_site": 298, "mouse_sera_escape": -0.06196, "mutant": "Q", "mutation": "T301Q", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": -0.152, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.787, "ferret_sera_escape": null, "mature_H5_site": 298, "mouse_sera_escape": null, "mutant": "R", "mutation": "T301R", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 298, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T301T", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3608, "ferret_sera_escape": 0.02167, "mature_H5_site": 298, "mouse_sera_escape": 0.03234, "mutant": "V", "mutation": "T301V", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": 0.9135, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3641, "ferret_sera_escape": 0.1982, "mature_H5_site": 298, "mouse_sera_escape": 0.1925, "mutant": "W", "mutation": "T301W", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": 0.7569, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1224, "ferret_sera_escape": 0.2993, "mature_H5_site": 298, "mouse_sera_escape": 0.1383, "mutant": "Y", "mutation": "T301Y", "reference_site": "301", "region": "HA1", "sequential_site": 314, "stability": 0.1093, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.574, "ferret_sera_escape": -0.102, "mature_H5_site": 299, "mouse_sera_escape": 0.0927, "mutant": "A", "mutation": "I302A", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": -0.4837, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "D", "mutation": "I302D", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.339, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "G", "mutation": "I302G", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "H", "mutation": "I302H", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 299, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I302I", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.884, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "K", "mutation": "I302K", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.05906, "ferret_sera_escape": -0.1131, "mature_H5_site": 299, "mouse_sera_escape": 0.1913, "mutant": "L", "mutation": "I302L", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": 0.5065, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.7368, "ferret_sera_escape": -0.02313, "mature_H5_site": 299, "mouse_sera_escape": -0.09599, "mutant": "M", "mutation": "I302M", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": -0.232, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "N", "mutation": "I302N", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I302Q", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.822, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "R", "mutation": "I302R", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.85, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "S", "mutation": "I302S", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.171, "ferret_sera_escape": 0.213, "mature_H5_site": 299, "mouse_sera_escape": 0.1199, "mutant": "T", "mutation": "I302T", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": -0.1797, "wildtype": "I"}, {"a26_usage": null, "cell_entry": 0.06557, "ferret_sera_escape": 0.0599, "mature_H5_site": 299, "mouse_sera_escape": -0.06478, "mutant": "V", "mutation": "I302V", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": 0.3944, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.432, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "W", "mutation": "I302W", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 299, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I302Y", "reference_site": "302", "region": "HA1", "sequential_site": 315, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.584, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "A", "mutation": "G303A", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "C", "mutation": "G303C", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "D", "mutation": "G303D", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "F", "mutation": "G303F", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 300, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G303G", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.826, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "H", "mutation": "G303H", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "I", "mutation": "G303I", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.069, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "K", "mutation": "G303K", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.004, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "L", "mutation": "G303L", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "M", "mutation": "G303M", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "N", "mutation": "G303N", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "P", "mutation": "G303P", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G303Q", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "R", "mutation": "G303R", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "S", "mutation": "G303S", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.026, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "V", "mutation": "G303V", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "W", "mutation": "G303W", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 300, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G303Y", "reference_site": "303", "region": "HA1", "sequential_site": 316, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4521, "ferret_sera_escape": -0.1288, "mature_H5_site": 301, "mouse_sera_escape": null, "mutant": "A", "mutation": "E304A", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.0295, "ferret_sera_escape": null, "mature_H5_site": 301, "mouse_sera_escape": null, "mutant": "C", "mutation": "E304C", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.556, "ferret_sera_escape": -0.03166, "mature_H5_site": 301, "mouse_sera_escape": -0.03509, "mutant": "D", "mutation": "E304D", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": -0.2694, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 301, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E304E", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.296, "ferret_sera_escape": -0.2596, "mature_H5_site": 301, "mouse_sera_escape": 0.4468, "mutant": "F", "mutation": "E304F", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": 1.828, "wildtype": "E"}, {"a26_usage": 0.473, "cell_entry": -0.7993, "ferret_sera_escape": 0.0176, "mature_H5_site": 301, "mouse_sera_escape": 0.05528, "mutant": "G", "mutation": "E304G", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": -0.1977, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7413, "ferret_sera_escape": -0.02141, "mature_H5_site": 301, "mouse_sera_escape": 0.1133, "mutant": "H", "mutation": "E304H", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": 0.5496, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.001, "ferret_sera_escape": 0.02007, "mature_H5_site": 301, "mouse_sera_escape": 0.1223, "mutant": "I", "mutation": "E304I", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": 0.5649, "wildtype": "E"}, {"a26_usage": 0.0858, "cell_entry": -0.052, "ferret_sera_escape": 0.01642, "mature_H5_site": 301, "mouse_sera_escape": -0.01441, "mutant": "K", "mutation": "E304K", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": -0.1366, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7932, "ferret_sera_escape": null, "mature_H5_site": 301, "mouse_sera_escape": null, "mutant": "L", "mutation": "E304L", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2023, "ferret_sera_escape": -0.04407, "mature_H5_site": 301, "mouse_sera_escape": -0.01882, "mutant": "M", "mutation": "E304M", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": 0.175, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.968, "ferret_sera_escape": null, "mature_H5_site": 301, "mouse_sera_escape": null, "mutant": "P", "mutation": "E304P", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": null, "wildtype": "E"}, {"a26_usage": 0.4645, "cell_entry": -0.965, "ferret_sera_escape": -0.03268, "mature_H5_site": 301, "mouse_sera_escape": 0.201, "mutant": "R", "mutation": "E304R", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": 0.03259, "wildtype": "E"}, {"a26_usage": 0.1685, "cell_entry": -0.08097, "ferret_sera_escape": -0.1145, "mature_H5_site": 301, "mouse_sera_escape": -0.02002, "mutant": "S", "mutation": "E304S", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": -0.2115, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7158, "ferret_sera_escape": null, "mature_H5_site": 301, "mouse_sera_escape": null, "mutant": "T", "mutation": "E304T", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06391, "ferret_sera_escape": -0.08525, "mature_H5_site": 301, "mouse_sera_escape": -0.03307, "mutant": "V", "mutation": "E304V", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": 0.5197, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.094, "ferret_sera_escape": -0.07135, "mature_H5_site": 301, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E304Y", "reference_site": "304", "region": "HA1", "sequential_site": 317, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "A", "mutation": "C305A", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 302, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C305C", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "D", "mutation": "C305D", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.898, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "E", "mutation": "C305E", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "F", "mutation": "C305F", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.249, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "G", "mutation": "C305G", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.988, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "H", "mutation": "C305H", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "K", "mutation": "C305K", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "L", "mutation": "C305L", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "N", "mutation": "C305N", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C305Q", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "R", "mutation": "C305R", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "S", "mutation": "C305S", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "T", "mutation": "C305T", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "V", "mutation": "C305V", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "W", "mutation": "C305W", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 302, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C305Y", "reference_site": "305", "region": "HA1", "sequential_site": 318, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.1275, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "A", "mutation": "P306A", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "C", "mutation": "P306C", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": null, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "F", "mutation": "P306F", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.136, "ferret_sera_escape": -0.08925, "mature_H5_site": 303, "mouse_sera_escape": 0.1051, "mutant": "G", "mutation": "P306G", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": 1.03, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "H", "mutation": "P306H", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "I", "mutation": "P306I", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "K", "mutation": "P306K", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.377, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "L", "mutation": "P306L", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.627, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "M", "mutation": "P306M", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "N", "mutation": "P306N", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 303, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P306P", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P306Q", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.7, "ferret_sera_escape": -0.7422, "mature_H5_site": 303, "mouse_sera_escape": -0.1354, "mutant": "S", "mutation": "P306S", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "T", "mutation": "P306T", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "V", "mutation": "P306V", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.012, "ferret_sera_escape": null, "mature_H5_site": 303, "mouse_sera_escape": null, "mutant": "W", "mutation": "P306W", "reference_site": "306", "region": "HA1", "sequential_site": 319, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.838, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "A", "mutation": "K307A", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.274, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "D", "mutation": "K307D", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.445, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "E", "mutation": "K307E", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.323, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "F", "mutation": "K307F", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "G", "mutation": "K307G", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.498, "ferret_sera_escape": 0.05923, "mature_H5_site": 304, "mouse_sera_escape": 0.0958, "mutant": "H", "mutation": "K307H", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": -0.09664, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.333, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "I", "mutation": "K307I", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 304, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K307K", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "L", "mutation": "K307L", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.267, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "M", "mutation": "K307M", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "N", "mutation": "K307N", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "P", "mutation": "K307P", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.316, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "Q", "mutation": "K307Q", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.319, "ferret_sera_escape": 0.1917, "mature_H5_site": 304, "mouse_sera_escape": 0.4336, "mutant": "R", "mutation": "K307R", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.821, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "S", "mutation": "K307S", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.845, "ferret_sera_escape": -0.03604, "mature_H5_site": 304, "mouse_sera_escape": 0.1009, "mutant": "T", "mutation": "K307T", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.49, "ferret_sera_escape": -0.09891, "mature_H5_site": 304, "mouse_sera_escape": -0.1293, "mutant": "V", "mutation": "K307V", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": -0.2164, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 304, "mouse_sera_escape": null, "mutant": "W", "mutation": "K307W", "reference_site": "307", "region": "HA1", "sequential_site": 320, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y308C", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y308D", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y308E", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y308G", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y308I", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y308L", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": null, "cell_entry": -3.563, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y308M", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y308N", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.785, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y308Q", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y308R", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y308T", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y308V", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.585, "ferret_sera_escape": null, "mature_H5_site": 305, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y308W", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 305, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y308Y", "reference_site": "308", "region": "HA1", "sequential_site": 321, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.094, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "A", "mutation": "V309A", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.817, "ferret_sera_escape": -0.1326, "mature_H5_site": 306, "mouse_sera_escape": 0.07488, "mutant": "C", "mutation": "V309C", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": -0.2218, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "D", "mutation": "V309D", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "E", "mutation": "V309E", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "F", "mutation": "V309F", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.007, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "G", "mutation": "V309G", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "H", "mutation": "V309H", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.689, "ferret_sera_escape": -0.1444, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "I", "mutation": "V309I", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.897, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "K", "mutation": "V309K", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.686, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "L", "mutation": "V309L", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "M", "mutation": "V309M", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.843, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "R", "mutation": "V309R", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.359, "ferret_sera_escape": 0.04204, "mature_H5_site": 306, "mouse_sera_escape": -0.04377, "mutant": "T", "mutation": "V309T", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": -0.2404, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 306, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V309V", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "W", "mutation": "V309W", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.587, "ferret_sera_escape": null, "mature_H5_site": 306, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V309Y", "reference_site": "309", "region": "HA1", "sequential_site": 322, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2336, "ferret_sera_escape": 0.04488, "mature_H5_site": 21, "mouse_sera_escape": 0.09133, "mutant": "A", "mutation": "E31A", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.2127, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7526, "ferret_sera_escape": 0.02106, "mature_H5_site": 21, "mouse_sera_escape": 0.01635, "mutant": "C", "mutation": "E31C", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.1909, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.013, "ferret_sera_escape": -0.1675, "mature_H5_site": 21, "mouse_sera_escape": -0.07694, "mutant": "D", "mutation": "E31D", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": -0.2157, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 21, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E31E", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.279, "ferret_sera_escape": null, "mature_H5_site": 21, "mouse_sera_escape": null, "mutant": "F", "mutation": "E31F", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.533, "ferret_sera_escape": -0.07743, "mature_H5_site": 21, "mouse_sera_escape": 0.08016, "mutant": "G", "mutation": "E31G", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.2024, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.007725, "ferret_sera_escape": 0.1091, "mature_H5_site": 21, "mouse_sera_escape": -0.06131, "mutant": "H", "mutation": "E31H", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.216, "ferret_sera_escape": null, "mature_H5_site": 21, "mouse_sera_escape": null, "mutant": "I", "mutation": "E31I", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2315, "ferret_sera_escape": 0.01244, "mature_H5_site": 21, "mouse_sera_escape": 0.07375, "mutant": "K", "mutation": "E31K", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.6966, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.094, "ferret_sera_escape": -0.1522, "mature_H5_site": 21, "mouse_sera_escape": 0.04931, "mutant": "L", "mutation": "E31L", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": -0.09359, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.06906, "ferret_sera_escape": null, "mature_H5_site": 21, "mouse_sera_escape": null, "mutant": "M", "mutation": "E31M", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3974, "ferret_sera_escape": -0.1918, "mature_H5_site": 21, "mouse_sera_escape": 0.1181, "mutant": "N", "mutation": "E31N", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": -0.03575, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6577, "ferret_sera_escape": null, "mature_H5_site": 21, "mouse_sera_escape": null, "mutant": "P", "mutation": "E31P", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.07231, "ferret_sera_escape": 0.04775, "mature_H5_site": 21, "mouse_sera_escape": 0.02129, "mutant": "Q", "mutation": "E31Q", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.5868, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6499, "ferret_sera_escape": -0.07666, "mature_H5_site": 21, "mouse_sera_escape": 0.0497, "mutant": "R", "mutation": "E31R", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 1.009, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2634, "ferret_sera_escape": -0.0305, "mature_H5_site": 21, "mouse_sera_escape": 0.04438, "mutant": "S", "mutation": "E31S", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 1.315, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5679, "ferret_sera_escape": 0.02685, "mature_H5_site": 21, "mouse_sera_escape": -0.01402, "mutant": "V", "mutation": "E31V", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.2562, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.377, "ferret_sera_escape": 0.1159, "mature_H5_site": 21, "mouse_sera_escape": 0.2443, "mutant": "W", "mutation": "E31W", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": 0.2738, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.498, "ferret_sera_escape": 0.0443, "mature_H5_site": 21, "mouse_sera_escape": 0.05803, "mutant": "Y", "mutation": "E31Y", "reference_site": "31", "region": "HA1", "sequential_site": 37, "stability": -0.0005835, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.163, "ferret_sera_escape": null, "mature_H5_site": 307, "mouse_sera_escape": null, "mutant": "A", "mutation": "K310A", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.508, "ferret_sera_escape": -0.2333, "mature_H5_site": 307, "mouse_sera_escape": 0.2745, "mutant": "C", "mutation": "K310C", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 1.339, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.008, "ferret_sera_escape": -0.3682, "mature_H5_site": 307, "mouse_sera_escape": 0.1686, "mutant": "D", "mutation": "K310D", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 0.8751, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.348, "ferret_sera_escape": -0.1226, "mature_H5_site": 307, "mouse_sera_escape": 0.1048, "mutant": "E", "mutation": "K310E", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 0.7171, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.009, "ferret_sera_escape": -0.1037, "mature_H5_site": 307, "mouse_sera_escape": 0.2614, "mutant": "F", "mutation": "K310F", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 1.137, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.408, "ferret_sera_escape": -0.1626, "mature_H5_site": 307, "mouse_sera_escape": -0.08859, "mutant": "G", "mutation": "K310G", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 1.804, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3301, "ferret_sera_escape": -0.008974, "mature_H5_site": 307, "mouse_sera_escape": 0.05169, "mutant": "H", "mutation": "K310H", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 0.8882, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 307, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K310K", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 0.0, "wildtype": "K"}, {"a26_usage": null, "cell_entry": -5.313, "ferret_sera_escape": null, "mature_H5_site": 307, "mouse_sera_escape": null, "mutant": "L", "mutation": "K310L", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.196, "ferret_sera_escape": null, "mature_H5_site": 307, "mouse_sera_escape": null, "mutant": "M", "mutation": "K310M", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7102, "ferret_sera_escape": -0.07383, "mature_H5_site": 307, "mouse_sera_escape": 0.09006, "mutant": "N", "mutation": "K310N", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 1.707, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.914, "ferret_sera_escape": null, "mature_H5_site": 307, "mouse_sera_escape": null, "mutant": "P", "mutation": "K310P", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7229, "ferret_sera_escape": -0.001727, "mature_H5_site": 307, "mouse_sera_escape": 0.1969, "mutant": "Q", "mutation": "K310Q", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 1.542, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2898, "ferret_sera_escape": -0.02549, "mature_H5_site": 307, "mouse_sera_escape": 0.03226, "mutant": "R", "mutation": "K310R", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 0.6794, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.9836, "ferret_sera_escape": -0.07804, "mature_H5_site": 307, "mouse_sera_escape": null, "mutant": "S", "mutation": "K310S", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": 0.9266, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.69, "ferret_sera_escape": null, "mature_H5_site": 307, "mouse_sera_escape": null, "mutant": "V", "mutation": "K310V", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.931, "ferret_sera_escape": null, "mature_H5_site": 307, "mouse_sera_escape": null, "mutant": "W", "mutation": "K310W", "reference_site": "310", "region": "HA1", "sequential_site": 323, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03533, "ferret_sera_escape": -0.1011, "mature_H5_site": 308, "mouse_sera_escape": -0.07366, "mutant": "A", "mutation": "S311A", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": 0.149, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.05619, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "C", "mutation": "S311C", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "D", "mutation": "S311D", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "F", "mutation": "S311F", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.629, "ferret_sera_escape": -0.08104, "mature_H5_site": 308, "mouse_sera_escape": 0.01017, "mutant": "G", "mutation": "S311G", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": 0.1301, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3355, "ferret_sera_escape": -0.07642, "mature_H5_site": 308, "mouse_sera_escape": 0.0375, "mutant": "I", "mutation": "S311I", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": -0.04661, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "K", "mutation": "S311K", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6445, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "L", "mutation": "S311L", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.985, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": 0.02298, "mutant": "M", "mutation": "S311M", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.167, "ferret_sera_escape": -0.05085, "mature_H5_site": 308, "mouse_sera_escape": 0.05174, "mutant": "N", "mutation": "S311N", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": 0.1765, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "P", "mutation": "S311P", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.777, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "R", "mutation": "S311R", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 308, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S311S", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1297, "ferret_sera_escape": -0.05758, "mature_H5_site": 308, "mouse_sera_escape": 0.03364, "mutant": "T", "mutation": "S311T", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": -0.2401, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1737, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "V", "mutation": "S311V", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 308, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S311Y", "reference_site": "311", "region": "HA1", "sequential_site": 324, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4553, "ferret_sera_escape": 0.01017, "mature_H5_site": 309, "mouse_sera_escape": 0.02464, "mutant": "A", "mutation": "N312A", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.1042, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07363, "ferret_sera_escape": 0.01935, "mature_H5_site": 309, "mouse_sera_escape": 0.02883, "mutant": "C", "mutation": "N312C", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.07742, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.03951, "ferret_sera_escape": -0.1365, "mature_H5_site": 309, "mouse_sera_escape": -0.0001547, "mutant": "D", "mutation": "N312D", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": 0.1691, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.09834, "ferret_sera_escape": 0.01523, "mature_H5_site": 309, "mouse_sera_escape": -0.02071, "mutant": "E", "mutation": "N312E", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": 0.1491, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.004592, "ferret_sera_escape": -0.04139, "mature_H5_site": 309, "mouse_sera_escape": 0.004021, "mutant": "F", "mutation": "N312F", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.09747, "wildtype": "N"}, {"a26_usage": 0.07573, "cell_entry": -0.01632, "ferret_sera_escape": -0.04675, "mature_H5_site": 309, "mouse_sera_escape": 0.01963, "mutant": "H", "mutation": "N312H", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.09312, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1411, "ferret_sera_escape": -0.03112, "mature_H5_site": 309, "mouse_sera_escape": -0.01409, "mutant": "I", "mutation": "N312I", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.05172, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.116, "ferret_sera_escape": 0.1264, "mature_H5_site": 309, "mouse_sera_escape": 0.07565, "mutant": "K", "mutation": "N312K", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3112, "ferret_sera_escape": -0.04619, "mature_H5_site": 309, "mouse_sera_escape": -0.04928, "mutant": "L", "mutation": "N312L", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.1558, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2403, "ferret_sera_escape": 0.1637, "mature_H5_site": 309, "mouse_sera_escape": -0.04495, "mutant": "M", "mutation": "N312M", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.07116, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 309, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N312N", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3483, "ferret_sera_escape": -0.1424, "mature_H5_site": 309, "mouse_sera_escape": -0.02319, "mutant": "P", "mutation": "N312P", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.1758, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.03838, "ferret_sera_escape": 0.117, "mature_H5_site": 309, "mouse_sera_escape": 0.06004, "mutant": "R", "mutation": "N312R", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.1425, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.06465, "ferret_sera_escape": -0.05422, "mature_H5_site": 309, "mouse_sera_escape": 0.004641, "mutant": "S", "mutation": "N312S", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.01558, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.00225, "ferret_sera_escape": 0.01824, "mature_H5_site": 309, "mouse_sera_escape": 0.02196, "mutant": "T", "mutation": "N312T", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": 0.1184, "wildtype": "N"}, {"a26_usage": 0.2638, "cell_entry": -0.05144, "ferret_sera_escape": 0.04071, "mature_H5_site": 309, "mouse_sera_escape": -0.04032, "mutant": "V", "mutation": "N312V", "reference_site": "312", "region": "HA1", "sequential_site": 325, "stability": -0.04081, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04393, "ferret_sera_escape": -0.03603, "mature_H5_site": 310, "mouse_sera_escape": -0.05499, "mutant": "A", "mutation": "K313A", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.01465, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5039, "ferret_sera_escape": 0.04006, "mature_H5_site": 310, "mouse_sera_escape": 0.004066, "mutant": "C", "mutation": "K313C", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.09299, "wildtype": "K"}, {"a26_usage": null, "cell_entry": -1.281, "ferret_sera_escape": -0.145, "mature_H5_site": 310, "mouse_sera_escape": null, "mutant": "D", "mutation": "K313D", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7088, "ferret_sera_escape": 0.161, "mature_H5_site": 310, "mouse_sera_escape": -0.01477, "mutant": "E", "mutation": "K313E", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.2162, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2309, "ferret_sera_escape": -0.04088, "mature_H5_site": 310, "mouse_sera_escape": -0.08302, "mutant": "F", "mutation": "K313F", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.1402, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8627, "ferret_sera_escape": -0.03016, "mature_H5_site": 310, "mouse_sera_escape": -0.0711, "mutant": "G", "mutation": "K313G", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": 0.4163, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.544, "ferret_sera_escape": null, "mature_H5_site": 310, "mouse_sera_escape": null, "mutant": "I", "mutation": "K313I", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 310, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K313K", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.121, "ferret_sera_escape": -0.1464, "mature_H5_site": 310, "mouse_sera_escape": null, "mutant": "L", "mutation": "K313L", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5647, "ferret_sera_escape": 0.04259, "mature_H5_site": 310, "mouse_sera_escape": null, "mutant": "M", "mutation": "K313M", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3387, "ferret_sera_escape": -0.1522, "mature_H5_site": 310, "mouse_sera_escape": -0.08061, "mutant": "N", "mutation": "K313N", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.2754, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.808, "ferret_sera_escape": null, "mature_H5_site": 310, "mouse_sera_escape": null, "mutant": "P", "mutation": "K313P", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6448, "ferret_sera_escape": 0.02885, "mature_H5_site": 310, "mouse_sera_escape": 0.07202, "mutant": "Q", "mutation": "K313Q", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.07274, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2134, "ferret_sera_escape": 0.05527, "mature_H5_site": 310, "mouse_sera_escape": 0.04203, "mutant": "R", "mutation": "K313R", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.03834, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.788, "ferret_sera_escape": 0.4327, "mature_H5_site": 310, "mouse_sera_escape": 0.02673, "mutant": "S", "mutation": "K313S", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.069, "ferret_sera_escape": -0.3476, "mature_H5_site": 310, "mouse_sera_escape": -0.1104, "mutant": "V", "mutation": "K313V", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.281, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.006, "ferret_sera_escape": 0.05184, "mature_H5_site": 310, "mouse_sera_escape": -0.04403, "mutant": "W", "mutation": "K313W", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.2285, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8353, "ferret_sera_escape": -0.0154, "mature_H5_site": 310, "mouse_sera_escape": -0.0233, "mutant": "Y", "mutation": "K313Y", "reference_site": "313", "region": "HA1", "sequential_site": 326, "stability": -0.1658, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "A", "mutation": "L314A", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.46, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "C", "mutation": "L314C", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.952, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "E", "mutation": "L314E", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.817, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "F", "mutation": "L314F", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.605, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "G", "mutation": "L314G", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "H", "mutation": "L314H", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.427, "ferret_sera_escape": -0.1216, "mature_H5_site": 311, "mouse_sera_escape": 0.09845, "mutant": "I", "mutation": "L314I", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": -0.05791, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "K", "mutation": "L314K", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 311, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L314L", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.601, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "M", "mutation": "L314M", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.013, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "N", "mutation": "L314N", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "P", "mutation": "L314P", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L314Q", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "R", "mutation": "L314R", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "S", "mutation": "L314S", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.01, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "T", "mutation": "L314T", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "V", "mutation": "L314V", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 311, "mouse_sera_escape": null, "mutant": "W", "mutation": "L314W", "reference_site": "314", "region": "HA1", "sequential_site": 327, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06373, "ferret_sera_escape": -0.001787, "mature_H5_site": 312, "mouse_sera_escape": 0.0879, "mutant": "A", "mutation": "V315A", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 1.567, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2216, "ferret_sera_escape": 0.09106, "mature_H5_site": 312, "mouse_sera_escape": 0.06085, "mutant": "C", "mutation": "V315C", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 0.9585, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 312, "mouse_sera_escape": null, "mutant": "D", "mutation": "V315D", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.498, "ferret_sera_escape": null, "mature_H5_site": 312, "mouse_sera_escape": null, "mutant": "E", "mutation": "V315E", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.312, "ferret_sera_escape": 0.01326, "mature_H5_site": 312, "mouse_sera_escape": 0.03647, "mutant": "F", "mutation": "V315F", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 0.1866, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.472, "ferret_sera_escape": -0.1711, "mature_H5_site": 312, "mouse_sera_escape": 0.6132, "mutant": "G", "mutation": "V315G", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6726, "ferret_sera_escape": null, "mature_H5_site": 312, "mouse_sera_escape": null, "mutant": "H", "mutation": "V315H", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.008165, "ferret_sera_escape": 0.08123, "mature_H5_site": 312, "mouse_sera_escape": 0.03878, "mutant": "I", "mutation": "V315I", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": -0.1062, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5023, "ferret_sera_escape": -0.05331, "mature_H5_site": 312, "mouse_sera_escape": 0.01706, "mutant": "K", "mutation": "V315K", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 0.776, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3479, "ferret_sera_escape": -0.07235, "mature_H5_site": 312, "mouse_sera_escape": -0.009075, "mutant": "L", "mutation": "V315L", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 1.331, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.003785, "ferret_sera_escape": -0.06027, "mature_H5_site": 312, "mouse_sera_escape": 0.04433, "mutant": "M", "mutation": "V315M", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 1.075, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5965, "ferret_sera_escape": -0.1175, "mature_H5_site": 312, "mouse_sera_escape": 0.3837, "mutant": "N", "mutation": "V315N", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 1.716, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4559, "ferret_sera_escape": 0.08028, "mature_H5_site": 312, "mouse_sera_escape": 0.006346, "mutant": "Q", "mutation": "V315Q", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 0.4132, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.05245, "ferret_sera_escape": -0.002237, "mature_H5_site": 312, "mouse_sera_escape": 0.1699, "mutant": "R", "mutation": "V315R", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 1.862, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.829, "ferret_sera_escape": 0.019, "mature_H5_site": 312, "mouse_sera_escape": null, "mutant": "S", "mutation": "V315S", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 312, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V315V", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.159, "ferret_sera_escape": -0.04555, "mature_H5_site": 312, "mouse_sera_escape": 0.06865, "mutant": "Y", "mutation": "V315Y", "reference_site": "315", "region": "HA1", "sequential_site": 328, "stability": 1.117, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "A", "mutation": "L316A", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "E", "mutation": "L316E", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "G", "mutation": "L316G", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "H", "mutation": "L316H", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 313, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L316L", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.05, "ferret_sera_escape": -0.06383, "mature_H5_site": 313, "mouse_sera_escape": -0.02965, "mutant": "M", "mutation": "L316M", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": 1.243, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "N", "mutation": "L316N", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.84, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "P", "mutation": "L316P", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L316Q", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.574, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "R", "mutation": "L316R", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "S", "mutation": "L316S", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.8901, "ferret_sera_escape": -0.01726, "mature_H5_site": 313, "mouse_sera_escape": 0.01028, "mutant": "V", "mutation": "L316V", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": -0.192, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 313, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L316Y", "reference_site": "316", "region": "HA1", "sequential_site": 329, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 314, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A317A", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5285, "ferret_sera_escape": -0.03775, "mature_H5_site": 314, "mouse_sera_escape": 0.2172, "mutant": "C", "mutation": "A317C", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": -0.1234, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "D", "mutation": "A317D", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.215, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "E", "mutation": "A317E", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "F", "mutation": "A317F", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5958, "ferret_sera_escape": -0.1028, "mature_H5_site": 314, "mouse_sera_escape": 0.03157, "mutant": "G", "mutation": "A317G", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": -0.2257, "wildtype": "A"}, {"a26_usage": null, "cell_entry": -0.01706, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "I", "mutation": "A317I", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "K", "mutation": "A317K", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.823, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "L", "mutation": "A317L", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.295, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "M", "mutation": "A317M", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "N", "mutation": "A317N", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "P", "mutation": "A317P", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A317Q", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "R", "mutation": "A317R", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.859, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "S", "mutation": "A317S", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.553, "ferret_sera_escape": -0.1325, "mature_H5_site": 314, "mouse_sera_escape": 0.06712, "mutant": "T", "mutation": "A317T", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": 0.1442, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4158, "ferret_sera_escape": -0.01401, "mature_H5_site": 314, "mouse_sera_escape": 0.02533, "mutant": "V", "mutation": "A317V", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": 0.8405, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "W", "mutation": "A317W", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 314, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A317Y", "reference_site": "317", "region": "HA1", "sequential_site": 330, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.618, "ferret_sera_escape": null, "mature_H5_site": 315, "mouse_sera_escape": null, "mutant": "A", "mutation": "T318A", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 315, "mouse_sera_escape": null, "mutant": "D", "mutation": "T318D", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.136, "ferret_sera_escape": null, "mature_H5_site": 315, "mouse_sera_escape": -0.05116, "mutant": "E", "mutation": "T318E", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 315, "mouse_sera_escape": null, "mutant": "G", "mutation": "T318G", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.169, "ferret_sera_escape": null, "mature_H5_site": 315, "mouse_sera_escape": null, "mutant": "H", "mutation": "T318H", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.735, "ferret_sera_escape": 0.05462, "mature_H5_site": 315, "mouse_sera_escape": 0.08398, "mutant": "I", "mutation": "T318I", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": 0.5462, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1585, "ferret_sera_escape": 0.05474, "mature_H5_site": 315, "mouse_sera_escape": -0.06191, "mutant": "K", "mutation": "T318K", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2562, "ferret_sera_escape": -0.0149, "mature_H5_site": 315, "mouse_sera_escape": 0.06052, "mutant": "L", "mutation": "T318L", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": 0.02013, "wildtype": "T"}, {"a26_usage": 0.1335, "cell_entry": -0.3248, "ferret_sera_escape": 0.04584, "mature_H5_site": 315, "mouse_sera_escape": 0.08109, "mutant": "M", "mutation": "T318M", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": 0.0842, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.857, "ferret_sera_escape": null, "mature_H5_site": 315, "mouse_sera_escape": null, "mutant": "N", "mutation": "T318N", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3703, "ferret_sera_escape": 0.04758, "mature_H5_site": 315, "mouse_sera_escape": -0.02641, "mutant": "Q", "mutation": "T318Q", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": -0.1943, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5656, "ferret_sera_escape": null, "mature_H5_site": 315, "mouse_sera_escape": null, "mutant": "R", "mutation": "T318R", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 315, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T318T", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.23, "ferret_sera_escape": -0.01436, "mature_H5_site": 315, "mouse_sera_escape": 0.06197, "mutant": "V", "mutation": "T318V", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": -0.03366, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.446, "ferret_sera_escape": 0.07379, "mature_H5_site": 315, "mouse_sera_escape": 0.1702, "mutant": "W", "mutation": "T318W", "reference_site": "318", "region": "HA1", "sequential_site": 331, "stability": -0.8588, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.894, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "C", "mutation": "G319C", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.353, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "D", "mutation": "G319D", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "E", "mutation": "G319E", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "F", "mutation": "G319F", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 316, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G319G", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.101, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "H", "mutation": "G319H", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "I", "mutation": "G319I", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "K", "mutation": "G319K", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.007, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "L", "mutation": "G319L", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "M", "mutation": "G319M", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "N", "mutation": "G319N", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "P", "mutation": "G319P", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "S", "mutation": "G319S", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.873, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "T", "mutation": "G319T", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "V", "mutation": "G319V", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.863, "ferret_sera_escape": null, "mature_H5_site": 316, "mouse_sera_escape": null, "mutant": "W", "mutation": "G319W", "reference_site": "319", "region": "HA1", "sequential_site": 332, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.926, "ferret_sera_escape": -0.3679, "mature_H5_site": 22, "mouse_sera_escape": -0.1191, "mutant": "A", "mutation": "K32A", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": -0.1999, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.9328, "ferret_sera_escape": -0.2761, "mature_H5_site": 22, "mouse_sera_escape": null, "mutant": "C", "mutation": "K32C", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.363, "ferret_sera_escape": null, "mature_H5_site": 22, "mouse_sera_escape": null, "mutant": "D", "mutation": "K32D", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3666, "ferret_sera_escape": -0.07898, "mature_H5_site": 22, "mouse_sera_escape": 0.01565, "mutant": "H", "mutation": "K32H", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": 0.9802, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2186, "ferret_sera_escape": 0.001288, "mature_H5_site": 22, "mouse_sera_escape": -0.04851, "mutant": "I", "mutation": "K32I", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": -0.7656, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 22, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K32K", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.8645, "cell_entry": -0.3318, "ferret_sera_escape": null, "mature_H5_site": 22, "mouse_sera_escape": null, "mutant": "L", "mutation": "K32L", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4696, "ferret_sera_escape": -0.04662, "mature_H5_site": 22, "mouse_sera_escape": -0.1602, "mutant": "M", "mutation": "K32M", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": 0.0243, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4788, "ferret_sera_escape": -0.002157, "mature_H5_site": 22, "mouse_sera_escape": 0.07026, "mutant": "N", "mutation": "K32N", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": -0.1458, "wildtype": "K"}, {"a26_usage": 0.004918, "cell_entry": -0.03636, "ferret_sera_escape": 0.03815, "mature_H5_site": 22, "mouse_sera_escape": -0.0232, "mutant": "P", "mutation": "K32P", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": 0.5621, "wildtype": "K"}, {"a26_usage": 0.1331, "cell_entry": 0.03646, "ferret_sera_escape": -0.05831, "mature_H5_site": 22, "mouse_sera_escape": -0.1632, "mutant": "Q", "mutation": "K32Q", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": -0.205, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7013, "ferret_sera_escape": -0.003793, "mature_H5_site": 22, "mouse_sera_escape": 0.05935, "mutant": "R", "mutation": "K32R", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": 1.414, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03918, "ferret_sera_escape": -0.04683, "mature_H5_site": 22, "mouse_sera_escape": -0.1386, "mutant": "S", "mutation": "K32S", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": -0.1656, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.144, "ferret_sera_escape": -0.0163, "mature_H5_site": 22, "mouse_sera_escape": 0.1153, "mutant": "T", "mutation": "K32T", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": -0.1746, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.857, "ferret_sera_escape": null, "mature_H5_site": 22, "mouse_sera_escape": null, "mutant": "V", "mutation": "K32V", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": -0.09428, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.371, "ferret_sera_escape": -0.31, "mature_H5_site": 22, "mouse_sera_escape": null, "mutant": "W", "mutation": "K32W", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.007195, "ferret_sera_escape": -0.02407, "mature_H5_site": 22, "mouse_sera_escape": -0.08414, "mutant": "Y", "mutation": "K32Y", "reference_site": "32", "region": "HA1", "sequential_site": 38, "stability": 0.4681, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.906, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "C", "mutation": "L320C", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.874, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "D", "mutation": "L320D", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "E", "mutation": "L320E", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.038, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "F", "mutation": "L320F", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4321, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "I", "mutation": "L320I", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "K", "mutation": "L320K", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 317, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L320L", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06974, "ferret_sera_escape": -0.005233, "mature_H5_site": 317, "mouse_sera_escape": 0.04991, "mutant": "M", "mutation": "L320M", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": -0.2516, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "N", "mutation": "L320N", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.698, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "P", "mutation": "L320P", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.814, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "R", "mutation": "L320R", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "S", "mutation": "L320S", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.066, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "W", "mutation": "L320W", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.653, "ferret_sera_escape": null, "mature_H5_site": 317, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L320Y", "reference_site": "320", "region": "HA1", "sequential_site": 333, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.828, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "A", "mutation": "R321A", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": null, "cell_entry": -3.564, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "D", "mutation": "R321D", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "E", "mutation": "R321E", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.229, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "F", "mutation": "R321F", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.745, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "G", "mutation": "R321G", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.82, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "H", "mutation": "R321H", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.885, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "I", "mutation": "R321I", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.267, "ferret_sera_escape": 0.02098, "mature_H5_site": 318, "mouse_sera_escape": -0.03141, "mutant": "K", "mutation": "R321K", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": -0.003753, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.806, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "L", "mutation": "R321L", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.129, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "M", "mutation": "R321M", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.675, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "N", "mutation": "R321N", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.947, "ferret_sera_escape": -0.2337, "mature_H5_site": 318, "mouse_sera_escape": 0.2891, "mutant": "P", "mutation": "R321P", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.271, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "Q", "mutation": "R321Q", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 318, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R321R", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.777, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "S", "mutation": "R321S", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.754, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "T", "mutation": "R321T", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.776, "ferret_sera_escape": -0.4193, "mature_H5_site": 318, "mouse_sera_escape": 0.1627, "mutant": "V", "mutation": "R321V", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.826, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "W", "mutation": "R321W", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.142, "ferret_sera_escape": null, "mature_H5_site": 318, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R321Y", "reference_site": "321", "region": "HA1", "sequential_site": 334, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.992, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "A", "mutation": "N322A", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.62, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "C", "mutation": "N322C", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.746, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "D", "mutation": "N322D", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.845, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "E", "mutation": "N322E", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.055, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "F", "mutation": "N322F", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5156, "ferret_sera_escape": -0.4511, "mature_H5_site": 319, "mouse_sera_escape": -0.06753, "mutant": "G", "mutation": "N322G", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.868, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "H", "mutation": "N322H", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.06028, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "I", "mutation": "N322I", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7166, "ferret_sera_escape": -0.2848, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "K", "mutation": "N322K", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4512, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "L", "mutation": "N322L", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8267, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "M", "mutation": "N322M", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 319, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N322N", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.947, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "P", "mutation": "N322P", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.094, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N322Q", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.764, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "R", "mutation": "N322R", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.63, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "S", "mutation": "N322S", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.95, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "T", "mutation": "N322T", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8907, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "V", "mutation": "N322V", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.133, "ferret_sera_escape": null, "mature_H5_site": 319, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N322Y", "reference_site": "322", "region": "HA1", "sequential_site": 335, "stability": null, "wildtype": "N"}, {"a26_usage": 0.09105, "cell_entry": -0.04155, "ferret_sera_escape": 0.056, "mature_H5_site": 320, "mouse_sera_escape": 0.04428, "mutant": "A", "mutation": "S323A", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.1325, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.29, "ferret_sera_escape": 0.1063, "mature_H5_site": 320, "mouse_sera_escape": 0.2006, "mutant": "C", "mutation": "S323C", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": 0.4671, "wildtype": "S"}, {"a26_usage": null, "cell_entry": 0.039, "ferret_sera_escape": 0.02891, "mature_H5_site": 320, "mouse_sera_escape": -0.02286, "mutant": "D", "mutation": "S323D", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": 0.04593, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2743, "ferret_sera_escape": null, "mature_H5_site": 320, "mouse_sera_escape": null, "mutant": "E", "mutation": "S323E", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.003295, "ferret_sera_escape": 0.05552, "mature_H5_site": 320, "mouse_sera_escape": 0.0221, "mutant": "G", "mutation": "S323G", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": 0.07725, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.07157, "ferret_sera_escape": -0.09933, "mature_H5_site": 320, "mouse_sera_escape": -0.02394, "mutant": "H", "mutation": "S323H", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.2636, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.707, "ferret_sera_escape": 0.1534, "mature_H5_site": 320, "mouse_sera_escape": null, "mutant": "I", "mutation": "S323I", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": 1.15, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.06501, "ferret_sera_escape": -0.03692, "mature_H5_site": 320, "mouse_sera_escape": -0.0823, "mutant": "K", "mutation": "S323K", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.1293, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.485, "ferret_sera_escape": 0.151, "mature_H5_site": 320, "mouse_sera_escape": 0.1512, "mutant": "L", "mutation": "S323L", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": 1.116, "wildtype": "S"}, {"a26_usage": 1.135, "cell_entry": -2.617, "ferret_sera_escape": -0.09504, "mature_H5_site": 320, "mouse_sera_escape": 0.01132, "mutant": "M", "mutation": "S323M", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.5236, "ferret_sera_escape": -0.2572, "mature_H5_site": 320, "mouse_sera_escape": -0.04369, "mutant": "N", "mutation": "S323N", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.06875, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1952, "ferret_sera_escape": -0.0992, "mature_H5_site": 320, "mouse_sera_escape": 0.05117, "mutant": "P", "mutation": "S323P", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.1665, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.05623, "ferret_sera_escape": 0.004659, "mature_H5_site": 320, "mouse_sera_escape": 0.1283, "mutant": "Q", "mutation": "S323Q", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.1413, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -0.2505, "ferret_sera_escape": -0.1524, "mature_H5_site": 320, "mouse_sera_escape": -0.1101, "mutant": "R", "mutation": "S323R", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 320, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S323S", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.102, "ferret_sera_escape": 0.1104, "mature_H5_site": 320, "mouse_sera_escape": 0.2331, "mutant": "V", "mutation": "S323V", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": 1.35, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.01485, "ferret_sera_escape": 0.06559, "mature_H5_site": 320, "mouse_sera_escape": 0.07776, "mutant": "W", "mutation": "S323W", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.2148, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.07295, "ferret_sera_escape": 0.01007, "mature_H5_site": 320, "mouse_sera_escape": -0.073, "mutant": "Y", "mutation": "S323Y", "reference_site": "323", "region": "HA1", "sequential_site": 336, "stability": -0.1613, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6343, "ferret_sera_escape": 0.03484, "mature_H5_site": 321, "mouse_sera_escape": -0.03664, "mutant": "A", "mutation": "P324A", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": 0.09317, "wildtype": "P"}, {"a26_usage": 0.5084, "cell_entry": -0.2232, "ferret_sera_escape": -0.01089, "mature_H5_site": 321, "mouse_sera_escape": null, "mutant": "C", "mutation": "P324C", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": 0.01863, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1866, "ferret_sera_escape": 0.1407, "mature_H5_site": 321, "mouse_sera_escape": 0.08088, "mutant": "E", "mutation": "P324E", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": 0.03475, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.6168, "ferret_sera_escape": -0.05367, "mature_H5_site": 321, "mouse_sera_escape": null, "mutant": "G", "mutation": "P324G", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.09831, "ferret_sera_escape": 0.08385, "mature_H5_site": 321, "mouse_sera_escape": 0.04461, "mutant": "H", "mutation": "P324H", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": -0.01276, "wildtype": "P"}, {"a26_usage": 0.07059, "cell_entry": -0.1055, "ferret_sera_escape": 0.002548, "mature_H5_site": 321, "mouse_sera_escape": 0.01616, "mutant": "I", "mutation": "P324I", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": -0.04046, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.03263, "ferret_sera_escape": null, "mature_H5_site": 321, "mouse_sera_escape": null, "mutant": "L", "mutation": "P324L", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1588, "ferret_sera_escape": 0.04224, "mature_H5_site": 321, "mouse_sera_escape": -0.006322, "mutant": "N", "mutation": "P324N", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": -0.00212, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 321, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P324P", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.07755, "ferret_sera_escape": -0.02852, "mature_H5_site": 321, "mouse_sera_escape": -0.0002475, "mutant": "Q", "mutation": "P324Q", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": -0.04908, "wildtype": "P"}, {"a26_usage": 0.003017, "cell_entry": 0.04963, "ferret_sera_escape": -0.1812, "mature_H5_site": 321, "mouse_sera_escape": -0.1439, "mutant": "R", "mutation": "P324R", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": -0.01751, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.07107, "ferret_sera_escape": 0.06216, "mature_H5_site": 321, "mouse_sera_escape": 0.03853, "mutant": "S", "mutation": "P324S", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": 0.01193, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.7241, "ferret_sera_escape": -0.07936, "mature_H5_site": 321, "mouse_sera_escape": 0.1871, "mutant": "T", "mutation": "P324T", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": 0.0148, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1532, "ferret_sera_escape": 0.00142, "mature_H5_site": 321, "mouse_sera_escape": -0.0288, "mutant": "V", "mutation": "P324V", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": -0.03472, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.4194, "ferret_sera_escape": -0.07306, "mature_H5_site": 321, "mouse_sera_escape": -0.01007, "mutant": "W", "mutation": "P324W", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": -0.003264, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.7439, "ferret_sera_escape": 0.2359, "mature_H5_site": 321, "mouse_sera_escape": 0.02928, "mutant": "Y", "mutation": "P324Y", "reference_site": "324", "region": "HA1", "sequential_site": 337, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.01924, "ferret_sera_escape": 0.03486, "mature_H5_site": 322, "mouse_sera_escape": 0.07308, "mutant": "A", "mutation": "L325A", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.02499, "wildtype": "L"}, {"a26_usage": 0.05557, "cell_entry": -0.1827, "ferret_sera_escape": -0.09581, "mature_H5_site": 322, "mouse_sera_escape": -0.08414, "mutant": "C", "mutation": "L325C", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": -0.08614, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.03556, "ferret_sera_escape": -0.1458, "mature_H5_site": 322, "mouse_sera_escape": 0.003765, "mutant": "D", "mutation": "L325D", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.1011, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2797, "ferret_sera_escape": 0.0442, "mature_H5_site": 322, "mouse_sera_escape": 0.01784, "mutant": "E", "mutation": "L325E", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": -0.0005663, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1614, "ferret_sera_escape": 9.967e-05, "mature_H5_site": 322, "mouse_sera_escape": 0.03865, "mutant": "G", "mutation": "L325G", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.02644, "wildtype": "L"}, {"a26_usage": 0.08608, "cell_entry": -0.6185, "ferret_sera_escape": 0.006943, "mature_H5_site": 322, "mouse_sera_escape": -0.08262, "mutant": "H", "mutation": "L325H", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.1473, "wildtype": "L"}, {"a26_usage": 0.06831, "cell_entry": 0.07276, "ferret_sera_escape": 0.005307, "mature_H5_site": 322, "mouse_sera_escape": -0.03623, "mutant": "I", "mutation": "L325I", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.0591, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1546, "ferret_sera_escape": 0.00845, "mature_H5_site": 322, "mouse_sera_escape": 0.003069, "mutant": "K", "mutation": "L325K", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.06644, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 322, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L325L", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.04496, "cell_entry": -0.3378, "ferret_sera_escape": 0.03101, "mature_H5_site": 322, "mouse_sera_escape": 0.02512, "mutant": "M", "mutation": "L325M", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.08026, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.07551, "ferret_sera_escape": -0.1557, "mature_H5_site": 322, "mouse_sera_escape": -0.1487, "mutant": "N", "mutation": "L325N", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.006605, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06666, "ferret_sera_escape": 0.11, "mature_H5_site": 322, "mouse_sera_escape": -0.04144, "mutant": "Q", "mutation": "L325Q", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.0728, "wildtype": "L"}, {"a26_usage": 0.04182, "cell_entry": 0.07336, "ferret_sera_escape": 0.03848, "mature_H5_site": 322, "mouse_sera_escape": -0.1567, "mutant": "R", "mutation": "L325R", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.04254, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5357, "ferret_sera_escape": null, "mature_H5_site": 322, "mouse_sera_escape": null, "mutant": "T", "mutation": "L325T", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.00195, "ferret_sera_escape": -0.04594, "mature_H5_site": 322, "mouse_sera_escape": 0.01632, "mutant": "V", "mutation": "L325V", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.08033, "wildtype": "L"}, {"a26_usage": 0.1194, "cell_entry": -0.02877, "ferret_sera_escape": -0.08493, "mature_H5_site": 322, "mouse_sera_escape": -0.01965, "mutant": "W", "mutation": "L325W", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": 0.0107, "wildtype": "L"}, {"a26_usage": 0.1136, "cell_entry": 0.05221, "ferret_sera_escape": -0.0402, "mature_H5_site": 322, "mouse_sera_escape": -0.06625, "mutant": "Y", "mutation": "L325Y", "reference_site": "325", "region": "HA1", "sequential_site": 338, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.04685, "ferret_sera_escape": 0.08457, "mature_H5_site": 323, "mouse_sera_escape": -0.133, "mutant": "A", "mutation": "R326A", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.002554, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.08008, "ferret_sera_escape": 0.07326, "mature_H5_site": 323, "mouse_sera_escape": 0.04311, "mutant": "C", "mutation": "R326C", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.0233, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.562, "ferret_sera_escape": null, "mature_H5_site": 323, "mouse_sera_escape": null, "mutant": "D", "mutation": "R326D", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.266, "ferret_sera_escape": -5.733e-05, "mature_H5_site": 323, "mouse_sera_escape": 0.2913, "mutant": "E", "mutation": "R326E", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": -0.004059, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1051, "ferret_sera_escape": -0.03911, "mature_H5_site": 323, "mouse_sera_escape": 0.08853, "mutant": "F", "mutation": "R326F", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.01245, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.05941, "ferret_sera_escape": -0.07091, "mature_H5_site": 323, "mouse_sera_escape": -0.05245, "mutant": "G", "mutation": "R326G", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": -0.0007344, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.003475, "ferret_sera_escape": -0.03973, "mature_H5_site": 323, "mouse_sera_escape": -0.05467, "mutant": "H", "mutation": "R326H", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.1275, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.05031, "ferret_sera_escape": null, "mature_H5_site": 323, "mouse_sera_escape": null, "mutant": "I", "mutation": "R326I", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4284, "ferret_sera_escape": 0.134, "mature_H5_site": 323, "mouse_sera_escape": 0.05584, "mutant": "K", "mutation": "R326K", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.07274, "wildtype": "R"}, {"a26_usage": 0.1083, "cell_entry": -0.2477, "ferret_sera_escape": 0.01236, "mature_H5_site": 323, "mouse_sera_escape": 0.01751, "mutant": "L", "mutation": "R326L", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.07376, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.02796, "ferret_sera_escape": 0.04513, "mature_H5_site": 323, "mouse_sera_escape": -0.04777, "mutant": "M", "mutation": "R326M", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.05109, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4669, "ferret_sera_escape": null, "mature_H5_site": 323, "mouse_sera_escape": null, "mutant": "N", "mutation": "R326N", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": null, "wildtype": "R"}, {"a26_usage": 0.1352, "cell_entry": 0.04852, "ferret_sera_escape": 0.06783, "mature_H5_site": 323, "mouse_sera_escape": -0.01094, "mutant": "Q", "mutation": "R326Q", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.05486, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 323, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R326R", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2349, "ferret_sera_escape": -0.0906, "mature_H5_site": 323, "mouse_sera_escape": 0.01443, "mutant": "S", "mutation": "R326S", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.03201, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2323, "ferret_sera_escape": null, "mature_H5_site": 323, "mouse_sera_escape": null, "mutant": "T", "mutation": "R326T", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1277, "ferret_sera_escape": 0.1225, "mature_H5_site": 323, "mouse_sera_escape": 0.05792, "mutant": "V", "mutation": "R326V", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.2303, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3319, "ferret_sera_escape": -0.07635, "mature_H5_site": 323, "mouse_sera_escape": 0.08009, "mutant": "W", "mutation": "R326W", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": -0.02386, "wildtype": "R"}, {"a26_usage": 0.09865, "cell_entry": 0.03368, "ferret_sera_escape": 0.05436, "mature_H5_site": 323, "mouse_sera_escape": 0.02116, "mutant": "Y", "mutation": "R326Y", "reference_site": "326", "region": "HA1", "sequential_site": 339, "stability": 0.01071, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3196, "ferret_sera_escape": 0.04839, "mature_H5_site": 324, "mouse_sera_escape": -0.005777, "mutant": "A", "mutation": "E327A", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.1072, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2663, "ferret_sera_escape": 0.08306, "mature_H5_site": 324, "mouse_sera_escape": -0.1518, "mutant": "C", "mutation": "E327C", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.181, "wildtype": "E"}, {"a26_usage": 0.4887, "cell_entry": -0.1089, "ferret_sera_escape": -0.1186, "mature_H5_site": 324, "mouse_sera_escape": -0.01733, "mutant": "D", "mutation": "E327D", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.1223, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 324, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E327E", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.002401, "ferret_sera_escape": -0.06851, "mature_H5_site": 324, "mouse_sera_escape": -0.03692, "mutant": "F", "mutation": "E327F", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.08354, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06116, "ferret_sera_escape": -0.07034, "mature_H5_site": 324, "mouse_sera_escape": -0.04397, "mutant": "G", "mutation": "E327G", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.02445, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1623, "ferret_sera_escape": -0.1472, "mature_H5_site": 324, "mouse_sera_escape": -0.1769, "mutant": "H", "mutation": "E327H", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.06898, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1583, "ferret_sera_escape": -0.03867, "mature_H5_site": 324, "mouse_sera_escape": -0.07667, "mutant": "I", "mutation": "E327I", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.09918, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.744, "ferret_sera_escape": -0.06336, "mature_H5_site": 324, "mouse_sera_escape": -0.0548, "mutant": "K", "mutation": "E327K", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.08692, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06317, "ferret_sera_escape": 0.01454, "mature_H5_site": 324, "mouse_sera_escape": 0.03804, "mutant": "L", "mutation": "E327L", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.09755, "wildtype": "E"}, {"a26_usage": null, "cell_entry": -0.09467, "ferret_sera_escape": null, "mature_H5_site": 324, "mouse_sera_escape": null, "mutant": "N", "mutation": "E327N", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": null, "wildtype": "E"}, {"a26_usage": 0.1755, "cell_entry": -0.07594, "ferret_sera_escape": -0.08662, "mature_H5_site": 324, "mouse_sera_escape": -0.01727, "mutant": "Q", "mutation": "E327Q", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.0232, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2668, "ferret_sera_escape": 0.03827, "mature_H5_site": 324, "mouse_sera_escape": -0.03549, "mutant": "R", "mutation": "E327R", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.09135, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4871, "ferret_sera_escape": 0.101, "mature_H5_site": 324, "mouse_sera_escape": -0.02106, "mutant": "S", "mutation": "E327S", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.09222, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2793, "ferret_sera_escape": 0.01881, "mature_H5_site": 324, "mouse_sera_escape": -0.03494, "mutant": "V", "mutation": "E327V", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.05991, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.04419, "ferret_sera_escape": -0.09317, "mature_H5_site": 324, "mouse_sera_escape": 0.03545, "mutant": "W", "mutation": "E327W", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.1164, "wildtype": "E"}, {"a26_usage": 0.008215, "cell_entry": 0.03971, "ferret_sera_escape": 0.07341, "mature_H5_site": 324, "mouse_sera_escape": -0.07968, "mutant": "Y", "mutation": "E327Y", "reference_site": "327", "region": "HA1", "sequential_site": 340, "stability": -0.0942, "wildtype": "E"}, {"a26_usage": 0.1512, "cell_entry": 0.04226, "ferret_sera_escape": 0.07889, "mature_H5_site": 325, "mouse_sera_escape": null, "mutant": "A", "mutation": "K328A", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.1318, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7532, "ferret_sera_escape": -0.0417, "mature_H5_site": 325, "mouse_sera_escape": -0.1602, "mutant": "C", "mutation": "K328C", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": -0.1135, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.056, "ferret_sera_escape": null, "mature_H5_site": 325, "mouse_sera_escape": null, "mutant": "D", "mutation": "K328D", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.877, "ferret_sera_escape": 0.05958, "mature_H5_site": 325, "mouse_sera_escape": 0.1716, "mutant": "E", "mutation": "K328E", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": -0.03997, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1584, "ferret_sera_escape": 0.03472, "mature_H5_site": 325, "mouse_sera_escape": 0.003367, "mutant": "F", "mutation": "K328F", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.09508, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03592, "ferret_sera_escape": 0.03283, "mature_H5_site": 325, "mouse_sera_escape": 0.07289, "mutant": "G", "mutation": "K328G", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.06623, "wildtype": "K"}, {"a26_usage": 0.04962, "cell_entry": 0.00832, "ferret_sera_escape": -0.03733, "mature_H5_site": 325, "mouse_sera_escape": -0.0141, "mutant": "H", "mutation": "K328H", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": -0.0273, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03372, "ferret_sera_escape": 0.03102, "mature_H5_site": 325, "mouse_sera_escape": -0.06957, "mutant": "I", "mutation": "K328I", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.013, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 325, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K328K", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.213, "ferret_sera_escape": 0.1471, "mature_H5_site": 325, "mouse_sera_escape": 0.03706, "mutant": "N", "mutation": "K328N", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.07229, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07345, "ferret_sera_escape": 0.03618, "mature_H5_site": 325, "mouse_sera_escape": -0.04863, "mutant": "R", "mutation": "K328R", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": -0.06764, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3032, "ferret_sera_escape": 0.06543, "mature_H5_site": 325, "mouse_sera_escape": 0.1136, "mutant": "S", "mutation": "K328S", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.01921, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05675, "ferret_sera_escape": 0.05679, "mature_H5_site": 325, "mouse_sera_escape": -0.05843, "mutant": "V", "mutation": "K328V", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.06224, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8701, "ferret_sera_escape": 0.03892, "mature_H5_site": 325, "mouse_sera_escape": 0.08765, "mutant": "W", "mutation": "K328W", "reference_site": "328", "region": "HA1", "sequential_site": 341, "stability": 0.02936, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "D", "mutation": "R328aD", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.841, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "E", "mutation": "R328aE", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.652, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "F", "mutation": "R328aF", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.86, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "G", "mutation": "R328aG", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.795, "ferret_sera_escape": 0.671, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "H", "mutation": "R328aH", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.114, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "I", "mutation": "R328aI", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.84, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "K", "mutation": "R328aK", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "L", "mutation": "R328aL", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "M", "mutation": "R328aM", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.482, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": -0.1289, "mutant": "P", "mutation": "R328aP", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.083, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "Q", "mutation": "R328aQ", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 326, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R328aR", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "S", "mutation": "R328aS", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.763, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "T", "mutation": "R328aT", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.512, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "V", "mutation": "R328aV", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.663, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "W", "mutation": "R328aW", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.732, "ferret_sera_escape": null, "mature_H5_site": 326, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R328aY", "reference_site": "328a", "region": "PBCS", "sequential_site": 342, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.06475, "ferret_sera_escape": -0.09224, "mature_H5_site": 327, "mouse_sera_escape": -0.0898, "mutant": "A", "mutation": "R328bA", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": 0.009548, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.08059, "ferret_sera_escape": -0.439, "mature_H5_site": 327, "mouse_sera_escape": -0.4603, "mutant": "C", "mutation": "R328bC", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": -0.1023, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.08, "ferret_sera_escape": null, "mature_H5_site": 327, "mouse_sera_escape": null, "mutant": "D", "mutation": "R328bD", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4824, "ferret_sera_escape": null, "mature_H5_site": 327, "mouse_sera_escape": null, "mutant": "E", "mutation": "R328bE", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.06731, "ferret_sera_escape": null, "mature_H5_site": 327, "mouse_sera_escape": null, "mutant": "F", "mutation": "R328bF", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.25, "ferret_sera_escape": 0.07936, "mature_H5_site": 327, "mouse_sera_escape": 0.1731, "mutant": "G", "mutation": "R328bG", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": -0.04324, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1409, "ferret_sera_escape": 0.08366, "mature_H5_site": 327, "mouse_sera_escape": -0.09088, "mutant": "I", "mutation": "R328bI", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": 0.0003689, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0356, "ferret_sera_escape": -0.1096, "mature_H5_site": 327, "mouse_sera_escape": -0.1058, "mutant": "K", "mutation": "R328bK", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": -0.02507, "wildtype": "R"}, {"a26_usage": 0.09562, "cell_entry": -0.003765, "ferret_sera_escape": 0.002133, "mature_H5_site": 327, "mouse_sera_escape": -0.09729, "mutant": "L", "mutation": "R328bL", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": -0.04653, "wildtype": "R"}, {"a26_usage": 0.09677, "cell_entry": 0.02313, "ferret_sera_escape": -0.09024, "mature_H5_site": 327, "mouse_sera_escape": -0.02739, "mutant": "M", "mutation": "R328bM", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": -0.04391, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3905, "ferret_sera_escape": null, "mature_H5_site": 327, "mouse_sera_escape": null, "mutant": "N", "mutation": "R328bN", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.09431, "ferret_sera_escape": -0.05577, "mature_H5_site": 327, "mouse_sera_escape": 0.01034, "mutant": "P", "mutation": "R328bP", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": 0.0797, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 327, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R328bR", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.943, "ferret_sera_escape": 0.05939, "mature_H5_site": 327, "mouse_sera_escape": 0.02469, "mutant": "S", "mutation": "R328bS", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": 0.07773, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3589, "ferret_sera_escape": 0.04622, "mature_H5_site": 327, "mouse_sera_escape": 0.01632, "mutant": "T", "mutation": "R328bT", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": 0.01398, "wildtype": "R"}, {"a26_usage": null, "cell_entry": -0.3909, "ferret_sera_escape": 0.00766, "mature_H5_site": 327, "mouse_sera_escape": 0.01216, "mutant": "W", "mutation": "R328bW", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1196, "ferret_sera_escape": 0.06344, "mature_H5_site": 327, "mouse_sera_escape": -0.07169, "mutant": "Y", "mutation": "R328bY", "reference_site": "328b", "region": "PBCS", "sequential_site": 343, "stability": -0.008973, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.514, "ferret_sera_escape": -0.06687, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "A", "mutation": "K328cA", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": 0.01605, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.159, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "C", "mutation": "K328cC", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "D", "mutation": "K328cD", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "E", "mutation": "K328cE", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.712, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "F", "mutation": "K328cF", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.824, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "G", "mutation": "K328cG", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.063, "ferret_sera_escape": 0.1342, "mature_H5_site": 328, "mouse_sera_escape": 0.1771, "mutant": "I", "mutation": "K328cI", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 328, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K328cK", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "M", "mutation": "K328cM", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.732, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "N", "mutation": "K328cN", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.857, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "P", "mutation": "K328cP", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.713, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "Q", "mutation": "K328cQ", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.09191, "ferret_sera_escape": -0.09746, "mature_H5_site": 328, "mouse_sera_escape": -0.01855, "mutant": "R", "mutation": "K328cR", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": -0.008006, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.352, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "S", "mutation": "K328cS", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.197, "ferret_sera_escape": 0.2915, "mature_H5_site": 328, "mouse_sera_escape": 0.1912, "mutant": "T", "mutation": "K328cT", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": 0.02119, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.001, "ferret_sera_escape": 0.1448, "mature_H5_site": 328, "mouse_sera_escape": 0.2306, "mutant": "V", "mutation": "K328cV", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": 0.02245, "wildtype": "K"}, {"a26_usage": null, "cell_entry": -5.874, "ferret_sera_escape": null, "mature_H5_site": 328, "mouse_sera_escape": null, "mutant": "W", "mutation": "K328cW", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.551, "ferret_sera_escape": -0.05989, "mature_H5_site": 328, "mouse_sera_escape": 0.008904, "mutant": "Y", "mutation": "K328cY", "reference_site": "328c", "region": "PBCS", "sequential_site": 344, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "A", "mutation": "R329A", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.431, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "C", "mutation": "R329C", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "D", "mutation": "R329D", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "E", "mutation": "R329E", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.633, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "F", "mutation": "R329F", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "G", "mutation": "R329G", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "H", "mutation": "R329H", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.832, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "I", "mutation": "R329I", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.291, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "K", "mutation": "R329K", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.822, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "M", "mutation": "R329M", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "N", "mutation": "R329N", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.903, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "P", "mutation": "R329P", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "Q", "mutation": "R329Q", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 329, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R329R", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.735, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "S", "mutation": "R329S", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.731, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "T", "mutation": "R329T", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.837, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "V", "mutation": "R329V", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "W", "mutation": "R329W", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.811, "ferret_sera_escape": null, "mature_H5_site": 329, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R329Y", "reference_site": "329", "region": "PBCS", "sequential_site": 345, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7969, "ferret_sera_escape": -0.09333, "mature_H5_site": 23, "mouse_sera_escape": -0.02656, "mutant": "A", "mutation": "N33A", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.3272, "wildtype": "N"}, {"a26_usage": 1.304, "cell_entry": -0.1255, "ferret_sera_escape": -0.0541, "mature_H5_site": 23, "mouse_sera_escape": null, "mutant": "C", "mutation": "N33C", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.35, "ferret_sera_escape": 0.02909, "mature_H5_site": 23, "mouse_sera_escape": -0.01962, "mutant": "D", "mutation": "N33D", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7246, "ferret_sera_escape": -0.1071, "mature_H5_site": 23, "mouse_sera_escape": -0.05998, "mutant": "E", "mutation": "N33E", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.034, "ferret_sera_escape": -0.2497, "mature_H5_site": 23, "mouse_sera_escape": -0.03433, "mutant": "F", "mutation": "N33F", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": -0.04192, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1855, "ferret_sera_escape": -0.2066, "mature_H5_site": 23, "mouse_sera_escape": -0.1343, "mutant": "H", "mutation": "N33H", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.6506, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.683, "ferret_sera_escape": -0.04788, "mature_H5_site": 23, "mouse_sera_escape": 0.053, "mutant": "K", "mutation": "N33K", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.5282, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.45, "ferret_sera_escape": null, "mature_H5_site": 23, "mouse_sera_escape": null, "mutant": "L", "mutation": "N33L", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.027, "ferret_sera_escape": -0.2635, "mature_H5_site": 23, "mouse_sera_escape": 0.00373, "mutant": "M", "mutation": "N33M", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.2038, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 23, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N33N", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6412, "ferret_sera_escape": -0.1612, "mature_H5_site": 23, "mouse_sera_escape": -0.05566, "mutant": "Q", "mutation": "N33Q", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.4517, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2287, "ferret_sera_escape": -0.006357, "mature_H5_site": 23, "mouse_sera_escape": 0.06192, "mutant": "R", "mutation": "N33R", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.9194, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.217, "ferret_sera_escape": -0.1169, "mature_H5_site": 23, "mouse_sera_escape": -0.03528, "mutant": "S", "mutation": "N33S", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": 0.2066, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 23, "mouse_sera_escape": null, "mutant": "V", "mutation": "N33V", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 23, "mouse_sera_escape": null, "mutant": "W", "mutation": "N33W", "reference_site": "33", "region": "HA1", "sequential_site": 39, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.46, "ferret_sera_escape": -0.07743, "mature_H5_site": 330, "mouse_sera_escape": 0.532, "mutant": "A", "mutation": "G330A", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.756, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "C", "mutation": "G330C", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.518, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "D", "mutation": "G330D", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.554, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "E", "mutation": "G330E", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.403, "ferret_sera_escape": -0.0635, "mature_H5_site": 330, "mouse_sera_escape": 0.3959, "mutant": "F", "mutation": "G330F", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": 1.009, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 330, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G330G", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.335, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "H", "mutation": "G330H", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "I", "mutation": "G330I", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.515, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "K", "mutation": "G330K", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "L", "mutation": "G330L", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.848, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "M", "mutation": "G330M", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.855, "ferret_sera_escape": 0.2101, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "N", "mutation": "G330N", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.88, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "P", "mutation": "G330P", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.548, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G330Q", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.628, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "R", "mutation": "G330R", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.118, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "S", "mutation": "G330S", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.691, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "T", "mutation": "G330T", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.448, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "V", "mutation": "G330V", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1889, "ferret_sera_escape": -0.05713, "mature_H5_site": 330, "mouse_sera_escape": -0.0154, "mutant": "W", "mutation": "G330W", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": 0.4056, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.474, "ferret_sera_escape": null, "mature_H5_site": 330, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G330Y", "reference_site": "330", "region": "HA2", "sequential_site": 346, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.439, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "C", "mutation": "L331C", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.862, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "D", "mutation": "L331D", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "E", "mutation": "L331E", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.11, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "F", "mutation": "L331F", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "G", "mutation": "L331G", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.861, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "H", "mutation": "L331H", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7486, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "I", "mutation": "L331I", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.793, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "K", "mutation": "L331K", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 331, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L331L", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.83, "ferret_sera_escape": -0.0941, "mature_H5_site": 331, "mouse_sera_escape": 0.04818, "mutant": "M", "mutation": "L331M", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": 0.5362, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "P", "mutation": "L331P", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.678, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L331Q", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.833, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "R", "mutation": "L331R", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "S", "mutation": "L331S", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.895, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "T", "mutation": "L331T", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.362, "ferret_sera_escape": -0.2245, "mature_H5_site": 331, "mouse_sera_escape": 0.6048, "mutant": "V", "mutation": "L331V", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": 0.8239, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.846, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "W", "mutation": "L331W", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 331, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L331Y", "reference_site": "331", "region": "HA2", "sequential_site": 347, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.856, "ferret_sera_escape": -0.1123, "mature_H5_site": 332, "mouse_sera_escape": 0.3842, "mutant": "A", "mutation": "F332A", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": 0.8835, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "C", "mutation": "F332C", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "D", "mutation": "F332D", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.454, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "E", "mutation": "F332E", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 332, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F332F", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.601, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "G", "mutation": "F332G", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "H", "mutation": "F332H", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.329, "ferret_sera_escape": -0.1003, "mature_H5_site": 332, "mouse_sera_escape": 0.4064, "mutant": "I", "mutation": "F332I", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": 1.592, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.822, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "K", "mutation": "F332K", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.181, "ferret_sera_escape": -0.1054, "mature_H5_site": 332, "mouse_sera_escape": 0.385, "mutant": "L", "mutation": "F332L", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": 1.38, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.221, "ferret_sera_escape": -0.1519, "mature_H5_site": 332, "mouse_sera_escape": 0.4544, "mutant": "M", "mutation": "F332M", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": 1.181, "wildtype": "F"}, {"a26_usage": null, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "N", "mutation": "F332N", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.018, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "P", "mutation": "F332P", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.869, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F332Q", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "R", "mutation": "F332R", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "S", "mutation": "F332S", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "T", "mutation": "F332T", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.939, "ferret_sera_escape": -0.1829, "mature_H5_site": 332, "mouse_sera_escape": 0.2684, "mutant": "V", "mutation": "F332V", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": 1.479, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.699, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "W", "mutation": "F332W", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.636, "ferret_sera_escape": null, "mature_H5_site": 332, "mouse_sera_escape": null, "mutant": "Y", "mutation": "F332Y", "reference_site": "332", "region": "HA2", "sequential_site": 348, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.035, "ferret_sera_escape": -0.1124, "mature_H5_site": 333, "mouse_sera_escape": 0.3503, "mutant": "A", "mutation": "G333A", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 1.241, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.842, "ferret_sera_escape": null, "mature_H5_site": 333, "mouse_sera_escape": null, "mutant": "C", "mutation": "G333C", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.678, "ferret_sera_escape": null, "mature_H5_site": 333, "mouse_sera_escape": null, "mutant": "D", "mutation": "G333D", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.63, "ferret_sera_escape": null, "mature_H5_site": 333, "mouse_sera_escape": null, "mutant": "E", "mutation": "G333E", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.189, "ferret_sera_escape": -0.1415, "mature_H5_site": 333, "mouse_sera_escape": 0.1984, "mutant": "F", "mutation": "G333F", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 1.295, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 333, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G333G", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.604, "ferret_sera_escape": -0.1355, "mature_H5_site": 333, "mouse_sera_escape": 0.5327, "mutant": "H", "mutation": "G333H", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 0.5796, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.65, "ferret_sera_escape": -0.1925, "mature_H5_site": 333, "mouse_sera_escape": null, "mutant": "K", "mutation": "G333K", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 0.9927, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.6009, "ferret_sera_escape": -0.1541, "mature_H5_site": 333, "mouse_sera_escape": 0.2912, "mutant": "L", "mutation": "G333L", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 1.363, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2621, "ferret_sera_escape": -0.1237, "mature_H5_site": 333, "mouse_sera_escape": 0.2083, "mutant": "M", "mutation": "G333M", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 1.773, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 333, "mouse_sera_escape": null, "mutant": "P", "mutation": "G333P", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.191, "ferret_sera_escape": 0.00674, "mature_H5_site": 333, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G333Q", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.603, "ferret_sera_escape": -0.1827, "mature_H5_site": 333, "mouse_sera_escape": 0.3784, "mutant": "R", "mutation": "G333R", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 0.9795, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7004, "ferret_sera_escape": -0.1172, "mature_H5_site": 333, "mouse_sera_escape": 0.4115, "mutant": "S", "mutation": "G333S", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 1.286, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.585, "ferret_sera_escape": -0.2927, "mature_H5_site": 333, "mouse_sera_escape": 0.12, "mutant": "V", "mutation": "G333V", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 1.485, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.516, "ferret_sera_escape": null, "mature_H5_site": 333, "mouse_sera_escape": null, "mutant": "W", "mutation": "G333W", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.925, "ferret_sera_escape": -0.2494, "mature_H5_site": 333, "mouse_sera_escape": 0.1799, "mutant": "Y", "mutation": "G333Y", "reference_site": "333", "region": "HA2", "sequential_site": 349, "stability": 1.11, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 334, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A334A", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.603, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "C", "mutation": "A334C", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "D", "mutation": "A334D", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.508, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "E", "mutation": "A334E", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.953, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "F", "mutation": "A334F", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.414, "ferret_sera_escape": -0.1556, "mature_H5_site": 334, "mouse_sera_escape": 0.445, "mutant": "G", "mutation": "A334G", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.491, "ferret_sera_escape": -0.1861, "mature_H5_site": 334, "mouse_sera_escape": 0.2083, "mutant": "I", "mutation": "A334I", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": 1.259, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "K", "mutation": "A334K", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.422, "ferret_sera_escape": -0.1446, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "L", "mutation": "A334L", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.235, "ferret_sera_escape": -0.1677, "mature_H5_site": 334, "mouse_sera_escape": 0.2144, "mutant": "M", "mutation": "A334M", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": 2.225, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.79, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A334Q", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "R", "mutation": "A334R", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.266, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "S", "mutation": "A334S", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.7, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "T", "mutation": "A334T", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.957, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": -0.1384, "mutant": "V", "mutation": "A334V", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.661, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "W", "mutation": "A334W", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 334, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A334Y", "reference_site": "334", "region": "HA2", "sequential_site": 350, "stability": null, "wildtype": "A"}, {"a26_usage": 2.489, "cell_entry": -1.958, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "A", "mutation": "I335A", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.631, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "C", "mutation": "I335C", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.588, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "D", "mutation": "I335D", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.701, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "E", "mutation": "I335E", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "G", "mutation": "I335G", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.816, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "H", "mutation": "I335H", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 335, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I335I", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "K", "mutation": "I335K", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3644, "ferret_sera_escape": -0.07554, "mature_H5_site": 335, "mouse_sera_escape": 0.2042, "mutant": "L", "mutation": "I335L", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": 1.293, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.7006, "ferret_sera_escape": -0.1176, "mature_H5_site": 335, "mouse_sera_escape": 0.09558, "mutant": "M", "mutation": "I335M", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": 1.549, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "N", "mutation": "I335N", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.678, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "P", "mutation": "I335P", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I335Q", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.809, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "R", "mutation": "I335R", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "S", "mutation": "I335S", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.782, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "T", "mutation": "I335T", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.05497, "ferret_sera_escape": -0.118, "mature_H5_site": 335, "mouse_sera_escape": 0.02733, "mutant": "V", "mutation": "I335V", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": 1.062, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.497, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "W", "mutation": "I335W", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.752, "ferret_sera_escape": null, "mature_H5_site": 335, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I335Y", "reference_site": "335", "region": "HA2", "sequential_site": 351, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 336, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A336A", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.803, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "C", "mutation": "A336C", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "E", "mutation": "A336E", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.301, "ferret_sera_escape": 0.2453, "mature_H5_site": 336, "mouse_sera_escape": 0.3167, "mutant": "G", "mutation": "A336G", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.391, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "H", "mutation": "A336H", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.886, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "K", "mutation": "A336K", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": null, "cell_entry": -2.044, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "L", "mutation": "A336L", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.581, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "M", "mutation": "A336M", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "N", "mutation": "A336N", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A336Q", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.872, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "R", "mutation": "A336R", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.913, "ferret_sera_escape": -0.05082, "mature_H5_site": 336, "mouse_sera_escape": 0.06822, "mutant": "S", "mutation": "A336S", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": -0.1591, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.642, "ferret_sera_escape": 0.08096, "mature_H5_site": 336, "mouse_sera_escape": 0.4128, "mutant": "T", "mutation": "A336T", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": 0.01279, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.758, "ferret_sera_escape": -0.4007, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "V", "mutation": "A336V", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.99, "ferret_sera_escape": 0.2316, "mature_H5_site": 336, "mouse_sera_escape": 0.2424, "mutant": "W", "mutation": "A336W", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": 0.9507, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.385, "ferret_sera_escape": null, "mature_H5_site": 336, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A336Y", "reference_site": "336", "region": "HA2", "sequential_site": 352, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.369, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "C", "mutation": "G337C", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.774, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "D", "mutation": "G337D", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.746, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "E", "mutation": "G337E", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "F", "mutation": "G337F", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 337, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G337G", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "H", "mutation": "G337H", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "I", "mutation": "G337I", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "K", "mutation": "G337K", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.042, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "L", "mutation": "G337L", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.841, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "P", "mutation": "G337P", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.559, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G337Q", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "R", "mutation": "G337R", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.576, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "S", "mutation": "G337S", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.611, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "V", "mutation": "G337V", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.841, "ferret_sera_escape": null, "mature_H5_site": 337, "mouse_sera_escape": null, "mutant": "W", "mutation": "G337W", "reference_site": "337", "region": "HA2", "sequential_site": 353, "stability": null, "wildtype": "G"}, {"a26_usage": null, "cell_entry": -3.512, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "A", "mutation": "F338A", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "D", "mutation": "F338D", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.875, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "E", "mutation": "F338E", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 338, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F338F", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.824, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "G", "mutation": "F338G", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "H", "mutation": "F338H", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.553, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "I", "mutation": "F338I", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "K", "mutation": "F338K", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.095, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "L", "mutation": "F338L", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.803, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "N", "mutation": "F338N", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.806, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F338Q", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "R", "mutation": "F338R", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "S", "mutation": "F338S", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.745, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "T", "mutation": "F338T", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.764, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "V", "mutation": "F338V", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.463, "ferret_sera_escape": -0.09663, "mature_H5_site": 338, "mouse_sera_escape": 0.04159, "mutant": "W", "mutation": "F338W", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": 0.9281, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.254, "ferret_sera_escape": null, "mature_H5_site": 338, "mouse_sera_escape": null, "mutant": "Y", "mutation": "F338Y", "reference_site": "338", "region": "HA2", "sequential_site": 354, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.835, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "A", "mutation": "I339A", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.829, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "C", "mutation": "I339C", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.525, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "D", "mutation": "I339D", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.119, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "E", "mutation": "I339E", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -4.749, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "F", "mutation": "I339F", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.436, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "H", "mutation": "I339H", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 339, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I339I", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.744, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "K", "mutation": "I339K", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.511, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "N", "mutation": "I339N", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.73, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "P", "mutation": "I339P", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.888, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I339Q", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "R", "mutation": "I339R", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.729, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "S", "mutation": "I339S", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "T", "mutation": "I339T", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.98, "ferret_sera_escape": null, "mature_H5_site": 339, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I339Y", "reference_site": "339", "region": "HA2", "sequential_site": 355, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.025, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "A", "mutation": "V34A", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.482, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "C", "mutation": "V34C", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "D", "mutation": "V34D", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "E", "mutation": "V34E", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.888, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "F", "mutation": "V34F", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.314, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "G", "mutation": "V34G", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "H", "mutation": "V34H", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.235, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "I", "mutation": "V34I", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "K", "mutation": "V34K", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8625, "ferret_sera_escape": -0.0934, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "L", "mutation": "V34L", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.611, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "M", "mutation": "V34M", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "N", "mutation": "V34N", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.855, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V34Q", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "R", "mutation": "V34R", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "S", "mutation": "V34S", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.604, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "T", "mutation": "V34T", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 24, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V34V", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 24, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V34Y", "reference_site": "34", "region": "HA1", "sequential_site": 40, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.435, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "A", "mutation": "E340A", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.753, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "C", "mutation": "E340C", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.192, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "D", "mutation": "E340D", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 340, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E340E", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.061, "ferret_sera_escape": 0.4853, "mature_H5_site": 340, "mouse_sera_escape": 0.1923, "mutant": "F", "mutation": "E340F", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.924, "ferret_sera_escape": -0.07067, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "G", "mutation": "E340G", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.706, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "H", "mutation": "E340H", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.38, "ferret_sera_escape": 0.1439, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "I", "mutation": "E340I", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": -0.005454, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.698, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "K", "mutation": "E340K", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.12, "ferret_sera_escape": 0.13, "mature_H5_site": 340, "mouse_sera_escape": 0.3031, "mutant": "M", "mutation": "E340M", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.635, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "N", "mutation": "E340N", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.501, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "Q", "mutation": "E340Q", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -6.054, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "R", "mutation": "E340R", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.396, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "S", "mutation": "E340S", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.524, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "V", "mutation": "E340V", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.847, "ferret_sera_escape": 0.007779, "mature_H5_site": 340, "mouse_sera_escape": 0.3888, "mutant": "W", "mutation": "E340W", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": 0.4343, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.565, "ferret_sera_escape": null, "mature_H5_site": 340, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E340Y", "reference_site": "340", "region": "HA2", "sequential_site": 356, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.162, "ferret_sera_escape": -0.04935, "mature_H5_site": 341, "mouse_sera_escape": -0.09464, "mutant": "A", "mutation": "G341A", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": -0.4084, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.905, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "C", "mutation": "G341C", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.554, "ferret_sera_escape": -0.2516, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "D", "mutation": "G341D", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.993, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "E", "mutation": "G341E", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.284, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "F", "mutation": "G341F", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 341, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G341G", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.468, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "H", "mutation": "G341H", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.237, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "I", "mutation": "G341I", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.848, "ferret_sera_escape": 0.3152, "mature_H5_site": 341, "mouse_sera_escape": 0.146, "mutant": "K", "mutation": "G341K", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": 0.02166, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.448, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "L", "mutation": "G341L", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.082, "ferret_sera_escape": -0.07914, "mature_H5_site": 341, "mouse_sera_escape": 0.01542, "mutant": "M", "mutation": "G341M", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "P", "mutation": "G341P", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.494, "ferret_sera_escape": -0.1037, "mature_H5_site": 341, "mouse_sera_escape": 0.02115, "mutant": "Q", "mutation": "G341Q", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": -0.07671, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.26, "ferret_sera_escape": 0.3108, "mature_H5_site": 341, "mouse_sera_escape": 0.354, "mutant": "R", "mutation": "G341R", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.226, "ferret_sera_escape": -0.2333, "mature_H5_site": 341, "mouse_sera_escape": -0.2146, "mutant": "S", "mutation": "G341S", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": 0.1229, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.311, "ferret_sera_escape": 0.3481, "mature_H5_site": 341, "mouse_sera_escape": 0.03644, "mutant": "T", "mutation": "G341T", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.096, "ferret_sera_escape": -0.2008, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "V", "mutation": "G341V", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": -0.0138, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.687, "ferret_sera_escape": null, "mature_H5_site": 341, "mouse_sera_escape": null, "mutant": "W", "mutation": "G341W", "reference_site": "341", "region": "HA2", "sequential_site": 357, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.299, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "A", "mutation": "G342A", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "D", "mutation": "G342D", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.268, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "E", "mutation": "G342E", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "F", "mutation": "G342F", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 342, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G342G", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.596, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "H", "mutation": "G342H", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "I", "mutation": "G342I", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": null, "cell_entry": -5.818, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "K", "mutation": "G342K", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "L", "mutation": "G342L", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "M", "mutation": "G342M", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": null, "cell_entry": -5.577, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "N", "mutation": "G342N", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "P", "mutation": "G342P", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G342Q", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": -0.298, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "R", "mutation": "G342R", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "T", "mutation": "G342T", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.399, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "V", "mutation": "G342V", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.806, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "W", "mutation": "G342W", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 342, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G342Y", "reference_site": "342", "region": "HA2", "sequential_site": 358, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.795, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "C", "mutation": "W343C", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.772, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "D", "mutation": "W343D", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.993, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "E", "mutation": "W343E", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.279, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "F", "mutation": "W343F", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.754, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "G", "mutation": "W343G", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.454, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "I", "mutation": "W343I", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.258, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "K", "mutation": "W343K", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "L", "mutation": "W343L", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.931, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "M", "mutation": "W343M", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "N", "mutation": "W343N", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.711, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "P", "mutation": "W343P", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W343Q", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.762, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "S", "mutation": "W343S", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.73, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "T", "mutation": "W343T", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "V", "mutation": "W343V", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 343, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W343W", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.603, "ferret_sera_escape": null, "mature_H5_site": 343, "mouse_sera_escape": null, "mutant": "Y", "mutation": "W343Y", "reference_site": "343", "region": "HA2", "sequential_site": 359, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.3003, "ferret_sera_escape": 0.04032, "mature_H5_site": 344, "mouse_sera_escape": 0.0634, "mutant": "A", "mutation": "Q344A", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.01962, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.3258, "ferret_sera_escape": -0.04957, "mature_H5_site": 344, "mouse_sera_escape": 0.003724, "mutant": "C", "mutation": "Q344C", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.0446, "wildtype": "Q"}, {"a26_usage": 0.01972, "cell_entry": 0.008405, "ferret_sera_escape": 0.1325, "mature_H5_site": 344, "mouse_sera_escape": -0.03507, "mutant": "D", "mutation": "Q344D", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": -0.04501, "wildtype": "Q"}, {"a26_usage": 0.06465, "cell_entry": 0.05667, "ferret_sera_escape": 0.02244, "mature_H5_site": 344, "mouse_sera_escape": -0.03372, "mutant": "E", "mutation": "Q344E", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": -0.03283, "wildtype": "Q"}, {"a26_usage": 0.6251, "cell_entry": -0.07407, "ferret_sera_escape": -0.07382, "mature_H5_site": 344, "mouse_sera_escape": 0.08231, "mutant": "H", "mutation": "Q344H", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.4754, "wildtype": "Q"}, {"a26_usage": 0.06965, "cell_entry": -1.02, "ferret_sera_escape": -0.0462, "mature_H5_site": 344, "mouse_sera_escape": -0.0316, "mutant": "I", "mutation": "Q344I", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.6092, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.7721, "ferret_sera_escape": -0.1716, "mature_H5_site": 344, "mouse_sera_escape": -0.05693, "mutant": "K", "mutation": "Q344K", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": -0.05818, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.051, "ferret_sera_escape": 0.04744, "mature_H5_site": 344, "mouse_sera_escape": -0.03979, "mutant": "L", "mutation": "Q344L", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.4721, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.316, "ferret_sera_escape": -0.2422, "mature_H5_site": 344, "mouse_sera_escape": -0.1867, "mutant": "M", "mutation": "Q344M", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.08878, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.0657, "ferret_sera_escape": -0.0664, "mature_H5_site": 344, "mouse_sera_escape": 0.007667, "mutant": "N", "mutation": "Q344N", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": -0.08229, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.06274, "ferret_sera_escape": 0.04883, "mature_H5_site": 344, "mouse_sera_escape": -0.007899, "mutant": "P", "mutation": "Q344P", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.04412, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 344, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q344Q", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.141, "ferret_sera_escape": 0.03072, "mature_H5_site": 344, "mouse_sera_escape": 0.1437, "mutant": "R", "mutation": "Q344R", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.1315, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.3437, "ferret_sera_escape": 0.03401, "mature_H5_site": 344, "mouse_sera_escape": -0.04086, "mutant": "S", "mutation": "Q344S", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": -0.01223, "wildtype": "Q"}, {"a26_usage": 0.004325, "cell_entry": -0.5702, "ferret_sera_escape": 0.0533, "mature_H5_site": 344, "mouse_sera_escape": 0.03138, "mutant": "T", "mutation": "Q344T", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.1767, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.9498, "ferret_sera_escape": -0.03442, "mature_H5_site": 344, "mouse_sera_escape": 0.05206, "mutant": "V", "mutation": "Q344V", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": 0.3606, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1852, "ferret_sera_escape": -0.06349, "mature_H5_site": 344, "mouse_sera_escape": -0.1168, "mutant": "W", "mutation": "Q344W", "reference_site": "344", "region": "HA2", "sequential_site": 360, "stability": -0.02302, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.884, "ferret_sera_escape": 0.003507, "mature_H5_site": 345, "mouse_sera_escape": -0.0888, "mutant": "A", "mutation": "G345A", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.799, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "C", "mutation": "G345C", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.486, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "D", "mutation": "G345D", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.53, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": 0.1204, "mutant": "F", "mutation": "G345F", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 345, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G345G", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.366, "ferret_sera_escape": 0.02444, "mature_H5_site": 345, "mouse_sera_escape": -0.00273, "mutant": "H", "mutation": "G345H", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": -0.08184, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "I", "mutation": "G345I", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.68, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": -0.1309, "mutant": "L", "mutation": "G345L", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.797, "ferret_sera_escape": 0.03496, "mature_H5_site": 345, "mouse_sera_escape": 0.2806, "mutant": "M", "mutation": "G345M", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": -0.03682, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.389, "ferret_sera_escape": 0.09393, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "P", "mutation": "G345P", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.92, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G345Q", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.069, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "R", "mutation": "G345R", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.144, "ferret_sera_escape": -0.07298, "mature_H5_site": 345, "mouse_sera_escape": 0.004074, "mutant": "S", "mutation": "G345S", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": -0.06669, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.675, "ferret_sera_escape": 0.1557, "mature_H5_site": 345, "mouse_sera_escape": 0.09029, "mutant": "T", "mutation": "G345T", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": -0.161, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.836, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "V", "mutation": "G345V", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.42, "ferret_sera_escape": null, "mature_H5_site": 345, "mouse_sera_escape": null, "mutant": "W", "mutation": "G345W", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.405, "ferret_sera_escape": 0.4383, "mature_H5_site": 345, "mouse_sera_escape": 0.2752, "mutant": "Y", "mutation": "G345Y", "reference_site": "345", "region": "HA2", "sequential_site": 361, "stability": -0.08898, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "C", "mutation": "M346C", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "D", "mutation": "M346D", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": null, "cell_entry": -2.978, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "E", "mutation": "M346E", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.05502, "ferret_sera_escape": -0.3012, "mature_H5_site": 346, "mouse_sera_escape": -0.246, "mutant": "F", "mutation": "M346F", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": -0.08419, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.719, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "G", "mutation": "M346G", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "H", "mutation": "M346H", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.894, "ferret_sera_escape": -0.09775, "mature_H5_site": 346, "mouse_sera_escape": 0.1406, "mutant": "I", "mutation": "M346I", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": -0.1314, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.867, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "K", "mutation": "M346K", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.5736, "ferret_sera_escape": -0.01951, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "L", "mutation": "M346L", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 346, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M346M", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "N", "mutation": "M346N", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "P", "mutation": "M346P", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "R", "mutation": "M346R", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "S", "mutation": "M346S", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.173, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "V", "mutation": "M346V", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.795, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "W", "mutation": "M346W", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.847, "ferret_sera_escape": null, "mature_H5_site": 346, "mouse_sera_escape": null, "mutant": "Y", "mutation": "M346Y", "reference_site": "346", "region": "HA2", "sequential_site": 362, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.7103, "ferret_sera_escape": -0.00316, "mature_H5_site": 347, "mouse_sera_escape": -0.008063, "mutant": "A", "mutation": "V347A", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.09931, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5873, "ferret_sera_escape": 0.02776, "mature_H5_site": 347, "mouse_sera_escape": 0.09978, "mutant": "C", "mutation": "V347C", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.1522, "wildtype": "V"}, {"a26_usage": null, "cell_entry": -5.074, "ferret_sera_escape": null, "mature_H5_site": 347, "mouse_sera_escape": null, "mutant": "D", "mutation": "V347D", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.319, "ferret_sera_escape": 0.1219, "mature_H5_site": 347, "mouse_sera_escape": 0.06536, "mutant": "E", "mutation": "V347E", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.102, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.121, "ferret_sera_escape": -0.04243, "mature_H5_site": 347, "mouse_sera_escape": -0.02175, "mutant": "F", "mutation": "V347F", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.1276, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.654, "ferret_sera_escape": -0.00862, "mature_H5_site": 347, "mouse_sera_escape": -0.01634, "mutant": "G", "mutation": "V347G", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.0614, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.218, "ferret_sera_escape": 0.04256, "mature_H5_site": 347, "mouse_sera_escape": 0.3304, "mutant": "H", "mutation": "V347H", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2599, "ferret_sera_escape": -0.0008267, "mature_H5_site": 347, "mouse_sera_escape": -0.02686, "mutant": "I", "mutation": "V347I", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.09652, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.03992, "ferret_sera_escape": 0.002308, "mature_H5_site": 347, "mouse_sera_escape": -0.07904, "mutant": "L", "mutation": "V347L", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.0734, "wildtype": "V"}, {"a26_usage": 0.04177, "cell_entry": -0.05824, "ferret_sera_escape": -0.03132, "mature_H5_site": 347, "mouse_sera_escape": -0.09917, "mutant": "M", "mutation": "V347M", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.1081, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.916, "ferret_sera_escape": null, "mature_H5_site": 347, "mouse_sera_escape": null, "mutant": "N", "mutation": "V347N", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.001, "ferret_sera_escape": -0.05155, "mature_H5_site": 347, "mouse_sera_escape": 0.1135, "mutant": "Q", "mutation": "V347Q", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.04444, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7611, "ferret_sera_escape": -0.04555, "mature_H5_site": 347, "mouse_sera_escape": 0.2706, "mutant": "R", "mutation": "V347R", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.1073, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.125, "ferret_sera_escape": -0.1129, "mature_H5_site": 347, "mouse_sera_escape": 0.1962, "mutant": "S", "mutation": "V347S", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.1244, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 347, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V347V", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.07599, "cell_entry": 0.07594, "ferret_sera_escape": -0.04964, "mature_H5_site": 347, "mouse_sera_escape": 0.0109, "mutant": "Y", "mutation": "V347Y", "reference_site": "347", "region": "HA2", "sequential_site": 363, "stability": -0.1012, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.844, "ferret_sera_escape": -0.07237, "mature_H5_site": 348, "mouse_sera_escape": null, "mutant": "C", "mutation": "D348C", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 348, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D348D", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2697, "ferret_sera_escape": -0.1348, "mature_H5_site": 348, "mouse_sera_escape": -0.08247, "mutant": "E", "mutation": "D348E", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.1455, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.615, "ferret_sera_escape": null, "mature_H5_site": 348, "mouse_sera_escape": null, "mutant": "F", "mutation": "D348F", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5736, "ferret_sera_escape": -0.2358, "mature_H5_site": 348, "mouse_sera_escape": -0.1141, "mutant": "H", "mutation": "D348H", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.1281, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.937, "ferret_sera_escape": null, "mature_H5_site": 348, "mouse_sera_escape": null, "mutant": "K", "mutation": "D348K", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.591, "ferret_sera_escape": null, "mature_H5_site": 348, "mouse_sera_escape": null, "mutant": "L", "mutation": "D348L", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2994, "ferret_sera_escape": -0.09225, "mature_H5_site": 348, "mouse_sera_escape": -0.05296, "mutant": "N", "mutation": "D348N", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.1644, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7125, "ferret_sera_escape": -0.1426, "mature_H5_site": 348, "mouse_sera_escape": -0.08404, "mutant": "Q", "mutation": "D348Q", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.2715, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.107, "ferret_sera_escape": null, "mature_H5_site": 348, "mouse_sera_escape": null, "mutant": "R", "mutation": "D348R", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": null, "wildtype": "D"}, {"a26_usage": 0.4373, "cell_entry": -0.1254, "ferret_sera_escape": -0.05222, "mature_H5_site": 348, "mouse_sera_escape": -0.06899, "mutant": "S", "mutation": "D348S", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.1579, "wildtype": "D"}, {"a26_usage": 0.8325, "cell_entry": -0.9481, "ferret_sera_escape": null, "mature_H5_site": 348, "mouse_sera_escape": null, "mutant": "T", "mutation": "D348T", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5348, "ferret_sera_escape": -0.2215, "mature_H5_site": 348, "mouse_sera_escape": -0.2842, "mutant": "V", "mutation": "D348V", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.2119, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.868, "ferret_sera_escape": -0.1861, "mature_H5_site": 348, "mouse_sera_escape": -0.3, "mutant": "W", "mutation": "D348W", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.5426, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4447, "ferret_sera_escape": -0.1825, "mature_H5_site": 348, "mouse_sera_escape": -0.2062, "mutant": "Y", "mutation": "D348Y", "reference_site": "348", "region": "HA2", "sequential_site": 364, "stability": -0.1488, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.431, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "C", "mutation": "G349C", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.795, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "D", "mutation": "G349D", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.857, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "F", "mutation": "G349F", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 349, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G349G", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "H", "mutation": "G349H", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "I", "mutation": "G349I", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": null, "cell_entry": -5.945, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "K", "mutation": "G349K", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "L", "mutation": "G349L", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "M", "mutation": "G349M", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "N", "mutation": "G349N", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "P", "mutation": "G349P", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G349Q", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.876, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "R", "mutation": "G349R", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.931, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "S", "mutation": "G349S", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.832, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "T", "mutation": "G349T", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.44, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "V", "mutation": "G349V", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "W", "mutation": "G349W", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 349, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G349Y", "reference_site": "349", "region": "HA2", "sequential_site": 365, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.05959, "ferret_sera_escape": -0.2141, "mature_H5_site": 25, "mouse_sera_escape": -0.09439, "mutant": "A", "mutation": "T35A", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": 0.03848, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.6734, "ferret_sera_escape": -0.08631, "mature_H5_site": 25, "mouse_sera_escape": 0.1133, "mutant": "D", "mutation": "T35D", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": -0.05123, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1543, "ferret_sera_escape": null, "mature_H5_site": 25, "mouse_sera_escape": null, "mutant": "E", "mutation": "T35E", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.06106, "ferret_sera_escape": -0.1429, "mature_H5_site": 25, "mouse_sera_escape": -0.04143, "mutant": "F", "mutation": "T35F", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": 0.1075, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4002, "ferret_sera_escape": -0.2636, "mature_H5_site": 25, "mouse_sera_escape": -0.09406, "mutant": "H", "mutation": "T35H", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": 0.0008317, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.8224, "ferret_sera_escape": 0.08765, "mature_H5_site": 25, "mouse_sera_escape": 0.1151, "mutant": "I", "mutation": "T35I", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": -0.131, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.05531, "ferret_sera_escape": -0.2425, "mature_H5_site": 25, "mouse_sera_escape": -0.03897, "mutant": "K", "mutation": "T35K", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": -0.1219, "wildtype": "T"}, {"a26_usage": 0.2467, "cell_entry": 0.06399, "ferret_sera_escape": -0.2636, "mature_H5_site": 25, "mouse_sera_escape": -0.03045, "mutant": "L", "mutation": "T35L", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": -0.00703, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.303, "ferret_sera_escape": -0.2418, "mature_H5_site": 25, "mouse_sera_escape": -0.08086, "mutant": "M", "mutation": "T35M", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": 0.09216, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.04879, "ferret_sera_escape": -0.2115, "mature_H5_site": 25, "mouse_sera_escape": -0.05638, "mutant": "N", "mutation": "T35N", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": -0.04686, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.03163, "ferret_sera_escape": -0.02862, "mature_H5_site": 25, "mouse_sera_escape": 0.07289, "mutant": "P", "mutation": "T35P", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": 0.1894, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.01751, "ferret_sera_escape": 0.131, "mature_H5_site": 25, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T35Q", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.63, "ferret_sera_escape": -0.2127, "mature_H5_site": 25, "mouse_sera_escape": -0.02464, "mutant": "R", "mutation": "T35R", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3758, "ferret_sera_escape": -0.1744, "mature_H5_site": 25, "mouse_sera_escape": 0.08441, "mutant": "S", "mutation": "T35S", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": -0.01182, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 25, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T35T", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.04975, "ferret_sera_escape": -0.1472, "mature_H5_site": 25, "mouse_sera_escape": -0.03642, "mutant": "W", "mutation": "T35W", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.07353, "ferret_sera_escape": -0.2289, "mature_H5_site": 25, "mouse_sera_escape": -0.04406, "mutant": "Y", "mutation": "T35Y", "reference_site": "35", "region": "HA1", "sequential_site": 41, "stability": 0.1005, "wildtype": "T"}, {"a26_usage": null, "cell_entry": -5.914, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "A", "mutation": "W350A", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.705, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "C", "mutation": "W350C", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "D", "mutation": "W350D", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "E", "mutation": "W350E", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.746, "ferret_sera_escape": -0.05273, "mature_H5_site": 350, "mouse_sera_escape": -0.04606, "mutant": "F", "mutation": "W350F", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": -0.09743, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "G", "mutation": "W350G", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "H", "mutation": "W350H", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.03, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "I", "mutation": "W350I", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "K", "mutation": "W350K", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.012, "ferret_sera_escape": 0.2162, "mature_H5_site": 350, "mouse_sera_escape": 0.1321, "mutant": "L", "mutation": "W350L", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.088, "ferret_sera_escape": -0.288, "mature_H5_site": 350, "mouse_sera_escape": -0.06406, "mutant": "M", "mutation": "W350M", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.888, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "P", "mutation": "W350P", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W350Q", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "R", "mutation": "W350R", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "S", "mutation": "W350S", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "T", "mutation": "W350T", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.062, "ferret_sera_escape": null, "mature_H5_site": 350, "mouse_sera_escape": null, "mutant": "V", "mutation": "W350V", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 350, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W350W", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.606, "ferret_sera_escape": 0.3015, "mature_H5_site": 350, "mouse_sera_escape": 0.3279, "mutant": "Y", "mutation": "W350Y", "reference_site": "350", "region": "HA2", "sequential_site": 366, "stability": -0.2603, "wildtype": "W"}, {"a26_usage": null, "cell_entry": -5.99, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y351A", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y351C", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y351D", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.34, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "F", "mutation": "Y351F", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.004, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y351G", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y351H", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.937, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y351I", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y351K", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y351L", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.981, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y351M", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.015, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y351N", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y351P", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y351Q", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y351R", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y351S", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y351T", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 351, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y351W", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 351, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y351Y", "reference_site": "351", "region": "HA2", "sequential_site": 367, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "A", "mutation": "G352A", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "C", "mutation": "G352C", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "D", "mutation": "G352D", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "E", "mutation": "G352E", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "F", "mutation": "G352F", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 352, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G352G", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "H", "mutation": "G352H", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "I", "mutation": "G352I", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "K", "mutation": "G352K", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "L", "mutation": "G352L", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.305, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "M", "mutation": "G352M", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "N", "mutation": "G352N", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": null, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "P", "mutation": "G352P", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G352Q", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.842, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "R", "mutation": "G352R", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "S", "mutation": "G352S", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.174, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "T", "mutation": "G352T", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.861, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "V", "mutation": "G352V", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.464, "ferret_sera_escape": null, "mature_H5_site": 352, "mouse_sera_escape": null, "mutant": "W", "mutation": "G352W", "reference_site": "352", "region": "HA2", "sequential_site": 368, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y353A", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.809, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y353C", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.84, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y353D", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y353E", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.3944, "ferret_sera_escape": -0.1563, "mature_H5_site": 353, "mouse_sera_escape": 0.06587, "mutant": "F", "mutation": "Y353F", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": 0.07773, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.879, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y353G", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y353H", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.011, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y353I", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.796, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y353K", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.842, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y353L", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.008, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y353N", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y353P", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.021, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y353Q", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y353R", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.123, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y353T", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 353, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y353V", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.5176, "ferret_sera_escape": -0.1742, "mature_H5_site": 353, "mouse_sera_escape": -0.1603, "mutant": "W", "mutation": "Y353W", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": 0.09595, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 353, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y353Y", "reference_site": "353", "region": "HA2", "sequential_site": 369, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.073, "ferret_sera_escape": null, "mature_H5_site": 354, "mouse_sera_escape": null, "mutant": "D", "mutation": "H354D", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.112, "ferret_sera_escape": null, "mature_H5_site": 354, "mouse_sera_escape": null, "mutant": "E", "mutation": "H354E", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.611, "ferret_sera_escape": -0.02329, "mature_H5_site": 354, "mouse_sera_escape": -0.07132, "mutant": "F", "mutation": "H354F", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": 0.05642, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.708, "ferret_sera_escape": null, "mature_H5_site": 354, "mouse_sera_escape": null, "mutant": "G", "mutation": "H354G", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 354, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H354H", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 354, "mouse_sera_escape": null, "mutant": "I", "mutation": "H354I", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": null, "wildtype": "H"}, {"a26_usage": 0.2113, "cell_entry": -0.2202, "ferret_sera_escape": -0.1071, "mature_H5_site": 354, "mouse_sera_escape": 0.03737, "mutant": "K", "mutation": "H354K", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": 0.01965, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.059, "ferret_sera_escape": 0.01448, "mature_H5_site": 354, "mouse_sera_escape": -0.1834, "mutant": "L", "mutation": "H354L", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": -0.1188, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1193, "ferret_sera_escape": -0.0501, "mature_H5_site": 354, "mouse_sera_escape": -0.06029, "mutant": "M", "mutation": "H354M", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": -0.1061, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.111, "ferret_sera_escape": null, "mature_H5_site": 354, "mouse_sera_escape": null, "mutant": "N", "mutation": "H354N", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1964, "ferret_sera_escape": 0.03885, "mature_H5_site": 354, "mouse_sera_escape": -0.0295, "mutant": "R", "mutation": "H354R", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": -0.03999, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.000995, "ferret_sera_escape": 0.1017, "mature_H5_site": 354, "mouse_sera_escape": -0.01624, "mutant": "S", "mutation": "H354S", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": 0.05372, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.219, "ferret_sera_escape": null, "mature_H5_site": 354, "mouse_sera_escape": null, "mutant": "T", "mutation": "H354T", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.499, "ferret_sera_escape": null, "mature_H5_site": 354, "mouse_sera_escape": null, "mutant": "V", "mutation": "H354V", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.544, "ferret_sera_escape": -0.0024, "mature_H5_site": 354, "mouse_sera_escape": 0.05739, "mutant": "W", "mutation": "H354W", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": 0.3456, "wildtype": "H"}, {"a26_usage": 0.5957, "cell_entry": -1.301, "ferret_sera_escape": -0.1255, "mature_H5_site": 354, "mouse_sera_escape": 0.08556, "mutant": "Y", "mutation": "H354Y", "reference_site": "354", "region": "HA2", "sequential_site": 370, "stability": 0.3825, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3039, "ferret_sera_escape": 0.08185, "mature_H5_site": 355, "mouse_sera_escape": 0.0981, "mutant": "A", "mutation": "H355A", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.01466, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.96, "ferret_sera_escape": null, "mature_H5_site": 355, "mouse_sera_escape": null, "mutant": "D", "mutation": "H355D", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.841, "ferret_sera_escape": 0.01615, "mature_H5_site": 355, "mouse_sera_escape": null, "mutant": "E", "mutation": "H355E", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.263, "ferret_sera_escape": -0.07255, "mature_H5_site": 355, "mouse_sera_escape": 0.02947, "mutant": "F", "mutation": "H355F", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.2703, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.36, "ferret_sera_escape": null, "mature_H5_site": 355, "mouse_sera_escape": null, "mutant": "G", "mutation": "H355G", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 355, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H355H", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.333, "ferret_sera_escape": null, "mature_H5_site": 355, "mouse_sera_escape": null, "mutant": "I", "mutation": "H355I", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1826, "ferret_sera_escape": -0.06984, "mature_H5_site": 355, "mouse_sera_escape": -0.002164, "mutant": "L", "mutation": "H355L", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.003531, "wildtype": "H"}, {"a26_usage": 0.3416, "cell_entry": -0.6519, "ferret_sera_escape": -0.06324, "mature_H5_site": 355, "mouse_sera_escape": -0.02043, "mutant": "M", "mutation": "H355M", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.3372, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.829, "ferret_sera_escape": null, "mature_H5_site": 355, "mouse_sera_escape": null, "mutant": "N", "mutation": "H355N", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5116, "ferret_sera_escape": null, "mature_H5_site": 355, "mouse_sera_escape": null, "mutant": "Q", "mutation": "H355Q", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.856, "ferret_sera_escape": null, "mature_H5_site": 355, "mouse_sera_escape": null, "mutant": "R", "mutation": "H355R", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.2482, "ferret_sera_escape": 0.01786, "mature_H5_site": 355, "mouse_sera_escape": -0.1041, "mutant": "S", "mutation": "H355S", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.006645, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3129, "ferret_sera_escape": 0.07551, "mature_H5_site": 355, "mouse_sera_escape": 0.2832, "mutant": "V", "mutation": "H355V", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.1214, "wildtype": "H"}, {"a26_usage": 0.4866, "cell_entry": -1.204, "ferret_sera_escape": -0.03437, "mature_H5_site": 355, "mouse_sera_escape": -0.06402, "mutant": "Y", "mutation": "H355Y", "reference_site": "355", "region": "HA2", "sequential_site": 371, "stability": 0.3516, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.06263, "ferret_sera_escape": 0.01766, "mature_H5_site": 356, "mouse_sera_escape": -0.06233, "mutant": "C", "mutation": "S356C", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": 0.03091, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1314, "ferret_sera_escape": 0.1128, "mature_H5_site": 356, "mouse_sera_escape": 0.02575, "mutant": "D", "mutation": "S356D", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.01744, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1531, "ferret_sera_escape": -0.1091, "mature_H5_site": 356, "mouse_sera_escape": -0.08542, "mutant": "E", "mutation": "S356E", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": 0.01262, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.07867, "ferret_sera_escape": -0.1223, "mature_H5_site": 356, "mouse_sera_escape": -0.02076, "mutant": "F", "mutation": "S356F", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.04711, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.046, "ferret_sera_escape": null, "mature_H5_site": 356, "mouse_sera_escape": null, "mutant": "G", "mutation": "S356G", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6692, "ferret_sera_escape": 0.07158, "mature_H5_site": 356, "mouse_sera_escape": -0.05984, "mutant": "H", "mutation": "S356H", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.1201, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1908, "ferret_sera_escape": 0.1265, "mature_H5_site": 356, "mouse_sera_escape": 0.1201, "mutant": "I", "mutation": "S356I", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.05106, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2403, "ferret_sera_escape": -0.0182, "mature_H5_site": 356, "mouse_sera_escape": -0.06309, "mutant": "K", "mutation": "S356K", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.0792, "wildtype": "S"}, {"a26_usage": 0.06793, "cell_entry": 0.07318, "ferret_sera_escape": -0.08667, "mature_H5_site": 356, "mouse_sera_escape": -0.09902, "mutant": "L", "mutation": "S356L", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.05135, "wildtype": "S"}, {"a26_usage": 0.6651, "cell_entry": -0.1524, "ferret_sera_escape": 0.07735, "mature_H5_site": 356, "mouse_sera_escape": 0.08511, "mutant": "M", "mutation": "S356M", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.008623, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3316, "ferret_sera_escape": -0.02389, "mature_H5_site": 356, "mouse_sera_escape": 0.01859, "mutant": "N", "mutation": "S356N", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.04972, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.877, "ferret_sera_escape": null, "mature_H5_site": 356, "mouse_sera_escape": null, "mutant": "P", "mutation": "S356P", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": null, "wildtype": "S"}, {"a26_usage": 0.02285, "cell_entry": 0.07727, "ferret_sera_escape": 5.933e-05, "mature_H5_site": 356, "mouse_sera_escape": null, "mutant": "Q", "mutation": "S356Q", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": 0.04096, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1829, "ferret_sera_escape": -0.02246, "mature_H5_site": 356, "mouse_sera_escape": 0.06302, "mutant": "R", "mutation": "S356R", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.08338, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 356, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S356S", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.04664, "ferret_sera_escape": 0.07652, "mature_H5_site": 356, "mouse_sera_escape": null, "mutant": "T", "mutation": "S356T", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.04194, "ferret_sera_escape": 0.01321, "mature_H5_site": 356, "mouse_sera_escape": -0.02344, "mutant": "V", "mutation": "S356V", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.02199, "wildtype": "S"}, {"a26_usage": 0.02423, "cell_entry": -0.5616, "ferret_sera_escape": -0.02143, "mature_H5_site": 356, "mouse_sera_escape": 0.05127, "mutant": "W", "mutation": "S356W", "reference_site": "356", "region": "HA2", "sequential_site": 372, "stability": -0.06401, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.416, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "C", "mutation": "N357C", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "D", "mutation": "N357D", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.045, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "E", "mutation": "N357E", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "F", "mutation": "N357F", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -6.034, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "G", "mutation": "N357G", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "H", "mutation": "N357H", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "K", "mutation": "N357K", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "M", "mutation": "N357M", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 357, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N357N", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.83, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "P", "mutation": "N357P", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N357Q", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "R", "mutation": "N357R", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.835, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "V", "mutation": "N357V", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 357, "mouse_sera_escape": null, "mutant": "W", "mutation": "N357W", "reference_site": "357", "region": "HA2", "sequential_site": 373, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1878, "ferret_sera_escape": -0.03242, "mature_H5_site": 358, "mouse_sera_escape": 0.07868, "mutant": "C", "mutation": "E358C", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.08506, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01101, "ferret_sera_escape": 0.1111, "mature_H5_site": 358, "mouse_sera_escape": 0.003017, "mutant": "D", "mutation": "E358D", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": 0.04012, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 358, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E358E", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.04931, "cell_entry": -0.3746, "ferret_sera_escape": -0.1836, "mature_H5_site": 358, "mouse_sera_escape": -0.05146, "mutant": "G", "mutation": "E358G", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.01586, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3734, "ferret_sera_escape": 0.05369, "mature_H5_site": 358, "mouse_sera_escape": 0.02814, "mutant": "I", "mutation": "E358I", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.07273, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.208, "ferret_sera_escape": -0.05264, "mature_H5_site": 358, "mouse_sera_escape": 0.1705, "mutant": "K", "mutation": "E358K", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2666, "ferret_sera_escape": -0.0159, "mature_H5_site": 358, "mouse_sera_escape": 0.025, "mutant": "L", "mutation": "E358L", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.06603, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07484, "ferret_sera_escape": 0.006067, "mature_H5_site": 358, "mouse_sera_escape": 0.029, "mutant": "N", "mutation": "E358N", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.0468, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.448, "ferret_sera_escape": null, "mature_H5_site": 358, "mouse_sera_escape": null, "mutant": "P", "mutation": "E358P", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": null, "wildtype": "E"}, {"a26_usage": 0.2992, "cell_entry": -0.2098, "ferret_sera_escape": 0.0355, "mature_H5_site": 358, "mouse_sera_escape": 0.09162, "mutant": "Q", "mutation": "E358Q", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.05344, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7569, "ferret_sera_escape": 0.001853, "mature_H5_site": 358, "mouse_sera_escape": 0.08439, "mutant": "S", "mutation": "E358S", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": 0.03684, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07576, "ferret_sera_escape": -0.02942, "mature_H5_site": 358, "mouse_sera_escape": 0.08005, "mutant": "T", "mutation": "E358T", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.07702, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07242, "ferret_sera_escape": 0.2163, "mature_H5_site": 358, "mouse_sera_escape": 0.05785, "mutant": "V", "mutation": "E358V", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": -0.03558, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.351, "ferret_sera_escape": -0.3226, "mature_H5_site": 358, "mouse_sera_escape": 0.03627, "mutant": "W", "mutation": "E358W", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.068, "ferret_sera_escape": -0.1213, "mature_H5_site": 358, "mouse_sera_escape": -0.05259, "mutant": "Y", "mutation": "E358Y", "reference_site": "358", "region": "HA2", "sequential_site": 374, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.569, "ferret_sera_escape": -0.1038, "mature_H5_site": 359, "mouse_sera_escape": -0.06223, "mutant": "A", "mutation": "Q359A", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.04351, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.4672, "ferret_sera_escape": -0.08185, "mature_H5_site": 359, "mouse_sera_escape": 0.08863, "mutant": "D", "mutation": "Q359D", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.0729, "wildtype": "Q"}, {"a26_usage": 0.2017, "cell_entry": -0.04854, "ferret_sera_escape": -0.1104, "mature_H5_site": 359, "mouse_sera_escape": -0.04317, "mutant": "E", "mutation": "Q359E", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.06327, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.08376, "ferret_sera_escape": null, "mature_H5_site": 359, "mouse_sera_escape": null, "mutant": "F", "mutation": "Q359F", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1041, "ferret_sera_escape": null, "mature_H5_site": 359, "mouse_sera_escape": null, "mutant": "H", "mutation": "Q359H", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.04396, "ferret_sera_escape": -0.1358, "mature_H5_site": 359, "mouse_sera_escape": -0.06619, "mutant": "I", "mutation": "Q359I", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.08213, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.583, "ferret_sera_escape": 0.01606, "mature_H5_site": 359, "mouse_sera_escape": 0.2214, "mutant": "K", "mutation": "Q359K", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.07239, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.03834, "ferret_sera_escape": -0.02199, "mature_H5_site": 359, "mouse_sera_escape": -0.008382, "mutant": "L", "mutation": "Q359L", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.006579, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5241, "ferret_sera_escape": -0.03912, "mature_H5_site": 359, "mouse_sera_escape": -0.03865, "mutant": "M", "mutation": "Q359M", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.04058, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.733, "ferret_sera_escape": -0.1989, "mature_H5_site": 359, "mouse_sera_escape": 0.05975, "mutant": "N", "mutation": "Q359N", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.07098, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.212, "ferret_sera_escape": null, "mature_H5_site": 359, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q359P", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 359, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q359Q", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.8552, "ferret_sera_escape": -0.06253, "mature_H5_site": 359, "mouse_sera_escape": 0.1742, "mutant": "R", "mutation": "Q359R", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.1211, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 359, "mouse_sera_escape": null, "mutant": "S", "mutation": "Q359S", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 359, "mouse_sera_escape": null, "mutant": "T", "mutation": "Q359T", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.4509, "ferret_sera_escape": -0.1446, "mature_H5_site": 359, "mouse_sera_escape": 0.07644, "mutant": "V", "mutation": "Q359V", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.1256, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.05101, "ferret_sera_escape": -0.05613, "mature_H5_site": 359, "mouse_sera_escape": -0.0453, "mutant": "W", "mutation": "Q359W", "reference_site": "359", "region": "HA2", "sequential_site": 375, "stability": -0.006867, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.861, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "A", "mutation": "V36A", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.057, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "C", "mutation": "V36C", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -6.01, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "D", "mutation": "V36D", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "E", "mutation": "V36E", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "F", "mutation": "V36F", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "G", "mutation": "V36G", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2526, "ferret_sera_escape": 0.0471, "mature_H5_site": 26, "mouse_sera_escape": 0.06256, "mutant": "I", "mutation": "V36I", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": 0.0839, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.037, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "L", "mutation": "V36L", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.097, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "M", "mutation": "V36M", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.656, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "N", "mutation": "V36N", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.698, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "P", "mutation": "V36P", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V36Q", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.013, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "R", "mutation": "V36R", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "S", "mutation": "V36S", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "T", "mutation": "V36T", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 26, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V36V", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.054, "ferret_sera_escape": null, "mature_H5_site": 26, "mouse_sera_escape": null, "mutant": "W", "mutation": "V36W", "reference_site": "36", "region": "HA1", "sequential_site": 42, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.439, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "C", "mutation": "G360C", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "D", "mutation": "G360D", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.736, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "E", "mutation": "G360E", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 360, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G360G", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.819, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "H", "mutation": "G360H", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.426, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "I", "mutation": "G360I", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "K", "mutation": "G360K", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "L", "mutation": "G360L", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.671, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "N", "mutation": "G360N", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "P", "mutation": "G360P", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.399, "ferret_sera_escape": 0.0826, "mature_H5_site": 360, "mouse_sera_escape": 0.1499, "mutant": "S", "mutation": "G360S", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": -0.1955, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.579, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "T", "mutation": "G360T", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.821, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "V", "mutation": "G360V", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.355, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "W", "mutation": "G360W", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.644, "ferret_sera_escape": null, "mature_H5_site": 360, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G360Y", "reference_site": "360", "region": "HA2", "sequential_site": 376, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.023, "ferret_sera_escape": -0.07388, "mature_H5_site": 361, "mouse_sera_escape": 0.2368, "mutant": "C", "mutation": "S361C", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4424, "ferret_sera_escape": -0.1076, "mature_H5_site": 361, "mouse_sera_escape": -0.07331, "mutant": "D", "mutation": "S361D", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.1099, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -0.03728, "ferret_sera_escape": null, "mature_H5_site": 361, "mouse_sera_escape": null, "mutant": "E", "mutation": "S361E", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3236, "ferret_sera_escape": -0.05186, "mature_H5_site": 361, "mouse_sera_escape": -0.02692, "mutant": "F", "mutation": "S361F", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.08057, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06629, "ferret_sera_escape": -0.07656, "mature_H5_site": 361, "mouse_sera_escape": 0.06053, "mutant": "H", "mutation": "S361H", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.0749, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2004, "ferret_sera_escape": 0.08013, "mature_H5_site": 361, "mouse_sera_escape": 0.0446, "mutant": "I", "mutation": "S361I", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.081, "ferret_sera_escape": 0.1506, "mature_H5_site": 361, "mouse_sera_escape": 0.202, "mutant": "K", "mutation": "S361K", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.01333, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.347, "ferret_sera_escape": -0.2355, "mature_H5_site": 361, "mouse_sera_escape": 0.09728, "mutant": "L", "mutation": "S361L", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.2056, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.05795, "ferret_sera_escape": 0.02898, "mature_H5_site": 361, "mouse_sera_escape": -0.0422, "mutant": "M", "mutation": "S361M", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.1828, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.828, "ferret_sera_escape": -0.009977, "mature_H5_site": 361, "mouse_sera_escape": 0.07156, "mutant": "N", "mutation": "S361N", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.838, "ferret_sera_escape": null, "mature_H5_site": 361, "mouse_sera_escape": null, "mutant": "P", "mutation": "S361P", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2279, "ferret_sera_escape": 0.05282, "mature_H5_site": 361, "mouse_sera_escape": 0.02891, "mutant": "Q", "mutation": "S361Q", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.03773, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1748, "ferret_sera_escape": -0.01043, "mature_H5_site": 361, "mouse_sera_escape": 0.1473, "mutant": "R", "mutation": "S361R", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.1152, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 361, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S361S", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.0247, "ferret_sera_escape": -0.02651, "mature_H5_site": 361, "mouse_sera_escape": 0.005695, "mutant": "T", "mutation": "S361T", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.05898, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06492, "ferret_sera_escape": -0.09316, "mature_H5_site": 361, "mouse_sera_escape": -0.001487, "mutant": "V", "mutation": "S361V", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.07866, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.05194, "ferret_sera_escape": 0.121, "mature_H5_site": 361, "mouse_sera_escape": -0.01399, "mutant": "W", "mutation": "S361W", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.06712, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1629, "ferret_sera_escape": -0.02559, "mature_H5_site": 361, "mouse_sera_escape": 0.03064, "mutant": "Y", "mutation": "S361Y", "reference_site": "361", "region": "HA2", "sequential_site": 377, "stability": -0.1157, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.02103, "ferret_sera_escape": null, "mature_H5_site": 362, "mouse_sera_escape": null, "mutant": "A", "mutation": "G362A", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.9292, "ferret_sera_escape": -0.1088, "mature_H5_site": 362, "mouse_sera_escape": 0.06967, "mutant": "C", "mutation": "G362C", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": -0.01388, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7029, "ferret_sera_escape": -0.06603, "mature_H5_site": 362, "mouse_sera_escape": -0.1159, "mutant": "D", "mutation": "G362D", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": -0.1153, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.182, "ferret_sera_escape": -0.05039, "mature_H5_site": 362, "mouse_sera_escape": 0.2541, "mutant": "E", "mutation": "G362E", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": -0.005209, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.253, "ferret_sera_escape": -0.184, "mature_H5_site": 362, "mouse_sera_escape": 0.2772, "mutant": "F", "mutation": "G362F", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.02233, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 362, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G362G", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5714, "ferret_sera_escape": -0.3031, "mature_H5_site": 362, "mouse_sera_escape": 0.1726, "mutant": "H", "mutation": "G362H", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": -0.03617, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.314, "ferret_sera_escape": 0.05769, "mature_H5_site": 362, "mouse_sera_escape": 0.353, "mutant": "I", "mutation": "G362I", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.04043, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.322, "ferret_sera_escape": -0.0817, "mature_H5_site": 362, "mouse_sera_escape": 0.1892, "mutant": "K", "mutation": "G362K", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.03723, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3178, "ferret_sera_escape": -0.2008, "mature_H5_site": 362, "mouse_sera_escape": 0.09079, "mutant": "M", "mutation": "G362M", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.09489, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.336, "ferret_sera_escape": -0.1296, "mature_H5_site": 362, "mouse_sera_escape": 0.178, "mutant": "N", "mutation": "G362N", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": -0.02992, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.598, "ferret_sera_escape": null, "mature_H5_site": 362, "mouse_sera_escape": null, "mutant": "P", "mutation": "G362P", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7936, "ferret_sera_escape": -0.01014, "mature_H5_site": 362, "mouse_sera_escape": 0.2009, "mutant": "Q", "mutation": "G362Q", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.1408, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7424, "ferret_sera_escape": -0.02258, "mature_H5_site": 362, "mouse_sera_escape": 0.1859, "mutant": "R", "mutation": "G362R", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.1115, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.03737, "ferret_sera_escape": 0.04514, "mature_H5_site": 362, "mouse_sera_escape": 0.134, "mutant": "S", "mutation": "G362S", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.0009184, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.261, "ferret_sera_escape": null, "mature_H5_site": 362, "mouse_sera_escape": null, "mutant": "T", "mutation": "G362T", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.421, "ferret_sera_escape": -0.215, "mature_H5_site": 362, "mouse_sera_escape": 0.2141, "mutant": "V", "mutation": "G362V", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": 0.04874, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.339, "ferret_sera_escape": -0.2891, "mature_H5_site": 362, "mouse_sera_escape": 0.02598, "mutant": "W", "mutation": "G362W", "reference_site": "362", "region": "HA2", "sequential_site": 378, "stability": -0.03231, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.841, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y363D", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.009, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y363G", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.171, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y363H", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.616, "ferret_sera_escape": 0.02437, "mature_H5_site": 363, "mouse_sera_escape": 0.2549, "mutant": "I", "mutation": "Y363I", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": -0.1759, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y363K", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.219, "ferret_sera_escape": -0.02104, "mature_H5_site": 363, "mouse_sera_escape": 0.1856, "mutant": "M", "mutation": "Y363M", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": -0.2342, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.654, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y363N", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y363P", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.357, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y363Q", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y363R", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y363S", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y363T", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.777, "ferret_sera_escape": null, "mature_H5_site": 363, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y363V", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6294, "ferret_sera_escape": -0.2013, "mature_H5_site": 363, "mouse_sera_escape": -0.08164, "mutant": "W", "mutation": "Y363W", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": -0.2114, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 363, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y363Y", "reference_site": "363", "region": "HA2", "sequential_site": 379, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 364, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A364A", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.161, "ferret_sera_escape": -0.08006, "mature_H5_site": 364, "mouse_sera_escape": -0.085, "mutant": "C", "mutation": "A364C", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.418, "ferret_sera_escape": null, "mature_H5_site": 364, "mouse_sera_escape": null, "mutant": "D", "mutation": "A364D", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.728, "ferret_sera_escape": null, "mature_H5_site": 364, "mouse_sera_escape": null, "mutant": "E", "mutation": "A364E", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.474, "ferret_sera_escape": null, "mature_H5_site": 364, "mouse_sera_escape": null, "mutant": "F", "mutation": "A364F", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.33, "ferret_sera_escape": -0.02686, "mature_H5_site": 364, "mouse_sera_escape": 0.1658, "mutant": "G", "mutation": "A364G", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": -0.07853, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.359, "ferret_sera_escape": -0.3084, "mature_H5_site": 364, "mouse_sera_escape": 0.1401, "mutant": "I", "mutation": "A364I", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": 0.1392, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.564, "ferret_sera_escape": null, "mature_H5_site": 364, "mouse_sera_escape": null, "mutant": "K", "mutation": "A364K", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.9535, "ferret_sera_escape": -0.05472, "mature_H5_site": 364, "mouse_sera_escape": 0.2242, "mutant": "M", "mutation": "A364M", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": 0.003595, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.87, "ferret_sera_escape": null, "mature_H5_site": 364, "mouse_sera_escape": null, "mutant": "N", "mutation": "A364N", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 364, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A364Q", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.06152, "cell_entry": -0.1324, "ferret_sera_escape": 0.2671, "mature_H5_site": 364, "mouse_sera_escape": 0.06395, "mutant": "S", "mutation": "A364S", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": 0.00583, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.18, "ferret_sera_escape": -0.122, "mature_H5_site": 364, "mouse_sera_escape": 0.05024, "mutant": "T", "mutation": "A364T", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": 0.2339, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.008, "ferret_sera_escape": 0.01409, "mature_H5_site": 364, "mouse_sera_escape": -0.005255, "mutant": "V", "mutation": "A364V", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": 0.05338, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.627, "ferret_sera_escape": null, "mature_H5_site": 364, "mouse_sera_escape": null, "mutant": "W", "mutation": "A364W", "reference_site": "364", "region": "HA2", "sequential_site": 380, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 365, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A365A", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.926, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "D", "mutation": "A365D", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "E", "mutation": "A365E", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.954, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "F", "mutation": "A365F", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.907, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "H", "mutation": "A365H", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.735, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "I", "mutation": "A365I", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.827, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "K", "mutation": "A365K", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.529, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "L", "mutation": "A365L", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.362, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "M", "mutation": "A365M", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.832, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "N", "mutation": "A365N", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.975, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A365Q", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.757, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "R", "mutation": "A365R", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.295, "cell_entry": -0.1733, "ferret_sera_escape": 0.07661, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "S", "mutation": "A365S", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.175, "ferret_sera_escape": 0.2766, "mature_H5_site": 365, "mouse_sera_escape": 0.6934, "mutant": "T", "mutation": "A365T", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": -0.2564, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.354, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "V", "mutation": "A365V", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 365, "mouse_sera_escape": null, "mutant": "W", "mutation": "A365W", "reference_site": "365", "region": "HA2", "sequential_site": 381, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1232, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "A", "mutation": "D366A", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1671, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "C", "mutation": "D366C", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 366, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D366D", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.955, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "F", "mutation": "D366F", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.06, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "G", "mutation": "D366G", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.1073, "cell_entry": 0.00462, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "H", "mutation": "D366H", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.09276, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "N", "mutation": "D366N", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.944, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "P", "mutation": "D366P", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.1562, "cell_entry": -0.1119, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "R", "mutation": "D366R", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.9413, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "S", "mutation": "D366S", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.288, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "T", "mutation": "D366T", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.009, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "V", "mutation": "D366V", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.442, "ferret_sera_escape": null, "mature_H5_site": 366, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D366Y", "reference_site": "366", "region": "HA2", "sequential_site": 382, "stability": null, "wildtype": "D"}, {"a26_usage": 0.1684, "cell_entry": -0.876, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "A", "mutation": "K367A", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.06172, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "E", "mutation": "K367E", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": null, "cell_entry": -0.1276, "ferret_sera_escape": 0.1757, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "I", "mutation": "K367I", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 367, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K367K", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.298, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "L", "mutation": "K367L", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.9462, "cell_entry": -0.2492, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "M", "mutation": "K367M", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2832, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "N", "mutation": "K367N", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.248, "ferret_sera_escape": -0.2695, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "P", "mutation": "K367P", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03098, "ferret_sera_escape": 0.1326, "mature_H5_site": 367, "mouse_sera_escape": 0.02126, "mutant": "Q", "mutation": "K367Q", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3132, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "R", "mutation": "K367R", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.7208, "cell_entry": -4.048, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "S", "mutation": "K367S", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.23, "cell_entry": -0.8258, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "T", "mutation": "K367T", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": null, "cell_entry": 0.01182, "ferret_sera_escape": null, "mature_H5_site": 367, "mouse_sera_escape": null, "mutant": "W", "mutation": "K367W", "reference_site": "367", "region": "HA2", "sequential_site": 383, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.00256, "ferret_sera_escape": null, "mature_H5_site": 368, "mouse_sera_escape": null, "mutant": "D", "mutation": "E368D", "reference_site": "368", "region": "HA2", "sequential_site": 384, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 368, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E368E", "reference_site": "368", "region": "HA2", "sequential_site": 384, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2061, "ferret_sera_escape": -0.01226, "mature_H5_site": 368, "mouse_sera_escape": -0.06088, "mutant": "G", "mutation": "E368G", "reference_site": "368", "region": "HA2", "sequential_site": 384, "stability": -0.03281, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.00354, "ferret_sera_escape": -0.004617, "mature_H5_site": 368, "mouse_sera_escape": -0.03037, "mutant": "K", "mutation": "E368K", "reference_site": "368", "region": "HA2", "sequential_site": 384, "stability": -0.1331, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1272, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "A", "mutation": "S369A", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1512, "ferret_sera_escape": -0.03363, "mature_H5_site": 369, "mouse_sera_escape": -0.07967, "mutant": "C", "mutation": "S369C", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": -0.02221, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.613, "ferret_sera_escape": -0.191, "mature_H5_site": 369, "mouse_sera_escape": -0.0338, "mutant": "D", "mutation": "S369D", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.01033, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "E", "mutation": "S369E", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 1.814, "cell_entry": -1.502, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "F", "mutation": "S369F", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.06606, "ferret_sera_escape": -0.1719, "mature_H5_site": 369, "mouse_sera_escape": 0.03938, "mutant": "G", "mutation": "S369G", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": -0.1264, "wildtype": "S"}, {"a26_usage": 0.1978, "cell_entry": -1.536, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "I", "mutation": "S369I", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4442, "ferret_sera_escape": 0.02305, "mature_H5_site": 369, "mouse_sera_escape": 0.414, "mutant": "L", "mutation": "S369L", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.18, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "N", "mutation": "S369N", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.577, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "P", "mutation": "S369P", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4384, "ferret_sera_escape": 0.01371, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "R", "mutation": "S369R", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 369, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S369S", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.963, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "T", "mutation": "S369T", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.653, "ferret_sera_escape": 0.3821, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "V", "mutation": "S369V", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.721, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "W", "mutation": "S369W", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4119, "ferret_sera_escape": null, "mature_H5_site": 369, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S369Y", "reference_site": "369", "region": "HA2", "sequential_site": 385, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "A", "mutation": "T37A", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.748, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "C", "mutation": "T37C", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "D", "mutation": "T37D", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "E", "mutation": "T37E", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "F", "mutation": "T37F", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.325, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "G", "mutation": "T37G", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "H", "mutation": "T37H", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.867, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "I", "mutation": "T37I", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "K", "mutation": "T37K", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "L", "mutation": "T37L", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.034, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "M", "mutation": "T37M", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": null, "cell_entry": -2.751, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "N", "mutation": "T37N", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.72, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "P", "mutation": "T37P", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.575, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "S", "mutation": "T37S", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 27, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T37T", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.158, "ferret_sera_escape": null, "mature_H5_site": 27, "mouse_sera_escape": null, "mutant": "W", "mutation": "T37W", "reference_site": "37", "region": "HA1", "sequential_site": 43, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.802, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "A", "mutation": "T370A", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.494, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "C", "mutation": "T370C", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "D", "mutation": "T370D", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.726, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "E", "mutation": "T370E", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "F", "mutation": "T370F", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "G", "mutation": "T370G", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.121, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "H", "mutation": "T370H", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "I", "mutation": "T370I", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.483, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "K", "mutation": "T370K", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "L", "mutation": "T370L", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.871, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "M", "mutation": "T370M", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "N", "mutation": "T370N", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "P", "mutation": "T370P", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.848, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T370Q", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.879, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "R", "mutation": "T370R", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.01304, "ferret_sera_escape": -0.03962, "mature_H5_site": 370, "mouse_sera_escape": -0.00353, "mutant": "S", "mutation": "T370S", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": -0.2099, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 370, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T370T", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.667, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "V", "mutation": "T370V", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "W", "mutation": "T370W", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.849, "ferret_sera_escape": null, "mature_H5_site": 370, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T370Y", "reference_site": "370", "region": "HA2", "sequential_site": 386, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.07425, "ferret_sera_escape": -0.08653, "mature_H5_site": 371, "mouse_sera_escape": 0.1046, "mutant": "A", "mutation": "Q371A", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.1655, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.419, "ferret_sera_escape": null, "mature_H5_site": 371, "mouse_sera_escape": null, "mutant": "C", "mutation": "Q371C", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.769, "ferret_sera_escape": -0.08981, "mature_H5_site": 371, "mouse_sera_escape": 0.1489, "mutant": "D", "mutation": "Q371D", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.1421, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2286, "ferret_sera_escape": -0.1642, "mature_H5_site": 371, "mouse_sera_escape": 0.03427, "mutant": "E", "mutation": "Q371E", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.06881, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 371, "mouse_sera_escape": null, "mutant": "F", "mutation": "Q371F", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5295, "ferret_sera_escape": -0.2519, "mature_H5_site": 371, "mouse_sera_escape": 0.02748, "mutant": "G", "mutation": "Q371G", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.023, "ferret_sera_escape": null, "mature_H5_site": 371, "mouse_sera_escape": null, "mutant": "H", "mutation": "Q371H", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.143, "ferret_sera_escape": -0.02396, "mature_H5_site": 371, "mouse_sera_escape": 0.3547, "mutant": "I", "mutation": "Q371I", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.1476, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.69, "ferret_sera_escape": -0.02867, "mature_H5_site": 371, "mouse_sera_escape": 0.1413, "mutant": "K", "mutation": "Q371K", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.008556, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.734, "ferret_sera_escape": null, "mature_H5_site": 371, "mouse_sera_escape": null, "mutant": "L", "mutation": "Q371L", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.7269, "ferret_sera_escape": 0.05508, "mature_H5_site": 371, "mouse_sera_escape": 0.1042, "mutant": "M", "mutation": "Q371M", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.07456, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.01187, "ferret_sera_escape": 0.005164, "mature_H5_site": 371, "mouse_sera_escape": 0.04116, "mutant": "N", "mutation": "Q371N", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.09053, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 371, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q371P", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 371, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q371Q", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.411, "ferret_sera_escape": 0.1985, "mature_H5_site": 371, "mouse_sera_escape": 0.2459, "mutant": "R", "mutation": "Q371R", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2476, "ferret_sera_escape": -0.08532, "mature_H5_site": 371, "mouse_sera_escape": 0.04861, "mutant": "S", "mutation": "Q371S", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.1918, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.9552, "ferret_sera_escape": -0.03909, "mature_H5_site": 371, "mouse_sera_escape": 0.05093, "mutant": "T", "mutation": "Q371T", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": -0.149, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.256, "ferret_sera_escape": null, "mature_H5_site": 371, "mouse_sera_escape": null, "mutant": "V", "mutation": "Q371V", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.589, "ferret_sera_escape": null, "mature_H5_site": 371, "mouse_sera_escape": null, "mutant": "Y", "mutation": "Q371Y", "reference_site": "371", "region": "HA2", "sequential_site": 387, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.05935, "ferret_sera_escape": -0.09079, "mature_H5_site": 372, "mouse_sera_escape": -0.0709, "mutant": "A", "mutation": "K372A", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1635, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.06388, "ferret_sera_escape": -0.05973, "mature_H5_site": 372, "mouse_sera_escape": -0.0147, "mutant": "C", "mutation": "K372C", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1796, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.725, "ferret_sera_escape": null, "mature_H5_site": 372, "mouse_sera_escape": -0.1707, "mutant": "D", "mutation": "K372D", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.147, "ferret_sera_escape": -0.1683, "mature_H5_site": 372, "mouse_sera_escape": 0.04285, "mutant": "E", "mutation": "K372E", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1876, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5297, "ferret_sera_escape": -0.1184, "mature_H5_site": 372, "mouse_sera_escape": -0.03781, "mutant": "F", "mutation": "K372F", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1076, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4995, "ferret_sera_escape": -0.2319, "mature_H5_site": 372, "mouse_sera_escape": -0.09209, "mutant": "G", "mutation": "K372G", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1013, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3715, "ferret_sera_escape": 0.03925, "mature_H5_site": 372, "mouse_sera_escape": -0.05646, "mutant": "H", "mutation": "K372H", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1184, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2627, "ferret_sera_escape": null, "mature_H5_site": 372, "mouse_sera_escape": -0.05502, "mutant": "I", "mutation": "K372I", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 372, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K372K", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03692, "ferret_sera_escape": -0.03942, "mature_H5_site": 372, "mouse_sera_escape": -0.1493, "mutant": "L", "mutation": "K372L", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.2929, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5105, "ferret_sera_escape": -0.1472, "mature_H5_site": 372, "mouse_sera_escape": -0.03143, "mutant": "M", "mutation": "K372M", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.0184, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.04168, "ferret_sera_escape": -0.1502, "mature_H5_site": 372, "mouse_sera_escape": 0.0007795, "mutant": "N", "mutation": "K372N", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.3352, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.421, "ferret_sera_escape": null, "mature_H5_site": 372, "mouse_sera_escape": null, "mutant": "P", "mutation": "K372P", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.002069, "ferret_sera_escape": -0.09448, "mature_H5_site": 372, "mouse_sera_escape": -0.08272, "mutant": "Q", "mutation": "K372Q", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1763, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.02441, "ferret_sera_escape": -0.05219, "mature_H5_site": 372, "mouse_sera_escape": 0.01597, "mutant": "R", "mutation": "K372R", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.1229, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.02657, "ferret_sera_escape": null, "mature_H5_site": 372, "mouse_sera_escape": null, "mutant": "S", "mutation": "K372S", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1544, "ferret_sera_escape": 0.02241, "mature_H5_site": 372, "mouse_sera_escape": 0.03536, "mutant": "T", "mutation": "K372T", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.238, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5793, "ferret_sera_escape": null, "mature_H5_site": 372, "mouse_sera_escape": null, "mutant": "V", "mutation": "K372V", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2627, "ferret_sera_escape": 0.01271, "mature_H5_site": 372, "mouse_sera_escape": 0.02299, "mutant": "W", "mutation": "K372W", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": 0.7202, "wildtype": "K"}, {"a26_usage": 0.07052, "cell_entry": -0.1247, "ferret_sera_escape": -0.05016, "mature_H5_site": 372, "mouse_sera_escape": -0.05639, "mutant": "Y", "mutation": "K372Y", "reference_site": "372", "region": "HA2", "sequential_site": 388, "stability": -0.2332, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 373, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A373A", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.848, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "C", "mutation": "A373C", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "D", "mutation": "A373D", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.892, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "E", "mutation": "A373E", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "F", "mutation": "A373F", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.01648, "ferret_sera_escape": 0.01838, "mature_H5_site": 373, "mouse_sera_escape": 0.006231, "mutant": "G", "mutation": "A373G", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": 0.8378, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "H", "mutation": "A373H", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "K", "mutation": "A373K", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "L", "mutation": "A373L", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.367, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "M", "mutation": "A373M", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "N", "mutation": "A373N", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "P", "mutation": "A373P", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.87, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A373Q", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.806, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "R", "mutation": "A373R", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.542, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "S", "mutation": "A373S", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.028, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "T", "mutation": "A373T", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "V", "mutation": "A373V", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.594, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "W", "mutation": "A373W", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": null, "cell_entry": -5.87, "ferret_sera_escape": null, "mature_H5_site": 373, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A373Y", "reference_site": "373", "region": "HA2", "sequential_site": 389, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.059, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "C", "mutation": "I374C", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.318, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "D", "mutation": "I374D", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.02657, "cell_entry": -0.2379, "ferret_sera_escape": -0.02611, "mature_H5_site": 374, "mouse_sera_escape": 0.04862, "mutant": "F", "mutation": "I374F", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": -0.2311, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.904, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "G", "mutation": "I374G", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.44, "ferret_sera_escape": -0.09267, "mature_H5_site": 374, "mouse_sera_escape": 0.02047, "mutant": "H", "mutation": "I374H", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": -0.334, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 374, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I374I", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.875, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "K", "mutation": "I374K", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.05206, "ferret_sera_escape": 0.03999, "mature_H5_site": 374, "mouse_sera_escape": 0.02229, "mutant": "L", "mutation": "I374L", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": -0.2401, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.213, "ferret_sera_escape": -0.1007, "mature_H5_site": 374, "mouse_sera_escape": 0.2308, "mutant": "N", "mutation": "I374N", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": -0.3011, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.258, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "P", "mutation": "I374P", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.1133, "ferret_sera_escape": 0.001767, "mature_H5_site": 374, "mouse_sera_escape": 0.01013, "mutant": "Q", "mutation": "I374Q", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": -0.1075, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.87, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "R", "mutation": "I374R", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.072, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "S", "mutation": "I374S", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03099, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "T", "mutation": "I374T", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03036, "ferret_sera_escape": -0.0136, "mature_H5_site": 374, "mouse_sera_escape": -0.07489, "mutant": "V", "mutation": "I374V", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": -0.08675, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.412, "ferret_sera_escape": null, "mature_H5_site": 374, "mouse_sera_escape": null, "mutant": "W", "mutation": "I374W", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -0.2033, "ferret_sera_escape": -0.08111, "mature_H5_site": 374, "mouse_sera_escape": -0.06245, "mutant": "Y", "mutation": "I374Y", "reference_site": "374", "region": "HA2", "sequential_site": 390, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.169, "ferret_sera_escape": null, "mature_H5_site": 375, "mouse_sera_escape": null, "mutant": "A", "mutation": "D375A", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.064, "ferret_sera_escape": 0.02573, "mature_H5_site": 375, "mouse_sera_escape": 0.1217, "mutant": "C", "mutation": "D375C", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.1075, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 375, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D375D", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7386, "ferret_sera_escape": 0.002568, "mature_H5_site": 375, "mouse_sera_escape": -0.002979, "mutant": "E", "mutation": "D375E", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.07786, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7592, "ferret_sera_escape": -0.00759, "mature_H5_site": 375, "mouse_sera_escape": 0.1265, "mutant": "F", "mutation": "D375F", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.2911, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.01165, "ferret_sera_escape": -0.1019, "mature_H5_site": 375, "mouse_sera_escape": 0.03899, "mutant": "G", "mutation": "D375G", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.2, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3345, "ferret_sera_escape": -0.05913, "mature_H5_site": 375, "mouse_sera_escape": 0.06578, "mutant": "H", "mutation": "D375H", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.2788, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.9873, "ferret_sera_escape": 0.1535, "mature_H5_site": 375, "mouse_sera_escape": 0.2372, "mutant": "I", "mutation": "D375I", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.09736, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.27, "ferret_sera_escape": 0.2369, "mature_H5_site": 375, "mouse_sera_escape": 0.375, "mutant": "K", "mutation": "D375K", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.001408, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2831, "ferret_sera_escape": 0.2526, "mature_H5_site": 375, "mouse_sera_escape": 0.2816, "mutant": "L", "mutation": "D375L", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.03567, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8669, "ferret_sera_escape": 0.09393, "mature_H5_site": 375, "mouse_sera_escape": 0.01292, "mutant": "M", "mutation": "D375M", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.02772, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.01528, "ferret_sera_escape": 0.03182, "mature_H5_site": 375, "mouse_sera_escape": 0.02313, "mutant": "N", "mutation": "D375N", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.01576, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 375, "mouse_sera_escape": null, "mutant": "P", "mutation": "D375P", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.195, "ferret_sera_escape": 0.02062, "mature_H5_site": 375, "mouse_sera_escape": 0.1925, "mutant": "Q", "mutation": "D375Q", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.008504, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.206, "ferret_sera_escape": -0.0846, "mature_H5_site": 375, "mouse_sera_escape": 0.05213, "mutant": "R", "mutation": "D375R", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.02674, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1904, "ferret_sera_escape": -0.06669, "mature_H5_site": 375, "mouse_sera_escape": 0.0708, "mutant": "S", "mutation": "D375S", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.02383, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.289, "ferret_sera_escape": -0.02912, "mature_H5_site": 375, "mouse_sera_escape": -0.03268, "mutant": "T", "mutation": "D375T", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.2327, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.016, "ferret_sera_escape": -0.0354, "mature_H5_site": 375, "mouse_sera_escape": 0.1954, "mutant": "V", "mutation": "D375V", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.2796, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6915, "ferret_sera_escape": -0.01154, "mature_H5_site": 375, "mouse_sera_escape": -0.00228, "mutant": "W", "mutation": "D375W", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.298, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3159, "ferret_sera_escape": -0.1244, "mature_H5_site": 375, "mouse_sera_escape": -0.06397, "mutant": "Y", "mutation": "D375Y", "reference_site": "375", "region": "HA2", "sequential_site": 391, "stability": -0.2985, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.79, "ferret_sera_escape": 0.1893, "mature_H5_site": 376, "mouse_sera_escape": 0.1427, "mutant": "A", "mutation": "G376A", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": 0.04071, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3486, "ferret_sera_escape": 0.07596, "mature_H5_site": 376, "mouse_sera_escape": 0.05537, "mutant": "C", "mutation": "G376C", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": 0.1669, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.25, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "D", "mutation": "G376D", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.518, "ferret_sera_escape": -0.2168, "mature_H5_site": 376, "mouse_sera_escape": -0.01929, "mutant": "E", "mutation": "G376E", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": -0.3255, "wildtype": "G"}, {"a26_usage": 0.7482, "cell_entry": -1.242, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "F", "mutation": "G376F", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 376, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G376G", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8924, "ferret_sera_escape": 0.07721, "mature_H5_site": 376, "mouse_sera_escape": -0.08169, "mutant": "H", "mutation": "G376H", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": -0.1958, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "I", "mutation": "G376I", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7905, "ferret_sera_escape": 0.0526, "mature_H5_site": 376, "mouse_sera_escape": 0.02403, "mutant": "K", "mutation": "G376K", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": -0.1519, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.813, "ferret_sera_escape": 0.07487, "mature_H5_site": 376, "mouse_sera_escape": 0.188, "mutant": "L", "mutation": "G376L", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": 0.003357, "wildtype": "G"}, {"a26_usage": 2.006, "cell_entry": -2.567, "ferret_sera_escape": 0.1019, "mature_H5_site": 376, "mouse_sera_escape": -0.005341, "mutant": "M", "mutation": "G376M", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": 0.9232, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.184, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "N", "mutation": "G376N", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": -0.1205, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "P", "mutation": "G376P", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8916, "ferret_sera_escape": 0.0329, "mature_H5_site": 376, "mouse_sera_escape": 0.002529, "mutant": "Q", "mutation": "G376Q", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.103, "ferret_sera_escape": 0.08245, "mature_H5_site": 376, "mouse_sera_escape": -0.05001, "mutant": "R", "mutation": "G376R", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": -0.3027, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1824, "ferret_sera_escape": 0.03099, "mature_H5_site": 376, "mouse_sera_escape": 0.005389, "mutant": "S", "mutation": "G376S", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": -0.2601, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.009, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "T", "mutation": "G376T", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.988, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "V", "mutation": "G376V", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.891, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "W", "mutation": "G376W", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.738, "ferret_sera_escape": null, "mature_H5_site": 376, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G376Y", "reference_site": "376", "region": "HA2", "sequential_site": 392, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "A", "mutation": "V377A", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.938, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "C", "mutation": "V377C", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "D", "mutation": "V377D", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "E", "mutation": "V377E", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "F", "mutation": "V377F", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "G", "mutation": "V377G", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "H", "mutation": "V377H", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.735, "ferret_sera_escape": 0.08221, "mature_H5_site": 377, "mouse_sera_escape": 0.1457, "mutant": "I", "mutation": "V377I", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": 0.1484, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "K", "mutation": "V377K", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3085, "ferret_sera_escape": -0.04969, "mature_H5_site": 377, "mouse_sera_escape": -0.0641, "mutant": "L", "mutation": "V377L", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": -0.1373, "wildtype": "V"}, {"a26_usage": 0.0105, "cell_entry": 0.06978, "ferret_sera_escape": -0.04816, "mature_H5_site": 377, "mouse_sera_escape": -0.1009, "mutant": "M", "mutation": "V377M", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": -0.003665, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.991, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "N", "mutation": "V377N", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.047, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "P", "mutation": "V377P", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.435, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V377Q", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "R", "mutation": "V377R", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "S", "mutation": "V377S", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1386, "ferret_sera_escape": -0.07684, "mature_H5_site": 377, "mouse_sera_escape": -0.1912, "mutant": "T", "mutation": "V377T", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": 0.2277, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 377, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V377V", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "W", "mutation": "V377W", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.972, "ferret_sera_escape": null, "mature_H5_site": 377, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V377Y", "reference_site": "377", "region": "HA2", "sequential_site": 393, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1649, "ferret_sera_escape": -0.05614, "mature_H5_site": 378, "mouse_sera_escape": -0.05191, "mutant": "A", "mutation": "T378A", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.2339, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7997, "ferret_sera_escape": 0.1745, "mature_H5_site": 378, "mouse_sera_escape": 0.1387, "mutant": "C", "mutation": "T378C", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": 0.08122, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4491, "ferret_sera_escape": null, "mature_H5_site": 378, "mouse_sera_escape": null, "mutant": "D", "mutation": "T378D", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3271, "ferret_sera_escape": -0.07807, "mature_H5_site": 378, "mouse_sera_escape": -0.1958, "mutant": "E", "mutation": "T378E", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.1998, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.282, "ferret_sera_escape": -0.2605, "mature_H5_site": 378, "mouse_sera_escape": null, "mutant": "F", "mutation": "T378F", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.3682, "ferret_sera_escape": 0.03124, "mature_H5_site": 378, "mouse_sera_escape": -0.01197, "mutant": "I", "mutation": "T378I", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.1759, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4721, "ferret_sera_escape": null, "mature_H5_site": 378, "mouse_sera_escape": null, "mutant": "K", "mutation": "T378K", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.06678, "ferret_sera_escape": 0.05498, "mature_H5_site": 378, "mouse_sera_escape": null, "mutant": "L", "mutation": "T378L", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.08701, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.496, "ferret_sera_escape": -0.003803, "mature_H5_site": 378, "mouse_sera_escape": -0.08814, "mutant": "M", "mutation": "T378M", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.00125, "ferret_sera_escape": 0.1197, "mature_H5_site": 378, "mouse_sera_escape": 0.1095, "mutant": "N", "mutation": "T378N", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.02154, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 378, "mouse_sera_escape": null, "mutant": "P", "mutation": "T378P", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.03988, "ferret_sera_escape": 0.09374, "mature_H5_site": 378, "mouse_sera_escape": -0.002454, "mutant": "Q", "mutation": "T378Q", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.05409, "wildtype": "T"}, {"a26_usage": 0.183, "cell_entry": 0.02766, "ferret_sera_escape": 0.261, "mature_H5_site": 378, "mouse_sera_escape": 0.1591, "mutant": "R", "mutation": "T378R", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.09948, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.113, "ferret_sera_escape": -0.06396, "mature_H5_site": 378, "mouse_sera_escape": 0.01325, "mutant": "S", "mutation": "T378S", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.1873, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 378, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T378T", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.275, "ferret_sera_escape": -0.3814, "mature_H5_site": 378, "mouse_sera_escape": -0.1747, "mutant": "V", "mutation": "T378V", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.04362, "ferret_sera_escape": -0.1157, "mature_H5_site": 378, "mouse_sera_escape": -0.06045, "mutant": "Y", "mutation": "T378Y", "reference_site": "378", "region": "HA2", "sequential_site": 394, "stability": -0.1941, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.128, "ferret_sera_escape": -0.0873, "mature_H5_site": 379, "mouse_sera_escape": -0.07302, "mutant": "A", "mutation": "N379A", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.2441, "wildtype": "N"}, {"a26_usage": 0.07288, "cell_entry": 0.06038, "ferret_sera_escape": -0.1121, "mature_H5_site": 379, "mouse_sera_escape": 0.03061, "mutant": "C", "mutation": "N379C", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": 0.01986, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.904, "ferret_sera_escape": null, "mature_H5_site": 379, "mouse_sera_escape": null, "mutant": "D", "mutation": "N379D", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.167, "ferret_sera_escape": 0.00908, "mature_H5_site": 379, "mouse_sera_escape": 0.08496, "mutant": "E", "mutation": "N379E", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.2129, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.461, "ferret_sera_escape": -0.2607, "mature_H5_site": 379, "mouse_sera_escape": null, "mutant": "F", "mutation": "N379F", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.2711, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.857, "ferret_sera_escape": null, "mature_H5_site": 379, "mouse_sera_escape": null, "mutant": "G", "mutation": "N379G", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4054, "ferret_sera_escape": -0.1081, "mature_H5_site": 379, "mouse_sera_escape": -0.1095, "mutant": "H", "mutation": "N379H", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.256, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.567, "ferret_sera_escape": null, "mature_H5_site": 379, "mouse_sera_escape": null, "mutant": "K", "mutation": "N379K", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": null, "wildtype": "N"}, {"a26_usage": 0.1078, "cell_entry": -0.2277, "ferret_sera_escape": -0.1387, "mature_H5_site": 379, "mouse_sera_escape": 0.02888, "mutant": "M", "mutation": "N379M", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.6238, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 379, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N379N", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 379, "mouse_sera_escape": null, "mutant": "P", "mutation": "N379P", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1106, "ferret_sera_escape": 0.1692, "mature_H5_site": 379, "mouse_sera_escape": -0.009046, "mutant": "Q", "mutation": "N379Q", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.1142, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8377, "ferret_sera_escape": -0.002971, "mature_H5_site": 379, "mouse_sera_escape": 0.002575, "mutant": "S", "mutation": "N379S", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.2359, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4985, "ferret_sera_escape": 0.0167, "mature_H5_site": 379, "mouse_sera_escape": 0.0648, "mutant": "T", "mutation": "N379T", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.3502, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1851, "ferret_sera_escape": -0.1713, "mature_H5_site": 379, "mouse_sera_escape": -0.02247, "mutant": "V", "mutation": "N379V", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": -0.2744, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.242, "ferret_sera_escape": null, "mature_H5_site": 379, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N379Y", "reference_site": "379", "region": "HA2", "sequential_site": 395, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3828, "ferret_sera_escape": null, "mature_H5_site": 28, "mouse_sera_escape": null, "mutant": "C", "mutation": "H38C", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4376, "ferret_sera_escape": 0.1093, "mature_H5_site": 28, "mouse_sera_escape": 0.009816, "mutant": "D", "mutation": "H38D", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.06377, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.7857, "ferret_sera_escape": null, "mature_H5_site": 28, "mouse_sera_escape": null, "mutant": "E", "mutation": "H38E", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4315, "ferret_sera_escape": 0.07293, "mature_H5_site": 28, "mouse_sera_escape": 0.02962, "mutant": "G", "mutation": "H38G", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.7879, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 28, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H38H", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.311, "ferret_sera_escape": null, "mature_H5_site": 28, "mouse_sera_escape": null, "mutant": "I", "mutation": "H38I", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.05457, "ferret_sera_escape": 0.1288, "mature_H5_site": 28, "mouse_sera_escape": 0.0261, "mutant": "K", "mutation": "H38K", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.5803, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.8934, "ferret_sera_escape": 0.09786, "mature_H5_site": 28, "mouse_sera_escape": 0.02448, "mutant": "L", "mutation": "H38L", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.06623, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1058, "ferret_sera_escape": 0.187, "mature_H5_site": 28, "mouse_sera_escape": 0.08503, "mutant": "M", "mutation": "H38M", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.4301, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.1779, "ferret_sera_escape": 0.1144, "mature_H5_site": 28, "mouse_sera_escape": -0.02218, "mutant": "N", "mutation": "H38N", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.009514, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 28, "mouse_sera_escape": null, "mutant": "P", "mutation": "H38P", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": null, "wildtype": "H"}, {"a26_usage": 0.01952, "cell_entry": -0.1169, "ferret_sera_escape": 0.09371, "mature_H5_site": 28, "mouse_sera_escape": 0.01646, "mutant": "Q", "mutation": "H38Q", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.06745, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5789, "ferret_sera_escape": 0.06422, "mature_H5_site": 28, "mouse_sera_escape": -0.02068, "mutant": "R", "mutation": "H38R", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.8089, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.009455, "ferret_sera_escape": 0.07742, "mature_H5_site": 28, "mouse_sera_escape": 0.08129, "mutant": "S", "mutation": "H38S", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.8359, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3096, "ferret_sera_escape": null, "mature_H5_site": 28, "mouse_sera_escape": null, "mutant": "T", "mutation": "H38T", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.123, "ferret_sera_escape": 0.05121, "mature_H5_site": 28, "mouse_sera_escape": 0.01575, "mutant": "V", "mutation": "H38V", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": -0.08786, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.464, "ferret_sera_escape": 0.2835, "mature_H5_site": 28, "mouse_sera_escape": -0.07472, "mutant": "W", "mutation": "H38W", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 0.4911, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.5849, "ferret_sera_escape": 0.0608, "mature_H5_site": 28, "mouse_sera_escape": 0.09519, "mutant": "Y", "mutation": "H38Y", "reference_site": "38", "region": "HA1", "sequential_site": 44, "stability": 1.04, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.764, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "C", "mutation": "K380C", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "D", "mutation": "K380D", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.878, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "E", "mutation": "K380E", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "F", "mutation": "K380F", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.825, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "G", "mutation": "K380G", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "H", "mutation": "K380H", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.931, "ferret_sera_escape": 0.1045, "mature_H5_site": 380, "mouse_sera_escape": 0.02815, "mutant": "I", "mutation": "K380I", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": -0.05952, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 380, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K380K", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.889, "ferret_sera_escape": 0.1424, "mature_H5_site": 380, "mouse_sera_escape": 0.3108, "mutant": "L", "mutation": "K380L", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.23, "ferret_sera_escape": 0.03235, "mature_H5_site": 380, "mouse_sera_escape": 0.2446, "mutant": "M", "mutation": "K380M", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": 0.2599, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "N", "mutation": "K380N", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "P", "mutation": "K380P", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.585, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "Q", "mutation": "K380Q", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.494, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "R", "mutation": "K380R", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.657, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "S", "mutation": "K380S", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "T", "mutation": "K380T", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "W", "mutation": "K380W", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.356, "ferret_sera_escape": null, "mature_H5_site": 380, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K380Y", "reference_site": "380", "region": "HA2", "sequential_site": 396, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5301, "ferret_sera_escape": -0.0891, "mature_H5_site": 381, "mouse_sera_escape": -0.126, "mutant": "A", "mutation": "V381A", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": -0.3457, "wildtype": "V"}, {"a26_usage": 0.02138, "cell_entry": 0.06348, "ferret_sera_escape": -0.06401, "mature_H5_site": 381, "mouse_sera_escape": -0.02887, "mutant": "C", "mutation": "V381C", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": -0.2664, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "D", "mutation": "V381D", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.975, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "E", "mutation": "V381E", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.614, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "F", "mutation": "V381F", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.994, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "G", "mutation": "V381G", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.514, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "H", "mutation": "V381H", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.643, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "K", "mutation": "V381K", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6062, "ferret_sera_escape": -0.1018, "mature_H5_site": 381, "mouse_sera_escape": -0.0673, "mutant": "L", "mutation": "V381L", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": -0.2605, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7463, "ferret_sera_escape": -0.1506, "mature_H5_site": 381, "mouse_sera_escape": -0.01654, "mutant": "M", "mutation": "V381M", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": -0.281, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.886, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "N", "mutation": "V381N", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "P", "mutation": "V381P", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.674, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V381Q", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.742, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "R", "mutation": "V381R", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "S", "mutation": "V381S", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 381, "mouse_sera_escape": null, "mutant": "T", "mutation": "V381T", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 381, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V381V", "reference_site": "381", "region": "HA2", "sequential_site": 397, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.156, "ferret_sera_escape": null, "mature_H5_site": 382, "mouse_sera_escape": null, "mutant": "A", "mutation": "N382A", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.305, "ferret_sera_escape": null, "mature_H5_site": 382, "mouse_sera_escape": null, "mutant": "C", "mutation": "N382C", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02307, "ferret_sera_escape": -0.2049, "mature_H5_site": 382, "mouse_sera_escape": -0.02658, "mutant": "D", "mutation": "N382D", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.2057, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.459, "ferret_sera_escape": 0.01651, "mature_H5_site": 382, "mouse_sera_escape": 0.1738, "mutant": "E", "mutation": "N382E", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.24, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.942, "ferret_sera_escape": -0.08693, "mature_H5_site": 382, "mouse_sera_escape": null, "mutant": "F", "mutation": "N382F", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.393, "ferret_sera_escape": 0.1043, "mature_H5_site": 382, "mouse_sera_escape": 0.5642, "mutant": "H", "mutation": "N382H", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.04847, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7948, "ferret_sera_escape": -0.01629, "mature_H5_site": 382, "mouse_sera_escape": -0.01331, "mutant": "I", "mutation": "N382I", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.3108, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.231, "ferret_sera_escape": 0.1245, "mature_H5_site": 382, "mouse_sera_escape": 0.4179, "mutant": "K", "mutation": "N382K", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.198, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7235, "ferret_sera_escape": -0.007163, "mature_H5_site": 382, "mouse_sera_escape": 0.02517, "mutant": "L", "mutation": "N382L", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.248, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.557, "ferret_sera_escape": null, "mature_H5_site": 382, "mouse_sera_escape": null, "mutant": "M", "mutation": "N382M", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 382, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N382N", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 382, "mouse_sera_escape": null, "mutant": "P", "mutation": "N382P", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.003, "ferret_sera_escape": -0.04507, "mature_H5_site": 382, "mouse_sera_escape": 0.06608, "mutant": "Q", "mutation": "N382Q", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5337, "ferret_sera_escape": 0.02227, "mature_H5_site": 382, "mouse_sera_escape": 0.04442, "mutant": "R", "mutation": "N382R", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.05055, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.00319, "ferret_sera_escape": -0.04688, "mature_H5_site": 382, "mouse_sera_escape": -0.08796, "mutant": "S", "mutation": "N382S", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.2901, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1704, "ferret_sera_escape": 0.00514, "mature_H5_site": 382, "mouse_sera_escape": 0.04844, "mutant": "T", "mutation": "N382T", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.3569, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1851, "ferret_sera_escape": -0.1406, "mature_H5_site": 382, "mouse_sera_escape": 0.08735, "mutant": "V", "mutation": "N382V", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.5831, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.075, "ferret_sera_escape": -0.111, "mature_H5_site": 382, "mouse_sera_escape": 0.1002, "mutant": "W", "mutation": "N382W", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": -0.322, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.399, "ferret_sera_escape": null, "mature_H5_site": 382, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N382Y", "reference_site": "382", "region": "HA2", "sequential_site": 398, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.01306, "ferret_sera_escape": -0.08314, "mature_H5_site": 383, "mouse_sera_escape": 0.03095, "mutant": "A", "mutation": "S383A", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": 0.04929, "wildtype": "S"}, {"a26_usage": 0.3868, "cell_entry": -0.4896, "ferret_sera_escape": 0.007403, "mature_H5_site": 383, "mouse_sera_escape": 0.1208, "mutant": "C", "mutation": "S383C", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": -0.1818, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.796, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "D", "mutation": "S383D", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.7635, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "E", "mutation": "S383E", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.058, "ferret_sera_escape": 0.07427, "mature_H5_site": 383, "mouse_sera_escape": 0.1409, "mutant": "F", "mutation": "S383F", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": 0.08136, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.726, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "G", "mutation": "S383G", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.02006, "ferret_sera_escape": 0.1726, "mature_H5_site": 383, "mouse_sera_escape": 0.03486, "mutant": "H", "mutation": "S383H", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": 1.204, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.649, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "I", "mutation": "S383I", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.031, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "K", "mutation": "S383K", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.131, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "L", "mutation": "S383L", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.77, "ferret_sera_escape": 0.03278, "mature_H5_site": 383, "mouse_sera_escape": 0.1069, "mutant": "M", "mutation": "S383M", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": -0.4126, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3177, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "N", "mutation": "S383N", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "P", "mutation": "S383P", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1286, "ferret_sera_escape": -0.09028, "mature_H5_site": 383, "mouse_sera_escape": -0.03359, "mutant": "Q", "mutation": "S383Q", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": -0.03165, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.756, "ferret_sera_escape": 0.1995, "mature_H5_site": 383, "mouse_sera_escape": -0.0349, "mutant": "R", "mutation": "S383R", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 383, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S383S", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.592, "ferret_sera_escape": 0.1852, "mature_H5_site": 383, "mouse_sera_escape": 0.1778, "mutant": "T", "mutation": "S383T", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": 0.9713, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.876, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "V", "mutation": "S383V", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.24, "ferret_sera_escape": null, "mature_H5_site": 383, "mouse_sera_escape": null, "mutant": "W", "mutation": "S383W", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6387, "ferret_sera_escape": -0.01168, "mature_H5_site": 383, "mouse_sera_escape": 0.03235, "mutant": "Y", "mutation": "S383Y", "reference_site": "383", "region": "HA2", "sequential_site": 399, "stability": 0.03749, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "A", "mutation": "I384A", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.41, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "C", "mutation": "I384C", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.865, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "D", "mutation": "I384D", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.838, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "E", "mutation": "I384E", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "F", "mutation": "I384F", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.428, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "G", "mutation": "I384G", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 384, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I384I", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "K", "mutation": "I384K", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.08789, "ferret_sera_escape": -0.06528, "mature_H5_site": 384, "mouse_sera_escape": 0.05478, "mutant": "L", "mutation": "I384L", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": -0.2902, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.05531, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "M", "mutation": "I384M", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "N", "mutation": "I384N", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "P", "mutation": "I384P", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.812, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I384Q", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "R", "mutation": "I384R", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "S", "mutation": "I384S", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 384, "mouse_sera_escape": null, "mutant": "T", "mutation": "I384T", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.07887, "ferret_sera_escape": -0.01496, "mature_H5_site": 384, "mouse_sera_escape": 0.0184, "mutant": "V", "mutation": "I384V", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": -0.319, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.643, "ferret_sera_escape": -0.1834, "mature_H5_site": 384, "mouse_sera_escape": 0.01634, "mutant": "W", "mutation": "I384W", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": -0.02701, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.7933, "ferret_sera_escape": -0.09297, "mature_H5_site": 384, "mouse_sera_escape": 0.1313, "mutant": "Y", "mutation": "I384Y", "reference_site": "384", "region": "HA2", "sequential_site": 400, "stability": 0.8802, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.8579, "ferret_sera_escape": -0.04637, "mature_H5_site": 385, "mouse_sera_escape": 0.01156, "mutant": "A", "mutation": "I385A", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": -0.1061, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.094, "ferret_sera_escape": 0.04301, "mature_H5_site": 385, "mouse_sera_escape": 0.03655, "mutant": "C", "mutation": "I385C", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": 1.843, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "D", "mutation": "I385D", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "E", "mutation": "I385E", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.67, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "F", "mutation": "I385F", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -4.071, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "G", "mutation": "I385G", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.935, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "H", "mutation": "I385H", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 385, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I385I", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": 0.0, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -1.217, "ferret_sera_escape": -0.3092, "mature_H5_site": 385, "mouse_sera_escape": 0.0674, "mutant": "K", "mutation": "I385K", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2661, "ferret_sera_escape": -0.06524, "mature_H5_site": 385, "mouse_sera_escape": 0.07492, "mutant": "L", "mutation": "I385L", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": -0.3608, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.565, "ferret_sera_escape": -0.1717, "mature_H5_site": 385, "mouse_sera_escape": 0.05824, "mutant": "M", "mutation": "I385M", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": 0.4598, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.2, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "N", "mutation": "I385N", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.858, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "P", "mutation": "I385P", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.051, "ferret_sera_escape": -0.2662, "mature_H5_site": 385, "mouse_sera_escape": 0.2445, "mutant": "Q", "mutation": "I385Q", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.891, "ferret_sera_escape": -0.1091, "mature_H5_site": 385, "mouse_sera_escape": 0.2279, "mutant": "R", "mutation": "I385R", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": 0.7311, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.327, "ferret_sera_escape": -0.1587, "mature_H5_site": 385, "mouse_sera_escape": 0.1683, "mutant": "S", "mutation": "I385S", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": 0.06389, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5425, "ferret_sera_escape": -0.03451, "mature_H5_site": 385, "mouse_sera_escape": 0.005185, "mutant": "T", "mutation": "I385T", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": -0.04606, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.06388, "ferret_sera_escape": -0.19, "mature_H5_site": 385, "mouse_sera_escape": -0.1446, "mutant": "V", "mutation": "I385V", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": -0.46, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "W", "mutation": "I385W", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.588, "ferret_sera_escape": null, "mature_H5_site": 385, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I385Y", "reference_site": "385", "region": "HA2", "sequential_site": 401, "stability": null, "wildtype": "I"}, {"a26_usage": 0.2406, "cell_entry": -0.2489, "ferret_sera_escape": 0.09529, "mature_H5_site": 386, "mouse_sera_escape": 0.1423, "mutant": "A", "mutation": "D386A", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": -0.1231, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4324, "ferret_sera_escape": 0.2616, "mature_H5_site": 386, "mouse_sera_escape": 0.2418, "mutant": "C", "mutation": "D386C", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 0.9094, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 386, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D386D", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.4295, "cell_entry": -0.3902, "ferret_sera_escape": 0.02958, "mature_H5_site": 386, "mouse_sera_escape": -0.008534, "mutant": "E", "mutation": "D386E", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 0.04817, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.05201, "ferret_sera_escape": 0.02025, "mature_H5_site": 386, "mouse_sera_escape": 0.04321, "mutant": "F", "mutation": "D386F", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 1.398, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6954, "ferret_sera_escape": -0.02572, "mature_H5_site": 386, "mouse_sera_escape": 0.0727, "mutant": "G", "mutation": "D386G", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 1.283, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4652, "ferret_sera_escape": 0.04519, "mature_H5_site": 386, "mouse_sera_escape": 0.002734, "mutant": "H", "mutation": "D386H", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 1.02, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.07297, "ferret_sera_escape": -0.0414, "mature_H5_site": 386, "mouse_sera_escape": -0.07842, "mutant": "I", "mutation": "D386I", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": -0.1715, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6246, "ferret_sera_escape": 0.02856, "mature_H5_site": 386, "mouse_sera_escape": 0.1008, "mutant": "K", "mutation": "D386K", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": -0.1576, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3314, "ferret_sera_escape": 0.2173, "mature_H5_site": 386, "mouse_sera_escape": 0.01179, "mutant": "M", "mutation": "D386M", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 0.2341, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2731, "ferret_sera_escape": 0.0487, "mature_H5_site": 386, "mouse_sera_escape": 0.005812, "mutant": "N", "mutation": "D386N", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 0.961, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 386, "mouse_sera_escape": null, "mutant": "P", "mutation": "D386P", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.01364, "ferret_sera_escape": 0.06237, "mature_H5_site": 386, "mouse_sera_escape": 0.03129, "mutant": "Q", "mutation": "D386Q", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 0.3412, "wildtype": "D"}, {"a26_usage": null, "cell_entry": -0.6795, "ferret_sera_escape": null, "mature_H5_site": 386, "mouse_sera_escape": null, "mutant": "S", "mutation": "D386S", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.04728, "ferret_sera_escape": 0.05259, "mature_H5_site": 386, "mouse_sera_escape": 0.09068, "mutant": "T", "mutation": "D386T", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 1.283, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.05536, "ferret_sera_escape": -0.007658, "mature_H5_site": 386, "mouse_sera_escape": -0.01954, "mutant": "V", "mutation": "D386V", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": -0.1235, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3205, "ferret_sera_escape": -0.007573, "mature_H5_site": 386, "mouse_sera_escape": 0.05302, "mutant": "Y", "mutation": "D386Y", "reference_site": "386", "region": "HA2", "sequential_site": 402, "stability": 1.508, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4461, "ferret_sera_escape": 0.09446, "mature_H5_site": 387, "mouse_sera_escape": 0.07017, "mutant": "A", "mutation": "K387A", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": 0.611, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0548, "ferret_sera_escape": 0.02285, "mature_H5_site": 387, "mouse_sera_escape": 0.05705, "mutant": "C", "mutation": "K387C", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": 0.6692, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.448, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "D", "mutation": "K387D", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.529, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "E", "mutation": "K387E", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": null, "cell_entry": -5.704, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "F", "mutation": "K387F", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 387, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K387K", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.822, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "L", "mutation": "K387L", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.13, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "M", "mutation": "K387M", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2553, "ferret_sera_escape": -0.1775, "mature_H5_site": 387, "mouse_sera_escape": -0.04884, "mutant": "N", "mutation": "K387N", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": -0.2541, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "P", "mutation": "K387P", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.029, "ferret_sera_escape": -0.2887, "mature_H5_site": 387, "mouse_sera_escape": -0.08553, "mutant": "Q", "mutation": "K387Q", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": -0.3146, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4854, "ferret_sera_escape": -0.04253, "mature_H5_site": 387, "mouse_sera_escape": 0.01335, "mutant": "R", "mutation": "K387R", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": -0.2264, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04736, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "S", "mutation": "K387S", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03702, "ferret_sera_escape": 0.06456, "mature_H5_site": 387, "mouse_sera_escape": -0.04051, "mutant": "T", "mutation": "K387T", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": 0.02732, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.353, "ferret_sera_escape": 0.3941, "mature_H5_site": 387, "mouse_sera_escape": 0.3017, "mutant": "V", "mutation": "K387V", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": 1.816, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "W", "mutation": "K387W", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.776, "ferret_sera_escape": null, "mature_H5_site": 387, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K387Y", "reference_site": "387", "region": "HA2", "sequential_site": 403, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.683, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "A", "mutation": "M388A", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.811, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "C", "mutation": "M388C", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.864, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "D", "mutation": "M388D", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "E", "mutation": "M388E", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.367, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "F", "mutation": "M388F", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.648, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "G", "mutation": "M388G", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.885, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "H", "mutation": "M388H", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.483, "ferret_sera_escape": 0.02593, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "I", "mutation": "M388I", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": 0.02815, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.805, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "K", "mutation": "M388K", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.142, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "L", "mutation": "M388L", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 388, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M388M", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.941, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "N", "mutation": "M388N", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "R", "mutation": "M388R", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.896, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "T", "mutation": "M388T", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.067, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "V", "mutation": "M388V", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 388, "mouse_sera_escape": null, "mutant": "W", "mutation": "M388W", "reference_site": "388", "region": "HA2", "sequential_site": 404, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.352, "ferret_sera_escape": 0.07466, "mature_H5_site": 389, "mouse_sera_escape": 0.1389, "mutant": "C", "mutation": "N389C", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.1193, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9133, "ferret_sera_escape": -0.007947, "mature_H5_site": 389, "mouse_sera_escape": -0.1293, "mutant": "D", "mutation": "N389D", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": -0.4135, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.06765, "ferret_sera_escape": -0.0586, "mature_H5_site": 389, "mouse_sera_escape": 0.01119, "mutant": "E", "mutation": "N389E", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": -0.02471, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5404, "ferret_sera_escape": 0.01159, "mature_H5_site": 389, "mouse_sera_escape": -0.01738, "mutant": "G", "mutation": "N389G", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": -0.0149, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3852, "ferret_sera_escape": 0.02851, "mature_H5_site": 389, "mouse_sera_escape": 0.1074, "mutant": "H", "mutation": "N389H", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.3951, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7934, "ferret_sera_escape": 0.09485, "mature_H5_site": 389, "mouse_sera_escape": 0.06356, "mutant": "I", "mutation": "N389I", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 1.041, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.876, "ferret_sera_escape": 0.2288, "mature_H5_site": 389, "mouse_sera_escape": 0.2334, "mutant": "K", "mutation": "N389K", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.3485, "wildtype": "N"}, {"a26_usage": null, "cell_entry": -0.8758, "ferret_sera_escape": null, "mature_H5_site": 389, "mouse_sera_escape": null, "mutant": "L", "mutation": "N389L", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 389, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N389N", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.795, "ferret_sera_escape": null, "mature_H5_site": 389, "mouse_sera_escape": null, "mutant": "P", "mutation": "N389P", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4306, "ferret_sera_escape": 0.005414, "mature_H5_site": 389, "mouse_sera_escape": 0.0429, "mutant": "Q", "mutation": "N389Q", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.06365, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.322, "ferret_sera_escape": 0.2183, "mature_H5_site": 389, "mouse_sera_escape": 0.1559, "mutant": "R", "mutation": "N389R", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.2802, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4582, "ferret_sera_escape": 0.0121, "mature_H5_site": 389, "mouse_sera_escape": -0.03788, "mutant": "S", "mutation": "N389S", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.6192, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1446, "ferret_sera_escape": 0.2185, "mature_H5_site": 389, "mouse_sera_escape": 0.07399, "mutant": "T", "mutation": "N389T", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 0.03419, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2366, "ferret_sera_escape": -0.002318, "mature_H5_site": 389, "mouse_sera_escape": 0.1088, "mutant": "V", "mutation": "N389V", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": 1.259, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.785, "ferret_sera_escape": null, "mature_H5_site": 389, "mouse_sera_escape": 0.1465, "mutant": "W", "mutation": "N389W", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04963, "ferret_sera_escape": 0.1665, "mature_H5_site": 389, "mouse_sera_escape": -0.06861, "mutant": "Y", "mutation": "N389Y", "reference_site": "389", "region": "HA2", "sequential_site": 405, "stability": -0.1708, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 29, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A39A", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1739, "ferret_sera_escape": -0.04791, "mature_H5_site": 29, "mouse_sera_escape": null, "mutant": "C", "mutation": "A39C", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 29, "mouse_sera_escape": null, "mutant": "D", "mutation": "A39D", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 29, "mouse_sera_escape": null, "mutant": "E", "mutation": "A39E", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.027, "ferret_sera_escape": 0.001163, "mature_H5_site": 29, "mouse_sera_escape": 0.157, "mutant": "F", "mutation": "A39F", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 1.28, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7388, "ferret_sera_escape": -0.04578, "mature_H5_site": 29, "mouse_sera_escape": 0.01454, "mutant": "G", "mutation": "A39G", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 0.07747, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.06004, "ferret_sera_escape": 0.06746, "mature_H5_site": 29, "mouse_sera_escape": 0.1073, "mutant": "I", "mutation": "A39I", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 1.356, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.784, "ferret_sera_escape": 0.1632, "mature_H5_site": 29, "mouse_sera_escape": 0.1058, "mutant": "L", "mutation": "A39L", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2987, "ferret_sera_escape": null, "mature_H5_site": 29, "mouse_sera_escape": null, "mutant": "M", "mutation": "A39M", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.495, "ferret_sera_escape": null, "mature_H5_site": 29, "mouse_sera_escape": null, "mutant": "N", "mutation": "A39N", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.178, "ferret_sera_escape": null, "mature_H5_site": 29, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A39Q", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.246, "ferret_sera_escape": null, "mature_H5_site": 29, "mouse_sera_escape": null, "mutant": "R", "mutation": "A39R", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3373, "ferret_sera_escape": -0.264, "mature_H5_site": 29, "mouse_sera_escape": -0.092, "mutant": "S", "mutation": "A39S", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3065, "ferret_sera_escape": -0.02992, "mature_H5_site": 29, "mouse_sera_escape": 0.06449, "mutant": "T", "mutation": "A39T", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 1.395, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.09754, "ferret_sera_escape": -0.01163, "mature_H5_site": 29, "mouse_sera_escape": -0.05207, "mutant": "V", "mutation": "A39V", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 0.8518, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.07439, "ferret_sera_escape": 0.0666, "mature_H5_site": 29, "mouse_sera_escape": 0.03098, "mutant": "W", "mutation": "A39W", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 1.619, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2895, "ferret_sera_escape": -0.1755, "mature_H5_site": 29, "mouse_sera_escape": 0.03361, "mutant": "Y", "mutation": "A39Y", "reference_site": "39", "region": "HA1", "sequential_site": 45, "stability": 1.207, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.324, "ferret_sera_escape": 0.1627, "mature_H5_site": 390, "mouse_sera_escape": 0.2271, "mutant": "A", "mutation": "T390A", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": -0.00728, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.099, "ferret_sera_escape": 0.2526, "mature_H5_site": 390, "mouse_sera_escape": -0.01112, "mutant": "C", "mutation": "T390C", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": 0.2441, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.147, "ferret_sera_escape": 0.96, "mature_H5_site": 390, "mouse_sera_escape": 0.1322, "mutant": "E", "mutation": "T390E", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.762, "ferret_sera_escape": null, "mature_H5_site": 390, "mouse_sera_escape": null, "mutant": "F", "mutation": "T390F", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.853, "ferret_sera_escape": 0.02422, "mature_H5_site": 390, "mouse_sera_escape": 0.1173, "mutant": "G", "mutation": "T390G", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": -0.02997, "wildtype": "T"}, {"a26_usage": null, "cell_entry": -2.232, "ferret_sera_escape": null, "mature_H5_site": 390, "mouse_sera_escape": null, "mutant": "H", "mutation": "T390H", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.057, "ferret_sera_escape": 0.02277, "mature_H5_site": 390, "mouse_sera_escape": 0.07416, "mutant": "I", "mutation": "T390I", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": 0.6983, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 390, "mouse_sera_escape": null, "mutant": "K", "mutation": "T390K", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.005, "ferret_sera_escape": -0.145, "mature_H5_site": 390, "mouse_sera_escape": -0.007517, "mutant": "L", "mutation": "T390L", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": -0.3676, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.6905, "ferret_sera_escape": -0.04432, "mature_H5_site": 390, "mouse_sera_escape": 0.09562, "mutant": "M", "mutation": "T390M", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": -0.02424, "wildtype": "T"}, {"a26_usage": 0.7677, "cell_entry": -0.9642, "ferret_sera_escape": -0.2589, "mature_H5_site": 390, "mouse_sera_escape": null, "mutant": "N", "mutation": "T390N", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.9618, "ferret_sera_escape": -0.01795, "mature_H5_site": 390, "mouse_sera_escape": -0.17, "mutant": "Q", "mutation": "T390Q", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": -0.05523, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.182, "ferret_sera_escape": null, "mature_H5_site": 390, "mouse_sera_escape": null, "mutant": "R", "mutation": "T390R", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 390, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T390T", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.0215, "ferret_sera_escape": -0.02794, "mature_H5_site": 390, "mouse_sera_escape": -0.03329, "mutant": "V", "mutation": "T390V", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": -0.06492, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.626, "ferret_sera_escape": null, "mature_H5_site": 390, "mouse_sera_escape": null, "mutant": "W", "mutation": "T390W", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.731, "ferret_sera_escape": null, "mature_H5_site": 390, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T390Y", "reference_site": "390", "region": "HA2", "sequential_site": 406, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.45, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "C", "mutation": "Q391C", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.04577, "ferret_sera_escape": -0.02237, "mature_H5_site": 391, "mouse_sera_escape": 0.1568, "mutant": "D", "mutation": "Q391D", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": 0.9144, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.01487, "ferret_sera_escape": -0.04111, "mature_H5_site": 391, "mouse_sera_escape": 0.09521, "mutant": "E", "mutation": "Q391E", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": 1.267, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.35, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "F", "mutation": "Q391F", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.048, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "G", "mutation": "Q391G", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2074, "ferret_sera_escape": 0.1207, "mature_H5_site": 391, "mouse_sera_escape": 0.1037, "mutant": "H", "mutation": "Q391H", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": 0.821, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "I", "mutation": "Q391I", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.854, "ferret_sera_escape": -0.03499, "mature_H5_site": 391, "mouse_sera_escape": -0.03696, "mutant": "K", "mutation": "Q391K", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": -0.6098, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "L", "mutation": "Q391L", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "M", "mutation": "Q391M", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0242, "cell_entry": 0.05083, "ferret_sera_escape": -0.03789, "mature_H5_site": 391, "mouse_sera_escape": -0.07705, "mutant": "N", "mutation": "Q391N", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": -0.1423, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.053, "ferret_sera_escape": 0.01911, "mature_H5_site": 391, "mouse_sera_escape": -0.02228, "mutant": "P", "mutation": "Q391P", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": 0.04534, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 391, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q391Q", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.7793, "ferret_sera_escape": -0.008034, "mature_H5_site": 391, "mouse_sera_escape": 0.1603, "mutant": "R", "mutation": "Q391R", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": 0.1133, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.47, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "S", "mutation": "Q391S", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.09, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "T", "mutation": "Q391T", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.777, "ferret_sera_escape": 0.06526, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "V", "mutation": "Q391V", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.646, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "W", "mutation": "Q391W", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 391, "mouse_sera_escape": null, "mutant": "Y", "mutation": "Q391Y", "reference_site": "391", "region": "HA2", "sequential_site": 407, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.369, "ferret_sera_escape": -0.2577, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "A", "mutation": "F392A", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.13, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "C", "mutation": "F392C", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.687, "ferret_sera_escape": -0.1175, "mature_H5_site": 392, "mouse_sera_escape": 0.08179, "mutant": "D", "mutation": "F392D", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": -0.2133, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.15, "ferret_sera_escape": -0.01144, "mature_H5_site": 392, "mouse_sera_escape": 0.09996, "mutant": "E", "mutation": "F392E", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": -0.2199, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 392, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F392F", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "G", "mutation": "F392G", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.877, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "H", "mutation": "F392H", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.608, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "I", "mutation": "F392I", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.716, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "K", "mutation": "F392K", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.319, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "L", "mutation": "F392L", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.6621, "ferret_sera_escape": -0.03627, "mature_H5_site": 392, "mouse_sera_escape": -0.05475, "mutant": "M", "mutation": "F392M", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.545, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "N", "mutation": "F392N", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.559, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F392Q", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "R", "mutation": "F392R", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.351, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "S", "mutation": "F392S", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "T", "mutation": "F392T", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.684, "ferret_sera_escape": null, "mature_H5_site": 392, "mouse_sera_escape": null, "mutant": "V", "mutation": "F392V", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": null, "wildtype": "F"}, {"a26_usage": 0.03541, "cell_entry": 0.06695, "ferret_sera_escape": 0.105, "mature_H5_site": 392, "mouse_sera_escape": 0.05836, "mutant": "W", "mutation": "F392W", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": -0.09249, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.06471, "ferret_sera_escape": -0.1059, "mature_H5_site": 392, "mouse_sera_escape": -0.005196, "mutant": "Y", "mutation": "F392Y", "reference_site": "392", "region": "HA2", "sequential_site": 408, "stability": -0.01713, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.6151, "ferret_sera_escape": -0.1275, "mature_H5_site": 393, "mouse_sera_escape": -0.03869, "mutant": "C", "mutation": "E393C", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": -0.1168, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4048, "ferret_sera_escape": -0.1193, "mature_H5_site": 393, "mouse_sera_escape": -0.04378, "mutant": "D", "mutation": "E393D", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 393, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E393E", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.937, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "F", "mutation": "E393F", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.115, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "G", "mutation": "E393G", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.063, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "H", "mutation": "E393H", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.005, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "I", "mutation": "E393I", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.528, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "K", "mutation": "E393K", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.632, "ferret_sera_escape": -0.00948, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "L", "mutation": "E393L", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": -0.08601, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7436, "ferret_sera_escape": 0.1573, "mature_H5_site": 393, "mouse_sera_escape": 0.1227, "mutant": "M", "mutation": "E393M", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": 0.5148, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.673, "ferret_sera_escape": -0.05259, "mature_H5_site": 393, "mouse_sera_escape": -0.05035, "mutant": "N", "mutation": "E393N", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": -0.2455, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "P", "mutation": "E393P", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9021, "ferret_sera_escape": 0.09864, "mature_H5_site": 393, "mouse_sera_escape": 0.03689, "mutant": "Q", "mutation": "E393Q", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": 0.3659, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "R", "mutation": "E393R", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5766, "ferret_sera_escape": -0.0452, "mature_H5_site": 393, "mouse_sera_escape": 0.00158, "mutant": "S", "mutation": "E393S", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": 0.2572, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9938, "ferret_sera_escape": -0.1112, "mature_H5_site": 393, "mouse_sera_escape": 0.0329, "mutant": "T", "mutation": "E393T", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": -0.1567, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.239, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "V", "mutation": "E393V", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.037, "ferret_sera_escape": null, "mature_H5_site": 393, "mouse_sera_escape": null, "mutant": "W", "mutation": "E393W", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.535, "ferret_sera_escape": -0.1768, "mature_H5_site": 393, "mouse_sera_escape": 0.0474, "mutant": "Y", "mutation": "E393Y", "reference_site": "393", "region": "HA2", "sequential_site": 409, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 394, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A394A", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "D", "mutation": "A394D", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "E", "mutation": "A394E", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.272, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "F", "mutation": "A394F", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4164, "ferret_sera_escape": -0.03109, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "G", "mutation": "A394G", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "H", "mutation": "A394H", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.966, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "L", "mutation": "A394L", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.016, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "N", "mutation": "A394N", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.848, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A394Q", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": null, "cell_entry": -5.886, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "R", "mutation": "A394R", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3754, "ferret_sera_escape": -0.08439, "mature_H5_site": 394, "mouse_sera_escape": 0.06331, "mutant": "S", "mutation": "A394S", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": -0.294, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.753, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "T", "mutation": "A394T", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.396, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "V", "mutation": "A394V", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.447, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "W", "mutation": "A394W", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.758, "ferret_sera_escape": null, "mature_H5_site": 394, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A394Y", "reference_site": "394", "region": "HA2", "sequential_site": 410, "stability": null, "wildtype": "A"}, {"a26_usage": 0.04238, "cell_entry": -0.1565, "ferret_sera_escape": -0.08094, "mature_H5_site": 395, "mouse_sera_escape": -0.1623, "mutant": "A", "mutation": "V395A", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": -0.2025, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1455, "ferret_sera_escape": -0.04332, "mature_H5_site": 395, "mouse_sera_escape": -0.04361, "mutant": "C", "mutation": "V395C", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": 0.5284, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.303, "ferret_sera_escape": -0.01186, "mature_H5_site": 395, "mouse_sera_escape": -0.006312, "mutant": "D", "mutation": "V395D", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": -0.2851, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2526, "ferret_sera_escape": -0.03257, "mature_H5_site": 395, "mouse_sera_escape": 0.2011, "mutant": "F", "mutation": "V395F", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": 1.538, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6314, "ferret_sera_escape": 0.007603, "mature_H5_site": 395, "mouse_sera_escape": 0.08996, "mutant": "G", "mutation": "V395G", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": -0.03766, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.329, "ferret_sera_escape": -0.1677, "mature_H5_site": 395, "mouse_sera_escape": null, "mutant": "K", "mutation": "V395K", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.9791, "ferret_sera_escape": -0.04588, "mature_H5_site": 395, "mouse_sera_escape": -0.007262, "mutant": "L", "mutation": "V395L", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": 0.1443, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0625, "ferret_sera_escape": -0.0868, "mature_H5_site": 395, "mouse_sera_escape": 0.07819, "mutant": "M", "mutation": "V395M", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": 0.3047, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.227, "ferret_sera_escape": null, "mature_H5_site": 395, "mouse_sera_escape": null, "mutant": "N", "mutation": "V395N", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.316, "ferret_sera_escape": null, "mature_H5_site": 395, "mouse_sera_escape": null, "mutant": "P", "mutation": "V395P", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1606, "ferret_sera_escape": -0.03407, "mature_H5_site": 395, "mouse_sera_escape": -0.06103, "mutant": "Q", "mutation": "V395Q", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": -0.5452, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5861, "ferret_sera_escape": -0.1648, "mature_H5_site": 395, "mouse_sera_escape": 0.4395, "mutant": "R", "mutation": "V395R", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": 1.247, "wildtype": "V"}, {"a26_usage": 0.3893, "cell_entry": 0.01376, "ferret_sera_escape": 0.02431, "mature_H5_site": 395, "mouse_sera_escape": 0.06659, "mutant": "S", "mutation": "V395S", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": -0.1421, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.05529, "ferret_sera_escape": -0.08247, "mature_H5_site": 395, "mouse_sera_escape": -0.02504, "mutant": "T", "mutation": "V395T", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": -0.1157, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 395, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V395V", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.886, "ferret_sera_escape": null, "mature_H5_site": 395, "mouse_sera_escape": null, "mutant": "W", "mutation": "V395W", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.736, "ferret_sera_escape": null, "mature_H5_site": 395, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V395Y", "reference_site": "395", "region": "HA2", "sequential_site": 411, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.521, "ferret_sera_escape": 0.07289, "mature_H5_site": 396, "mouse_sera_escape": 0.2027, "mutant": "A", "mutation": "G396A", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": 0.0688, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.01034, "ferret_sera_escape": 0.02617, "mature_H5_site": 396, "mouse_sera_escape": 0.1273, "mutant": "C", "mutation": "G396C", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": -0.5722, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.9118, "ferret_sera_escape": -0.1433, "mature_H5_site": 396, "mouse_sera_escape": -0.02759, "mutant": "D", "mutation": "G396D", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": -0.2287, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.774, "ferret_sera_escape": -0.02541, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "F", "mutation": "G396F", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 396, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G396G", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.603, "ferret_sera_escape": null, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "I", "mutation": "G396I", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "K", "mutation": "G396K", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.358, "ferret_sera_escape": null, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "L", "mutation": "G396L", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.635, "ferret_sera_escape": 0.1525, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "M", "mutation": "G396M", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.826, "ferret_sera_escape": 0.07072, "mature_H5_site": 396, "mouse_sera_escape": 0.1572, "mutant": "N", "mutation": "G396N", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": 0.1042, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.354, "ferret_sera_escape": null, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "P", "mutation": "G396P", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.341, "ferret_sera_escape": 0.06246, "mature_H5_site": 396, "mouse_sera_escape": 0.2885, "mutant": "Q", "mutation": "G396Q", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": 0.01885, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.738, "ferret_sera_escape": null, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "R", "mutation": "G396R", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.317, "ferret_sera_escape": -0.06863, "mature_H5_site": 396, "mouse_sera_escape": 0.04222, "mutant": "S", "mutation": "G396S", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": -0.00352, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5512, "ferret_sera_escape": 0.3609, "mature_H5_site": 396, "mouse_sera_escape": 0.2729, "mutant": "T", "mutation": "G396T", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": -0.4363, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.925, "ferret_sera_escape": 0.1101, "mature_H5_site": 396, "mouse_sera_escape": 0.2264, "mutant": "V", "mutation": "G396V", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": 0.1641, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.691, "ferret_sera_escape": 0.4797, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "W", "mutation": "G396W", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.697, "ferret_sera_escape": null, "mature_H5_site": 396, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G396Y", "reference_site": "396", "region": "HA2", "sequential_site": 412, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.7532, "ferret_sera_escape": -0.02135, "mature_H5_site": 397, "mouse_sera_escape": 0.1151, "mutant": "A", "mutation": "R397A", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 0.2169, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.439, "ferret_sera_escape": -0.08105, "mature_H5_site": 397, "mouse_sera_escape": 0.0523, "mutant": "C", "mutation": "R397C", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 1.627, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2741, "ferret_sera_escape": -0.01186, "mature_H5_site": 397, "mouse_sera_escape": 0.01802, "mutant": "E", "mutation": "R397E", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 0.4435, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.7, "ferret_sera_escape": null, "mature_H5_site": 397, "mouse_sera_escape": null, "mutant": "F", "mutation": "R397F", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.09892, "ferret_sera_escape": -0.2096, "mature_H5_site": 397, "mouse_sera_escape": 0.1358, "mutant": "G", "mutation": "R397G", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 0.08968, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.33, "ferret_sera_escape": null, "mature_H5_site": 397, "mouse_sera_escape": null, "mutant": "I", "mutation": "R397I", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1115, "ferret_sera_escape": -0.0537, "mature_H5_site": 397, "mouse_sera_escape": -0.02408, "mutant": "K", "mutation": "R397K", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": -0.3344, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.856, "ferret_sera_escape": 0.2157, "mature_H5_site": 397, "mouse_sera_escape": null, "mutant": "M", "mutation": "R397M", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 1.955, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.04207, "ferret_sera_escape": -0.03913, "mature_H5_site": 397, "mouse_sera_escape": 0.01119, "mutant": "N", "mutation": "R397N", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 1.063, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.417, "ferret_sera_escape": -0.04704, "mature_H5_site": 397, "mouse_sera_escape": 0.2182, "mutant": "P", "mutation": "R397P", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 0.9182, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.01926, "ferret_sera_escape": -0.03096, "mature_H5_site": 397, "mouse_sera_escape": 0.1216, "mutant": "Q", "mutation": "R397Q", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 0.9139, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 397, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R397R", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7415, "ferret_sera_escape": -0.1023, "mature_H5_site": 397, "mouse_sera_escape": 0.1909, "mutant": "S", "mutation": "R397S", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 2.099, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.821, "ferret_sera_escape": 0.006374, "mature_H5_site": 397, "mouse_sera_escape": null, "mutant": "V", "mutation": "R397V", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": 1.091, "wildtype": "R"}, {"a26_usage": null, "cell_entry": -0.5185, "ferret_sera_escape": null, "mature_H5_site": 397, "mouse_sera_escape": null, "mutant": "W", "mutation": "R397W", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7234, "ferret_sera_escape": null, "mature_H5_site": 397, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R397Y", "reference_site": "397", "region": "HA2", "sequential_site": 413, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "A", "mutation": "E398A", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2475, "ferret_sera_escape": 0.01031, "mature_H5_site": 398, "mouse_sera_escape": -0.05375, "mutant": "C", "mutation": "E398C", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": -0.1042, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.05463, "ferret_sera_escape": -0.001492, "mature_H5_site": 398, "mouse_sera_escape": -0.0001438, "mutant": "D", "mutation": "E398D", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": -0.4834, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 398, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E398E", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.685, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "F", "mutation": "E398F", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "G", "mutation": "E398G", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.933, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "H", "mutation": "E398H", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.925, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "I", "mutation": "E398I", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.223, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "K", "mutation": "E398K", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.425, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "L", "mutation": "E398L", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.572, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "M", "mutation": "E398M", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.789, "ferret_sera_escape": -0.1711, "mature_H5_site": 398, "mouse_sera_escape": 0.8449, "mutant": "N", "mutation": "E398N", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": 0.3455, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7298, "ferret_sera_escape": 0.07972, "mature_H5_site": 398, "mouse_sera_escape": 0.4876, "mutant": "P", "mutation": "E398P", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.617, "ferret_sera_escape": -0.09907, "mature_H5_site": 398, "mouse_sera_escape": -0.04305, "mutant": "Q", "mutation": "E398Q", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": -0.3129, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.533, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "R", "mutation": "E398R", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6365, "ferret_sera_escape": -0.3135, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "T", "mutation": "E398T", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.783, "ferret_sera_escape": -0.07115, "mature_H5_site": 398, "mouse_sera_escape": 1.014, "mutant": "V", "mutation": "E398V", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": 0.8262, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.562, "ferret_sera_escape": null, "mature_H5_site": 398, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E398Y", "reference_site": "398", "region": "HA2", "sequential_site": 414, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "A", "mutation": "F399A", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.019, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "C", "mutation": "F399C", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.914, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "D", "mutation": "F399D", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "E", "mutation": "F399E", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 399, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F399F", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.712, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "G", "mutation": "F399G", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "H", "mutation": "F399H", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "I", "mutation": "F399I", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "L", "mutation": "F399L", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "M", "mutation": "F399M", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F399Q", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.852, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "S", "mutation": "F399S", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": null, "cell_entry": -5.028, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "T", "mutation": "F399T", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 399, "mouse_sera_escape": null, "mutant": "V", "mutation": "F399V", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.8844, "ferret_sera_escape": -0.0207, "mature_H5_site": 399, "mouse_sera_escape": 0.2748, "mutant": "W", "mutation": "F399W", "reference_site": "399", "region": "HA2", "sequential_site": 415, "stability": 1.39, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.097, "ferret_sera_escape": 0.3406, "mature_H5_site": -7, "mouse_sera_escape": 0.07878, "mutant": "A", "mutation": "I4A", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.05993, "ferret_sera_escape": -0.1704, "mature_H5_site": -7, "mouse_sera_escape": -0.1065, "mutant": "C", "mutation": "I4C", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": -0.01576, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -0.4002, "ferret_sera_escape": null, "mature_H5_site": -7, "mouse_sera_escape": null, "mutant": "G", "mutation": "I4G", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.454, "ferret_sera_escape": -0.07749, "mature_H5_site": -7, "mouse_sera_escape": -0.09242, "mutant": "H", "mutation": "I4H", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": -0.1527, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -7, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I4I", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": 0.0, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": -7, "mouse_sera_escape": null, "mutant": "K", "mutation": "I4K", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.02342, "ferret_sera_escape": 0.1197, "mature_H5_site": -7, "mouse_sera_escape": null, "mutant": "L", "mutation": "I4L", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03197, "ferret_sera_escape": -0.111, "mature_H5_site": -7, "mouse_sera_escape": -0.1791, "mutant": "M", "mutation": "I4M", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": -0.04943, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.7, "ferret_sera_escape": null, "mature_H5_site": -7, "mouse_sera_escape": null, "mutant": "N", "mutation": "I4N", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.195, "ferret_sera_escape": null, "mature_H5_site": -7, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I4Q", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": -7, "mouse_sera_escape": null, "mutant": "R", "mutation": "I4R", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -0.6002, "ferret_sera_escape": null, "mature_H5_site": -7, "mouse_sera_escape": null, "mutant": "T", "mutation": "I4T", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5877, "ferret_sera_escape": null, "mature_H5_site": -7, "mouse_sera_escape": null, "mutant": "V", "mutation": "I4V", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.7617, "ferret_sera_escape": 0.2113, "mature_H5_site": -7, "mouse_sera_escape": 0.08095, "mutant": "W", "mutation": "I4W", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": 0.004053, "wildtype": "I"}, {"a26_usage": 0.01598, "cell_entry": 0.02726, "ferret_sera_escape": null, "mature_H5_site": -7, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I4Y", "reference_site": "4", "region": "HA1", "sequential_site": 10, "stability": null, "wildtype": "I"}, {"a26_usage": 0.1514, "cell_entry": -0.2044, "ferret_sera_escape": -0.02214, "mature_H5_site": 30, "mouse_sera_escape": 0.02034, "mutant": "C", "mutation": "Q40C", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": 0.724, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.612, "ferret_sera_escape": null, "mature_H5_site": 30, "mouse_sera_escape": null, "mutant": "D", "mutation": "Q40D", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2469, "ferret_sera_escape": -0.1092, "mature_H5_site": 30, "mouse_sera_escape": -0.06486, "mutant": "E", "mutation": "Q40E", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": -0.02949, "wildtype": "Q"}, {"a26_usage": null, "cell_entry": -0.3605, "ferret_sera_escape": null, "mature_H5_site": 30, "mouse_sera_escape": null, "mutant": "F", "mutation": "Q40F", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1545, "ferret_sera_escape": -0.05905, "mature_H5_site": 30, "mouse_sera_escape": -0.1272, "mutant": "H", "mutation": "Q40H", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": 0.1993, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.9664, "ferret_sera_escape": 0.01859, "mature_H5_site": 30, "mouse_sera_escape": 0.009966, "mutant": "I", "mutation": "Q40I", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2197, "ferret_sera_escape": null, "mature_H5_site": 30, "mouse_sera_escape": null, "mutant": "K", "mutation": "Q40K", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": 0.4784, "wildtype": "Q"}, {"a26_usage": 0.7307, "cell_entry": -0.3981, "ferret_sera_escape": 0.3083, "mature_H5_site": 30, "mouse_sera_escape": null, "mutant": "L", "mutation": "Q40L", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.693, "ferret_sera_escape": null, "mature_H5_site": 30, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q40P", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 30, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q40Q", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.426, "ferret_sera_escape": 0.1616, "mature_H5_site": 30, "mouse_sera_escape": 0.325, "mutant": "R", "mutation": "Q40R", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": 0.4541, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2906, "ferret_sera_escape": -0.3253, "mature_H5_site": 30, "mouse_sera_escape": -0.201, "mutant": "S", "mutation": "Q40S", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": 0.8475, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.01736, "ferret_sera_escape": -0.166, "mature_H5_site": 30, "mouse_sera_escape": 0.009143, "mutant": "V", "mutation": "Q40V", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": 1.621, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1165, "ferret_sera_escape": -0.03681, "mature_H5_site": 30, "mouse_sera_escape": 0.02139, "mutant": "W", "mutation": "Q40W", "reference_site": "40", "region": "HA1", "sequential_site": 46, "stability": -0.1532, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.01834, "ferret_sera_escape": -0.3145, "mature_H5_site": 400, "mouse_sera_escape": -0.0938, "mutant": "C", "mutation": "N400C", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": -0.3174, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.981, "ferret_sera_escape": -0.1088, "mature_H5_site": 400, "mouse_sera_escape": 0.0105, "mutant": "D", "mutation": "N400D", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": -0.253, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.633, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "E", "mutation": "N400E", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5786, "ferret_sera_escape": -0.01646, "mature_H5_site": 400, "mouse_sera_escape": 0.1012, "mutant": "G", "mutation": "N400G", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": 0.261, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3016, "ferret_sera_escape": -0.06842, "mature_H5_site": 400, "mouse_sera_escape": -0.003189, "mutant": "H", "mutation": "N400H", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": -0.1351, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "I", "mutation": "N400I", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.741, "ferret_sera_escape": 0.1219, "mature_H5_site": 400, "mouse_sera_escape": 0.07115, "mutant": "K", "mutation": "N400K", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": -0.2876, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.978, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "L", "mutation": "N400L", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.614, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "M", "mutation": "N400M", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 400, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N400N", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "P", "mutation": "N400P", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.287, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N400Q", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.489, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "R", "mutation": "N400R", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.06839, "ferret_sera_escape": -0.1014, "mature_H5_site": 400, "mouse_sera_escape": 0.01365, "mutant": "S", "mutation": "N400S", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": -0.03817, "wildtype": "N"}, {"a26_usage": null, "cell_entry": 0.02341, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "T", "mutation": "N400T", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.453, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "V", "mutation": "N400V", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "W", "mutation": "N400W", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -6.017, "ferret_sera_escape": null, "mature_H5_site": 400, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N400Y", "reference_site": "400", "region": "HA2", "sequential_site": 416, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04626, "ferret_sera_escape": -0.02229, "mature_H5_site": 401, "mouse_sera_escape": -0.04736, "mutant": "A", "mutation": "N401A", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.1279, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1383, "ferret_sera_escape": 0.08884, "mature_H5_site": 401, "mouse_sera_escape": 0.001731, "mutant": "C", "mutation": "N401C", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.04709, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.106, "ferret_sera_escape": 0.06327, "mature_H5_site": 401, "mouse_sera_escape": 0.0131, "mutant": "D", "mutation": "N401D", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.01146, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2854, "ferret_sera_escape": -0.2993, "mature_H5_site": 401, "mouse_sera_escape": -0.1341, "mutant": "E", "mutation": "N401E", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.07544, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.07135, "ferret_sera_escape": -0.01018, "mature_H5_site": 401, "mouse_sera_escape": -0.03125, "mutant": "F", "mutation": "N401F", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.203, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04331, "ferret_sera_escape": 0.1173, "mature_H5_site": 401, "mouse_sera_escape": 0.0456, "mutant": "G", "mutation": "N401G", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.002678, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1922, "ferret_sera_escape": -0.01541, "mature_H5_site": 401, "mouse_sera_escape": -0.06635, "mutant": "I", "mutation": "N401I", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04602, "ferret_sera_escape": 0.07719, "mature_H5_site": 401, "mouse_sera_escape": 0.1581, "mutant": "K", "mutation": "N401K", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": 0.2206, "wildtype": "N"}, {"a26_usage": null, "cell_entry": 0.01504, "ferret_sera_escape": null, "mature_H5_site": 401, "mouse_sera_escape": null, "mutant": "L", "mutation": "N401L", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 401, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N401N", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7028, "ferret_sera_escape": -0.144, "mature_H5_site": 401, "mouse_sera_escape": -0.02139, "mutant": "P", "mutation": "N401P", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.1534, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.07158, "ferret_sera_escape": -0.0255, "mature_H5_site": 401, "mouse_sera_escape": -0.07116, "mutant": "Q", "mutation": "N401Q", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": 0.05023, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05539, "ferret_sera_escape": -0.02517, "mature_H5_site": 401, "mouse_sera_escape": 0.02307, "mutant": "R", "mutation": "N401R", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": 0.008294, "wildtype": "N"}, {"a26_usage": 0.2881, "cell_entry": -0.5873, "ferret_sera_escape": null, "mature_H5_site": 401, "mouse_sera_escape": -0.09779, "mutant": "S", "mutation": "N401S", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.06799, "ferret_sera_escape": 0.03892, "mature_H5_site": 401, "mouse_sera_escape": -0.06534, "mutant": "T", "mutation": "N401T", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.1781, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.04712, "ferret_sera_escape": 0.01916, "mature_H5_site": 401, "mouse_sera_escape": 0.05708, "mutant": "V", "mutation": "N401V", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.1774, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.06691, "ferret_sera_escape": 0.06245, "mature_H5_site": 401, "mouse_sera_escape": -0.008749, "mutant": "W", "mutation": "N401W", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": 0.8301, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04162, "ferret_sera_escape": -0.02603, "mature_H5_site": 401, "mouse_sera_escape": -0.05511, "mutant": "Y", "mutation": "N401Y", "reference_site": "401", "region": "HA2", "sequential_site": 417, "stability": -0.2652, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.953, "ferret_sera_escape": 0.1161, "mature_H5_site": 402, "mouse_sera_escape": 0.07234, "mutant": "A", "mutation": "L402A", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.101, "ferret_sera_escape": 0.1474, "mature_H5_site": 402, "mouse_sera_escape": 0.2435, "mutant": "C", "mutation": "L402C", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": 0.3942, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.153, "ferret_sera_escape": 0.08348, "mature_H5_site": 402, "mouse_sera_escape": 0.146, "mutant": "D", "mutation": "L402D", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": -0.04008, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.873, "ferret_sera_escape": 0.04138, "mature_H5_site": 402, "mouse_sera_escape": 0.3914, "mutant": "E", "mutation": "L402E", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": -0.09088, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2883, "ferret_sera_escape": 0.1378, "mature_H5_site": 402, "mouse_sera_escape": -0.07911, "mutant": "F", "mutation": "L402F", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": -0.3552, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.994, "ferret_sera_escape": 0.1193, "mature_H5_site": 402, "mouse_sera_escape": null, "mutant": "G", "mutation": "L402G", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": 0.1354, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3643, "ferret_sera_escape": 0.05689, "mature_H5_site": 402, "mouse_sera_escape": -0.02209, "mutant": "I", "mutation": "L402I", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": -0.2325, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.377, "ferret_sera_escape": null, "mature_H5_site": 402, "mouse_sera_escape": null, "mutant": "K", "mutation": "L402K", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 402, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L402L", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7639, "ferret_sera_escape": -0.1151, "mature_H5_site": 402, "mouse_sera_escape": 0.02099, "mutant": "M", "mutation": "L402M", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": 0.1347, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.304, "ferret_sera_escape": -0.04732, "mature_H5_site": 402, "mouse_sera_escape": 0.116, "mutant": "N", "mutation": "L402N", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": 0.1336, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.978, "ferret_sera_escape": null, "mature_H5_site": 402, "mouse_sera_escape": null, "mutant": "P", "mutation": "L402P", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7077, "ferret_sera_escape": 0.1042, "mature_H5_site": 402, "mouse_sera_escape": 0.274, "mutant": "Q", "mutation": "L402Q", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": -0.03667, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.058, "ferret_sera_escape": 0.4479, "mature_H5_site": 402, "mouse_sera_escape": 0.5319, "mutant": "R", "mutation": "L402R", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": 1.226, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 402, "mouse_sera_escape": null, "mutant": "T", "mutation": "L402T", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.002795, "ferret_sera_escape": -0.1329, "mature_H5_site": 402, "mouse_sera_escape": -0.1116, "mutant": "V", "mutation": "L402V", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": -0.1478, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1514, "ferret_sera_escape": null, "mature_H5_site": 402, "mouse_sera_escape": null, "mutant": "W", "mutation": "L402W", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4193, "ferret_sera_escape": 0.04761, "mature_H5_site": 402, "mouse_sera_escape": 0.06484, "mutant": "Y", "mutation": "L402Y", "reference_site": "402", "region": "HA2", "sequential_site": 418, "stability": -0.2498, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.892, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "A", "mutation": "E403A", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "C", "mutation": "E403C", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "D", "mutation": "E403D", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 403, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E403E", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.747, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "F", "mutation": "E403F", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "G", "mutation": "E403G", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "H", "mutation": "E403H", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.997, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "I", "mutation": "E403I", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.845, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "K", "mutation": "E403K", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "L", "mutation": "E403L", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "M", "mutation": "E403M", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "N", "mutation": "E403N", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "P", "mutation": "E403P", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "Q", "mutation": "E403Q", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "R", "mutation": "E403R", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "S", "mutation": "E403S", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "T", "mutation": "E403T", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "V", "mutation": "E403V", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "W", "mutation": "E403W", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.167, "ferret_sera_escape": null, "mature_H5_site": 403, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E403Y", "reference_site": "403", "region": "HA2", "sequential_site": 419, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.271, "ferret_sera_escape": -0.1238, "mature_H5_site": 404, "mouse_sera_escape": -0.004708, "mutant": "C", "mutation": "R404C", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": -0.2587, "wildtype": "R"}, {"a26_usage": null, "cell_entry": -5.904, "ferret_sera_escape": null, "mature_H5_site": 404, "mouse_sera_escape": null, "mutant": "D", "mutation": "R404D", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.811, "ferret_sera_escape": null, "mature_H5_site": 404, "mouse_sera_escape": null, "mutant": "F", "mutation": "R404F", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.926, "ferret_sera_escape": null, "mature_H5_site": 404, "mouse_sera_escape": null, "mutant": "G", "mutation": "R404G", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5145, "ferret_sera_escape": -0.2844, "mature_H5_site": 404, "mouse_sera_escape": -0.08383, "mutant": "H", "mutation": "R404H", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": -0.1338, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.553, "ferret_sera_escape": -0.09603, "mature_H5_site": 404, "mouse_sera_escape": -0.09995, "mutant": "I", "mutation": "R404I", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": -0.7531, "wildtype": "R"}, {"a26_usage": 0.0481, "cell_entry": -0.05765, "ferret_sera_escape": 0.04756, "mature_H5_site": 404, "mouse_sera_escape": 0.011, "mutant": "K", "mutation": "R404K", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": -0.1664, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.418, "ferret_sera_escape": -0.2313, "mature_H5_site": 404, "mouse_sera_escape": 0.06041, "mutant": "L", "mutation": "R404L", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": -0.3614, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1928, "ferret_sera_escape": -0.1314, "mature_H5_site": 404, "mouse_sera_escape": -0.04474, "mutant": "M", "mutation": "R404M", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": -0.3231, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.09634, "ferret_sera_escape": -0.05186, "mature_H5_site": 404, "mouse_sera_escape": -0.1309, "mutant": "Q", "mutation": "R404Q", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": -0.4108, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 404, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R404R", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.366, "ferret_sera_escape": null, "mature_H5_site": 404, "mouse_sera_escape": null, "mutant": "V", "mutation": "R404V", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.239, "ferret_sera_escape": null, "mature_H5_site": 404, "mouse_sera_escape": null, "mutant": "W", "mutation": "R404W", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.328, "ferret_sera_escape": null, "mature_H5_site": 404, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R404Y", "reference_site": "404", "region": "HA2", "sequential_site": 420, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -6.015, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "A", "mutation": "R405A", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.325, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "C", "mutation": "R405C", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "D", "mutation": "R405D", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "E", "mutation": "R405E", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "F", "mutation": "R405F", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": null, "cell_entry": -5.877, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "G", "mutation": "R405G", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.894, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "H", "mutation": "R405H", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "I", "mutation": "R405I", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "K", "mutation": "R405K", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.711, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "L", "mutation": "R405L", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "M", "mutation": "R405M", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "N", "mutation": "R405N", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 405, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R405R", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.695, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "S", "mutation": "R405S", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.515, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "T", "mutation": "R405T", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.997, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "W", "mutation": "R405W", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 405, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R405Y", "reference_site": "405", "region": "HA2", "sequential_site": 421, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.537, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "A", "mutation": "I406A", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.595, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "C", "mutation": "I406C", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "D", "mutation": "I406D", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "E", "mutation": "I406E", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.17, "ferret_sera_escape": -0.1051, "mature_H5_site": 406, "mouse_sera_escape": 0.06332, "mutant": "F", "mutation": "I406F", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": 0.8334, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "G", "mutation": "I406G", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 406, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I406I", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "K", "mutation": "I406K", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6878, "ferret_sera_escape": 0.02728, "mature_H5_site": 406, "mouse_sera_escape": 0.08092, "mutant": "L", "mutation": "I406L", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": 0.9376, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.404, "ferret_sera_escape": -0.126, "mature_H5_site": 406, "mouse_sera_escape": -0.02473, "mutant": "M", "mutation": "I406M", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "P", "mutation": "I406P", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.895, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "R", "mutation": "I406R", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "S", "mutation": "I406S", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.359, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "T", "mutation": "I406T", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.3184, "cell_entry": -0.4836, "ferret_sera_escape": -0.09341, "mature_H5_site": 406, "mouse_sera_escape": -0.01798, "mutant": "V", "mutation": "I406V", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": -0.05386, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.41, "ferret_sera_escape": 0.03791, "mature_H5_site": 406, "mouse_sera_escape": 0.1523, "mutant": "W", "mutation": "I406W", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": 0.4579, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.8275, "ferret_sera_escape": null, "mature_H5_site": 406, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I406Y", "reference_site": "406", "region": "HA2", "sequential_site": 422, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.752, "ferret_sera_escape": 0.01527, "mature_H5_site": 407, "mouse_sera_escape": 0.07276, "mutant": "A", "mutation": "E407A", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 1.483, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.755, "ferret_sera_escape": -0.09594, "mature_H5_site": 407, "mouse_sera_escape": -0.007637, "mutant": "C", "mutation": "E407C", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": -0.00858, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.647, "ferret_sera_escape": -0.1088, "mature_H5_site": 407, "mouse_sera_escape": -0.1113, "mutant": "D", "mutation": "E407D", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": -0.2119, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 407, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E407E", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2576, "ferret_sera_escape": 0.001543, "mature_H5_site": 407, "mouse_sera_escape": 0.1017, "mutant": "F", "mutation": "E407F", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 1.854, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.514, "ferret_sera_escape": -0.08591, "mature_H5_site": 407, "mouse_sera_escape": 0.02864, "mutant": "G", "mutation": "E407G", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": -0.0347, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.0126, "ferret_sera_escape": -0.07791, "mature_H5_site": 407, "mouse_sera_escape": -0.02443, "mutant": "H", "mutation": "E407H", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": -0.2141, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.029, "ferret_sera_escape": null, "mature_H5_site": 407, "mouse_sera_escape": null, "mutant": "I", "mutation": "E407I", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.201, "ferret_sera_escape": -0.06668, "mature_H5_site": 407, "mouse_sera_escape": 0.133, "mutant": "K", "mutation": "E407K", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 0.9306, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.501, "ferret_sera_escape": -0.208, "mature_H5_site": 407, "mouse_sera_escape": null, "mutant": "L", "mutation": "E407L", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 0.7533, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.544, "ferret_sera_escape": null, "mature_H5_site": 407, "mouse_sera_escape": 0.1348, "mutant": "M", "mutation": "E407M", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.286, "ferret_sera_escape": -0.2913, "mature_H5_site": 407, "mouse_sera_escape": -0.04817, "mutant": "N", "mutation": "E407N", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": -0.03245, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 407, "mouse_sera_escape": null, "mutant": "P", "mutation": "E407P", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.28, "ferret_sera_escape": -0.3233, "mature_H5_site": 407, "mouse_sera_escape": -0.03573, "mutant": "Q", "mutation": "E407Q", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.00553, "ferret_sera_escape": -0.2754, "mature_H5_site": 407, "mouse_sera_escape": -0.09899, "mutant": "S", "mutation": "E407S", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 0.8929, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.301, "ferret_sera_escape": -0.1529, "mature_H5_site": 407, "mouse_sera_escape": 0.662, "mutant": "T", "mutation": "E407T", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 0.7825, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.273, "ferret_sera_escape": null, "mature_H5_site": 407, "mouse_sera_escape": 0.7003, "mutant": "V", "mutation": "E407V", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.05611, "ferret_sera_escape": null, "mature_H5_site": 407, "mouse_sera_escape": null, "mutant": "W", "mutation": "E407W", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3366, "ferret_sera_escape": -0.03037, "mature_H5_site": 407, "mouse_sera_escape": 0.06667, "mutant": "Y", "mutation": "E407Y", "reference_site": "407", "region": "HA2", "sequential_site": 423, "stability": 1.665, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0657, "ferret_sera_escape": 0.01877, "mature_H5_site": 408, "mouse_sera_escape": 0.2403, "mutant": "A", "mutation": "N408A", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.8457, "wildtype": "N"}, {"a26_usage": 0.02503, "cell_entry": 0.07118, "ferret_sera_escape": 0.1214, "mature_H5_site": 408, "mouse_sera_escape": 0.09547, "mutant": "C", "mutation": "N408C", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.862, "ferret_sera_escape": 0.07795, "mature_H5_site": 408, "mouse_sera_escape": -0.1507, "mutant": "D", "mutation": "N408D", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6343, "ferret_sera_escape": -0.005562, "mature_H5_site": 408, "mouse_sera_escape": 0.01643, "mutant": "E", "mutation": "N408E", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": -0.9864, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9346, "ferret_sera_escape": -0.4838, "mature_H5_site": 408, "mouse_sera_escape": -0.1187, "mutant": "F", "mutation": "N408F", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.719, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1895, "ferret_sera_escape": -0.08427, "mature_H5_site": 408, "mouse_sera_escape": 0.06398, "mutant": "G", "mutation": "N408G", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.09722, "wildtype": "N"}, {"a26_usage": null, "cell_entry": -0.04327, "ferret_sera_escape": -0.3752, "mature_H5_site": 408, "mouse_sera_escape": null, "mutant": "H", "mutation": "N408H", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9085, "ferret_sera_escape": null, "mature_H5_site": 408, "mouse_sera_escape": null, "mutant": "I", "mutation": "N408I", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.672, "ferret_sera_escape": -0.1829, "mature_H5_site": 408, "mouse_sera_escape": 0.5602, "mutant": "K", "mutation": "N408K", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.768, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04266, "ferret_sera_escape": -0.007397, "mature_H5_site": 408, "mouse_sera_escape": 0.05612, "mutant": "L", "mutation": "N408L", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.8249, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7057, "ferret_sera_escape": -0.02978, "mature_H5_site": 408, "mouse_sera_escape": 0.3955, "mutant": "M", "mutation": "N408M", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 1.269, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 408, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N408N", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 408, "mouse_sera_escape": null, "mutant": "P", "mutation": "N408P", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04367, "ferret_sera_escape": -0.1771, "mature_H5_site": 408, "mouse_sera_escape": -0.04453, "mutant": "Q", "mutation": "N408Q", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": -0.1454, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6967, "ferret_sera_escape": 0.1085, "mature_H5_site": 408, "mouse_sera_escape": 0.06319, "mutant": "S", "mutation": "N408S", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.2856, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4969, "ferret_sera_escape": -0.1595, "mature_H5_site": 408, "mouse_sera_escape": 0.2932, "mutant": "T", "mutation": "N408T", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.6629, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.117, "ferret_sera_escape": -0.1472, "mature_H5_site": 408, "mouse_sera_escape": 0.2868, "mutant": "V", "mutation": "N408V", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 1.107, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9513, "ferret_sera_escape": -0.3485, "mature_H5_site": 408, "mouse_sera_escape": -0.02193, "mutant": "W", "mutation": "N408W", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 0.3808, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.169, "ferret_sera_escape": -0.1301, "mature_H5_site": 408, "mouse_sera_escape": 0.03912, "mutant": "Y", "mutation": "N408Y", "reference_site": "408", "region": "HA2", "sequential_site": 424, "stability": 1.236, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.878, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "A", "mutation": "L409A", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "C", "mutation": "L409C", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "D", "mutation": "L409D", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.894, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "E", "mutation": "L409E", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.996, "ferret_sera_escape": -0.113, "mature_H5_site": 409, "mouse_sera_escape": 0.3935, "mutant": "F", "mutation": "L409F", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "G", "mutation": "L409G", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "H", "mutation": "L409H", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.386, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "I", "mutation": "L409I", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "K", "mutation": "L409K", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 409, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L409L", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "N", "mutation": "L409N", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "P", "mutation": "L409P", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.835, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L409Q", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "R", "mutation": "L409R", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "S", "mutation": "L409S", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.154, "ferret_sera_escape": 0.008573, "mature_H5_site": 409, "mouse_sera_escape": 0.09263, "mutant": "V", "mutation": "L409V", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": 1.071, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.809, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "W", "mutation": "L409W", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.991, "ferret_sera_escape": null, "mature_H5_site": 409, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L409Y", "reference_site": "409", "region": "HA2", "sequential_site": 425, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.165, "ferret_sera_escape": -0.06804, "mature_H5_site": 31, "mouse_sera_escape": null, "mutant": "A", "mutation": "D41A", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 31, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D41D", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2946, "ferret_sera_escape": 0.04599, "mature_H5_site": 31, "mouse_sera_escape": 0.07897, "mutant": "E", "mutation": "D41E", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": 1.517, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3858, "ferret_sera_escape": -0.03651, "mature_H5_site": 31, "mouse_sera_escape": 0.1429, "mutant": "G", "mutation": "D41G", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": 1.604, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.04228, "ferret_sera_escape": null, "mature_H5_site": 31, "mouse_sera_escape": null, "mutant": "H", "mutation": "D41H", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3564, "ferret_sera_escape": -0.04557, "mature_H5_site": 31, "mouse_sera_escape": 0.02066, "mutant": "K", "mutation": "D41K", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": -0.2327, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5279, "ferret_sera_escape": -0.06159, "mature_H5_site": 31, "mouse_sera_escape": -0.01646, "mutant": "L", "mutation": "D41L", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": -0.275, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.05694, "ferret_sera_escape": 0.01191, "mature_H5_site": 31, "mouse_sera_escape": -0.02046, "mutant": "M", "mutation": "D41M", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": -0.02056, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.03961, "ferret_sera_escape": 0.1142, "mature_H5_site": 31, "mouse_sera_escape": 0.03631, "mutant": "N", "mutation": "D41N", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": -0.06964, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4959, "ferret_sera_escape": -0.111, "mature_H5_site": 31, "mouse_sera_escape": -0.06069, "mutant": "P", "mutation": "D41P", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.06001, "ferret_sera_escape": -0.00353, "mature_H5_site": 31, "mouse_sera_escape": 0.09851, "mutant": "Q", "mutation": "D41Q", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": -0.2865, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7866, "ferret_sera_escape": -0.1366, "mature_H5_site": 31, "mouse_sera_escape": -0.04646, "mutant": "R", "mutation": "D41R", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": -0.1953, "wildtype": "D"}, {"a26_usage": 0.8774, "cell_entry": -0.3387, "ferret_sera_escape": -0.2291, "mature_H5_site": 31, "mouse_sera_escape": 0.4573, "mutant": "S", "mutation": "D41S", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.9921, "ferret_sera_escape": 0.03458, "mature_H5_site": 31, "mouse_sera_escape": 0.2019, "mutant": "T", "mutation": "D41T", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": 1.707, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5968, "ferret_sera_escape": null, "mature_H5_site": 31, "mouse_sera_escape": null, "mutant": "V", "mutation": "D41V", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": null, "wildtype": "D"}, {"a26_usage": 0.3703, "cell_entry": -0.3471, "ferret_sera_escape": 0.1232, "mature_H5_site": 31, "mouse_sera_escape": 0.2546, "mutant": "W", "mutation": "D41W", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": 1.612, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2681, "ferret_sera_escape": 0.01765, "mature_H5_site": 31, "mouse_sera_escape": 0.007474, "mutant": "Y", "mutation": "D41Y", "reference_site": "41", "region": "HA1", "sequential_site": 47, "stability": -0.184, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3307, "ferret_sera_escape": 0.03575, "mature_H5_site": 410, "mouse_sera_escape": 0.0247, "mutant": "A", "mutation": "N410A", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": 0.009286, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.231, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "C", "mutation": "N410C", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9637, "ferret_sera_escape": -0.04684, "mature_H5_site": 410, "mouse_sera_escape": 0.1223, "mutant": "D", "mutation": "N410D", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": -0.04098, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.21, "ferret_sera_escape": -0.2102, "mature_H5_site": 410, "mouse_sera_escape": 0.09249, "mutant": "E", "mutation": "N410E", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": 2.084, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3021, "ferret_sera_escape": -0.1244, "mature_H5_site": 410, "mouse_sera_escape": 0.2747, "mutant": "G", "mutation": "N410G", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": 0.5542, "wildtype": "N"}, {"a26_usage": 0.01257, "cell_entry": 0.005135, "ferret_sera_escape": 0.01191, "mature_H5_site": 410, "mouse_sera_escape": 0.0348, "mutant": "H", "mutation": "N410H", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": -0.1774, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.223, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "K", "mutation": "N410K", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.6, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "L", "mutation": "N410L", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.161, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": 1.15, "mutant": "M", "mutation": "N410M", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 410, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N410N", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.296, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N410Q", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": 0.5852, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.611, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "R", "mutation": "N410R", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.587, "ferret_sera_escape": -0.115, "mature_H5_site": 410, "mouse_sera_escape": 0.01127, "mutant": "S", "mutation": "N410S", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": -0.192, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.83, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "T", "mutation": "N410T", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "V", "mutation": "N410V", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.067, "ferret_sera_escape": null, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "W", "mutation": "N410W", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.231, "ferret_sera_escape": -0.2415, "mature_H5_site": 410, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N410Y", "reference_site": "410", "region": "HA2", "sequential_site": 426, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4272, "ferret_sera_escape": -0.1127, "mature_H5_site": 411, "mouse_sera_escape": 0.1439, "mutant": "A", "mutation": "K411A", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.803, "ferret_sera_escape": 0.3686, "mature_H5_site": 411, "mouse_sera_escape": 0.2578, "mutant": "C", "mutation": "K411C", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": -0.2077, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.699, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "D", "mutation": "K411D", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.7162, "cell_entry": -1.829, "ferret_sera_escape": 0.03857, "mature_H5_site": 411, "mouse_sera_escape": 0.02637, "mutant": "E", "mutation": "K411E", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": -0.2591, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.481, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "F", "mutation": "K411F", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": null, "cell_entry": -4.883, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "G", "mutation": "K411G", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.289, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "I", "mutation": "K411I", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 411, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K411K", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.723, "ferret_sera_escape": -0.1469, "mature_H5_site": 411, "mouse_sera_escape": 0.1327, "mutant": "L", "mutation": "K411L", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5161, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "M", "mutation": "K411M", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.522, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "N", "mutation": "K411N", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "P", "mutation": "K411P", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.07197, "ferret_sera_escape": -0.01675, "mature_H5_site": 411, "mouse_sera_escape": -0.07209, "mutant": "R", "mutation": "K411R", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": -0.2515, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2978, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "T", "mutation": "K411T", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.332, "ferret_sera_escape": -0.07142, "mature_H5_site": 411, "mouse_sera_escape": -0.07595, "mutant": "V", "mutation": "K411V", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": -0.2335, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "W", "mutation": "K411W", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.706, "ferret_sera_escape": null, "mature_H5_site": 411, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K411Y", "reference_site": "411", "region": "HA2", "sequential_site": 427, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.322, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "C", "mutation": "K412C", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.861, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "D", "mutation": "K412D", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.178, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "E", "mutation": "K412E", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.22, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "F", "mutation": "K412F", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.606, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "G", "mutation": "K412G", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.093, "ferret_sera_escape": 0.247, "mature_H5_site": 412, "mouse_sera_escape": 0.1306, "mutant": "H", "mutation": "K412H", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.9367, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.598, "ferret_sera_escape": -0.1227, "mature_H5_site": 412, "mouse_sera_escape": -0.1041, "mutant": "I", "mutation": "K412I", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.606, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 412, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K412K", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.642, "ferret_sera_escape": 0.1448, "mature_H5_site": 412, "mouse_sera_escape": 0.1274, "mutant": "L", "mutation": "K412L", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.8767, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.0, "ferret_sera_escape": 0.1616, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "M", "mutation": "K412M", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.572, "ferret_sera_escape": 0.2111, "mature_H5_site": 412, "mouse_sera_escape": 0.3292, "mutant": "N", "mutation": "K412N", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.1688, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.692, "ferret_sera_escape": 0.1466, "mature_H5_site": 412, "mouse_sera_escape": 0.1232, "mutant": "Q", "mutation": "K412Q", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.8259, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.737, "ferret_sera_escape": -0.2484, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "R", "mutation": "K412R", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "S", "mutation": "K412S", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "T", "mutation": "K412T", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.35, "ferret_sera_escape": 0.306, "mature_H5_site": 412, "mouse_sera_escape": 0.3033, "mutant": "V", "mutation": "K412V", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.3306, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.083, "ferret_sera_escape": null, "mature_H5_site": 412, "mouse_sera_escape": null, "mutant": "W", "mutation": "K412W", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.118, "ferret_sera_escape": -0.01199, "mature_H5_site": 412, "mouse_sera_escape": 0.3236, "mutant": "Y", "mutation": "K412Y", "reference_site": "412", "region": "HA2", "sequential_site": 428, "stability": 0.9124, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "A", "mutation": "M413A", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.797, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "F", "mutation": "M413F", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "G", "mutation": "M413G", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "H", "mutation": "M413H", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.2718, "ferret_sera_escape": -0.1016, "mature_H5_site": 413, "mouse_sera_escape": 0.0636, "mutant": "I", "mutation": "M413I", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": 0.5607, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "K", "mutation": "M413K", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.00092, "ferret_sera_escape": -0.07905, "mature_H5_site": 413, "mouse_sera_escape": -0.006619, "mutant": "L", "mutation": "M413L", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": 1.17, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 413, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M413M", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "N", "mutation": "M413N", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.964, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "P", "mutation": "M413P", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.409, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "Q", "mutation": "M413Q", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "S", "mutation": "M413S", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.29, "ferret_sera_escape": null, "mature_H5_site": 413, "mouse_sera_escape": null, "mutant": "T", "mutation": "M413T", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.1254, "ferret_sera_escape": 0.08285, "mature_H5_site": 413, "mouse_sera_escape": -0.01779, "mutant": "V", "mutation": "M413V", "reference_site": "413", "region": "HA2", "sequential_site": 429, "stability": -0.002705, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.028, "ferret_sera_escape": -0.09727, "mature_H5_site": 414, "mouse_sera_escape": 0.2234, "mutant": "A", "mutation": "E414A", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": 0.2993, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.315, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "C", "mutation": "E414C", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.457, "ferret_sera_escape": -0.1068, "mature_H5_site": 414, "mouse_sera_escape": 0.4814, "mutant": "D", "mutation": "E414D", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": 0.8328, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 414, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E414E", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.964, "ferret_sera_escape": -0.2996, "mature_H5_site": 414, "mouse_sera_escape": 0.3608, "mutant": "F", "mutation": "E414F", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.069, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "G", "mutation": "E414G", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2649, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "H", "mutation": "E414H", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2315, "ferret_sera_escape": 0.1856, "mature_H5_site": 414, "mouse_sera_escape": 0.1507, "mutant": "I", "mutation": "E414I", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": -0.3983, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.641, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "K", "mutation": "E414K", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": null, "cell_entry": -0.8568, "ferret_sera_escape": -0.09754, "mature_H5_site": 414, "mouse_sera_escape": 0.2857, "mutant": "L", "mutation": "E414L", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": -0.0599, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4277, "ferret_sera_escape": 0.03067, "mature_H5_site": 414, "mouse_sera_escape": 0.27, "mutant": "M", "mutation": "E414M", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": -0.3099, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.718, "ferret_sera_escape": -0.02499, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "N", "mutation": "E414N", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": -0.254, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3755, "ferret_sera_escape": 0.002617, "mature_H5_site": 414, "mouse_sera_escape": 0.1129, "mutant": "Q", "mutation": "E414Q", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": -0.2922, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.983, "ferret_sera_escape": 0.2877, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "R", "mutation": "E414R", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": -0.226, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5457, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "S", "mutation": "E414S", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.559, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": 0.1182, "mutant": "T", "mutation": "E414T", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.06156, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "V", "mutation": "E414V", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "W", "mutation": "E414W", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.839, "ferret_sera_escape": null, "mature_H5_site": 414, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E414Y", "reference_site": "414", "region": "HA2", "sequential_site": 430, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.343, "ferret_sera_escape": -0.4333, "mature_H5_site": 415, "mouse_sera_escape": -0.4182, "mutant": "A", "mutation": "D415A", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": -0.1906, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.099, "ferret_sera_escape": -0.2813, "mature_H5_site": 415, "mouse_sera_escape": -0.3007, "mutant": "C", "mutation": "D415C", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 415, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D415D", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.162, "ferret_sera_escape": -0.4499, "mature_H5_site": 415, "mouse_sera_escape": -0.3733, "mutant": "E", "mutation": "D415E", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": -0.3738, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.854, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "F", "mutation": "D415F", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7687, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "G", "mutation": "D415G", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.396, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "H", "mutation": "D415H", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": 0.1328, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.012, "ferret_sera_escape": -0.59, "mature_H5_site": 415, "mouse_sera_escape": -0.3836, "mutant": "I", "mutation": "D415I", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.726, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "K", "mutation": "D415K", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.829, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": -0.07787, "mutant": "L", "mutation": "D415L", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.508, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "M", "mutation": "D415M", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7733, "ferret_sera_escape": -0.2487, "mature_H5_site": 415, "mouse_sera_escape": -0.2303, "mutant": "N", "mutation": "D415N", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": -0.205, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "P", "mutation": "D415P", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.832, "ferret_sera_escape": -0.03999, "mature_H5_site": 415, "mouse_sera_escape": -0.02953, "mutant": "Q", "mutation": "D415Q", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": -0.04485, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.599, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "R", "mutation": "D415R", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.308, "ferret_sera_escape": -0.4954, "mature_H5_site": 415, "mouse_sera_escape": -0.557, "mutant": "T", "mutation": "D415T", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": -0.1006, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.055, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "V", "mutation": "D415V", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.747, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "W", "mutation": "D415W", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.365, "ferret_sera_escape": null, "mature_H5_site": 415, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D415Y", "reference_site": "415", "region": "HA2", "sequential_site": 431, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7084, "ferret_sera_escape": -0.2291, "mature_H5_site": 416, "mouse_sera_escape": -0.1096, "mutant": "A", "mutation": "G416A", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": -0.2343, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "C", "mutation": "G416C", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.053, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "D", "mutation": "G416D", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.229, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "E", "mutation": "G416E", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "F", "mutation": "G416F", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 416, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G416G", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "H", "mutation": "G416H", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "I", "mutation": "G416I", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.865, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "K", "mutation": "G416K", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "L", "mutation": "G416L", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.516, "ferret_sera_escape": 0.1183, "mature_H5_site": 416, "mouse_sera_escape": 0.3029, "mutant": "N", "mutation": "G416N", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": 0.8296, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "P", "mutation": "G416P", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.183, "ferret_sera_escape": -0.1813, "mature_H5_site": 416, "mouse_sera_escape": 0.1031, "mutant": "Q", "mutation": "G416Q", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": 0.6068, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.271, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "R", "mutation": "G416R", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.225, "ferret_sera_escape": -0.1979, "mature_H5_site": 416, "mouse_sera_escape": 0.05541, "mutant": "S", "mutation": "G416S", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": -0.2475, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.29, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "T", "mutation": "G416T", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 416, "mouse_sera_escape": null, "mutant": "V", "mutation": "G416V", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.716, "ferret_sera_escape": 0.05853, "mature_H5_site": 416, "mouse_sera_escape": 0.3744, "mutant": "Y", "mutation": "G416Y", "reference_site": "416", "region": "HA2", "sequential_site": 432, "stability": -0.1817, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.796, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "A", "mutation": "F417A", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.012, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "C", "mutation": "F417C", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.256, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "D", "mutation": "F417D", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "E", "mutation": "F417E", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 417, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F417F", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "G", "mutation": "F417G", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.848, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "H", "mutation": "F417H", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.617, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "I", "mutation": "F417I", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.71, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "K", "mutation": "F417K", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.915, "ferret_sera_escape": 0.03742, "mature_H5_site": 417, "mouse_sera_escape": 0.008507, "mutant": "L", "mutation": "F417L", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": 0.3511, "wildtype": "F"}, {"a26_usage": null, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "M", "mutation": "F417M", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "N", "mutation": "F417N", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.89, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "P", "mutation": "F417P", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.86, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F417Q", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "R", "mutation": "F417R", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "S", "mutation": "F417S", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "T", "mutation": "F417T", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "V", "mutation": "F417V", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "W", "mutation": "F417W", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 417, "mouse_sera_escape": null, "mutant": "Y", "mutation": "F417Y", "reference_site": "417", "region": "HA2", "sequential_site": 433, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.791, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "C", "mutation": "L418C", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9041, "ferret_sera_escape": 0.09284, "mature_H5_site": 418, "mouse_sera_escape": 0.1316, "mutant": "D", "mutation": "L418D", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 1.671, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.364, "ferret_sera_escape": 0.007684, "mature_H5_site": 418, "mouse_sera_escape": 0.09424, "mutant": "E", "mutation": "L418E", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 1.698, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.561, "ferret_sera_escape": 0.06553, "mature_H5_site": 418, "mouse_sera_escape": 0.3025, "mutant": "F", "mutation": "L418F", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 1.818, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.891, "ferret_sera_escape": -0.1008, "mature_H5_site": 418, "mouse_sera_escape": 0.0475, "mutant": "H", "mutation": "L418H", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.62, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "I", "mutation": "L418I", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.51, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "K", "mutation": "L418K", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 418, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L418L", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.664, "ferret_sera_escape": -0.0091, "mature_H5_site": 418, "mouse_sera_escape": 0.1316, "mutant": "N", "mutation": "L418N", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 1.805, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.719, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "P", "mutation": "L418P", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06695, "ferret_sera_escape": -0.1301, "mature_H5_site": 418, "mouse_sera_escape": 0.1966, "mutant": "Q", "mutation": "L418Q", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 0.5193, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.776, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "R", "mutation": "L418R", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.079, "ferret_sera_escape": -0.07414, "mature_H5_site": 418, "mouse_sera_escape": 0.5139, "mutant": "S", "mutation": "L418S", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 1.268, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.886, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "T", "mutation": "L418T", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.516, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "V", "mutation": "L418V", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.723, "ferret_sera_escape": null, "mature_H5_site": 418, "mouse_sera_escape": null, "mutant": "W", "mutation": "L418W", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.164, "ferret_sera_escape": 0.01811, "mature_H5_site": 418, "mouse_sera_escape": 0.1803, "mutant": "Y", "mutation": "L418Y", "reference_site": "418", "region": "HA2", "sequential_site": 434, "stability": 1.089, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 419, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D419D", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.031, "ferret_sera_escape": -0.08571, "mature_H5_site": 419, "mouse_sera_escape": 0.06388, "mutant": "E", "mutation": "D419E", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": 1.518, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.331, "ferret_sera_escape": null, "mature_H5_site": 419, "mouse_sera_escape": null, "mutant": "F", "mutation": "D419F", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8767, "ferret_sera_escape": 0.08097, "mature_H5_site": 419, "mouse_sera_escape": 0.1508, "mutant": "G", "mutation": "D419G", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": -0.1231, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 419, "mouse_sera_escape": null, "mutant": "I", "mutation": "D419I", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.402, "ferret_sera_escape": null, "mature_H5_site": 419, "mouse_sera_escape": null, "mutant": "L", "mutation": "D419L", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3654, "ferret_sera_escape": 0.004667, "mature_H5_site": 419, "mouse_sera_escape": 0.2683, "mutant": "M", "mutation": "D419M", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": 1.454, "wildtype": "D"}, {"a26_usage": 0.5048, "cell_entry": -0.8315, "ferret_sera_escape": 0.01171, "mature_H5_site": 419, "mouse_sera_escape": 0.1504, "mutant": "N", "mutation": "D419N", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": -0.1477, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.325, "ferret_sera_escape": null, "mature_H5_site": 419, "mouse_sera_escape": null, "mutant": "P", "mutation": "D419P", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.552, "ferret_sera_escape": -0.2125, "mature_H5_site": 419, "mouse_sera_escape": 0.4522, "mutant": "Q", "mutation": "D419Q", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": 0.1899, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 419, "mouse_sera_escape": null, "mutant": "R", "mutation": "D419R", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2809, "ferret_sera_escape": -0.04027, "mature_H5_site": 419, "mouse_sera_escape": 0.06462, "mutant": "S", "mutation": "D419S", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": 0.2792, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.383, "ferret_sera_escape": -0.1384, "mature_H5_site": 419, "mouse_sera_escape": 0.07944, "mutant": "V", "mutation": "D419V", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": -0.3396, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.487, "ferret_sera_escape": null, "mature_H5_site": 419, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D419Y", "reference_site": "419", "region": "HA2", "sequential_site": 435, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.048, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "A", "mutation": "I42A", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.505, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "C", "mutation": "I42C", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "D", "mutation": "I42D", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.861, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "E", "mutation": "I42E", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.98, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "F", "mutation": "I42F", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.961, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "G", "mutation": "I42G", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.715, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "H", "mutation": "I42H", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 32, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I42I", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "K", "mutation": "I42K", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.388, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "M", "mutation": "I42M", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.592, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "N", "mutation": "I42N", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "P", "mutation": "I42P", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I42Q", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.232, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "R", "mutation": "I42R", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.871, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "S", "mutation": "I42S", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "T", "mutation": "I42T", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6063, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "V", "mutation": "I42V", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 32, "mouse_sera_escape": null, "mutant": "W", "mutation": "I42W", "reference_site": "42", "region": "HA1", "sequential_site": 48, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.873, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "A", "mutation": "V420A", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.861, "ferret_sera_escape": 0.07914, "mature_H5_site": 420, "mouse_sera_escape": 0.1183, "mutant": "C", "mutation": "V420C", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.821, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "D", "mutation": "V420D", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.788, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "E", "mutation": "V420E", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.907, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "F", "mutation": "V420F", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "G", "mutation": "V420G", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "H", "mutation": "V420H", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.106, "ferret_sera_escape": 0.03035, "mature_H5_site": 420, "mouse_sera_escape": 0.03598, "mutant": "I", "mutation": "V420I", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": 0.4243, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.977, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "K", "mutation": "V420K", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.03869, "ferret_sera_escape": -0.05563, "mature_H5_site": 420, "mouse_sera_escape": -0.05888, "mutant": "L", "mutation": "V420L", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": -0.1246, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.333, "ferret_sera_escape": -0.08646, "mature_H5_site": 420, "mouse_sera_escape": -0.0006362, "mutant": "M", "mutation": "V420M", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": 1.69, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "N", "mutation": "V420N", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.881, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "P", "mutation": "V420P", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.615, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V420Q", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "R", "mutation": "V420R", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.897, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "S", "mutation": "V420S", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.581, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "T", "mutation": "V420T", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 420, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V420V", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "W", "mutation": "V420W", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 420, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V420Y", "reference_site": "420", "region": "HA2", "sequential_site": 436, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "C", "mutation": "W421C", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "D", "mutation": "W421D", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "E", "mutation": "W421E", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "G", "mutation": "W421G", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "H", "mutation": "W421H", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.879, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "I", "mutation": "W421I", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "K", "mutation": "W421K", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.88, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "L", "mutation": "W421L", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.247, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "M", "mutation": "W421M", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "N", "mutation": "W421N", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "P", "mutation": "W421P", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W421Q", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.095, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "R", "mutation": "W421R", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.874, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "S", "mutation": "W421S", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.465, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "T", "mutation": "W421T", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.107, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "V", "mutation": "W421V", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 421, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W421W", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.834, "ferret_sera_escape": null, "mature_H5_site": 421, "mouse_sera_escape": null, "mutant": "Y", "mutation": "W421Y", "reference_site": "421", "region": "HA2", "sequential_site": 437, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "A", "mutation": "T422A", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.221, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "C", "mutation": "T422C", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "D", "mutation": "T422D", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "E", "mutation": "T422E", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.801, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "G", "mutation": "T422G", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "H", "mutation": "T422H", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.746, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "I", "mutation": "T422I", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "L", "mutation": "T422L", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.59, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "M", "mutation": "T422M", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.923, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "N", "mutation": "T422N", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.194, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "P", "mutation": "T422P", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.24, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T422Q", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "R", "mutation": "T422R", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.786, "ferret_sera_escape": 0.05483, "mature_H5_site": 422, "mouse_sera_escape": 0.1205, "mutant": "S", "mutation": "T422S", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": -0.1377, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 422, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T422T", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "V", "mutation": "T422V", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "W", "mutation": "T422W", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.99, "ferret_sera_escape": null, "mature_H5_site": 422, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T422Y", "reference_site": "422", "region": "HA2", "sequential_site": 438, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.98, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y423A", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.46, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y423C", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.177, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y423D", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.502, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y423E", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7398, "ferret_sera_escape": -0.1458, "mature_H5_site": 423, "mouse_sera_escape": 0.259, "mutant": "F", "mutation": "Y423F", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.065, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y423H", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.714, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y423I", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.374, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y423K", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y423L", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y423M", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.907, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y423N", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.617, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y423P", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.93, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y423Q", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.806, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y423R", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.538, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y423V", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.197, "ferret_sera_escape": null, "mature_H5_site": 423, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y423W", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 423, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y423Y", "reference_site": "423", "region": "HA2", "sequential_site": 439, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.056, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "C", "mutation": "N424C", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.332, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "D", "mutation": "N424D", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3063, "ferret_sera_escape": -0.06419, "mature_H5_site": 424, "mouse_sera_escape": -0.08343, "mutant": "E", "mutation": "N424E", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": 0.8584, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.772, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "F", "mutation": "N424F", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.815, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "H", "mutation": "N424H", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "I", "mutation": "N424I", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.694, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "K", "mutation": "N424K", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.708, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "M", "mutation": "N424M", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 424, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N424N", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "P", "mutation": "N424P", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.907, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N424Q", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "R", "mutation": "N424R", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.704, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "S", "mutation": "N424S", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.867, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "T", "mutation": "N424T", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -6.021, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "V", "mutation": "N424V", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": null, "cell_entry": -5.785, "ferret_sera_escape": null, "mature_H5_site": 424, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N424Y", "reference_site": "424", "region": "HA2", "sequential_site": 440, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 425, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A425A", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.328, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "C", "mutation": "A425C", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.778, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "D", "mutation": "A425D", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.986, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "E", "mutation": "A425E", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.681, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "F", "mutation": "A425F", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.472, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "G", "mutation": "A425G", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.822, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "H", "mutation": "A425H", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.8683, "ferret_sera_escape": -0.06039, "mature_H5_site": 425, "mouse_sera_escape": 0.04859, "mutant": "I", "mutation": "A425I", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": -0.1382, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "K", "mutation": "A425K", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "L", "mutation": "A425L", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.399, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "N", "mutation": "A425N", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.888, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "P", "mutation": "A425P", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.876, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A425Q", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "R", "mutation": "A425R", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5487, "ferret_sera_escape": 0.004343, "mature_H5_site": 425, "mouse_sera_escape": -0.2134, "mutant": "S", "mutation": "A425S", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": 0.3656, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.9384, "ferret_sera_escape": -0.1295, "mature_H5_site": 425, "mouse_sera_escape": -0.1229, "mutant": "T", "mutation": "A425T", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": -0.3693, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.986, "ferret_sera_escape": -0.1152, "mature_H5_site": 425, "mouse_sera_escape": 0.005449, "mutant": "V", "mutation": "A425V", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": -0.06037, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.564, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "W", "mutation": "A425W", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.846, "ferret_sera_escape": null, "mature_H5_site": 425, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A425Y", "reference_site": "425", "region": "HA2", "sequential_site": 441, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.135, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "A", "mutation": "E426A", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.829, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "C", "mutation": "E426C", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.55, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "D", "mutation": "E426D", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 426, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E426E", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "F", "mutation": "E426F", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.967, "ferret_sera_escape": 0.02262, "mature_H5_site": 426, "mouse_sera_escape": 0.02021, "mutant": "G", "mutation": "E426G", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": null, "cell_entry": -5.656, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "I", "mutation": "E426I", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.457, "ferret_sera_escape": 0.0469, "mature_H5_site": 426, "mouse_sera_escape": 0.1059, "mutant": "K", "mutation": "E426K", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "L", "mutation": "E426L", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.007, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "M", "mutation": "E426M", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.558, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "P", "mutation": "E426P", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.756, "ferret_sera_escape": -0.1289, "mature_H5_site": 426, "mouse_sera_escape": 0.001571, "mutant": "Q", "mutation": "E426Q", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": -0.1506, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.856, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "S", "mutation": "E426S", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.86, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "T", "mutation": "E426T", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.746, "ferret_sera_escape": -0.0591, "mature_H5_site": 426, "mouse_sera_escape": 0.4253, "mutant": "V", "mutation": "E426V", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.994, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "W", "mutation": "E426W", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.85, "ferret_sera_escape": null, "mature_H5_site": 426, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E426Y", "reference_site": "426", "region": "HA2", "sequential_site": 442, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.914, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "A", "mutation": "L427A", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": null, "cell_entry": -4.474, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "C", "mutation": "L427C", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "D", "mutation": "L427D", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "G", "mutation": "L427G", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.716, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "H", "mutation": "L427H", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.266, "ferret_sera_escape": -0.2673, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "I", "mutation": "L427I", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "K", "mutation": "L427K", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 427, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L427L", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.566, "ferret_sera_escape": 0.2469, "mature_H5_site": 427, "mouse_sera_escape": 0.2186, "mutant": "M", "mutation": "L427M", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": 2.003, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.016, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "N", "mutation": "L427N", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "P", "mutation": "L427P", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L427Q", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.684, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "R", "mutation": "L427R", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "S", "mutation": "L427S", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.054, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "T", "mutation": "L427T", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.942, "ferret_sera_escape": -0.07797, "mature_H5_site": 427, "mouse_sera_escape": 0.4101, "mutant": "V", "mutation": "L427V", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": 0.7623, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.635, "ferret_sera_escape": null, "mature_H5_site": 427, "mouse_sera_escape": null, "mutant": "W", "mutation": "L427W", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.503, "ferret_sera_escape": 0.1675, "mature_H5_site": 427, "mouse_sera_escape": 0.1156, "mutant": "Y", "mutation": "L427Y", "reference_site": "427", "region": "HA2", "sequential_site": 443, "stability": 1.617, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.541, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "A", "mutation": "L428A", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.239, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "C", "mutation": "L428C", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "D", "mutation": "L428D", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.637, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "E", "mutation": "L428E", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6339, "ferret_sera_escape": -0.01424, "mature_H5_site": 428, "mouse_sera_escape": 0.05013, "mutant": "F", "mutation": "L428F", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.555, "ferret_sera_escape": 0.4986, "mature_H5_site": 428, "mouse_sera_escape": 0.5666, "mutant": "I", "mutation": "L428I", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": 1.416, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "K", "mutation": "L428K", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 428, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L428L", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1434, "ferret_sera_escape": 0.1451, "mature_H5_site": 428, "mouse_sera_escape": 0.009208, "mutant": "M", "mutation": "L428M", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": 1.513, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.022, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "N", "mutation": "L428N", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "P", "mutation": "L428P", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L428Q", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.972, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "R", "mutation": "L428R", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.874, "ferret_sera_escape": 0.2334, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "T", "mutation": "L428T", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.224, "ferret_sera_escape": null, "mature_H5_site": 428, "mouse_sera_escape": null, "mutant": "V", "mutation": "L428V", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5822, "ferret_sera_escape": -0.2336, "mature_H5_site": 428, "mouse_sera_escape": -0.1656, "mutant": "W", "mutation": "L428W", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.163, "ferret_sera_escape": -0.04157, "mature_H5_site": 428, "mouse_sera_escape": 0.2015, "mutant": "Y", "mutation": "L428Y", "reference_site": "428", "region": "HA2", "sequential_site": 444, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.556, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "C", "mutation": "V429C", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "E", "mutation": "V429E", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "F", "mutation": "V429F", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.84, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "G", "mutation": "V429G", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "H", "mutation": "V429H", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1104, "ferret_sera_escape": 0.07712, "mature_H5_site": 429, "mouse_sera_escape": 0.0004606, "mutant": "I", "mutation": "V429I", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": -0.1302, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "K", "mutation": "V429K", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.595, "ferret_sera_escape": -0.1606, "mature_H5_site": 429, "mouse_sera_escape": -0.1193, "mutant": "L", "mutation": "V429L", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.496, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "M", "mutation": "V429M", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "N", "mutation": "V429N", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "P", "mutation": "V429P", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V429Q", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "R", "mutation": "V429R", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.494, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "S", "mutation": "V429S", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8071, "ferret_sera_escape": -0.06854, "mature_H5_site": 429, "mouse_sera_escape": -0.08456, "mutant": "T", "mutation": "V429T", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": 0.2335, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 429, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V429V", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": 0.0, "wildtype": "V"}, {"a26_usage": null, "cell_entry": -3.022, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "W", "mutation": "V429W", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 429, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V429Y", "reference_site": "429", "region": "HA2", "sequential_site": 445, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "A", "mutation": "L43A", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.913, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "C", "mutation": "L43C", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "D", "mutation": "L43D", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "E", "mutation": "L43E", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.796, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "F", "mutation": "L43F", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.745, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "G", "mutation": "L43G", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "H", "mutation": "L43H", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.289, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "I", "mutation": "L43I", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "K", "mutation": "L43K", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 33, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L43L", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.112, "ferret_sera_escape": -0.0122, "mature_H5_site": 33, "mouse_sera_escape": -0.163, "mutant": "M", "mutation": "L43M", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": 0.03442, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "N", "mutation": "L43N", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.791, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "P", "mutation": "L43P", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.596, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L43Q", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "R", "mutation": "L43R", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.746, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "S", "mutation": "L43S", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "T", "mutation": "L43T", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "W", "mutation": "L43W", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 33, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L43Y", "reference_site": "43", "region": "HA1", "sequential_site": 49, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.542, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "A", "mutation": "L430A", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "C", "mutation": "L430C", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.816, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "E", "mutation": "L430E", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "F", "mutation": "L430F", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.521, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "G", "mutation": "L430G", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.697, "ferret_sera_escape": -0.09284, "mature_H5_site": 430, "mouse_sera_escape": -0.01187, "mutant": "I", "mutation": "L430I", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": -0.05187, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.729, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "K", "mutation": "L430K", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 430, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L430L", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.355, "ferret_sera_escape": -0.09206, "mature_H5_site": 430, "mouse_sera_escape": 0.1358, "mutant": "M", "mutation": "L430M", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": -0.2626, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "N", "mutation": "L430N", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "P", "mutation": "L430P", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.914, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L430Q", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "R", "mutation": "L430R", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "T", "mutation": "L430T", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.613, "ferret_sera_escape": -0.2478, "mature_H5_site": 430, "mouse_sera_escape": 0.01068, "mutant": "V", "mutation": "L430V", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": -0.2226, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "W", "mutation": "L430W", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.029, "ferret_sera_escape": null, "mature_H5_site": 430, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L430Y", "reference_site": "430", "region": "HA2", "sequential_site": 446, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.425, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "A", "mutation": "M431A", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "D", "mutation": "M431D", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.383, "ferret_sera_escape": -0.2085, "mature_H5_site": 431, "mouse_sera_escape": 0.2873, "mutant": "E", "mutation": "M431E", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.715, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "G", "mutation": "M431G", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.915, "ferret_sera_escape": -0.1324, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "H", "mutation": "M431H", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.519, "ferret_sera_escape": -0.1038, "mature_H5_site": 431, "mouse_sera_escape": 0.2612, "mutant": "I", "mutation": "M431I", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": 0.6702, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.249, "ferret_sera_escape": 0.09013, "mature_H5_site": 431, "mouse_sera_escape": 0.1272, "mutant": "K", "mutation": "M431K", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": 1.526, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.466, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "L", "mutation": "M431L", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": 0.7024, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 431, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M431M", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.696, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "N", "mutation": "M431N", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.647, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "Q", "mutation": "M431Q", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.29, "ferret_sera_escape": 0.2818, "mature_H5_site": 431, "mouse_sera_escape": 0.2798, "mutant": "R", "mutation": "M431R", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": 1.395, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.919, "ferret_sera_escape": 0.2248, "mature_H5_site": 431, "mouse_sera_escape": 0.006315, "mutant": "S", "mutation": "M431S", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.877, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "T", "mutation": "M431T", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.465, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "V", "mutation": "M431V", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.3077, "ferret_sera_escape": -0.06187, "mature_H5_site": 431, "mouse_sera_escape": 0.1993, "mutant": "W", "mutation": "M431W", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": 0.1453, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.131, "ferret_sera_escape": null, "mature_H5_site": 431, "mouse_sera_escape": null, "mutant": "Y", "mutation": "M431Y", "reference_site": "431", "region": "HA2", "sequential_site": 447, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.07977, "ferret_sera_escape": 0.1713, "mature_H5_site": 432, "mouse_sera_escape": 0.05805, "mutant": "A", "mutation": "E432A", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": 0.05542, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.103, "ferret_sera_escape": 0.1643, "mature_H5_site": 432, "mouse_sera_escape": 0.07336, "mutant": "C", "mutation": "E432C", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "D", "mutation": "E432D", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 432, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E432E", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "F", "mutation": "E432F", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": null, "cell_entry": -3.924, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "G", "mutation": "E432G", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.746, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "H", "mutation": "E432H", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.875, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "I", "mutation": "E432I", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -6.04, "ferret_sera_escape": -0.09961, "mature_H5_site": 432, "mouse_sera_escape": -0.1797, "mutant": "K", "mutation": "E432K", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": -0.2381, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.645, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "L", "mutation": "E432L", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.314, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "M", "mutation": "E432M", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.098, "ferret_sera_escape": -0.262, "mature_H5_site": 432, "mouse_sera_escape": 0.5874, "mutant": "N", "mutation": "E432N", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": 0.4854, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "P", "mutation": "E432P", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.557, "ferret_sera_escape": -0.01028, "mature_H5_site": 432, "mouse_sera_escape": 0.03085, "mutant": "Q", "mutation": "E432Q", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "R", "mutation": "E432R", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5347, "ferret_sera_escape": -0.1607, "mature_H5_site": 432, "mouse_sera_escape": -0.09767, "mutant": "S", "mutation": "E432S", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": 1.111, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.329, "ferret_sera_escape": -0.09794, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "T", "mutation": "E432T", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": 0.2655, "wildtype": "E"}, {"a26_usage": null, "cell_entry": -5.895, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "V", "mutation": "E432V", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.588, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "W", "mutation": "E432W", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.093, "ferret_sera_escape": null, "mature_H5_site": 432, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E432Y", "reference_site": "432", "region": "HA2", "sequential_site": 448, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.999, "ferret_sera_escape": null, "mature_H5_site": 433, "mouse_sera_escape": null, "mutant": "D", "mutation": "N433D", "reference_site": "433", "region": "HA2", "sequential_site": 449, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 433, "mouse_sera_escape": null, "mutant": "E", "mutation": "N433E", "reference_site": "433", "region": "HA2", "sequential_site": 449, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.009, "ferret_sera_escape": null, "mature_H5_site": 433, "mouse_sera_escape": null, "mutant": "G", "mutation": "N433G", "reference_site": "433", "region": "HA2", "sequential_site": 449, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 433, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N433N", "reference_site": "433", "region": "HA2", "sequential_site": 449, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 433, "mouse_sera_escape": null, "mutant": "S", "mutation": "N433S", "reference_site": "433", "region": "HA2", "sequential_site": 449, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.992, "ferret_sera_escape": null, "mature_H5_site": 433, "mouse_sera_escape": null, "mutant": "V", "mutation": "N433V", "reference_site": "433", "region": "HA2", "sequential_site": 449, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 433, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N433Y", "reference_site": "433", "region": "HA2", "sequential_site": 449, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.387, "ferret_sera_escape": 0.07113, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "A", "mutation": "E434A", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.741, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "C", "mutation": "E434C", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.063, "ferret_sera_escape": -0.08653, "mature_H5_site": 434, "mouse_sera_escape": 0.1699, "mutant": "D", "mutation": "E434D", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": 1.487, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 434, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E434E", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.234, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "F", "mutation": "E434F", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0387, "ferret_sera_escape": 0.1167, "mature_H5_site": 434, "mouse_sera_escape": 0.04604, "mutant": "G", "mutation": "E434G", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": 0.5272, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.711, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "H", "mutation": "E434H", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.087, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "I", "mutation": "E434I", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.369, "ferret_sera_escape": -0.07132, "mature_H5_site": 434, "mouse_sera_escape": 0.3653, "mutant": "K", "mutation": "E434K", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.675, "ferret_sera_escape": 0.1064, "mature_H5_site": 434, "mouse_sera_escape": 0.4753, "mutant": "L", "mutation": "E434L", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": 1.12, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.216, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "M", "mutation": "E434M", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "P", "mutation": "E434P", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6979, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "Q", "mutation": "E434Q", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.256, "ferret_sera_escape": 0.3391, "mature_H5_site": 434, "mouse_sera_escape": 0.3472, "mutant": "R", "mutation": "E434R", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": -0.1365, "wildtype": "E"}, {"a26_usage": null, "cell_entry": -3.077, "ferret_sera_escape": -0.5206, "mature_H5_site": 434, "mouse_sera_escape": 0.578, "mutant": "S", "mutation": "E434S", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7249, "ferret_sera_escape": 0.3183, "mature_H5_site": 434, "mouse_sera_escape": 0.4272, "mutant": "T", "mutation": "E434T", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": 1.076, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.39, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": 0.5883, "mutant": "V", "mutation": "E434V", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.506, "ferret_sera_escape": null, "mature_H5_site": 434, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E434Y", "reference_site": "434", "region": "HA2", "sequential_site": 450, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.371, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "C", "mutation": "R435C", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.672, "ferret_sera_escape": -0.1952, "mature_H5_site": 435, "mouse_sera_escape": 0.3825, "mutant": "D", "mutation": "R435D", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": 2.243, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.909, "ferret_sera_escape": -0.4258, "mature_H5_site": 435, "mouse_sera_escape": 0.3878, "mutant": "E", "mutation": "R435E", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": 2.157, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.732, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "F", "mutation": "R435F", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.082, "ferret_sera_escape": -0.1131, "mature_H5_site": 435, "mouse_sera_escape": 0.1421, "mutant": "G", "mutation": "R435G", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5032, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "H", "mutation": "R435H", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.72, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "I", "mutation": "R435I", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.13, "ferret_sera_escape": -0.06486, "mature_H5_site": 435, "mouse_sera_escape": 0.01396, "mutant": "K", "mutation": "R435K", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": 1.909, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "L", "mutation": "R435L", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.046, "ferret_sera_escape": -0.05447, "mature_H5_site": 435, "mouse_sera_escape": 0.00284, "mutant": "N", "mutation": "R435N", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": 0.9964, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "P", "mutation": "R435P", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.022, "ferret_sera_escape": -0.0395, "mature_H5_site": 435, "mouse_sera_escape": 0.2066, "mutant": "Q", "mutation": "R435Q", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": 2.158, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 435, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R435R", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.263, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "S", "mutation": "R435S", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -6.008, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "T", "mutation": "R435T", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.828, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "V", "mutation": "R435V", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "W", "mutation": "R435W", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.627, "ferret_sera_escape": null, "mature_H5_site": 435, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R435Y", "reference_site": "435", "region": "HA2", "sequential_site": 451, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "A", "mutation": "T436A", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "C", "mutation": "T436C", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.87, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "D", "mutation": "T436D", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "E", "mutation": "T436E", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.99, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "F", "mutation": "T436F", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "G", "mutation": "T436G", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "H", "mutation": "T436H", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "I", "mutation": "T436I", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "K", "mutation": "T436K", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "L", "mutation": "T436L", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.53, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "M", "mutation": "T436M", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "N", "mutation": "T436N", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "P", "mutation": "T436P", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T436Q", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.78, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "R", "mutation": "T436R", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.901, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "S", "mutation": "T436S", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 436, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T436T", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.975, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "V", "mutation": "T436V", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -6.014, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "W", "mutation": "T436W", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 436, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T436Y", "reference_site": "436", "region": "HA2", "sequential_site": 452, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "A", "mutation": "L437A", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "C", "mutation": "L437C", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "D", "mutation": "L437D", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "E", "mutation": "L437E", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.315, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "F", "mutation": "L437F", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "G", "mutation": "L437G", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "H", "mutation": "L437H", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.833, "ferret_sera_escape": -0.1317, "mature_H5_site": 437, "mouse_sera_escape": -0.1162, "mutant": "I", "mutation": "L437I", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.025, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "K", "mutation": "L437K", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 437, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L437L", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5108, "ferret_sera_escape": 0.08894, "mature_H5_site": 437, "mouse_sera_escape": 0.07157, "mutant": "M", "mutation": "L437M", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": 1.447, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "N", "mutation": "L437N", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.03, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "P", "mutation": "L437P", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.617, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L437Q", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.895, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "R", "mutation": "L437R", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "S", "mutation": "L437S", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.822, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "T", "mutation": "L437T", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.03, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "V", "mutation": "L437V", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "W", "mutation": "L437W", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 437, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L437Y", "reference_site": "437", "region": "HA2", "sequential_site": 453, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.03785, "ferret_sera_escape": 0.1314, "mature_H5_site": 438, "mouse_sera_escape": 0.07172, "mutant": "A", "mutation": "D438A", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 1.316, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.3, "ferret_sera_escape": -0.1835, "mature_H5_site": 438, "mouse_sera_escape": 0.08417, "mutant": "C", "mutation": "D438C", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 1.197, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 438, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D438D", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.005413, "ferret_sera_escape": 0.0158, "mature_H5_site": 438, "mouse_sera_escape": -0.01683, "mutant": "E", "mutation": "D438E", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 0.5611, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6214, "ferret_sera_escape": 0.02361, "mature_H5_site": 438, "mouse_sera_escape": 0.035, "mutant": "F", "mutation": "D438F", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": -0.157, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.09642, "ferret_sera_escape": 0.09123, "mature_H5_site": 438, "mouse_sera_escape": -0.06231, "mutant": "G", "mutation": "D438G", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 0.901, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.258, "ferret_sera_escape": null, "mature_H5_site": 438, "mouse_sera_escape": null, "mutant": "H", "mutation": "D438H", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.638, "ferret_sera_escape": -0.08338, "mature_H5_site": 438, "mouse_sera_escape": -0.125, "mutant": "I", "mutation": "D438I", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.039, "ferret_sera_escape": null, "mature_H5_site": 438, "mouse_sera_escape": null, "mutant": "K", "mutation": "D438K", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.496, "ferret_sera_escape": -0.03227, "mature_H5_site": 438, "mouse_sera_escape": 0.04889, "mutant": "L", "mutation": "D438L", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 0.4775, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2758, "ferret_sera_escape": 0.111, "mature_H5_site": 438, "mouse_sera_escape": -0.004324, "mutant": "M", "mutation": "D438M", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 0.6368, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.181, "ferret_sera_escape": -0.04643, "mature_H5_site": 438, "mouse_sera_escape": -0.04403, "mutant": "N", "mutation": "D438N", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 1.03, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 438, "mouse_sera_escape": null, "mutant": "P", "mutation": "D438P", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.04463, "ferret_sera_escape": -0.01261, "mature_H5_site": 438, "mouse_sera_escape": 0.03557, "mutant": "Q", "mutation": "D438Q", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 1.182, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.494, "ferret_sera_escape": null, "mature_H5_site": 438, "mouse_sera_escape": null, "mutant": "R", "mutation": "D438R", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.927, "ferret_sera_escape": -0.2326, "mature_H5_site": 438, "mouse_sera_escape": 0.2005, "mutant": "S", "mutation": "D438S", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": 0.6721, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.139, "ferret_sera_escape": -0.3365, "mature_H5_site": 438, "mouse_sera_escape": -0.1121, "mutant": "W", "mutation": "D438W", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": -0.248, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.841, "ferret_sera_escape": -0.1357, "mature_H5_site": 438, "mouse_sera_escape": 0.04139, "mutant": "Y", "mutation": "D438Y", "reference_site": "438", "region": "HA2", "sequential_site": 454, "stability": -0.1721, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.981, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "C", "mutation": "F439C", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.352, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "E", "mutation": "F439E", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 439, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F439F", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "G", "mutation": "F439G", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.314, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "H", "mutation": "F439H", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.985, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "I", "mutation": "F439I", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "K", "mutation": "F439K", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.66, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "L", "mutation": "F439L", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": null, "cell_entry": 0.07512, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "M", "mutation": "F439M", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.119, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "N", "mutation": "F439N", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "P", "mutation": "F439P", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "R", "mutation": "F439R", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.98, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "S", "mutation": "F439S", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.891, "ferret_sera_escape": null, "mature_H5_site": 439, "mouse_sera_escape": null, "mutant": "T", "mutation": "F439T", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.04575, "ferret_sera_escape": 0.03407, "mature_H5_site": 439, "mouse_sera_escape": 0.03733, "mutant": "W", "mutation": "F439W", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": -0.1757, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.3818, "ferret_sera_escape": 0.145, "mature_H5_site": 439, "mouse_sera_escape": 0.06036, "mutant": "Y", "mutation": "F439Y", "reference_site": "439", "region": "HA2", "sequential_site": 455, "stability": 0.5491, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.08625, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "A", "mutation": "E44A", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.04014, "cell_entry": 0.02215, "ferret_sera_escape": 0.1014, "mature_H5_site": 34, "mouse_sera_escape": 0.04893, "mutant": "C", "mutation": "E44C", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 0.5262, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7662, "ferret_sera_escape": -0.1223, "mature_H5_site": 34, "mouse_sera_escape": -0.06684, "mutant": "D", "mutation": "E44D", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": -0.5119, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 34, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E44E", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.846, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "F", "mutation": "E44F", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.8389, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "G", "mutation": "E44G", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.505, "ferret_sera_escape": -0.05772, "mature_H5_site": 34, "mouse_sera_escape": 0.01825, "mutant": "H", "mutation": "E44H", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 0.3479, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.561, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "I", "mutation": "E44I", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.332, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "K", "mutation": "E44K", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1896, "ferret_sera_escape": -0.01757, "mature_H5_site": 34, "mouse_sera_escape": 0.1305, "mutant": "L", "mutation": "E44L", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 1.231, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2553, "ferret_sera_escape": -0.2901, "mature_H5_site": 34, "mouse_sera_escape": -0.01246, "mutant": "M", "mutation": "E44M", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 1.632, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.765, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "N", "mutation": "E44N", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "P", "mutation": "E44P", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.05356, "ferret_sera_escape": 0.03587, "mature_H5_site": 34, "mouse_sera_escape": 0.1071, "mutant": "Q", "mutation": "E44Q", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 1.442, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.027, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "R", "mutation": "E44R", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.068, "ferret_sera_escape": -0.01962, "mature_H5_site": 34, "mouse_sera_escape": 0.1332, "mutant": "S", "mutation": "E44S", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 1.384, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4047, "ferret_sera_escape": 0.001483, "mature_H5_site": 34, "mouse_sera_escape": 0.2938, "mutant": "T", "mutation": "E44T", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 1.873, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.133, "ferret_sera_escape": null, "mature_H5_site": 34, "mouse_sera_escape": null, "mutant": "V", "mutation": "E44V", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.3527, "cell_entry": -0.1265, "ferret_sera_escape": 0.01564, "mature_H5_site": 34, "mouse_sera_escape": -0.04844, "mutant": "W", "mutation": "E44W", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1029, "ferret_sera_escape": -0.2138, "mature_H5_site": 34, "mouse_sera_escape": 0.09789, "mutant": "Y", "mutation": "E44Y", "reference_site": "44", "region": "region-C", "sequential_site": 50, "stability": 0.4516, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "A", "mutation": "H440A", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.788, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "C", "mutation": "H440C", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "D", "mutation": "H440D", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "E", "mutation": "H440E", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "F", "mutation": "H440F", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "G", "mutation": "H440G", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 440, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H440H", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.998, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "I", "mutation": "H440I", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "K", "mutation": "H440K", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.28, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "L", "mutation": "H440L", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.726, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "M", "mutation": "H440M", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "N", "mutation": "H440N", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.728, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "P", "mutation": "H440P", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "Q", "mutation": "H440Q", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.981, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "R", "mutation": "H440R", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.945, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "S", "mutation": "H440S", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "T", "mutation": "H440T", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "W", "mutation": "H440W", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.757, "ferret_sera_escape": null, "mature_H5_site": 440, "mouse_sera_escape": null, "mutant": "Y", "mutation": "H440Y", "reference_site": "440", "region": "HA2", "sequential_site": 456, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.59, "ferret_sera_escape": -0.08953, "mature_H5_site": 441, "mouse_sera_escape": 0.1694, "mutant": "C", "mutation": "D441C", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.35, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 441, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D441D", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8354, "ferret_sera_escape": -0.1575, "mature_H5_site": 441, "mouse_sera_escape": 0.05994, "mutant": "E", "mutation": "D441E", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.01512, "ferret_sera_escape": -0.1219, "mature_H5_site": 441, "mouse_sera_escape": 0.09207, "mutant": "F", "mutation": "D441F", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.763, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3171, "ferret_sera_escape": -0.05642, "mature_H5_site": 441, "mouse_sera_escape": 0.273, "mutant": "G", "mutation": "D441G", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.287, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6087, "ferret_sera_escape": -0.06517, "mature_H5_site": 441, "mouse_sera_escape": 0.2391, "mutant": "H", "mutation": "D441H", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.874, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.06995, "ferret_sera_escape": -0.09854, "mature_H5_site": 441, "mouse_sera_escape": 0.06969, "mutant": "I", "mutation": "D441I", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.936, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3141, "ferret_sera_escape": -0.08157, "mature_H5_site": 441, "mouse_sera_escape": 0.4223, "mutant": "K", "mutation": "D441K", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7025, "ferret_sera_escape": -0.07062, "mature_H5_site": 441, "mouse_sera_escape": 0.02221, "mutant": "L", "mutation": "D441L", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 2.024, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0691, "ferret_sera_escape": -0.03978, "mature_H5_site": 441, "mouse_sera_escape": 0.1384, "mutant": "M", "mutation": "D441M", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.877, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1571, "ferret_sera_escape": -0.1332, "mature_H5_site": 441, "mouse_sera_escape": 0.4756, "mutant": "N", "mutation": "D441N", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.284, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 441, "mouse_sera_escape": null, "mutant": "P", "mutation": "D441P", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5308, "ferret_sera_escape": -0.02527, "mature_H5_site": 441, "mouse_sera_escape": 0.2975, "mutant": "Q", "mutation": "D441Q", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.565, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5698, "ferret_sera_escape": -0.255, "mature_H5_site": 441, "mouse_sera_escape": 0.2982, "mutant": "R", "mutation": "D441R", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.443, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6056, "ferret_sera_escape": null, "mature_H5_site": 441, "mouse_sera_escape": null, "mutant": "S", "mutation": "D441S", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4856, "ferret_sera_escape": -0.1587, "mature_H5_site": 441, "mouse_sera_escape": 0.1724, "mutant": "T", "mutation": "D441T", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.659, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.18, "ferret_sera_escape": -0.1412, "mature_H5_site": 441, "mouse_sera_escape": 0.01989, "mutant": "V", "mutation": "D441V", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.418, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1939, "ferret_sera_escape": -0.1646, "mature_H5_site": 441, "mouse_sera_escape": 0.1513, "mutant": "W", "mutation": "D441W", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.554, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1355, "ferret_sera_escape": -0.1523, "mature_H5_site": 441, "mouse_sera_escape": 0.1625, "mutant": "Y", "mutation": "D441Y", "reference_site": "441", "region": "HA2", "sequential_site": 457, "stability": 1.915, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6136, "ferret_sera_escape": 0.08761, "mature_H5_site": 442, "mouse_sera_escape": 0.03131, "mutant": "A", "mutation": "S442A", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 1.107, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4608, "ferret_sera_escape": 0.05552, "mature_H5_site": 442, "mouse_sera_escape": 0.3766, "mutant": "C", "mutation": "S442C", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 1.351, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4101, "ferret_sera_escape": 0.01014, "mature_H5_site": 442, "mouse_sera_escape": 0.3162, "mutant": "D", "mutation": "S442D", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 1.766, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.5783, "ferret_sera_escape": -0.05847, "mature_H5_site": 442, "mouse_sera_escape": 0.1595, "mutant": "G", "mutation": "S442G", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 0.918, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.848, "ferret_sera_escape": null, "mature_H5_site": 442, "mouse_sera_escape": null, "mutant": "H", "mutation": "S442H", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 2.281, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3888, "ferret_sera_escape": 0.0311, "mature_H5_site": 442, "mouse_sera_escape": 0.07787, "mutant": "I", "mutation": "S442I", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 1.031, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.25, "ferret_sera_escape": null, "mature_H5_site": 442, "mouse_sera_escape": null, "mutant": "K", "mutation": "S442K", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4139, "ferret_sera_escape": -0.1313, "mature_H5_site": 442, "mouse_sera_escape": null, "mutant": "M", "mutation": "S442M", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.097, "ferret_sera_escape": -0.1239, "mature_H5_site": 442, "mouse_sera_escape": 0.2814, "mutant": "N", "mutation": "S442N", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 1.12, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 442, "mouse_sera_escape": null, "mutant": "P", "mutation": "S442P", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4683, "ferret_sera_escape": -0.09325, "mature_H5_site": 442, "mouse_sera_escape": 0.4498, "mutant": "Q", "mutation": "S442Q", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 1.131, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8379, "ferret_sera_escape": null, "mature_H5_site": 442, "mouse_sera_escape": null, "mutant": "R", "mutation": "S442R", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 442, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S442S", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.8914, "ferret_sera_escape": -0.2744, "mature_H5_site": 442, "mouse_sera_escape": null, "mutant": "T", "mutation": "S442T", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 0.9715, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.5617, "ferret_sera_escape": -0.1535, "mature_H5_site": 442, "mouse_sera_escape": 0.1347, "mutant": "V", "mutation": "S442V", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 1.164, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3473, "ferret_sera_escape": -0.3638, "mature_H5_site": 442, "mouse_sera_escape": 0.1357, "mutant": "Y", "mutation": "S442Y", "reference_site": "442", "region": "HA2", "sequential_site": 458, "stability": 0.4876, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.646, "ferret_sera_escape": -0.1602, "mature_H5_site": 443, "mouse_sera_escape": -0.1522, "mutant": "A", "mutation": "N443A", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.353, "ferret_sera_escape": -0.07914, "mature_H5_site": 443, "mouse_sera_escape": -0.06529, "mutant": "C", "mutation": "N443C", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": 0.7636, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "D", "mutation": "N443D", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.988, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "E", "mutation": "N443E", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.698, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "F", "mutation": "N443F", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.381, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "H", "mutation": "N443H", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": null, "cell_entry": -0.779, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "I", "mutation": "N443I", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.409, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "K", "mutation": "N443K", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.655, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "L", "mutation": "N443L", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1554, "ferret_sera_escape": -0.004507, "mature_H5_site": 443, "mouse_sera_escape": -0.04831, "mutant": "M", "mutation": "N443M", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": 0.9516, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 443, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N443N", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "P", "mutation": "N443P", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": null, "cell_entry": -0.1332, "ferret_sera_escape": -0.1248, "mature_H5_site": 443, "mouse_sera_escape": -0.07264, "mutant": "Q", "mutation": "N443Q", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.531, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "R", "mutation": "N443R", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4758, "ferret_sera_escape": -0.3637, "mature_H5_site": 443, "mouse_sera_escape": -0.05679, "mutant": "S", "mutation": "N443S", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": 0.3069, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3497, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "T", "mutation": "N443T", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5405, "ferret_sera_escape": -0.1613, "mature_H5_site": 443, "mouse_sera_escape": -0.04115, "mutant": "V", "mutation": "N443V", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": 0.1974, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.881, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "W", "mutation": "N443W", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.004, "ferret_sera_escape": null, "mature_H5_site": 443, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N443Y", "reference_site": "443", "region": "HA2", "sequential_site": 459, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "A", "mutation": "V444A", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "E", "mutation": "V444E", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "F", "mutation": "V444F", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.311, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "G", "mutation": "V444G", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "H", "mutation": "V444H", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.765, "ferret_sera_escape": -0.1006, "mature_H5_site": 444, "mouse_sera_escape": 0.2218, "mutant": "I", "mutation": "V444I", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": 1.131, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "K", "mutation": "V444K", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.00036, "ferret_sera_escape": 0.01457, "mature_H5_site": 444, "mouse_sera_escape": 0.08051, "mutant": "L", "mutation": "V444L", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": 1.624, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6685, "ferret_sera_escape": -0.2507, "mature_H5_site": 444, "mouse_sera_escape": -0.149, "mutant": "M", "mutation": "V444M", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": 0.6802, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.683, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "N", "mutation": "V444N", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.854, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "P", "mutation": "V444P", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V444Q", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "R", "mutation": "V444R", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "S", "mutation": "V444S", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.058, "ferret_sera_escape": -0.1317, "mature_H5_site": 444, "mouse_sera_escape": 0.05412, "mutant": "T", "mutation": "V444T", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": -0.1444, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 444, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V444V", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "W", "mutation": "V444W", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 444, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V444Y", "reference_site": "444", "region": "HA2", "sequential_site": 460, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3579, "ferret_sera_escape": -0.1039, "mature_H5_site": 445, "mouse_sera_escape": 0.1569, "mutant": "A", "mutation": "K445A", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": -0.001421, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.127, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "C", "mutation": "K445C", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.641, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "D", "mutation": "K445D", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.235, "ferret_sera_escape": -0.2387, "mature_H5_site": 445, "mouse_sera_escape": -0.07138, "mutant": "E", "mutation": "K445E", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": null, "cell_entry": -5.562, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "F", "mutation": "K445F", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.017, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "G", "mutation": "K445G", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.02545, "ferret_sera_escape": -0.06812, "mature_H5_site": 445, "mouse_sera_escape": 0.01962, "mutant": "H", "mutation": "K445H", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": 0.4749, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.936, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "I", "mutation": "K445I", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 445, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K445K", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.663, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "L", "mutation": "K445L", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.988, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "M", "mutation": "K445M", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.711, "ferret_sera_escape": -0.2216, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "N", "mutation": "K445N", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": 0.7245, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "P", "mutation": "K445P", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.159, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "Q", "mutation": "K445Q", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": 0.6892, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1215, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": -0.05118, "mutant": "R", "mutation": "K445R", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": -0.05484, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.753, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "S", "mutation": "K445S", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "T", "mutation": "K445T", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.119, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "W", "mutation": "K445W", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -4.285, "ferret_sera_escape": null, "mature_H5_site": 445, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K445Y", "reference_site": "445", "region": "HA2", "sequential_site": 461, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2843, "ferret_sera_escape": 0.1055, "mature_H5_site": 446, "mouse_sera_escape": 0.1911, "mutant": "A", "mutation": "N446A", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.691, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2437, "ferret_sera_escape": -0.05428, "mature_H5_site": 446, "mouse_sera_escape": 0.04006, "mutant": "C", "mutation": "N446C", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.016, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.219, "ferret_sera_escape": -0.142, "mature_H5_site": 446, "mouse_sera_escape": 0.4486, "mutant": "D", "mutation": "N446D", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.437, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2193, "ferret_sera_escape": -0.02002, "mature_H5_site": 446, "mouse_sera_escape": 0.2439, "mutant": "E", "mutation": "N446E", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.827, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.65, "ferret_sera_escape": -0.01015, "mature_H5_site": 446, "mouse_sera_escape": -0.04212, "mutant": "F", "mutation": "N446F", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3095, "ferret_sera_escape": -0.04183, "mature_H5_site": 446, "mouse_sera_escape": 0.05794, "mutant": "G", "mutation": "N446G", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.294, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.01017, "ferret_sera_escape": 0.01532, "mature_H5_site": 446, "mouse_sera_escape": 0.07707, "mutant": "H", "mutation": "N446H", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.469, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.03955, "ferret_sera_escape": -0.03516, "mature_H5_site": 446, "mouse_sera_escape": 0.09203, "mutant": "I", "mutation": "N446I", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.354, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02098, "ferret_sera_escape": 0.00423, "mature_H5_site": 446, "mouse_sera_escape": 0.007829, "mutant": "K", "mutation": "N446K", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.237, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1061, "ferret_sera_escape": -0.07055, "mature_H5_site": 446, "mouse_sera_escape": 0.03355, "mutant": "L", "mutation": "N446L", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.732, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.02659, "ferret_sera_escape": -0.06875, "mature_H5_site": 446, "mouse_sera_escape": 0.1226, "mutant": "M", "mutation": "N446M", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.759, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 446, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N446N", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 446, "mouse_sera_escape": null, "mutant": "P", "mutation": "N446P", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": null, "wildtype": "N"}, {"a26_usage": 0.00455, "cell_entry": 0.01668, "ferret_sera_escape": 0.1104, "mature_H5_site": 446, "mouse_sera_escape": 0.05206, "mutant": "Q", "mutation": "N446Q", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 0.2712, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.05188, "ferret_sera_escape": -0.0326, "mature_H5_site": 446, "mouse_sera_escape": -0.01965, "mutant": "R", "mutation": "N446R", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.442, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.101, "ferret_sera_escape": 0.00653, "mature_H5_site": 446, "mouse_sera_escape": 0.1964, "mutant": "S", "mutation": "N446S", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.407, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3255, "ferret_sera_escape": -0.009927, "mature_H5_site": 446, "mouse_sera_escape": 0.09373, "mutant": "T", "mutation": "N446T", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.388, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3681, "ferret_sera_escape": null, "mature_H5_site": 446, "mouse_sera_escape": null, "mutant": "V", "mutation": "N446V", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.272, "ferret_sera_escape": -0.0581, "mature_H5_site": 446, "mouse_sera_escape": 0.2189, "mutant": "W", "mutation": "N446W", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.614, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.0834, "ferret_sera_escape": -0.06872, "mature_H5_site": 446, "mouse_sera_escape": 0.05918, "mutant": "Y", "mutation": "N446Y", "reference_site": "446", "region": "HA2", "sequential_site": 462, "stability": 1.686, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.258, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "A", "mutation": "L447A", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "D", "mutation": "L447D", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.008, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "E", "mutation": "L447E", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "F", "mutation": "L447F", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "G", "mutation": "L447G", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "H", "mutation": "L447H", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0705, "ferret_sera_escape": -0.1096, "mature_H5_site": 447, "mouse_sera_escape": -0.06218, "mutant": "I", "mutation": "L447I", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": 0.5094, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 447, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L447L", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.05356, "ferret_sera_escape": 0.06096, "mature_H5_site": 447, "mouse_sera_escape": 0.03215, "mutant": "M", "mutation": "L447M", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": 0.05475, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.345, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "N", "mutation": "L447N", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "P", "mutation": "L447P", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "R", "mutation": "L447R", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.287, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "S", "mutation": "L447S", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.185, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "T", "mutation": "L447T", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 447, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L447Y", "reference_site": "447", "region": "HA2", "sequential_site": 463, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.413, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y448C", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y448D", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.773, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y448E", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.014, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "F", "mutation": "Y448F", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.883, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y448G", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.845, "ferret_sera_escape": 0.07162, "mature_H5_site": 448, "mouse_sera_escape": 0.4204, "mutant": "H", "mutation": "Y448H", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.489, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y448I", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": null, "cell_entry": -5.886, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y448K", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.191, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y448L", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.498, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y448M", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y448N", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y448P", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.698, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y448R", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.873, "ferret_sera_escape": null, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y448S", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.885, "ferret_sera_escape": -0.03581, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y448V", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.67, "ferret_sera_escape": -0.185, "mature_H5_site": 448, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y448W", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 448, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y448Y", "reference_site": "448", "region": "HA2", "sequential_site": 464, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.5241, "ferret_sera_escape": null, "mature_H5_site": 449, "mouse_sera_escape": null, "mutant": "C", "mutation": "D449C", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 449, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D449D", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.00824, "cell_entry": 0.00806, "ferret_sera_escape": 0.008355, "mature_H5_site": 449, "mouse_sera_escape": 0.004877, "mutant": "E", "mutation": "D449E", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 0.03676, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.06767, "ferret_sera_escape": -0.03076, "mature_H5_site": 449, "mouse_sera_escape": 0.2857, "mutant": "F", "mutation": "D449F", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 0.887, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.349, "ferret_sera_escape": 0.04416, "mature_H5_site": 449, "mouse_sera_escape": 0.1455, "mutant": "G", "mutation": "D449G", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 1.306, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.02862, "ferret_sera_escape": null, "mature_H5_site": 449, "mouse_sera_escape": null, "mutant": "H", "mutation": "D449H", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3533, "ferret_sera_escape": -0.1194, "mature_H5_site": 449, "mouse_sera_escape": 0.02414, "mutant": "I", "mutation": "D449I", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.906, "ferret_sera_escape": 0.4766, "mature_H5_site": 449, "mouse_sera_escape": 0.3991, "mutant": "K", "mutation": "D449K", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": -0.02702, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.03253, "ferret_sera_escape": 0.076, "mature_H5_site": 449, "mouse_sera_escape": 0.09386, "mutant": "L", "mutation": "D449L", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 1.062, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0079, "ferret_sera_escape": -0.3089, "mature_H5_site": 449, "mouse_sera_escape": 0.001209, "mutant": "M", "mutation": "D449M", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.04793, "ferret_sera_escape": -0.05471, "mature_H5_site": 449, "mouse_sera_escape": -0.05255, "mutant": "N", "mutation": "D449N", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 0.3196, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 449, "mouse_sera_escape": null, "mutant": "P", "mutation": "D449P", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5868, "ferret_sera_escape": -0.02271, "mature_H5_site": 449, "mouse_sera_escape": 0.135, "mutant": "R", "mutation": "D449R", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 0.6655, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.07106, "ferret_sera_escape": -0.1427, "mature_H5_site": 449, "mouse_sera_escape": -0.03205, "mutant": "T", "mutation": "D449T", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5101, "ferret_sera_escape": -0.05308, "mature_H5_site": 449, "mouse_sera_escape": -0.06133, "mutant": "V", "mutation": "D449V", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": -0.03697, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.03921, "ferret_sera_escape": -0.0489, "mature_H5_site": 449, "mouse_sera_escape": 0.1285, "mutant": "Y", "mutation": "D449Y", "reference_site": "449", "region": "HA2", "sequential_site": 465, "stability": 1.581, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.002845, "ferret_sera_escape": 0.01048, "mature_H5_site": 35, "mouse_sera_escape": -0.1178, "mutant": "A", "mutation": "K45A", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": 1.158, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.193, "ferret_sera_escape": 0.006508, "mature_H5_site": 35, "mouse_sera_escape": -0.003256, "mutant": "C", "mutation": "K45C", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": -0.1556, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6934, "ferret_sera_escape": -0.02172, "mature_H5_site": 35, "mouse_sera_escape": 0.01686, "mutant": "D", "mutation": "K45D", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": -0.05104, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8504, "ferret_sera_escape": null, "mature_H5_site": 35, "mouse_sera_escape": null, "mutant": "E", "mutation": "K45E", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.346, "ferret_sera_escape": -0.3444, "mature_H5_site": 35, "mouse_sera_escape": -0.1655, "mutant": "F", "mutation": "K45F", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.034, "ferret_sera_escape": 0.1065, "mature_H5_site": 35, "mouse_sera_escape": -0.02161, "mutant": "G", "mutation": "K45G", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04934, "ferret_sera_escape": -0.07075, "mature_H5_site": 35, "mouse_sera_escape": 0.003753, "mutant": "H", "mutation": "K45H", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": 1.804, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0264, "ferret_sera_escape": 0.02581, "mature_H5_site": 35, "mouse_sera_escape": -0.09038, "mutant": "I", "mutation": "K45I", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": -0.3739, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 35, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K45K", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7104, "ferret_sera_escape": -0.0899, "mature_H5_site": 35, "mouse_sera_escape": -0.1047, "mutant": "L", "mutation": "K45L", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": -0.2232, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2496, "ferret_sera_escape": -0.07576, "mature_H5_site": 35, "mouse_sera_escape": -0.03595, "mutant": "M", "mutation": "K45M", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": -0.07502, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2623, "ferret_sera_escape": -0.02002, "mature_H5_site": 35, "mouse_sera_escape": -0.02556, "mutant": "N", "mutation": "K45N", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": 0.4382, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.022, "ferret_sera_escape": null, "mature_H5_site": 35, "mouse_sera_escape": null, "mutant": "P", "mutation": "K45P", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": null, "wildtype": "K"}, {"a26_usage": 0.01495, "cell_entry": 0.07419, "ferret_sera_escape": 0.03759, "mature_H5_site": 35, "mouse_sera_escape": -0.05355, "mutant": "Q", "mutation": "K45Q", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": 0.1593, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1975, "ferret_sera_escape": -0.09119, "mature_H5_site": 35, "mouse_sera_escape": -0.07666, "mutant": "R", "mutation": "K45R", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": 0.6176, "wildtype": "K"}, {"a26_usage": 0.151, "cell_entry": -0.03245, "ferret_sera_escape": -0.02371, "mature_H5_site": 35, "mouse_sera_escape": -0.01717, "mutant": "S", "mutation": "K45S", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": 1.398, "wildtype": "K"}, {"a26_usage": 0.1002, "cell_entry": -0.02913, "ferret_sera_escape": -0.004117, "mature_H5_site": 35, "mouse_sera_escape": -0.0936, "mutant": "T", "mutation": "K45T", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": -0.06112, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6207, "ferret_sera_escape": -0.1264, "mature_H5_site": 35, "mouse_sera_escape": -0.06621, "mutant": "V", "mutation": "K45V", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": -0.05815, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8548, "ferret_sera_escape": -0.1191, "mature_H5_site": 35, "mouse_sera_escape": -0.1392, "mutant": "W", "mutation": "K45W", "reference_site": "45", "region": "region-C", "sequential_site": 51, "stability": null, "wildtype": "K"}, {"a26_usage": 0.2297, "cell_entry": -0.01907, "ferret_sera_escape": -0.08127, "mature_H5_site": 450, "mouse_sera_escape": 0.009541, "mutant": "A", "mutation": "K450A", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": -0.0405, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.639, "ferret_sera_escape": 0.04724, "mature_H5_site": 450, "mouse_sera_escape": 0.187, "mutant": "D", "mutation": "K450D", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": 0.03505, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.9716, "ferret_sera_escape": -0.005287, "mature_H5_site": 450, "mouse_sera_escape": 0.1535, "mutant": "E", "mutation": "K450E", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7024, "ferret_sera_escape": 0.3475, "mature_H5_site": 450, "mouse_sera_escape": 0.2773, "mutant": "F", "mutation": "K450F", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5758, "ferret_sera_escape": null, "mature_H5_site": 450, "mouse_sera_escape": -0.06747, "mutant": "I", "mutation": "K450I", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 450, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K450K", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.001765, "ferret_sera_escape": 0.02903, "mature_H5_site": 450, "mouse_sera_escape": -0.01948, "mutant": "L", "mutation": "K450L", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": 0.03724, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03883, "ferret_sera_escape": 0.04049, "mature_H5_site": 450, "mouse_sera_escape": 0.1865, "mutant": "M", "mutation": "K450M", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": -0.02278, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04594, "ferret_sera_escape": 0.02989, "mature_H5_site": 450, "mouse_sera_escape": -0.05571, "mutant": "N", "mutation": "K450N", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": 0.03022, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.384, "ferret_sera_escape": null, "mature_H5_site": 450, "mouse_sera_escape": null, "mutant": "P", "mutation": "K450P", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.004435, "ferret_sera_escape": 0.003753, "mature_H5_site": 450, "mouse_sera_escape": -0.004558, "mutant": "Q", "mutation": "K450Q", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": -0.08012, "wildtype": "K"}, {"a26_usage": 0.1631, "cell_entry": -0.4879, "ferret_sera_escape": 0.08906, "mature_H5_site": 450, "mouse_sera_escape": 0.0329, "mutant": "R", "mutation": "K450R", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": -0.06443, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04703, "ferret_sera_escape": 0.04334, "mature_H5_site": 450, "mouse_sera_escape": 0.09052, "mutant": "S", "mutation": "K450S", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": -0.0858, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.493, "ferret_sera_escape": -0.0002667, "mature_H5_site": 450, "mouse_sera_escape": 0.001463, "mutant": "T", "mutation": "K450T", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": -0.03077, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.548, "ferret_sera_escape": null, "mature_H5_site": 450, "mouse_sera_escape": null, "mutant": "W", "mutation": "K450W", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1986, "ferret_sera_escape": -0.2276, "mature_H5_site": 450, "mouse_sera_escape": 0.004321, "mutant": "Y", "mutation": "K450Y", "reference_site": "450", "region": "HA2", "sequential_site": 466, "stability": -0.1256, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.00839, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "A", "mutation": "V451A", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.721, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "D", "mutation": "V451D", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.397, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "E", "mutation": "V451E", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.99, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "F", "mutation": "V451F", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.871, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "G", "mutation": "V451G", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.532, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "H", "mutation": "V451H", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2242, "ferret_sera_escape": 0.03815, "mature_H5_site": 451, "mouse_sera_escape": -0.01004, "mutant": "I", "mutation": "V451I", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": -0.09503, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "K", "mutation": "V451K", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1984, "ferret_sera_escape": -0.1102, "mature_H5_site": 451, "mouse_sera_escape": -0.0634, "mutant": "L", "mutation": "V451L", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": -0.05236, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8446, "ferret_sera_escape": 0.0009143, "mature_H5_site": 451, "mouse_sera_escape": -0.0482, "mutant": "M", "mutation": "V451M", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": -0.01841, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.361, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "P", "mutation": "V451P", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8448, "ferret_sera_escape": 0.02208, "mature_H5_site": 451, "mouse_sera_escape": 0.03232, "mutant": "Q", "mutation": "V451Q", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": -0.03771, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.845, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "R", "mutation": "V451R", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4827, "ferret_sera_escape": -0.01615, "mature_H5_site": 451, "mouse_sera_escape": 0.03384, "mutant": "S", "mutation": "V451S", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": -0.2027, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 451, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V451V", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -6.008, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "W", "mutation": "V451W", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 451, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V451Y", "reference_site": "451", "region": "HA2", "sequential_site": 467, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.298, "ferret_sera_escape": 0.1987, "mature_H5_site": 452, "mouse_sera_escape": 0.09488, "mutant": "C", "mutation": "R452C", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.566, "ferret_sera_escape": 0.0726, "mature_H5_site": 452, "mouse_sera_escape": 0.3566, "mutant": "D", "mutation": "R452D", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.346, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "F", "mutation": "R452F", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7641, "ferret_sera_escape": 0.01998, "mature_H5_site": 452, "mouse_sera_escape": 0.09031, "mutant": "G", "mutation": "R452G", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": 0.8003, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5593, "ferret_sera_escape": -0.07221, "mature_H5_site": 452, "mouse_sera_escape": -0.001278, "mutant": "H", "mutation": "R452H", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": 0.7312, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "I", "mutation": "R452I", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.02398, "ferret_sera_escape": -0.1593, "mature_H5_site": 452, "mouse_sera_escape": -0.09131, "mutant": "K", "mutation": "R452K", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": 0.6882, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.894, "ferret_sera_escape": -0.06141, "mature_H5_site": 452, "mouse_sera_escape": -0.05162, "mutant": "L", "mutation": "R452L", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": 0.9826, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.099, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "M", "mutation": "R452M", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.703, "ferret_sera_escape": -0.3646, "mature_H5_site": 452, "mouse_sera_escape": -0.05115, "mutant": "N", "mutation": "R452N", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": 0.9411, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "P", "mutation": "R452P", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.8454, "ferret_sera_escape": -0.02968, "mature_H5_site": 452, "mouse_sera_escape": -0.0263, "mutant": "Q", "mutation": "R452Q", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 452, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R452R", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.507, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "S", "mutation": "R452S", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.024, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "T", "mutation": "R452T", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.378, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "V", "mutation": "R452V", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.23, "ferret_sera_escape": -0.1432, "mature_H5_site": 452, "mouse_sera_escape": 0.05852, "mutant": "W", "mutation": "R452W", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": 0.08079, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.954, "ferret_sera_escape": null, "mature_H5_site": 452, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R452Y", "reference_site": "452", "region": "HA2", "sequential_site": 468, "stability": null, "wildtype": "R"}, {"a26_usage": null, "cell_entry": -0.6952, "ferret_sera_escape": null, "mature_H5_site": 453, "mouse_sera_escape": null, "mutant": "A", "mutation": "L453A", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9578, "ferret_sera_escape": 0.0317, "mature_H5_site": 453, "mouse_sera_escape": 0.0788, "mutant": "C", "mutation": "L453C", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": 0.6218, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.675, "ferret_sera_escape": null, "mature_H5_site": 453, "mouse_sera_escape": null, "mutant": "D", "mutation": "L453D", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.765, "ferret_sera_escape": null, "mature_H5_site": 453, "mouse_sera_escape": null, "mutant": "E", "mutation": "L453E", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": null, "wildtype": "L"}, {"a26_usage": 0.5937, "cell_entry": -0.2931, "ferret_sera_escape": -0.02494, "mature_H5_site": 453, "mouse_sera_escape": 0.0009806, "mutant": "H", "mutation": "L453H", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": -0.227, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.344, "ferret_sera_escape": null, "mature_H5_site": 453, "mouse_sera_escape": null, "mutant": "K", "mutation": "L453K", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 453, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L453L", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.03297, "ferret_sera_escape": -0.01435, "mature_H5_site": 453, "mouse_sera_escape": 0.02087, "mutant": "M", "mutation": "L453M", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": 0.4469, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.647, "ferret_sera_escape": null, "mature_H5_site": 453, "mouse_sera_escape": null, "mutant": "N", "mutation": "L453N", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": 0.03406, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.996, "ferret_sera_escape": null, "mature_H5_site": 453, "mouse_sera_escape": null, "mutant": "P", "mutation": "L453P", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1687, "ferret_sera_escape": -0.07756, "mature_H5_site": 453, "mouse_sera_escape": 0.1021, "mutant": "Q", "mutation": "L453Q", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": 1.082, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5708, "ferret_sera_escape": -0.0589, "mature_H5_site": 453, "mouse_sera_escape": 0.05823, "mutant": "R", "mutation": "L453R", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": 1.162, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.065, "ferret_sera_escape": 0.04066, "mature_H5_site": 453, "mouse_sera_escape": 0.04893, "mutant": "S", "mutation": "L453S", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4896, "ferret_sera_escape": 0.1363, "mature_H5_site": 453, "mouse_sera_escape": 0.09831, "mutant": "V", "mutation": "L453V", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6917, "ferret_sera_escape": 0.02627, "mature_H5_site": 453, "mouse_sera_escape": 0.006637, "mutant": "W", "mutation": "L453W", "reference_site": "453", "region": "HA2", "sequential_site": 469, "stability": 0.3156, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1071, "ferret_sera_escape": 0.008665, "mature_H5_site": 454, "mouse_sera_escape": 0.05855, "mutant": "C", "mutation": "Q454C", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.02772, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.9606, "ferret_sera_escape": -0.002797, "mature_H5_site": 454, "mouse_sera_escape": 0.107, "mutant": "D", "mutation": "Q454D", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.1696, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1862, "ferret_sera_escape": 0.04314, "mature_H5_site": 454, "mouse_sera_escape": 0.09548, "mutant": "E", "mutation": "Q454E", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.006184, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.381, "ferret_sera_escape": -0.4447, "mature_H5_site": 454, "mouse_sera_escape": -0.1179, "mutant": "G", "mutation": "Q454G", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.00955, "ferret_sera_escape": 0.102, "mature_H5_site": 454, "mouse_sera_escape": 0.03364, "mutant": "H", "mutation": "Q454H", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.09894, "wildtype": "Q"}, {"a26_usage": 0.2263, "cell_entry": -0.3073, "ferret_sera_escape": -0.01026, "mature_H5_site": 454, "mouse_sera_escape": -0.03432, "mutant": "I", "mutation": "Q454I", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": 0.005626, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.015, "ferret_sera_escape": 0.1007, "mature_H5_site": 454, "mouse_sera_escape": 0.1414, "mutant": "K", "mutation": "Q454K", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": 0.511, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0651, "ferret_sera_escape": 0.1252, "mature_H5_site": 454, "mouse_sera_escape": 0.07188, "mutant": "M", "mutation": "Q454M", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": 0.1286, "wildtype": "Q"}, {"a26_usage": 0.2176, "cell_entry": -0.07897, "ferret_sera_escape": 0.2177, "mature_H5_site": 454, "mouse_sera_escape": null, "mutant": "N", "mutation": "Q454N", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 454, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q454Q", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.157, "ferret_sera_escape": -0.07183, "mature_H5_site": 454, "mouse_sera_escape": 0.0008825, "mutant": "R", "mutation": "Q454R", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.008293, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2767, "ferret_sera_escape": -0.02195, "mature_H5_site": 454, "mouse_sera_escape": 0.0568, "mutant": "S", "mutation": "Q454S", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.16, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5197, "ferret_sera_escape": -0.0365, "mature_H5_site": 454, "mouse_sera_escape": 0.04878, "mutant": "T", "mutation": "Q454T", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.05936, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.01913, "ferret_sera_escape": 0.04793, "mature_H5_site": 454, "mouse_sera_escape": 0.1164, "mutant": "V", "mutation": "Q454V", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": -0.03508, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.111, "ferret_sera_escape": null, "mature_H5_site": 454, "mouse_sera_escape": null, "mutant": "W", "mutation": "Q454W", "reference_site": "454", "region": "HA2", "sequential_site": 470, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.776, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "A", "mutation": "L455A", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.191, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "C", "mutation": "L455C", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "D", "mutation": "L455D", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "E", "mutation": "L455E", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "H", "mutation": "L455H", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5988, "ferret_sera_escape": -0.03344, "mature_H5_site": 455, "mouse_sera_escape": 0.03017, "mutant": "I", "mutation": "L455I", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": -0.05777, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "K", "mutation": "L455K", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 455, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L455L", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.148, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "M", "mutation": "L455M", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.945, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "N", "mutation": "L455N", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "P", "mutation": "L455P", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L455Q", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "R", "mutation": "L455R", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "S", "mutation": "L455S", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2562, "ferret_sera_escape": -0.1022, "mature_H5_site": 455, "mouse_sera_escape": 0.06407, "mutant": "T", "mutation": "L455T", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": -0.008337, "wildtype": "L"}, {"a26_usage": null, "cell_entry": -0.2412, "ferret_sera_escape": null, "mature_H5_site": 455, "mouse_sera_escape": null, "mutant": "V", "mutation": "L455V", "reference_site": "455", "region": "HA2", "sequential_site": 471, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1249, "ferret_sera_escape": -0.2587, "mature_H5_site": 456, "mouse_sera_escape": 0.312, "mutant": "A", "mutation": "R456A", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": -0.01742, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7026, "ferret_sera_escape": 0.1216, "mature_H5_site": 456, "mouse_sera_escape": 0.07874, "mutant": "D", "mutation": "R456D", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": 0.01205, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.613, "ferret_sera_escape": 0.05628, "mature_H5_site": 456, "mouse_sera_escape": 0.05379, "mutant": "E", "mutation": "R456E", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": -0.3205, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4486, "ferret_sera_escape": null, "mature_H5_site": 456, "mouse_sera_escape": null, "mutant": "H", "mutation": "R456H", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": 0.1056, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1729, "ferret_sera_escape": -0.0007667, "mature_H5_site": 456, "mouse_sera_escape": 0.08708, "mutant": "I", "mutation": "R456I", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": -0.1546, "wildtype": "R"}, {"a26_usage": 0.3557, "cell_entry": -0.1463, "ferret_sera_escape": 0.1335, "mature_H5_site": 456, "mouse_sera_escape": -0.004457, "mutant": "L", "mutation": "R456L", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": 0.002477, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.04334, "ferret_sera_escape": 0.02663, "mature_H5_site": 456, "mouse_sera_escape": -0.07565, "mutant": "M", "mutation": "R456M", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": -0.02119, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.09277, "ferret_sera_escape": 0.00288, "mature_H5_site": 456, "mouse_sera_escape": -0.01883, "mutant": "N", "mutation": "R456N", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": -0.04876, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.139, "ferret_sera_escape": null, "mature_H5_site": 456, "mouse_sera_escape": null, "mutant": "P", "mutation": "R456P", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0732, "ferret_sera_escape": 0.07948, "mature_H5_site": 456, "mouse_sera_escape": 0.05116, "mutant": "Q", "mutation": "R456Q", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": 0.3651, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 456, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R456R", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1887, "ferret_sera_escape": -0.1187, "mature_H5_site": 456, "mouse_sera_escape": null, "mutant": "S", "mutation": "R456S", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.263, "ferret_sera_escape": null, "mature_H5_site": 456, "mouse_sera_escape": null, "mutant": "T", "mutation": "R456T", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7692, "ferret_sera_escape": 0.01149, "mature_H5_site": 456, "mouse_sera_escape": -0.03336, "mutant": "V", "mutation": "R456V", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": 0.007682, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5899, "ferret_sera_escape": 0.03393, "mature_H5_site": 456, "mouse_sera_escape": 0.183, "mutant": "W", "mutation": "R456W", "reference_site": "456", "region": "HA2", "sequential_site": 472, "stability": 0.2861, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -4.076, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "C", "mutation": "D457C", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 457, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D457D", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.191, "ferret_sera_escape": -0.02275, "mature_H5_site": 457, "mouse_sera_escape": -0.0778, "mutant": "E", "mutation": "D457E", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": 0.5922, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.381, "ferret_sera_escape": 0.1378, "mature_H5_site": 457, "mouse_sera_escape": 0.1245, "mutant": "F", "mutation": "D457F", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": -0.17, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3666, "ferret_sera_escape": -0.2094, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "G", "mutation": "D457G", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": -0.02864, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.935, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "H", "mutation": "D457H", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.635, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "I", "mutation": "D457I", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.399, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "K", "mutation": "D457K", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.408, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "L", "mutation": "D457L", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.153, "ferret_sera_escape": -0.1074, "mature_H5_site": 457, "mouse_sera_escape": 0.1941, "mutant": "M", "mutation": "D457M", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": -0.1282, "wildtype": "D"}, {"a26_usage": 0.04511, "cell_entry": -1.779, "ferret_sera_escape": -0.1253, "mature_H5_site": 457, "mouse_sera_escape": -0.1662, "mutant": "N", "mutation": "D457N", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.9528, "ferret_sera_escape": -0.188, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "Q", "mutation": "D457Q", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.002, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "R", "mutation": "D457R", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4259, "ferret_sera_escape": -0.00269, "mature_H5_site": 457, "mouse_sera_escape": 0.008229, "mutant": "S", "mutation": "D457S", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": -0.02501, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6107, "ferret_sera_escape": -0.0872, "mature_H5_site": 457, "mouse_sera_escape": 0.00122, "mutant": "T", "mutation": "D457T", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": -0.06334, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.555, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "V", "mutation": "D457V", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.674, "ferret_sera_escape": null, "mature_H5_site": 457, "mouse_sera_escape": null, "mutant": "W", "mutation": "D457W", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.507, "ferret_sera_escape": 0.001189, "mature_H5_site": 457, "mouse_sera_escape": 0.07954, "mutant": "Y", "mutation": "D457Y", "reference_site": "457", "region": "HA2", "sequential_site": 473, "stability": -0.2305, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.693, "ferret_sera_escape": 0.05665, "mature_H5_site": 458, "mouse_sera_escape": 0.01458, "mutant": "A", "mutation": "N458A", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.937, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "C", "mutation": "N458C", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.048, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "D", "mutation": "N458D", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "E", "mutation": "N458E", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "F", "mutation": "N458F", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.802, "ferret_sera_escape": 0.04178, "mature_H5_site": 458, "mouse_sera_escape": 0.09727, "mutant": "G", "mutation": "N458G", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": -0.06885, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1576, "ferret_sera_escape": 0.05242, "mature_H5_site": 458, "mouse_sera_escape": 0.1048, "mutant": "H", "mutation": "N458H", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": -0.1049, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "I", "mutation": "N458I", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "K", "mutation": "N458K", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "L", "mutation": "N458L", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.697, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "M", "mutation": "N458M", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 458, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N458N", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "P", "mutation": "N458P", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.574, "ferret_sera_escape": 0.1119, "mature_H5_site": 458, "mouse_sera_escape": 0.04735, "mutant": "Q", "mutation": "N458Q", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": -0.06056, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "R", "mutation": "N458R", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.497, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "S", "mutation": "N458S", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.349, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "T", "mutation": "N458T", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "V", "mutation": "N458V", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "W", "mutation": "N458W", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 458, "mouse_sera_escape": null, "mutant": "Y", "mutation": "N458Y", "reference_site": "458", "region": "HA2", "sequential_site": 474, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 459, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A459A", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.6902, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "C", "mutation": "A459C", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "D", "mutation": "A459D", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "E", "mutation": "A459E", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "F", "mutation": "A459F", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1281, "ferret_sera_escape": -0.06379, "mature_H5_site": 459, "mouse_sera_escape": 0.02087, "mutant": "G", "mutation": "A459G", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": -0.1016, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.177, "ferret_sera_escape": -0.1114, "mature_H5_site": 459, "mouse_sera_escape": -0.01529, "mutant": "I", "mutation": "A459I", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": -0.2223, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "K", "mutation": "A459K", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "L", "mutation": "A459L", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.938, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "M", "mutation": "A459M", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "N", "mutation": "A459N", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A459Q", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "R", "mutation": "A459R", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.06205, "ferret_sera_escape": -0.04292, "mature_H5_site": 459, "mouse_sera_escape": -0.04387, "mutant": "S", "mutation": "A459S", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": -0.1625, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.013, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "T", "mutation": "A459T", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3183, "ferret_sera_escape": 0.1077, "mature_H5_site": 459, "mouse_sera_escape": 0.1729, "mutant": "V", "mutation": "A459V", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": 0.01815, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "W", "mutation": "A459W", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 459, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A459Y", "reference_site": "459", "region": "HA2", "sequential_site": 475, "stability": null, "wildtype": "A"}, {"a26_usage": 0.06573, "cell_entry": -0.1257, "ferret_sera_escape": 0.007626, "mature_H5_site": 36, "mouse_sera_escape": -0.01238, "mutant": "A", "mutation": "T46A", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": null, "wildtype": "T"}, {"a26_usage": 0.1262, "cell_entry": -0.009955, "ferret_sera_escape": -0.04358, "mature_H5_site": 36, "mouse_sera_escape": 0.003527, "mutant": "C", "mutation": "T46C", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": -0.0926, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5014, "ferret_sera_escape": -0.08219, "mature_H5_site": 36, "mouse_sera_escape": -0.0275, "mutant": "D", "mutation": "T46D", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": 0.1726, "wildtype": "T"}, {"a26_usage": 0.04344, "cell_entry": 0.03948, "ferret_sera_escape": -0.04316, "mature_H5_site": 36, "mouse_sera_escape": -0.03944, "mutant": "F", "mutation": "T46F", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": 0.05047, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.7, "ferret_sera_escape": 0.0235, "mature_H5_site": 36, "mouse_sera_escape": -0.1098, "mutant": "G", "mutation": "T46G", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": null, "wildtype": "T"}, {"a26_usage": null, "cell_entry": 0.01837, "ferret_sera_escape": null, "mature_H5_site": 36, "mouse_sera_escape": null, "mutant": "H", "mutation": "T46H", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": null, "wildtype": "T"}, {"a26_usage": 0.4604, "cell_entry": -0.2944, "ferret_sera_escape": -0.04202, "mature_H5_site": 36, "mouse_sera_escape": -0.05043, "mutant": "I", "mutation": "T46I", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": 0.01446, "wildtype": "T"}, {"a26_usage": 0.5146, "cell_entry": -0.1861, "ferret_sera_escape": -0.05077, "mature_H5_site": 36, "mouse_sera_escape": 0.01332, "mutant": "K", "mutation": "T46K", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": 0.05015, "wildtype": "T"}, {"a26_usage": 0.1591, "cell_entry": -0.2306, "ferret_sera_escape": null, "mature_H5_site": 36, "mouse_sera_escape": null, "mutant": "L", "mutation": "T46L", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": null, "wildtype": "T"}, {"a26_usage": 0.1329, "cell_entry": -0.1133, "ferret_sera_escape": 0.09653, "mature_H5_site": 36, "mouse_sera_escape": 0.05032, "mutant": "M", "mutation": "T46M", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": 0.007377, "wildtype": "T"}, {"a26_usage": 0.2583, "cell_entry": -0.02238, "ferret_sera_escape": 0.1144, "mature_H5_site": 36, "mouse_sera_escape": 0.004991, "mutant": "N", "mutation": "T46N", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": -0.0529, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 36, "mouse_sera_escape": null, "mutant": "P", "mutation": "T46P", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": null, "wildtype": "T"}, {"a26_usage": 0.09724, "cell_entry": -0.3068, "ferret_sera_escape": null, "mature_H5_site": 36, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T46Q", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.01962, "ferret_sera_escape": 0.06951, "mature_H5_site": 36, "mouse_sera_escape": -0.02286, "mutant": "R", "mutation": "T46R", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": -0.01583, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.003142, "ferret_sera_escape": -0.03301, "mature_H5_site": 36, "mouse_sera_escape": -0.05843, "mutant": "S", "mutation": "T46S", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": -0.0537, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 36, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T46T", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": 0.0, "wildtype": "T"}, {"a26_usage": null, "cell_entry": 0.04109, "ferret_sera_escape": null, "mature_H5_site": 36, "mouse_sera_escape": null, "mutant": "V", "mutation": "T46V", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.02424, "ferret_sera_escape": -0.03494, "mature_H5_site": 36, "mouse_sera_escape": -0.09287, "mutant": "W", "mutation": "T46W", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": 0.02111, "wildtype": "T"}, {"a26_usage": 0.07428, "cell_entry": 0.06686, "ferret_sera_escape": 0.08213, "mature_H5_site": 36, "mouse_sera_escape": -0.1593, "mutant": "Y", "mutation": "T46Y", "reference_site": "46", "region": "region-C", "sequential_site": 52, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.02059, "ferret_sera_escape": -0.00322, "mature_H5_site": 460, "mouse_sera_escape": -0.03946, "mutant": "C", "mutation": "K460C", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": -0.04841, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2447, "ferret_sera_escape": null, "mature_H5_site": 460, "mouse_sera_escape": null, "mutant": "D", "mutation": "K460D", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1981, "ferret_sera_escape": -0.05363, "mature_H5_site": 460, "mouse_sera_escape": -0.09486, "mutant": "E", "mutation": "K460E", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": 0.02291, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3082, "ferret_sera_escape": -0.07719, "mature_H5_site": 460, "mouse_sera_escape": -0.0947, "mutant": "F", "mutation": "K460F", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": 0.0174, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5496, "ferret_sera_escape": -0.09281, "mature_H5_site": 460, "mouse_sera_escape": -0.02869, "mutant": "G", "mutation": "K460G", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.01041, "ferret_sera_escape": -0.2617, "mature_H5_site": 460, "mouse_sera_escape": 0.05299, "mutant": "I", "mutation": "K460I", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 460, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K460K", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.02373, "cell_entry": -0.3389, "ferret_sera_escape": 0.01886, "mature_H5_site": 460, "mouse_sera_escape": 0.01032, "mutant": "M", "mutation": "K460M", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": 0.08023, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1367, "ferret_sera_escape": -0.03183, "mature_H5_site": 460, "mouse_sera_escape": 0.03565, "mutant": "N", "mutation": "K460N", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": 0.217, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.02157, "ferret_sera_escape": 0.05331, "mature_H5_site": 460, "mouse_sera_escape": 0.05073, "mutant": "R", "mutation": "K460R", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": -0.1462, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.989, "ferret_sera_escape": -0.05908, "mature_H5_site": 460, "mouse_sera_escape": 0.01981, "mutant": "S", "mutation": "K460S", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": -0.02249, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.783, "ferret_sera_escape": null, "mature_H5_site": 460, "mouse_sera_escape": null, "mutant": "T", "mutation": "K460T", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5993, "ferret_sera_escape": 0.08311, "mature_H5_site": 460, "mouse_sera_escape": -0.09388, "mutant": "V", "mutation": "K460V", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": -0.04686, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0338, "ferret_sera_escape": 0.08974, "mature_H5_site": 460, "mouse_sera_escape": 0.01514, "mutant": "W", "mutation": "K460W", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": 0.1686, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.00807, "ferret_sera_escape": 0.03642, "mature_H5_site": 460, "mouse_sera_escape": 0.0935, "mutant": "Y", "mutation": "K460Y", "reference_site": "460", "region": "HA2", "sequential_site": 476, "stability": 0.06024, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -3.133, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "C", "mutation": "E461C", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.144, "ferret_sera_escape": -0.04953, "mature_H5_site": 461, "mouse_sera_escape": 0.1029, "mutant": "D", "mutation": "E461D", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": 1.289, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 461, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E461E", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "F", "mutation": "E461F", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.026, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "I", "mutation": "E461I", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.796, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "K", "mutation": "E461K", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.08, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "L", "mutation": "E461L", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -4.801, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "M", "mutation": "E461M", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.713, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "Q", "mutation": "E461Q", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "R", "mutation": "E461R", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.677, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "S", "mutation": "E461S", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.786, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "T", "mutation": "E461T", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.965, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "V", "mutation": "E461V", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "W", "mutation": "E461W", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.356, "ferret_sera_escape": null, "mature_H5_site": 461, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E461Y", "reference_site": "461", "region": "HA2", "sequential_site": 477, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.8518, "ferret_sera_escape": -0.0287, "mature_H5_site": 462, "mouse_sera_escape": 0.03931, "mutant": "C", "mutation": "L462C", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": -0.01282, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1594, "ferret_sera_escape": 0.1011, "mature_H5_site": 462, "mouse_sera_escape": 0.06159, "mutant": "E", "mutation": "L462E", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": 0.2245, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.102, "ferret_sera_escape": -0.02211, "mature_H5_site": 462, "mouse_sera_escape": null, "mutant": "F", "mutation": "L462F", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9594, "ferret_sera_escape": -0.1265, "mature_H5_site": 462, "mouse_sera_escape": -0.01209, "mutant": "H", "mutation": "L462H", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1211, "ferret_sera_escape": -0.06565, "mature_H5_site": 462, "mouse_sera_escape": -0.08213, "mutant": "I", "mutation": "L462I", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": -0.08319, "wildtype": "L"}, {"a26_usage": 0.5155, "cell_entry": -0.2561, "ferret_sera_escape": -0.04429, "mature_H5_site": 462, "mouse_sera_escape": 0.05299, "mutant": "K", "mutation": "L462K", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": -0.01095, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 462, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L462L", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.02356, "ferret_sera_escape": -0.01349, "mature_H5_site": 462, "mouse_sera_escape": -0.01674, "mutant": "M", "mutation": "L462M", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": -0.0193, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5155, "ferret_sera_escape": -0.007977, "mature_H5_site": 462, "mouse_sera_escape": 0.02687, "mutant": "N", "mutation": "L462N", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": 0.0002655, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.471, "ferret_sera_escape": null, "mature_H5_site": 462, "mouse_sera_escape": null, "mutant": "P", "mutation": "L462P", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": null, "wildtype": "L"}, {"a26_usage": 0.3408, "cell_entry": -0.2969, "ferret_sera_escape": -0.1366, "mature_H5_site": 462, "mouse_sera_escape": 0.01259, "mutant": "Q", "mutation": "L462Q", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": -0.03445, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1847, "ferret_sera_escape": null, "mature_H5_site": 462, "mouse_sera_escape": null, "mutant": "R", "mutation": "L462R", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5838, "ferret_sera_escape": -0.03387, "mature_H5_site": 462, "mouse_sera_escape": -0.08454, "mutant": "S", "mutation": "L462S", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": -0.06686, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.06068, "ferret_sera_escape": 0.02853, "mature_H5_site": 462, "mouse_sera_escape": -0.02567, "mutant": "V", "mutation": "L462V", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": 0.03482, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6858, "ferret_sera_escape": -0.02801, "mature_H5_site": 462, "mouse_sera_escape": 0.0432, "mutant": "W", "mutation": "L462W", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4408, "ferret_sera_escape": 0.03111, "mature_H5_site": 462, "mouse_sera_escape": 0.02935, "mutant": "Y", "mutation": "L462Y", "reference_site": "462", "region": "HA2", "sequential_site": 478, "stability": -0.1233, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2323, "ferret_sera_escape": -0.02564, "mature_H5_site": 463, "mouse_sera_escape": 0.02868, "mutant": "A", "mutation": "G463A", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": 0.702, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.748, "ferret_sera_escape": -0.282, "mature_H5_site": 463, "mouse_sera_escape": 0.2094, "mutant": "C", "mutation": "G463C", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": -0.08797, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.857, "ferret_sera_escape": -0.3363, "mature_H5_site": 463, "mouse_sera_escape": 0.14, "mutant": "D", "mutation": "G463D", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.408, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "E", "mutation": "G463E", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.758, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "F", "mutation": "G463F", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 463, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G463G", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.192, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "H", "mutation": "G463H", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.527, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "I", "mutation": "G463I", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.053, "ferret_sera_escape": -0.1923, "mature_H5_site": 463, "mouse_sera_escape": 0.05211, "mutant": "L", "mutation": "G463L", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": 1.013, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.036, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "N", "mutation": "G463N", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": 1.386, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.9111, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "P", "mutation": "G463P", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.893, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G463Q", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.705, "ferret_sera_escape": -0.1795, "mature_H5_site": 463, "mouse_sera_escape": 0.1528, "mutant": "R", "mutation": "G463R", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.597, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "S", "mutation": "G463S", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2863, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "T", "mutation": "G463T", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.399, "ferret_sera_escape": null, "mature_H5_site": 463, "mouse_sera_escape": null, "mutant": "V", "mutation": "G463V", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.018, "ferret_sera_escape": 0.07141, "mature_H5_site": 463, "mouse_sera_escape": 0.02969, "mutant": "Y", "mutation": "G463Y", "reference_site": "463", "region": "HA2", "sequential_site": 479, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.9042, "ferret_sera_escape": -0.1162, "mature_H5_site": 464, "mouse_sera_escape": -0.06756, "mutant": "C", "mutation": "N464C", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.047, "ferret_sera_escape": null, "mature_H5_site": 464, "mouse_sera_escape": null, "mutant": "D", "mutation": "N464D", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.595, "ferret_sera_escape": null, "mature_H5_site": 464, "mouse_sera_escape": null, "mutant": "E", "mutation": "N464E", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5102, "ferret_sera_escape": -0.05627, "mature_H5_site": 464, "mouse_sera_escape": -0.09421, "mutant": "F", "mutation": "N464F", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.2767, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.29, "ferret_sera_escape": 0.04779, "mature_H5_site": 464, "mouse_sera_escape": 0.2042, "mutant": "G", "mutation": "N464G", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.09938, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.768, "ferret_sera_escape": 0.09651, "mature_H5_site": 464, "mouse_sera_escape": 0.08089, "mutant": "H", "mutation": "N464H", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.099, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.841, "ferret_sera_escape": null, "mature_H5_site": 464, "mouse_sera_escape": null, "mutant": "I", "mutation": "N464I", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.178, "ferret_sera_escape": -0.1201, "mature_H5_site": 464, "mouse_sera_escape": 0.1772, "mutant": "K", "mutation": "N464K", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.158, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.271, "ferret_sera_escape": -0.5411, "mature_H5_site": 464, "mouse_sera_escape": 0.1444, "mutant": "L", "mutation": "N464L", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.017, "ferret_sera_escape": -0.03292, "mature_H5_site": 464, "mouse_sera_escape": 0.01147, "mutant": "M", "mutation": "N464M", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.2788, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 464, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N464N", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.574, "ferret_sera_escape": null, "mature_H5_site": 464, "mouse_sera_escape": null, "mutant": "P", "mutation": "N464P", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05627, "ferret_sera_escape": -0.07061, "mature_H5_site": 464, "mouse_sera_escape": -0.002135, "mutant": "Q", "mutation": "N464Q", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.2839, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.164, "ferret_sera_escape": -0.05436, "mature_H5_site": 464, "mouse_sera_escape": 0.04602, "mutant": "R", "mutation": "N464R", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.1114, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6914, "ferret_sera_escape": -0.07957, "mature_H5_site": 464, "mouse_sera_escape": 0.007685, "mutant": "S", "mutation": "N464S", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.1971, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04759, "ferret_sera_escape": null, "mature_H5_site": 464, "mouse_sera_escape": null, "mutant": "T", "mutation": "N464T", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.803, "ferret_sera_escape": null, "mature_H5_site": 464, "mouse_sera_escape": null, "mutant": "V", "mutation": "N464V", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8419, "ferret_sera_escape": -0.1156, "mature_H5_site": 464, "mouse_sera_escape": null, "mutant": "W", "mutation": "N464W", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.236, "ferret_sera_escape": -0.0797, "mature_H5_site": 464, "mouse_sera_escape": -0.06784, "mutant": "Y", "mutation": "N464Y", "reference_site": "464", "region": "HA2", "sequential_site": 480, "stability": -0.1858, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.507, "ferret_sera_escape": -0.04891, "mature_H5_site": 465, "mouse_sera_escape": 0.02723, "mutant": "A", "mutation": "G465A", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": -0.01593, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.696, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "C", "mutation": "G465C", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "D", "mutation": "G465D", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "E", "mutation": "G465E", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.612, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "F", "mutation": "G465F", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 465, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G465G", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.822, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "H", "mutation": "G465H", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "I", "mutation": "G465I", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.673, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "L", "mutation": "G465L", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.927, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "M", "mutation": "G465M", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "N", "mutation": "G465N", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "P", "mutation": "G465P", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G465Q", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.277, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "R", "mutation": "G465R", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.309, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "S", "mutation": "G465S", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "T", "mutation": "G465T", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "V", "mutation": "G465V", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.08, "ferret_sera_escape": null, "mature_H5_site": 465, "mouse_sera_escape": null, "mutant": "W", "mutation": "G465W", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.799, "ferret_sera_escape": -0.3427, "mature_H5_site": 465, "mouse_sera_escape": 0.3107, "mutant": "Y", "mutation": "G465Y", "reference_site": "465", "region": "HA2", "sequential_site": 481, "stability": 1.124, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "A", "mutation": "C466A", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 466, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C466C", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "D", "mutation": "C466D", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "E", "mutation": "C466E", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.724, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "F", "mutation": "C466F", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.665, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "G", "mutation": "C466G", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "H", "mutation": "C466H", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "I", "mutation": "C466I", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "K", "mutation": "C466K", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "L", "mutation": "C466L", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.978, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "M", "mutation": "C466M", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.683, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "N", "mutation": "C466N", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.694, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "P", "mutation": "C466P", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C466Q", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.835, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "R", "mutation": "C466R", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "S", "mutation": "C466S", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "V", "mutation": "C466V", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.032, "ferret_sera_escape": null, "mature_H5_site": 466, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C466Y", "reference_site": "466", "region": "HA2", "sequential_site": 482, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "C", "mutation": "F467C", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -4.138, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "D", "mutation": "F467D", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.854, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "E", "mutation": "F467E", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 467, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F467F", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "G", "mutation": "F467G", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.746, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "H", "mutation": "F467H", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.08, "ferret_sera_escape": 0.01055, "mature_H5_site": 467, "mouse_sera_escape": 0.1009, "mutant": "I", "mutation": "F467I", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": -0.1754, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "K", "mutation": "F467K", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.2499, "ferret_sera_escape": -0.002523, "mature_H5_site": 467, "mouse_sera_escape": 0.005606, "mutant": "L", "mutation": "F467L", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": -0.2101, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.1281, "ferret_sera_escape": -0.0411, "mature_H5_site": 467, "mouse_sera_escape": 0.0183, "mutant": "M", "mutation": "F467M", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": -0.1863, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.019, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "N", "mutation": "F467N", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "P", "mutation": "F467P", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.752, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F467Q", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.861, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "R", "mutation": "F467R", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "S", "mutation": "F467S", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.991, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": null, "mutant": "T", "mutation": "F467T", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.335, "ferret_sera_escape": null, "mature_H5_site": 467, "mouse_sera_escape": 0.1746, "mutant": "V", "mutation": "F467V", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.3004, "ferret_sera_escape": -0.1227, "mature_H5_site": 467, "mouse_sera_escape": 0.00901, "mutant": "W", "mutation": "F467W", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": 0.4898, "wildtype": "F"}, {"a26_usage": 0.4561, "cell_entry": -0.2208, "ferret_sera_escape": -0.1063, "mature_H5_site": 467, "mouse_sera_escape": 0.04231, "mutant": "Y", "mutation": "F467Y", "reference_site": "467", "region": "HA2", "sequential_site": 483, "stability": 0.2105, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.03044, "ferret_sera_escape": 0.002663, "mature_H5_site": 468, "mouse_sera_escape": 0.01745, "mutant": "A", "mutation": "E468A", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.02791, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7865, "ferret_sera_escape": 0.009581, "mature_H5_site": 468, "mouse_sera_escape": 0.02855, "mutant": "C", "mutation": "E468C", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": -0.1399, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.0153, "ferret_sera_escape": -0.05675, "mature_H5_site": 468, "mouse_sera_escape": -0.05068, "mutant": "D", "mutation": "E468D", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": -0.05354, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 468, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E468E", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.03095, "ferret_sera_escape": 0.06745, "mature_H5_site": 468, "mouse_sera_escape": -0.02878, "mutant": "F", "mutation": "E468F", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.06107, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2032, "ferret_sera_escape": 0.1937, "mature_H5_site": 468, "mouse_sera_escape": null, "mutant": "G", "mutation": "E468G", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": -0.01223, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.005651, "ferret_sera_escape": 0.1735, "mature_H5_site": 468, "mouse_sera_escape": 0.1271, "mutant": "H", "mutation": "E468H", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.05895, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1486, "ferret_sera_escape": 0.1363, "mature_H5_site": 468, "mouse_sera_escape": 0.2347, "mutant": "I", "mutation": "E468I", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4674, "ferret_sera_escape": -0.04577, "mature_H5_site": 468, "mouse_sera_escape": -0.05989, "mutant": "K", "mutation": "E468K", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": -0.04289, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.01707, "ferret_sera_escape": -0.1187, "mature_H5_site": 468, "mouse_sera_escape": 0.01804, "mutant": "L", "mutation": "E468L", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.1005, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.05639, "ferret_sera_escape": null, "mature_H5_site": 468, "mouse_sera_escape": null, "mutant": "M", "mutation": "E468M", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2253, "ferret_sera_escape": -0.03848, "mature_H5_site": 468, "mouse_sera_escape": -0.09725, "mutant": "N", "mutation": "E468N", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.2978, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 468, "mouse_sera_escape": null, "mutant": "P", "mutation": "E468P", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7376, "ferret_sera_escape": -0.02819, "mature_H5_site": 468, "mouse_sera_escape": -0.01658, "mutant": "Q", "mutation": "E468Q", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": -0.01457, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.004885, "ferret_sera_escape": 0.05043, "mature_H5_site": 468, "mouse_sera_escape": 0.04895, "mutant": "R", "mutation": "E468R", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.01785, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.00313, "ferret_sera_escape": 0.1002, "mature_H5_site": 468, "mouse_sera_escape": 0.01088, "mutant": "S", "mutation": "E468S", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.06273, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.8816, "ferret_sera_escape": null, "mature_H5_site": 468, "mouse_sera_escape": null, "mutant": "T", "mutation": "E468T", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.1663, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9877, "ferret_sera_escape": -0.01183, "mature_H5_site": 468, "mouse_sera_escape": -0.008792, "mutant": "V", "mutation": "E468V", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": -0.07847, "wildtype": "E"}, {"a26_usage": 0.4248, "cell_entry": -0.2617, "ferret_sera_escape": -0.1262, "mature_H5_site": 468, "mouse_sera_escape": 0.01428, "mutant": "W", "mutation": "E468W", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.144, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.04634, "ferret_sera_escape": -0.0006551, "mature_H5_site": 468, "mouse_sera_escape": 0.04158, "mutant": "Y", "mutation": "E468Y", "reference_site": "468", "region": "HA2", "sequential_site": 484, "stability": 0.04786, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "A", "mutation": "F469A", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "C", "mutation": "F469C", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "D", "mutation": "F469D", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "E", "mutation": "F469E", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 469, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F469F", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.04, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "G", "mutation": "F469G", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "H", "mutation": "F469H", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.8797, "ferret_sera_escape": 0.02063, "mature_H5_site": 469, "mouse_sera_escape": 0.06531, "mutant": "I", "mutation": "F469I", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": -0.4546, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.817, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "K", "mutation": "F469K", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.1193, "ferret_sera_escape": -0.0002663, "mature_H5_site": 469, "mouse_sera_escape": 0.03077, "mutant": "L", "mutation": "F469L", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": -0.2203, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.3085, "ferret_sera_escape": 0.007731, "mature_H5_site": 469, "mouse_sera_escape": 0.003166, "mutant": "M", "mutation": "F469M", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": -0.1842, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "N", "mutation": "F469N", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "P", "mutation": "F469P", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "Q", "mutation": "F469Q", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "R", "mutation": "F469R", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "S", "mutation": "F469S", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.231, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": 0.08779, "mutant": "T", "mutation": "F469T", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "V", "mutation": "F469V", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 469, "mouse_sera_escape": null, "mutant": "W", "mutation": "F469W", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.5527, "ferret_sera_escape": -0.1041, "mature_H5_site": 469, "mouse_sera_escape": -0.0191, "mutant": "Y", "mutation": "F469Y", "reference_site": "469", "region": "HA2", "sequential_site": 485, "stability": -0.216, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.05332, "ferret_sera_escape": 0.01828, "mature_H5_site": 37, "mouse_sera_escape": 0.02492, "mutant": "A", "mutation": "H47A", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": 0.07366, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.12, "ferret_sera_escape": -0.1154, "mature_H5_site": 37, "mouse_sera_escape": -0.002099, "mutant": "C", "mutation": "H47C", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -2.965, "ferret_sera_escape": null, "mature_H5_site": 37, "mouse_sera_escape": null, "mutant": "D", "mutation": "H47D", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.977, "ferret_sera_escape": null, "mature_H5_site": 37, "mouse_sera_escape": null, "mutant": "E", "mutation": "H47E", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.21, "ferret_sera_escape": -0.04465, "mature_H5_site": 37, "mouse_sera_escape": 0.05865, "mutant": "F", "mutation": "H47F", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": -0.1343, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.09, "ferret_sera_escape": -0.1747, "mature_H5_site": 37, "mouse_sera_escape": 0.07248, "mutant": "G", "mutation": "H47G", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": -0.1973, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 37, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H47H", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -3.057, "ferret_sera_escape": null, "mature_H5_site": 37, "mouse_sera_escape": null, "mutant": "I", "mutation": "H47I", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.181, "ferret_sera_escape": null, "mature_H5_site": 37, "mouse_sera_escape": null, "mutant": "M", "mutation": "H47M", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3071, "ferret_sera_escape": -0.01044, "mature_H5_site": 37, "mouse_sera_escape": 0.045, "mutant": "N", "mutation": "H47N", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": -0.112, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.95, "ferret_sera_escape": null, "mature_H5_site": 37, "mouse_sera_escape": null, "mutant": "P", "mutation": "H47P", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.7665, "ferret_sera_escape": 0.004176, "mature_H5_site": 37, "mouse_sera_escape": 0.01814, "mutant": "Q", "mutation": "H47Q", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": -0.1626, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.986, "ferret_sera_escape": null, "mature_H5_site": 37, "mouse_sera_escape": null, "mutant": "R", "mutation": "H47R", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.3071, "ferret_sera_escape": 0.03, "mature_H5_site": 37, "mouse_sera_escape": 0.04447, "mutant": "S", "mutation": "H47S", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": -0.2037, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.2926, "ferret_sera_escape": 0.05329, "mature_H5_site": 37, "mouse_sera_escape": 0.2068, "mutant": "T", "mutation": "H47T", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": -0.0244, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.02953, "ferret_sera_escape": -0.1244, "mature_H5_site": 37, "mouse_sera_escape": 0.06347, "mutant": "V", "mutation": "H47V", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": 0.4462, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.268, "ferret_sera_escape": null, "mature_H5_site": 37, "mouse_sera_escape": null, "mutant": "W", "mutation": "H47W", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -0.4809, "ferret_sera_escape": -0.157, "mature_H5_site": 37, "mouse_sera_escape": 0.05475, "mutant": "Y", "mutation": "H47Y", "reference_site": "47", "region": "region-C", "sequential_site": 53, "stability": -0.1818, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -1.925, "ferret_sera_escape": 0.248, "mature_H5_site": 470, "mouse_sera_escape": 0.2605, "mutant": "A", "mutation": "Y470A", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.0134, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.48, "ferret_sera_escape": null, "mature_H5_site": 470, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y470C", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.004, "ferret_sera_escape": null, "mature_H5_site": 470, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y470D", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.565, "ferret_sera_escape": 0.1364, "mature_H5_site": 470, "mouse_sera_escape": 0.1274, "mutant": "E", "mutation": "Y470E", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": -0.007482, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.01928, "ferret_sera_escape": 0.1698, "mature_H5_site": 470, "mouse_sera_escape": 0.02062, "mutant": "F", "mutation": "Y470F", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": -0.02451, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.364, "ferret_sera_escape": -0.1035, "mature_H5_site": 470, "mouse_sera_escape": 0.02713, "mutant": "I", "mutation": "Y470I", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.001558, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.8497, "ferret_sera_escape": -0.04406, "mature_H5_site": 470, "mouse_sera_escape": -0.1454, "mutant": "K", "mutation": "Y470K", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.03657, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4909, "ferret_sera_escape": 0.03712, "mature_H5_site": 470, "mouse_sera_escape": 0.07367, "mutant": "L", "mutation": "Y470L", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.07176, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.9718, "ferret_sera_escape": 0.08922, "mature_H5_site": 470, "mouse_sera_escape": 0.06939, "mutant": "M", "mutation": "Y470M", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.026, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.006, "ferret_sera_escape": -0.02899, "mature_H5_site": 470, "mouse_sera_escape": 0.04629, "mutant": "N", "mutation": "Y470N", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": -0.048, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 470, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y470P", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7145, "ferret_sera_escape": null, "mature_H5_site": 470, "mouse_sera_escape": 0.02054, "mutant": "Q", "mutation": "Y470Q", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": -0.01652, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6609, "ferret_sera_escape": 0.08386, "mature_H5_site": 470, "mouse_sera_escape": 0.02226, "mutant": "R", "mutation": "Y470R", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": -0.06138, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.208, "ferret_sera_escape": -0.1035, "mature_H5_site": 470, "mouse_sera_escape": -0.06043, "mutant": "S", "mutation": "Y470S", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": -0.02879, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.259, "ferret_sera_escape": -0.01747, "mature_H5_site": 470, "mouse_sera_escape": -0.09619, "mutant": "T", "mutation": "Y470T", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.461, "ferret_sera_escape": 0.1504, "mature_H5_site": 470, "mouse_sera_escape": 0.008646, "mutant": "V", "mutation": "Y470V", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.009008, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6884, "ferret_sera_escape": -0.1376, "mature_H5_site": 470, "mouse_sera_escape": -0.06329, "mutant": "W", "mutation": "Y470W", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.1579, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 470, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y470Y", "reference_site": "470", "region": "HA2", "sequential_site": 486, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.837, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "A", "mutation": "H471A", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.245, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "C", "mutation": "H471C", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "D", "mutation": "H471D", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "E", "mutation": "H471E", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.298, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "F", "mutation": "H471F", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.892, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "G", "mutation": "H471G", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 471, "mouse_sera_escape": 0.0, "mutant": "H", "mutation": "H471H", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": 0.0, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -4.018, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "K", "mutation": "H471K", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "M", "mutation": "H471M", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.984, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "N", "mutation": "H471N", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "P", "mutation": "H471P", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "Q", "mutation": "H471Q", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "R", "mutation": "H471R", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "S", "mutation": "H471S", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "T", "mutation": "H471T", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.847, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "V", "mutation": "H471V", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "W", "mutation": "H471W", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.0, "cell_entry": -5.72, "ferret_sera_escape": null, "mature_H5_site": 471, "mouse_sera_escape": null, "mutant": "Y", "mutation": "H471Y", "reference_site": "471", "region": "HA2", "sequential_site": 487, "stability": null, "wildtype": "H"}, {"a26_usage": 0.03444, "cell_entry": -0.08278, "ferret_sera_escape": 0.02238, "mature_H5_site": 472, "mouse_sera_escape": -0.00617, "mutant": "A", "mutation": "K472A", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.02391, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0182, "ferret_sera_escape": 0.09362, "mature_H5_site": 472, "mouse_sera_escape": 0.1394, "mutant": "C", "mutation": "K472C", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.0721, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1708, "ferret_sera_escape": -0.07664, "mature_H5_site": 472, "mouse_sera_escape": 0.02273, "mutant": "D", "mutation": "K472D", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": 0.02457, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.156, "ferret_sera_escape": 0.03268, "mature_H5_site": 472, "mouse_sera_escape": 0.09155, "mutant": "E", "mutation": "K472E", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.03857, "wildtype": "K"}, {"a26_usage": 0.06373, "cell_entry": -0.0614, "ferret_sera_escape": 0.00185, "mature_H5_site": 472, "mouse_sera_escape": 0.02924, "mutant": "F", "mutation": "K472F", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.01771, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.00799, "ferret_sera_escape": 0.01297, "mature_H5_site": 472, "mouse_sera_escape": 0.1087, "mutant": "G", "mutation": "K472G", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.01907, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2637, "ferret_sera_escape": -0.2263, "mature_H5_site": 472, "mouse_sera_escape": 0.03101, "mutant": "H", "mutation": "K472H", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.07241, "wildtype": "K"}, {"a26_usage": 0.05594, "cell_entry": 0.02784, "ferret_sera_escape": -0.07901, "mature_H5_site": 472, "mouse_sera_escape": -0.02947, "mutant": "I", "mutation": "K472I", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.07822, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 472, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K472K", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2482, "ferret_sera_escape": 0.01327, "mature_H5_site": 472, "mouse_sera_escape": 0.04185, "mutant": "L", "mutation": "K472L", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": 0.003607, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0753, "ferret_sera_escape": 0.01112, "mature_H5_site": 472, "mouse_sera_escape": 0.08489, "mutant": "M", "mutation": "K472M", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.01356, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04923, "ferret_sera_escape": -0.03346, "mature_H5_site": 472, "mouse_sera_escape": 0.02843, "mutant": "N", "mutation": "K472N", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.04268, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.209, "ferret_sera_escape": 0.06498, "mature_H5_site": 472, "mouse_sera_escape": -0.02109, "mutant": "Q", "mutation": "K472Q", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.002295, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03329, "ferret_sera_escape": 0.03112, "mature_H5_site": 472, "mouse_sera_escape": 0.05719, "mutant": "R", "mutation": "K472R", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": 0.01398, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05821, "ferret_sera_escape": null, "mature_H5_site": 472, "mouse_sera_escape": null, "mutant": "S", "mutation": "K472S", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.0997, "ferret_sera_escape": -0.05328, "mature_H5_site": 472, "mouse_sera_escape": -0.01352, "mutant": "T", "mutation": "K472T", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.0636, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3759, "ferret_sera_escape": 0.1093, "mature_H5_site": 472, "mouse_sera_escape": -0.07362, "mutant": "V", "mutation": "K472V", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.04456, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5537, "ferret_sera_escape": -0.003405, "mature_H5_site": 472, "mouse_sera_escape": 0.1162, "mutant": "W", "mutation": "K472W", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": -0.09736, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.119, "ferret_sera_escape": null, "mature_H5_site": 472, "mouse_sera_escape": null, "mutant": "Y", "mutation": "K472Y", "reference_site": "472", "region": "HA2", "sequential_site": 488, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.978, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "A", "mutation": "C473A", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 473, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C473C", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.924, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "D", "mutation": "C473D", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "E", "mutation": "C473E", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.891, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "F", "mutation": "C473F", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.694, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "G", "mutation": "C473G", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.848, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "H", "mutation": "C473H", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "I", "mutation": "C473I", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.993, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "K", "mutation": "C473K", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "L", "mutation": "C473L", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "M", "mutation": "C473M", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "N", "mutation": "C473N", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "P", "mutation": "C473P", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.908, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C473Q", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "R", "mutation": "C473R", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.277, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "S", "mutation": "C473S", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "T", "mutation": "C473T", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "V", "mutation": "C473V", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.763, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "W", "mutation": "C473W", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 473, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C473Y", "reference_site": "473", "region": "HA2", "sequential_site": 489, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.2777, "ferret_sera_escape": 0.1222, "mature_H5_site": 474, "mouse_sera_escape": 0.05603, "mutant": "A", "mutation": "D474A", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": 0.007051, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3002, "ferret_sera_escape": -0.002654, "mature_H5_site": 474, "mouse_sera_escape": 0.0006444, "mutant": "C", "mutation": "D474C", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.007925, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 474, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D474D", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.04672, "ferret_sera_escape": null, "mature_H5_site": 474, "mouse_sera_escape": null, "mutant": "E", "mutation": "D474E", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6101, "ferret_sera_escape": -0.00683, "mature_H5_site": 474, "mouse_sera_escape": 0.03173, "mutant": "F", "mutation": "D474F", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.05808, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1828, "ferret_sera_escape": null, "mature_H5_site": 474, "mouse_sera_escape": null, "mutant": "G", "mutation": "D474G", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1123, "ferret_sera_escape": 0.129, "mature_H5_site": 474, "mouse_sera_escape": 0.05728, "mutant": "H", "mutation": "D474H", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.03574, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.776, "ferret_sera_escape": -0.2652, "mature_H5_site": 474, "mouse_sera_escape": -0.02841, "mutant": "I", "mutation": "D474I", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1623, "ferret_sera_escape": 0.1191, "mature_H5_site": 474, "mouse_sera_escape": 0.05449, "mutant": "L", "mutation": "D474L", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": 0.05988, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5227, "ferret_sera_escape": null, "mature_H5_site": 474, "mouse_sera_escape": null, "mutant": "M", "mutation": "D474M", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": null, "wildtype": "D"}, {"a26_usage": 0.05467, "cell_entry": 0.004995, "ferret_sera_escape": -0.02047, "mature_H5_site": 474, "mouse_sera_escape": 0.00547, "mutant": "N", "mutation": "D474N", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": 0.03676, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.05199, "ferret_sera_escape": 0.08187, "mature_H5_site": 474, "mouse_sera_escape": 0.03622, "mutant": "P", "mutation": "D474P", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.02689, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6385, "ferret_sera_escape": 0.1445, "mature_H5_site": 474, "mouse_sera_escape": 0.05405, "mutant": "Q", "mutation": "D474Q", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2171, "ferret_sera_escape": -0.02922, "mature_H5_site": 474, "mouse_sera_escape": -0.02334, "mutant": "R", "mutation": "D474R", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.1123, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2033, "ferret_sera_escape": 0.0345, "mature_H5_site": 474, "mouse_sera_escape": 0.03753, "mutant": "S", "mutation": "D474S", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.01805, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3021, "ferret_sera_escape": -0.008487, "mature_H5_site": 474, "mouse_sera_escape": 0.005721, "mutant": "T", "mutation": "D474T", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.04846, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.804, "ferret_sera_escape": null, "mature_H5_site": 474, "mouse_sera_escape": null, "mutant": "W", "mutation": "D474W", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8531, "ferret_sera_escape": 0.2217, "mature_H5_site": 474, "mouse_sera_escape": -0.02212, "mutant": "Y", "mutation": "D474Y", "reference_site": "474", "region": "HA2", "sequential_site": 490, "stability": -0.08201, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4861, "ferret_sera_escape": null, "mature_H5_site": 475, "mouse_sera_escape": null, "mutant": "A", "mutation": "N475A", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7183, "ferret_sera_escape": -0.06756, "mature_H5_site": 475, "mouse_sera_escape": 0.04213, "mutant": "C", "mutation": "N475C", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.1871, "wildtype": "N"}, {"a26_usage": 0.09419, "cell_entry": -0.1398, "ferret_sera_escape": -0.02913, "mature_H5_site": 475, "mouse_sera_escape": 0.1062, "mutant": "D", "mutation": "N475D", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.07342, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.07039, "ferret_sera_escape": -0.263, "mature_H5_site": 475, "mouse_sera_escape": 0.009285, "mutant": "E", "mutation": "N475E", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9918, "ferret_sera_escape": -0.06129, "mature_H5_site": 475, "mouse_sera_escape": -0.01838, "mutant": "G", "mutation": "N475G", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.1201, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.089, "ferret_sera_escape": 0.00313, "mature_H5_site": 475, "mouse_sera_escape": 0.1537, "mutant": "H", "mutation": "N475H", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.1791, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.263, "ferret_sera_escape": -0.1417, "mature_H5_site": 475, "mouse_sera_escape": -0.0384, "mutant": "K", "mutation": "N475K", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7843, "ferret_sera_escape": -0.0453, "mature_H5_site": 475, "mouse_sera_escape": 0.2227, "mutant": "L", "mutation": "N475L", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.142, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 475, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N475N", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.8844, "ferret_sera_escape": null, "mature_H5_site": 475, "mouse_sera_escape": null, "mutant": "P", "mutation": "N475P", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9446, "ferret_sera_escape": 0.0059, "mature_H5_site": 475, "mouse_sera_escape": 0.1149, "mutant": "Q", "mutation": "N475Q", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.1203, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.756, "ferret_sera_escape": null, "mature_H5_site": 475, "mouse_sera_escape": null, "mutant": "R", "mutation": "N475R", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6235, "ferret_sera_escape": -0.02934, "mature_H5_site": 475, "mouse_sera_escape": 0.09256, "mutant": "S", "mutation": "N475S", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.1188, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.09094, "ferret_sera_escape": -0.05147, "mature_H5_site": 475, "mouse_sera_escape": 0.06634, "mutant": "T", "mutation": "N475T", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": -0.3013, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.415, "ferret_sera_escape": -0.1083, "mature_H5_site": 475, "mouse_sera_escape": 0.07208, "mutant": "V", "mutation": "N475V", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.417, "ferret_sera_escape": null, "mature_H5_site": 475, "mouse_sera_escape": null, "mutant": "W", "mutation": "N475W", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7666, "ferret_sera_escape": -0.006467, "mature_H5_site": 475, "mouse_sera_escape": 0.1359, "mutant": "Y", "mutation": "N475Y", "reference_site": "475", "region": "HA2", "sequential_site": 491, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04997, "ferret_sera_escape": 0.09285, "mature_H5_site": 476, "mouse_sera_escape": 0.04904, "mutant": "A", "mutation": "E476A", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.03422, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7759, "ferret_sera_escape": 0.1192, "mature_H5_site": 476, "mouse_sera_escape": -0.05715, "mutant": "C", "mutation": "E476C", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": -0.04018, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.592, "ferret_sera_escape": null, "mature_H5_site": 476, "mouse_sera_escape": null, "mutant": "D", "mutation": "E476D", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 476, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E476E", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.5285, "cell_entry": -0.1221, "ferret_sera_escape": -0.06338, "mature_H5_site": 476, "mouse_sera_escape": 0.03335, "mutant": "G", "mutation": "E476G", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.02157, "wildtype": "E"}, {"a26_usage": 0.1099, "cell_entry": -0.05299, "ferret_sera_escape": 0.0742, "mature_H5_site": 476, "mouse_sera_escape": -0.03912, "mutant": "H", "mutation": "E476H", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": -0.01018, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7167, "ferret_sera_escape": 0.1499, "mature_H5_site": 476, "mouse_sera_escape": 0.09611, "mutant": "I", "mutation": "E476I", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": -0.0005629, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.00132, "ferret_sera_escape": 0.1284, "mature_H5_site": 476, "mouse_sera_escape": 0.0626, "mutant": "K", "mutation": "E476K", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.03765, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01675, "ferret_sera_escape": 0.1923, "mature_H5_site": 476, "mouse_sera_escape": 0.02247, "mutant": "L", "mutation": "E476L", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.06569, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2813, "ferret_sera_escape": 0.03375, "mature_H5_site": 476, "mouse_sera_escape": -0.00864, "mutant": "M", "mutation": "E476M", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": -0.02215, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2554, "ferret_sera_escape": null, "mature_H5_site": 476, "mouse_sera_escape": null, "mutant": "N", "mutation": "E476N", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1415, "ferret_sera_escape": 0.1133, "mature_H5_site": 476, "mouse_sera_escape": 0.06348, "mutant": "P", "mutation": "E476P", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": -0.05708, "wildtype": "E"}, {"a26_usage": 0.1341, "cell_entry": 0.07608, "ferret_sera_escape": 0.08131, "mature_H5_site": 476, "mouse_sera_escape": 0.1086, "mutant": "Q", "mutation": "E476Q", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.03044, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.03489, "ferret_sera_escape": 0.02843, "mature_H5_site": 476, "mouse_sera_escape": -0.01873, "mutant": "S", "mutation": "E476S", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.03182, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.306, "ferret_sera_escape": -0.02386, "mature_H5_site": 476, "mouse_sera_escape": -0.1, "mutant": "T", "mutation": "E476T", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": -0.01048, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.03134, "ferret_sera_escape": 0.3073, "mature_H5_site": 476, "mouse_sera_escape": 0.147, "mutant": "V", "mutation": "E476V", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.05441, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06209, "ferret_sera_escape": 0.03604, "mature_H5_site": 476, "mouse_sera_escape": -0.004136, "mutant": "W", "mutation": "E476W", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.03752, "wildtype": "E"}, {"a26_usage": 0.06743, "cell_entry": -0.01797, "ferret_sera_escape": 0.06543, "mature_H5_site": 476, "mouse_sera_escape": -0.1107, "mutant": "Y", "mutation": "E476Y", "reference_site": "476", "region": "HA2", "sequential_site": 492, "stability": 0.03292, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "A", "mutation": "C477A", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 477, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C477C", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.966, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "D", "mutation": "C477D", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.105, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "E", "mutation": "C477E", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "F", "mutation": "C477F", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.704, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "G", "mutation": "C477G", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "H", "mutation": "C477H", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": null, "cell_entry": -5.78, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "I", "mutation": "C477I", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.838, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "K", "mutation": "C477K", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.622, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "L", "mutation": "C477L", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.886, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "M", "mutation": "C477M", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "N", "mutation": "C477N", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.964, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C477Q", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.774, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "R", "mutation": "C477R", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.863, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "S", "mutation": "C477S", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.985, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "T", "mutation": "C477T", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "W", "mutation": "C477W", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.553, "ferret_sera_escape": null, "mature_H5_site": 477, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C477Y", "reference_site": "477", "region": "HA2", "sequential_site": 493, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.384, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "A", "mutation": "M478A", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.59, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "C", "mutation": "M478C", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "D", "mutation": "M478D", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.906, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "E", "mutation": "M478E", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.8904, "ferret_sera_escape": -0.00084, "mature_H5_site": 478, "mouse_sera_escape": 0.0885, "mutant": "F", "mutation": "M478F", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": -0.1553, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "G", "mutation": "M478G", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "H", "mutation": "M478H", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.7825, "ferret_sera_escape": 0.02627, "mature_H5_site": 478, "mouse_sera_escape": -0.003998, "mutant": "I", "mutation": "M478I", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": -0.2422, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -6.05, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "K", "mutation": "M478K", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.8727, "ferret_sera_escape": -0.183, "mature_H5_site": 478, "mouse_sera_escape": 0.09834, "mutant": "L", "mutation": "M478L", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": -0.2257, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 478, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M478M", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "N", "mutation": "M478N", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "P", "mutation": "M478P", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.535, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "Q", "mutation": "M478Q", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "R", "mutation": "M478R", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "S", "mutation": "M478S", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.548, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "T", "mutation": "M478T", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.6215, "ferret_sera_escape": 0.08772, "mature_H5_site": 478, "mouse_sera_escape": -0.0115, "mutant": "V", "mutation": "M478V", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.983, "ferret_sera_escape": null, "mature_H5_site": 478, "mouse_sera_escape": null, "mutant": "W", "mutation": "M478W", "reference_site": "478", "region": "HA2", "sequential_site": 494, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.3402, "ferret_sera_escape": -0.02155, "mature_H5_site": 479, "mouse_sera_escape": -0.06735, "mutant": "A", "mutation": "E479A", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.01393, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.07176, "ferret_sera_escape": -0.03943, "mature_H5_site": 479, "mouse_sera_escape": 0.0437, "mutant": "C", "mutation": "E479C", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.008387, "wildtype": "E"}, {"a26_usage": 0.11, "cell_entry": -0.5454, "ferret_sera_escape": -0.003227, "mature_H5_site": 479, "mouse_sera_escape": 0.0131, "mutant": "D", "mutation": "E479D", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.01866, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 479, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E479E", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2217, "ferret_sera_escape": -0.02874, "mature_H5_site": 479, "mouse_sera_escape": -0.05029, "mutant": "F", "mutation": "E479F", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5922, "ferret_sera_escape": 0.1443, "mature_H5_site": 479, "mouse_sera_escape": -0.01388, "mutant": "G", "mutation": "E479G", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.02659, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3883, "ferret_sera_escape": 0.05595, "mature_H5_site": 479, "mouse_sera_escape": 0.1191, "mutant": "H", "mutation": "E479H", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.02118, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.162, "ferret_sera_escape": 0.1288, "mature_H5_site": 479, "mouse_sera_escape": 0.05969, "mutant": "I", "mutation": "E479I", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.04456, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5117, "ferret_sera_escape": 0.0348, "mature_H5_site": 479, "mouse_sera_escape": -0.02546, "mutant": "K", "mutation": "E479K", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": -0.002853, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2853, "ferret_sera_escape": 0.1501, "mature_H5_site": 479, "mouse_sera_escape": 0.03485, "mutant": "L", "mutation": "E479L", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.06063, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.07452, "ferret_sera_escape": -0.03841, "mature_H5_site": 479, "mouse_sera_escape": -0.0666, "mutant": "M", "mutation": "E479M", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.01543, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1925, "ferret_sera_escape": 0.02632, "mature_H5_site": 479, "mouse_sera_escape": -0.001332, "mutant": "N", "mutation": "E479N", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.03838, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.845, "ferret_sera_escape": null, "mature_H5_site": 479, "mouse_sera_escape": null, "mutant": "P", "mutation": "E479P", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7171, "ferret_sera_escape": 0.07366, "mature_H5_site": 479, "mouse_sera_escape": -0.01557, "mutant": "Q", "mutation": "E479Q", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.05397, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.575, "ferret_sera_escape": 0.1693, "mature_H5_site": 479, "mouse_sera_escape": 0.008851, "mutant": "R", "mutation": "E479R", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.04269, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2402, "ferret_sera_escape": 0.1124, "mature_H5_site": 479, "mouse_sera_escape": 0.01496, "mutant": "S", "mutation": "E479S", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.09553, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.07883, "ferret_sera_escape": -0.00116, "mature_H5_site": 479, "mouse_sera_escape": -0.02387, "mutant": "T", "mutation": "E479T", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": -0.0354, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02541, "ferret_sera_escape": 0.008497, "mature_H5_site": 479, "mouse_sera_escape": 0.02404, "mutant": "V", "mutation": "E479V", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": -0.02631, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.416, "ferret_sera_escape": 0.01206, "mature_H5_site": 479, "mouse_sera_escape": 0.03488, "mutant": "W", "mutation": "E479W", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": -0.01001, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4616, "ferret_sera_escape": -0.02932, "mature_H5_site": 479, "mouse_sera_escape": 0.1165, "mutant": "Y", "mutation": "E479Y", "reference_site": "479", "region": "HA2", "sequential_site": 495, "stability": 0.09307, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3413, "ferret_sera_escape": 0.02905, "mature_H5_site": 38, "mouse_sera_escape": 0.0385, "mutant": "D", "mutation": "N48D", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": -0.1501, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.135, "ferret_sera_escape": null, "mature_H5_site": 38, "mouse_sera_escape": null, "mutant": "E", "mutation": "N48E", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.069, "ferret_sera_escape": -0.1579, "mature_H5_site": 38, "mouse_sera_escape": 0.07801, "mutant": "F", "mutation": "N48F", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": -0.2229, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.08924, "ferret_sera_escape": 0.1594, "mature_H5_site": 38, "mouse_sera_escape": 0.003307, "mutant": "G", "mutation": "N48G", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": -0.09558, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.086, "ferret_sera_escape": -0.05718, "mature_H5_site": 38, "mouse_sera_escape": 0.1561, "mutant": "H", "mutation": "N48H", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": -0.3148, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.223, "ferret_sera_escape": null, "mature_H5_site": 38, "mouse_sera_escape": null, "mutant": "K", "mutation": "N48K", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.234, "ferret_sera_escape": -0.13, "mature_H5_site": 38, "mouse_sera_escape": -0.01812, "mutant": "L", "mutation": "N48L", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": 0.09217, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.734, "ferret_sera_escape": null, "mature_H5_site": 38, "mouse_sera_escape": null, "mutant": "M", "mutation": "N48M", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 38, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N48N", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.716, "ferret_sera_escape": null, "mature_H5_site": 38, "mouse_sera_escape": null, "mutant": "P", "mutation": "N48P", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.56, "ferret_sera_escape": -0.06244, "mature_H5_site": 38, "mouse_sera_escape": 0.0006662, "mutant": "Q", "mutation": "N48Q", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": -0.2057, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -3.986, "ferret_sera_escape": null, "mature_H5_site": 38, "mouse_sera_escape": null, "mutant": "R", "mutation": "N48R", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.151, "ferret_sera_escape": 0.01226, "mature_H5_site": 38, "mouse_sera_escape": -0.002999, "mutant": "S", "mutation": "N48S", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.03306, "ferret_sera_escape": null, "mature_H5_site": 38, "mouse_sera_escape": -0.1947, "mutant": "T", "mutation": "N48T", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.246, "ferret_sera_escape": -0.02873, "mature_H5_site": 38, "mouse_sera_escape": 0.1266, "mutant": "V", "mutation": "N48V", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": -0.1463, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.224, "ferret_sera_escape": -0.293, "mature_H5_site": 38, "mouse_sera_escape": 0.0586, "mutant": "Y", "mutation": "N48Y", "reference_site": "48", "region": "region-C", "sequential_site": 54, "stability": -0.3066, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4241, "ferret_sera_escape": -0.0417, "mature_H5_site": 480, "mouse_sera_escape": 0.1121, "mutant": "C", "mutation": "S480C", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.03353, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6581, "ferret_sera_escape": -0.02009, "mature_H5_site": 480, "mouse_sera_escape": 0.001329, "mutant": "D", "mutation": "S480D", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.04857, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.08343, "ferret_sera_escape": 0.05242, "mature_H5_site": 480, "mouse_sera_escape": 0.03594, "mutant": "E", "mutation": "S480E", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.03651, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.7335, "ferret_sera_escape": 0.1648, "mature_H5_site": 480, "mouse_sera_escape": 0.08614, "mutant": "F", "mutation": "S480F", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.1562, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.132, "ferret_sera_escape": -0.06312, "mature_H5_site": 480, "mouse_sera_escape": -0.06035, "mutant": "G", "mutation": "S480G", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.02897, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.7248, "ferret_sera_escape": 0.1998, "mature_H5_site": 480, "mouse_sera_escape": 0.1495, "mutant": "H", "mutation": "S480H", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": 0.02546, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -3.721, "ferret_sera_escape": null, "mature_H5_site": 480, "mouse_sera_escape": null, "mutant": "I", "mutation": "S480I", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": null, "wildtype": "S"}, {"a26_usage": 0.1128, "cell_entry": -0.4846, "ferret_sera_escape": null, "mature_H5_site": 480, "mouse_sera_escape": null, "mutant": "K", "mutation": "S480K", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.007, "ferret_sera_escape": 0.004673, "mature_H5_site": 480, "mouse_sera_escape": 0.06156, "mutant": "L", "mutation": "S480L", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.1475, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.01755, "ferret_sera_escape": 0.01229, "mature_H5_site": 480, "mouse_sera_escape": -0.02905, "mutant": "M", "mutation": "S480M", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.05217, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -0.1153, "ferret_sera_escape": null, "mature_H5_site": 480, "mouse_sera_escape": null, "mutant": "N", "mutation": "S480N", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 480, "mouse_sera_escape": null, "mutant": "P", "mutation": "S480P", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1154, "ferret_sera_escape": -0.03623, "mature_H5_site": 480, "mouse_sera_escape": -0.04901, "mutant": "Q", "mutation": "S480Q", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.04446, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.01786, "ferret_sera_escape": 0.1472, "mature_H5_site": 480, "mouse_sera_escape": 0.07722, "mutant": "R", "mutation": "S480R", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.05052, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 480, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S480S", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.004784, "cell_entry": 0.0577, "ferret_sera_escape": -0.04838, "mature_H5_site": 480, "mouse_sera_escape": 0.001034, "mutant": "T", "mutation": "S480T", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.06706, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.113, "ferret_sera_escape": 0.1942, "mature_H5_site": 480, "mouse_sera_escape": null, "mutant": "V", "mutation": "S480V", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.01, "ferret_sera_escape": null, "mature_H5_site": 480, "mouse_sera_escape": null, "mutant": "W", "mutation": "S480W", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.135, "ferret_sera_escape": 0.1486, "mature_H5_site": 480, "mouse_sera_escape": 0.04185, "mutant": "Y", "mutation": "S480Y", "reference_site": "480", "region": "HA2", "sequential_site": 496, "stability": -0.1386, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.987, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "A", "mutation": "V481A", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2965, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "C", "mutation": "V481C", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "D", "mutation": "V481D", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "E", "mutation": "V481E", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "F", "mutation": "V481F", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.755, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "G", "mutation": "V481G", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -6.024, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "H", "mutation": "V481H", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.07554, "ferret_sera_escape": -0.1238, "mature_H5_site": 481, "mouse_sera_escape": -0.04285, "mutant": "I", "mutation": "V481I", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": -0.05477, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "K", "mutation": "V481K", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1209, "ferret_sera_escape": 0.1186, "mature_H5_site": 481, "mouse_sera_escape": 0.1545, "mutant": "L", "mutation": "V481L", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": -0.06899, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.518, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "M", "mutation": "V481M", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": null, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "N", "mutation": "V481N", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "P", "mutation": "V481P", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V481Q", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "R", "mutation": "V481R", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.556, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "S", "mutation": "V481S", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.839, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "T", "mutation": "V481T", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 481, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V481V", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.748, "ferret_sera_escape": null, "mature_H5_site": 481, "mouse_sera_escape": null, "mutant": "W", "mutation": "V481W", "reference_site": "481", "region": "HA2", "sequential_site": 497, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.9165, "ferret_sera_escape": -0.1888, "mature_H5_site": 482, "mouse_sera_escape": -0.1089, "mutant": "A", "mutation": "R482A", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1701, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3311, "ferret_sera_escape": -0.1591, "mature_H5_site": 482, "mouse_sera_escape": -0.09391, "mutant": "C", "mutation": "R482C", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1438, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.506, "ferret_sera_escape": 0.04659, "mature_H5_site": 482, "mouse_sera_escape": 0.06001, "mutant": "D", "mutation": "R482D", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.04525, "wildtype": "R"}, {"a26_usage": 0.7712, "cell_entry": -0.9797, "ferret_sera_escape": -0.02209, "mature_H5_site": 482, "mouse_sera_escape": -0.04521, "mutant": "E", "mutation": "R482E", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": 0.02405, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4458, "ferret_sera_escape": 0.017, "mature_H5_site": 482, "mouse_sera_escape": 0.165, "mutant": "F", "mutation": "R482F", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1245, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.628, "ferret_sera_escape": 0.04398, "mature_H5_site": 482, "mouse_sera_escape": null, "mutant": "H", "mutation": "R482H", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1539, "wildtype": "R"}, {"a26_usage": null, "cell_entry": -0.4656, "ferret_sera_escape": null, "mature_H5_site": 482, "mouse_sera_escape": null, "mutant": "I", "mutation": "R482I", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4002, "ferret_sera_escape": 0.04623, "mature_H5_site": 482, "mouse_sera_escape": 0.03565, "mutant": "K", "mutation": "R482K", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.004461, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.497, "ferret_sera_escape": null, "mature_H5_site": 482, "mouse_sera_escape": null, "mutant": "L", "mutation": "R482L", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2461, "ferret_sera_escape": 0.01753, "mature_H5_site": 482, "mouse_sera_escape": -0.05053, "mutant": "M", "mutation": "R482M", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.05069, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.897, "ferret_sera_escape": null, "mature_H5_site": 482, "mouse_sera_escape": null, "mutant": "P", "mutation": "R482P", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4239, "ferret_sera_escape": null, "mature_H5_site": 482, "mouse_sera_escape": null, "mutant": "Q", "mutation": "R482Q", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 482, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R482R", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1832, "ferret_sera_escape": 0.04419, "mature_H5_site": 482, "mouse_sera_escape": -0.05158, "mutant": "S", "mutation": "R482S", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1556, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5665, "ferret_sera_escape": -0.02183, "mature_H5_site": 482, "mouse_sera_escape": 0.02301, "mutant": "T", "mutation": "R482T", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1077, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2518, "ferret_sera_escape": -0.2844, "mature_H5_site": 482, "mouse_sera_escape": -0.0005412, "mutant": "V", "mutation": "R482V", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1226, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.798, "ferret_sera_escape": null, "mature_H5_site": 482, "mouse_sera_escape": null, "mutant": "W", "mutation": "R482W", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.54, "ferret_sera_escape": -0.03842, "mature_H5_site": 482, "mouse_sera_escape": 0.1033, "mutant": "Y", "mutation": "R482Y", "reference_site": "482", "region": "HA2", "sequential_site": 498, "stability": -0.1712, "wildtype": "R"}, {"a26_usage": 0.1731, "cell_entry": 0.01077, "ferret_sera_escape": -0.07382, "mature_H5_site": 483, "mouse_sera_escape": 0.2063, "mutant": "A", "mutation": "N483A", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.01999, "wildtype": "N"}, {"a26_usage": null, "cell_entry": -0.2424, "ferret_sera_escape": null, "mature_H5_site": 483, "mouse_sera_escape": null, "mutant": "E", "mutation": "N483E", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.06985, "ferret_sera_escape": -0.2094, "mature_H5_site": 483, "mouse_sera_escape": 0.02496, "mutant": "F", "mutation": "N483F", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": 0.006271, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.469, "ferret_sera_escape": 0.00864, "mature_H5_site": 483, "mouse_sera_escape": -0.01401, "mutant": "H", "mutation": "N483H", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.06717, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2435, "ferret_sera_escape": -0.09124, "mature_H5_site": 483, "mouse_sera_escape": 0.1531, "mutant": "I", "mutation": "N483I", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.06742, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.313, "ferret_sera_escape": 0.1406, "mature_H5_site": 483, "mouse_sera_escape": 0.2881, "mutant": "K", "mutation": "N483K", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": 0.08266, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.03695, "ferret_sera_escape": null, "mature_H5_site": 483, "mouse_sera_escape": null, "mutant": "M", "mutation": "N483M", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 483, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N483N", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 483, "mouse_sera_escape": null, "mutant": "P", "mutation": "N483P", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2143, "ferret_sera_escape": 0.03515, "mature_H5_site": 483, "mouse_sera_escape": -0.00882, "mutant": "Q", "mutation": "N483Q", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.04623, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.005845, "ferret_sera_escape": -0.1113, "mature_H5_site": 483, "mouse_sera_escape": 0.05608, "mutant": "R", "mutation": "N483R", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.03492, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05613, "ferret_sera_escape": -0.1501, "mature_H5_site": 483, "mouse_sera_escape": 0.01173, "mutant": "T", "mutation": "N483T", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.0795, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4616, "ferret_sera_escape": null, "mature_H5_site": 483, "mouse_sera_escape": -0.1457, "mutant": "V", "mutation": "N483V", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.08416, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.95, "ferret_sera_escape": -0.1005, "mature_H5_site": 483, "mouse_sera_escape": 0.0499, "mutant": "W", "mutation": "N483W", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": -0.04403, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.293, "ferret_sera_escape": -0.04107, "mature_H5_site": 483, "mouse_sera_escape": 0.1856, "mutant": "Y", "mutation": "N483Y", "reference_site": "483", "region": "HA2", "sequential_site": 499, "stability": null, "wildtype": "N"}, {"a26_usage": 0.1058, "cell_entry": -0.2218, "ferret_sera_escape": -0.07855, "mature_H5_site": 484, "mouse_sera_escape": -0.05522, "mutant": "A", "mutation": "G484A", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4692, "ferret_sera_escape": 0.01772, "mature_H5_site": 484, "mouse_sera_escape": 0.02099, "mutant": "C", "mutation": "G484C", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": 0.02961, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.05982, "ferret_sera_escape": 0.216, "mature_H5_site": 484, "mouse_sera_escape": -0.03881, "mutant": "D", "mutation": "G484D", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": -0.04878, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5809, "ferret_sera_escape": -0.1524, "mature_H5_site": 484, "mouse_sera_escape": 0.0768, "mutant": "E", "mutation": "G484E", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": 0.1361, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1127, "ferret_sera_escape": null, "mature_H5_site": 484, "mouse_sera_escape": null, "mutant": "F", "mutation": "G484F", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 484, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G484G", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.214, "ferret_sera_escape": 0.1419, "mature_H5_site": 484, "mouse_sera_escape": 0.08371, "mutant": "H", "mutation": "G484H", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": 1.152, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.509, "ferret_sera_escape": null, "mature_H5_site": 484, "mouse_sera_escape": null, "mutant": "I", "mutation": "G484I", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.328, "ferret_sera_escape": 0.07516, "mature_H5_site": 484, "mouse_sera_escape": 0.3594, "mutant": "L", "mutation": "G484L", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": -0.1193, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2729, "ferret_sera_escape": 0.0733, "mature_H5_site": 484, "mouse_sera_escape": 0.0007063, "mutant": "M", "mutation": "G484M", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": 0.1534, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.003895, "ferret_sera_escape": 0.01005, "mature_H5_site": 484, "mouse_sera_escape": -0.06427, "mutant": "N", "mutation": "G484N", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": -0.004433, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 484, "mouse_sera_escape": null, "mutant": "P", "mutation": "G484P", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": null, "wildtype": "G"}, {"a26_usage": 0.1481, "cell_entry": -0.9005, "ferret_sera_escape": -0.1341, "mature_H5_site": 484, "mouse_sera_escape": -0.2029, "mutant": "Q", "mutation": "G484Q", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": -0.01042, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.05835, "ferret_sera_escape": 0.05878, "mature_H5_site": 484, "mouse_sera_escape": -0.04683, "mutant": "R", "mutation": "G484R", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": 0.01681, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3554, "ferret_sera_escape": 0.06507, "mature_H5_site": 484, "mouse_sera_escape": 0.05255, "mutant": "S", "mutation": "G484S", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": -0.01896, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2872, "ferret_sera_escape": -0.05073, "mature_H5_site": 484, "mouse_sera_escape": -0.007237, "mutant": "T", "mutation": "G484T", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": -0.1222, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.018, "ferret_sera_escape": null, "mature_H5_site": 484, "mouse_sera_escape": null, "mutant": "V", "mutation": "G484V", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.08666, "ferret_sera_escape": -0.1106, "mature_H5_site": 484, "mouse_sera_escape": -0.03945, "mutant": "W", "mutation": "G484W", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": 0.01183, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2061, "ferret_sera_escape": null, "mature_H5_site": 484, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G484Y", "reference_site": "484", "region": "HA2", "sequential_site": 500, "stability": null, "wildtype": "G"}, {"a26_usage": 0.2613, "cell_entry": -0.02251, "ferret_sera_escape": -0.1925, "mature_H5_site": 485, "mouse_sera_escape": 0.01651, "mutant": "A", "mutation": "T485A", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.1055, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7313, "ferret_sera_escape": -0.03523, "mature_H5_site": 485, "mouse_sera_escape": 0.09408, "mutant": "C", "mutation": "T485C", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.1864, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.05696, "ferret_sera_escape": -0.2477, "mature_H5_site": 485, "mouse_sera_escape": 0.004812, "mutant": "D", "mutation": "T485D", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.1181, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2538, "ferret_sera_escape": -0.08826, "mature_H5_site": 485, "mouse_sera_escape": -0.003605, "mutant": "E", "mutation": "T485E", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.08511, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4049, "ferret_sera_escape": null, "mature_H5_site": 485, "mouse_sera_escape": null, "mutant": "F", "mutation": "T485F", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4218, "ferret_sera_escape": -0.03859, "mature_H5_site": 485, "mouse_sera_escape": 0.04721, "mutant": "G", "mutation": "T485G", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.1286, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.003445, "ferret_sera_escape": -0.1585, "mature_H5_site": 485, "mouse_sera_escape": 0.08029, "mutant": "H", "mutation": "T485H", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.05436, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.388, "ferret_sera_escape": -0.1291, "mature_H5_site": 485, "mouse_sera_escape": -0.09505, "mutant": "I", "mutation": "T485I", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.6316, "ferret_sera_escape": -0.1067, "mature_H5_site": 485, "mouse_sera_escape": 0.03449, "mutant": "K", "mutation": "T485K", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.058, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.4477, "ferret_sera_escape": -0.057, "mature_H5_site": 485, "mouse_sera_escape": 0.1268, "mutant": "L", "mutation": "T485L", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.06834, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1615, "ferret_sera_escape": 0.01678, "mature_H5_site": 485, "mouse_sera_escape": 0.07952, "mutant": "M", "mutation": "T485M", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.2203, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.02644, "ferret_sera_escape": -0.1403, "mature_H5_site": 485, "mouse_sera_escape": 0.05064, "mutant": "N", "mutation": "T485N", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": 0.03994, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.28, "ferret_sera_escape": null, "mature_H5_site": 485, "mouse_sera_escape": null, "mutant": "P", "mutation": "T485P", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5237, "ferret_sera_escape": -0.1187, "mature_H5_site": 485, "mouse_sera_escape": 0.02692, "mutant": "Q", "mutation": "T485Q", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.08441, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.08727, "ferret_sera_escape": -0.05868, "mature_H5_site": 485, "mouse_sera_escape": 0.02264, "mutant": "R", "mutation": "T485R", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.077, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.04661, "ferret_sera_escape": -0.1367, "mature_H5_site": 485, "mouse_sera_escape": -0.1089, "mutant": "S", "mutation": "T485S", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.03816, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 485, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T485T", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5876, "ferret_sera_escape": -0.1364, "mature_H5_site": 485, "mouse_sera_escape": 0.1533, "mutant": "V", "mutation": "T485V", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.08917, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.5887, "ferret_sera_escape": -0.00562, "mature_H5_site": 485, "mouse_sera_escape": 0.1038, "mutant": "W", "mutation": "T485W", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.08858, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.011, "ferret_sera_escape": -0.1911, "mature_H5_site": 485, "mouse_sera_escape": 0.02749, "mutant": "Y", "mutation": "T485Y", "reference_site": "485", "region": "HA2", "sequential_site": 501, "stability": -0.1081, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y486A", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y486C", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y486E", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "F", "mutation": "Y486F", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y486G", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.986, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y486H", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y486I", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.008, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y486K", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y486L", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.026, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y486M", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.69, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y486N", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y486Q", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y486R", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y486S", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y486T", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.524, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y486V", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 486, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y486W", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 486, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y486Y", "reference_site": "486", "region": "HA2", "sequential_site": 502, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4682, "ferret_sera_escape": 0.04825, "mature_H5_site": 487, "mouse_sera_escape": -0.004618, "mutant": "A", "mutation": "D487A", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.005016, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.173, "ferret_sera_escape": 0.178, "mature_H5_site": 487, "mouse_sera_escape": -0.1463, "mutant": "C", "mutation": "D487C", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.009653, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 487, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D487D", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1731, "ferret_sera_escape": -0.003282, "mature_H5_site": 487, "mouse_sera_escape": -0.0936, "mutant": "E", "mutation": "D487E", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.01722, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2668, "ferret_sera_escape": -0.04972, "mature_H5_site": 487, "mouse_sera_escape": -0.02422, "mutant": "H", "mutation": "D487H", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": 0.05022, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5252, "ferret_sera_escape": -0.05669, "mature_H5_site": 487, "mouse_sera_escape": -0.07358, "mutant": "I", "mutation": "D487I", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": 0.001618, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8147, "ferret_sera_escape": null, "mature_H5_site": 487, "mouse_sera_escape": null, "mutant": "K", "mutation": "D487K", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.261, "ferret_sera_escape": 0.03677, "mature_H5_site": 487, "mouse_sera_escape": -0.01068, "mutant": "L", "mutation": "D487L", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.03419, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.007755, "ferret_sera_escape": 0.0293, "mature_H5_site": 487, "mouse_sera_escape": 0.03563, "mutant": "M", "mutation": "D487M", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": 0.00607, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2084, "ferret_sera_escape": -0.002944, "mature_H5_site": 487, "mouse_sera_escape": 0.01645, "mutant": "N", "mutation": "D487N", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.05864, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7202, "ferret_sera_escape": -0.01938, "mature_H5_site": 487, "mouse_sera_escape": -0.08052, "mutant": "Q", "mutation": "D487Q", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.03337, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.934, "ferret_sera_escape": 0.05385, "mature_H5_site": 487, "mouse_sera_escape": 0.1254, "mutant": "R", "mutation": "D487R", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.1158, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.332, "ferret_sera_escape": 0.004047, "mature_H5_site": 487, "mouse_sera_escape": -0.01615, "mutant": "S", "mutation": "D487S", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8407, "ferret_sera_escape": -0.008417, "mature_H5_site": 487, "mouse_sera_escape": -0.04829, "mutant": "T", "mutation": "D487T", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": -0.009314, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7742, "ferret_sera_escape": 0.08631, "mature_H5_site": 487, "mouse_sera_escape": 0.02906, "mutant": "V", "mutation": "D487V", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1915, "ferret_sera_escape": 0.1837, "mature_H5_site": 487, "mouse_sera_escape": 0.0142, "mutant": "W", "mutation": "D487W", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.0038, "ferret_sera_escape": 0.08072, "mature_H5_site": 487, "mouse_sera_escape": 0.03014, "mutant": "Y", "mutation": "D487Y", "reference_site": "487", "region": "HA2", "sequential_site": 503, "stability": 0.005994, "wildtype": "D"}, {"a26_usage": 0.1383, "cell_entry": 0.07365, "ferret_sera_escape": 0.0986, "mature_H5_site": 488, "mouse_sera_escape": 0.06566, "mutant": "A", "mutation": "Y488A", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": 0.05392, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.376, "ferret_sera_escape": -0.02226, "mature_H5_site": 488, "mouse_sera_escape": 0.2638, "mutant": "C", "mutation": "Y488C", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.112, "ferret_sera_escape": null, "mature_H5_site": 488, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y488D", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.084, "ferret_sera_escape": -0.07626, "mature_H5_site": 488, "mouse_sera_escape": -0.04471, "mutant": "E", "mutation": "Y488E", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": -0.1476, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4645, "ferret_sera_escape": null, "mature_H5_site": 488, "mouse_sera_escape": null, "mutant": "F", "mutation": "Y488F", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.05038, "ferret_sera_escape": -0.02821, "mature_H5_site": 488, "mouse_sera_escape": 0.03168, "mutant": "H", "mutation": "Y488H", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": 0.06562, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.344, "ferret_sera_escape": -0.114, "mature_H5_site": 488, "mouse_sera_escape": 0.07447, "mutant": "I", "mutation": "Y488I", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": -0.04052, "wildtype": "Y"}, {"a26_usage": null, "cell_entry": -1.948, "ferret_sera_escape": 0.04465, "mature_H5_site": 488, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y488K", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1512, "ferret_sera_escape": -0.06652, "mature_H5_site": 488, "mouse_sera_escape": 0.06024, "mutant": "L", "mutation": "Y488L", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": 0.252, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.02742, "ferret_sera_escape": null, "mature_H5_site": 488, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y488M", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4111, "ferret_sera_escape": 0.1236, "mature_H5_site": 488, "mouse_sera_escape": 0.01596, "mutant": "N", "mutation": "Y488N", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": -0.3093, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6532, "ferret_sera_escape": null, "mature_H5_site": 488, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y488Q", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.745, "ferret_sera_escape": -0.4679, "mature_H5_site": 488, "mouse_sera_escape": 0.04581, "mutant": "R", "mutation": "Y488R", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7654, "ferret_sera_escape": 0.1234, "mature_H5_site": 488, "mouse_sera_escape": 0.1816, "mutant": "S", "mutation": "Y488S", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": -0.02091, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.371, "ferret_sera_escape": null, "mature_H5_site": 488, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y488T", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7161, "ferret_sera_escape": 0.1677, "mature_H5_site": 488, "mouse_sera_escape": 0.09412, "mutant": "V", "mutation": "Y488V", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": 0.05021, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.04519, "ferret_sera_escape": -0.05489, "mature_H5_site": 488, "mouse_sera_escape": 0.08623, "mutant": "W", "mutation": "Y488W", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": -0.021, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 488, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y488Y", "reference_site": "488", "region": "HA2", "sequential_site": 504, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.1065, "cell_entry": -0.1552, "ferret_sera_escape": 0.01578, "mature_H5_site": 489, "mouse_sera_escape": null, "mutant": "A", "mutation": "P489A", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.04013, "ferret_sera_escape": -0.08114, "mature_H5_site": 489, "mouse_sera_escape": -0.09864, "mutant": "D", "mutation": "P489D", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.04188, "wildtype": "P"}, {"a26_usage": 0.05559, "cell_entry": 0.01254, "ferret_sera_escape": -0.02879, "mature_H5_site": 489, "mouse_sera_escape": -0.007419, "mutant": "F", "mutation": "P489F", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.1571, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.02938, "ferret_sera_escape": -0.008341, "mature_H5_site": 489, "mouse_sera_escape": -0.03831, "mutant": "G", "mutation": "P489G", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": 0.01021, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.04882, "ferret_sera_escape": -0.13, "mature_H5_site": 489, "mouse_sera_escape": -0.1292, "mutant": "H", "mutation": "P489H", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.1497, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.02565, "ferret_sera_escape": 0.1073, "mature_H5_site": 489, "mouse_sera_escape": 0.0902, "mutant": "I", "mutation": "P489I", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.0572, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1846, "ferret_sera_escape": 0.04503, "mature_H5_site": 489, "mouse_sera_escape": -0.0008303, "mutant": "K", "mutation": "P489K", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": 0.01046, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3002, "ferret_sera_escape": 0.01532, "mature_H5_site": 489, "mouse_sera_escape": -0.01713, "mutant": "L", "mutation": "P489L", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.1017, "wildtype": "P"}, {"a26_usage": 0.2463, "cell_entry": -0.05812, "ferret_sera_escape": -0.1003, "mature_H5_site": 489, "mouse_sera_escape": -0.06198, "mutant": "M", "mutation": "P489M", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.04655, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.03125, "ferret_sera_escape": -0.05052, "mature_H5_site": 489, "mouse_sera_escape": 0.04904, "mutant": "N", "mutation": "P489N", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.1082, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 489, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P489P", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.04562, "ferret_sera_escape": -0.04763, "mature_H5_site": 489, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P489Q", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.001623, "ferret_sera_escape": 0.01454, "mature_H5_site": 489, "mouse_sera_escape": -0.03628, "mutant": "R", "mutation": "P489R", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.0638, "wildtype": "P"}, {"a26_usage": 0.3141, "cell_entry": -0.1684, "ferret_sera_escape": -0.05553, "mature_H5_site": 489, "mouse_sera_escape": -0.07532, "mutant": "S", "mutation": "P489S", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.04727, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.00477, "ferret_sera_escape": -0.01775, "mature_H5_site": 489, "mouse_sera_escape": -0.0118, "mutant": "T", "mutation": "P489T", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": 0.01112, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.07207, "ferret_sera_escape": 0.06028, "mature_H5_site": 489, "mouse_sera_escape": -0.05548, "mutant": "V", "mutation": "P489V", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.02577, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.04756, "ferret_sera_escape": -0.09197, "mature_H5_site": 489, "mouse_sera_escape": -0.07195, "mutant": "W", "mutation": "P489W", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": -0.3593, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.7819, "ferret_sera_escape": null, "mature_H5_site": 489, "mouse_sera_escape": null, "mutant": "Y", "mutation": "P489Y", "reference_site": "489", "region": "HA2", "sequential_site": 505, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.05816, "ferret_sera_escape": 0.04179, "mature_H5_site": 39, "mouse_sera_escape": 0.06745, "mutant": "A", "mutation": "G49A", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": -0.242, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.9058, "ferret_sera_escape": -0.3209, "mature_H5_site": 39, "mouse_sera_escape": -0.2144, "mutant": "C", "mutation": "G49C", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": -0.1228, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.6956, "ferret_sera_escape": -0.07903, "mature_H5_site": 39, "mouse_sera_escape": 0.1095, "mutant": "D", "mutation": "G49D", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": -0.09096, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4272, "ferret_sera_escape": 0.07139, "mature_H5_site": 39, "mouse_sera_escape": 0.1007, "mutant": "E", "mutation": "G49E", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": -0.0009832, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.06056, "ferret_sera_escape": 0.1391, "mature_H5_site": 39, "mouse_sera_escape": 0.098, "mutant": "F", "mutation": "G49F", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": 0.08422, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 39, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G49G", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.61, "ferret_sera_escape": null, "mature_H5_site": 39, "mouse_sera_escape": null, "mutant": "I", "mutation": "G49I", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.05038, "ferret_sera_escape": -0.08449, "mature_H5_site": 39, "mouse_sera_escape": 0.07819, "mutant": "K", "mutation": "G49K", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": -0.09203, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.062, "ferret_sera_escape": null, "mature_H5_site": 39, "mouse_sera_escape": null, "mutant": "L", "mutation": "G49L", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3176, "ferret_sera_escape": null, "mature_H5_site": 39, "mouse_sera_escape": null, "mutant": "M", "mutation": "G49M", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2082, "ferret_sera_escape": -0.3137, "mature_H5_site": 39, "mouse_sera_escape": -0.01293, "mutant": "N", "mutation": "G49N", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2848, "ferret_sera_escape": -0.05959, "mature_H5_site": 39, "mouse_sera_escape": 0.01099, "mutant": "P", "mutation": "G49P", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": -0.6273, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3163, "ferret_sera_escape": 0.06917, "mature_H5_site": 39, "mouse_sera_escape": 0.2008, "mutant": "Q", "mutation": "G49Q", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2613, "ferret_sera_escape": 0.01032, "mature_H5_site": 39, "mouse_sera_escape": 0.02293, "mutant": "R", "mutation": "G49R", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": -0.08033, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.03599, "ferret_sera_escape": -0.128, "mature_H5_site": 39, "mouse_sera_escape": -0.05649, "mutant": "S", "mutation": "G49S", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": 0.006178, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1132, "ferret_sera_escape": -0.1521, "mature_H5_site": 39, "mouse_sera_escape": 0.01068, "mutant": "T", "mutation": "G49T", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": 0.007772, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.383, "ferret_sera_escape": -0.4338, "mature_H5_site": 39, "mouse_sera_escape": 0.09786, "mutant": "V", "mutation": "G49V", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.9783, "ferret_sera_escape": null, "mature_H5_site": 39, "mouse_sera_escape": null, "mutant": "W", "mutation": "G49W", "reference_site": "49", "region": "region-C", "sequential_site": 55, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.262, "ferret_sera_escape": -0.09716, "mature_H5_site": 490, "mouse_sera_escape": 0.03823, "mutant": "D", "mutation": "Q490D", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.03974, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.04284, "ferret_sera_escape": -0.02687, "mature_H5_site": 490, "mouse_sera_escape": -0.02296, "mutant": "E", "mutation": "Q490E", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.004834, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.1291, "ferret_sera_escape": -0.06777, "mature_H5_site": 490, "mouse_sera_escape": -0.01027, "mutant": "F", "mutation": "Q490F", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.02245, "wildtype": "Q"}, {"a26_usage": 0.1202, "cell_entry": 0.05589, "ferret_sera_escape": -0.07583, "mature_H5_site": 490, "mouse_sera_escape": -0.1652, "mutant": "G", "mutation": "Q490G", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.03651, "wildtype": "Q"}, {"a26_usage": null, "cell_entry": -0.2641, "ferret_sera_escape": 0.07404, "mature_H5_site": 490, "mouse_sera_escape": 0.003055, "mutant": "I", "mutation": "Q490I", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.02865, "ferret_sera_escape": 0.05054, "mature_H5_site": 490, "mouse_sera_escape": -0.1217, "mutant": "K", "mutation": "Q490K", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.1201, "wildtype": "Q"}, {"a26_usage": 0.31, "cell_entry": -0.3354, "ferret_sera_escape": -0.04921, "mature_H5_site": 490, "mouse_sera_escape": -0.01687, "mutant": "L", "mutation": "Q490L", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": 0.08774, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.06731, "ferret_sera_escape": 0.108, "mature_H5_site": 490, "mouse_sera_escape": 0.01115, "mutant": "M", "mutation": "Q490M", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.02495, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.02872, "ferret_sera_escape": 0.05543, "mature_H5_site": 490, "mouse_sera_escape": -0.001378, "mutant": "N", "mutation": "Q490N", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": 0.004789, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.6023, "ferret_sera_escape": -0.1503, "mature_H5_site": 490, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q490P", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 490, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q490Q", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.07169, "ferret_sera_escape": -0.003198, "mature_H5_site": 490, "mouse_sera_escape": -0.03308, "mutant": "S", "mutation": "Q490S", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.004215, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2175, "ferret_sera_escape": -0.03473, "mature_H5_site": 490, "mouse_sera_escape": 0.05188, "mutant": "T", "mutation": "Q490T", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": 0.01537, "wildtype": "Q"}, {"a26_usage": null, "cell_entry": -1.909, "ferret_sera_escape": -0.02496, "mature_H5_site": 490, "mouse_sera_escape": 0.1249, "mutant": "V", "mutation": "Q490V", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.852, "ferret_sera_escape": 0.1552, "mature_H5_site": 490, "mouse_sera_escape": 0.04384, "mutant": "Y", "mutation": "Q490Y", "reference_site": "490", "region": "HA2", "sequential_site": 506, "stability": -0.0288, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.857, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y491A", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.018, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y491C", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y491D", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y491E", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.0366, "ferret_sera_escape": 0.03685, "mature_H5_site": 491, "mouse_sera_escape": -0.007037, "mutant": "F", "mutation": "Y491F", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": -0.001366, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.73, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y491G", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4017, "ferret_sera_escape": 0.03519, "mature_H5_site": 491, "mouse_sera_escape": 0.0873, "mutant": "H", "mutation": "Y491H", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": -0.03523, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.176, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y491I", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.453, "ferret_sera_escape": 0.1444, "mature_H5_site": 491, "mouse_sera_escape": 0.2205, "mutant": "K", "mutation": "Y491K", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": -0.2449, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.957, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y491L", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.419, "ferret_sera_escape": 0.04907, "mature_H5_site": 491, "mouse_sera_escape": 0.03843, "mutant": "M", "mutation": "Y491M", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": -0.1013, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.244, "ferret_sera_escape": -0.2383, "mature_H5_site": 491, "mouse_sera_escape": 0.04204, "mutant": "N", "mutation": "Y491N", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y491P", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.158, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y491Q", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.141, "ferret_sera_escape": -0.02028, "mature_H5_site": 491, "mouse_sera_escape": 0.02637, "mutant": "R", "mutation": "Y491R", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": -0.09213, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.632, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y491S", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y491T", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y491V", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1085, "ferret_sera_escape": null, "mature_H5_site": 491, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y491W", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 491, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y491Y", "reference_site": "491", "region": "HA2", "sequential_site": 507, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.06918, "ferret_sera_escape": 0.00212, "mature_H5_site": 492, "mouse_sera_escape": -0.02229, "mutant": "A", "mutation": "S492A", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.01557, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.5055, "ferret_sera_escape": null, "mature_H5_site": 492, "mouse_sera_escape": null, "mutant": "D", "mutation": "S492D", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.09166, "ferret_sera_escape": 0.08649, "mature_H5_site": 492, "mouse_sera_escape": -0.006167, "mutant": "E", "mutation": "S492E", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.1629, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3677, "ferret_sera_escape": null, "mature_H5_site": 492, "mouse_sera_escape": null, "mutant": "F", "mutation": "S492F", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.0695, "ferret_sera_escape": -0.05282, "mature_H5_site": 492, "mouse_sera_escape": 0.08057, "mutant": "G", "mutation": "S492G", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.04017, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1219, "ferret_sera_escape": -0.01079, "mature_H5_site": 492, "mouse_sera_escape": 0.008454, "mutant": "H", "mutation": "S492H", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.2178, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1893, "ferret_sera_escape": 0.05336, "mature_H5_site": 492, "mouse_sera_escape": -0.004489, "mutant": "I", "mutation": "S492I", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.1167, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1648, "ferret_sera_escape": -0.09105, "mature_H5_site": 492, "mouse_sera_escape": 0.003927, "mutant": "K", "mutation": "S492K", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": 0.1179, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.03846, "ferret_sera_escape": 0.1025, "mature_H5_site": 492, "mouse_sera_escape": -0.1745, "mutant": "L", "mutation": "S492L", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.07809, "ferret_sera_escape": 0.04069, "mature_H5_site": 492, "mouse_sera_escape": 0.03954, "mutant": "M", "mutation": "S492M", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": 0.1057, "wildtype": "S"}, {"a26_usage": 0.4265, "cell_entry": -0.193, "ferret_sera_escape": 0.03217, "mature_H5_site": 492, "mouse_sera_escape": 0.107, "mutant": "N", "mutation": "S492N", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.03062, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.593, "ferret_sera_escape": null, "mature_H5_site": 492, "mouse_sera_escape": null, "mutant": "P", "mutation": "S492P", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06974, "ferret_sera_escape": 0.03439, "mature_H5_site": 492, "mouse_sera_escape": 0.001119, "mutant": "Q", "mutation": "S492Q", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": 0.04227, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.04308, "ferret_sera_escape": -0.1017, "mature_H5_site": 492, "mouse_sera_escape": -0.03168, "mutant": "R", "mutation": "S492R", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": 0.1357, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 492, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S492S", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.4411, "cell_entry": -2.152, "ferret_sera_escape": 0.02309, "mature_H5_site": 492, "mouse_sera_escape": 0.05752, "mutant": "T", "mutation": "S492T", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.06466, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.08991, "ferret_sera_escape": 0.09907, "mature_H5_site": 492, "mouse_sera_escape": -0.007721, "mutant": "V", "mutation": "S492V", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.01128, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -0.7987, "ferret_sera_escape": -0.05698, "mature_H5_site": 492, "mouse_sera_escape": 0.1415, "mutant": "W", "mutation": "S492W", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.05597, "ferret_sera_escape": -0.06082, "mature_H5_site": 492, "mouse_sera_escape": 0.03563, "mutant": "Y", "mutation": "S492Y", "reference_site": "492", "region": "HA2", "sequential_site": 508, "stability": -0.1048, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.02256, "ferret_sera_escape": -0.09179, "mature_H5_site": 493, "mouse_sera_escape": -0.0445, "mutant": "A", "mutation": "E493A", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.01168, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.00506, "ferret_sera_escape": 0.07341, "mature_H5_site": 493, "mouse_sera_escape": 0.1107, "mutant": "D", "mutation": "E493D", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.06634, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 493, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E493E", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1319, "ferret_sera_escape": 0.003744, "mature_H5_site": 493, "mouse_sera_escape": -0.01105, "mutant": "F", "mutation": "E493F", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1969, "ferret_sera_escape": -0.02376, "mature_H5_site": 493, "mouse_sera_escape": 0.02527, "mutant": "G", "mutation": "E493G", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.0286, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.8727, "ferret_sera_escape": -0.1817, "mature_H5_site": 493, "mouse_sera_escape": 0.08723, "mutant": "H", "mutation": "E493H", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": -0.02668, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02653, "ferret_sera_escape": 0.1466, "mature_H5_site": 493, "mouse_sera_escape": 0.05136, "mutant": "I", "mutation": "E493I", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.05681, "wildtype": "E"}, {"a26_usage": 0.004545, "cell_entry": -0.05364, "ferret_sera_escape": -0.1433, "mature_H5_site": 493, "mouse_sera_escape": 0.01083, "mutant": "K", "mutation": "E493K", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.1884, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1879, "ferret_sera_escape": 0.1026, "mature_H5_site": 493, "mouse_sera_escape": -0.1019, "mutant": "L", "mutation": "E493L", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.04629, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6119, "ferret_sera_escape": -0.08209, "mature_H5_site": 493, "mouse_sera_escape": 0.08415, "mutant": "N", "mutation": "E493N", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": -0.0277, "wildtype": "E"}, {"a26_usage": 0.2579, "cell_entry": -0.1191, "ferret_sera_escape": -0.001429, "mature_H5_site": 493, "mouse_sera_escape": 0.01071, "mutant": "P", "mutation": "E493P", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.006802, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01898, "ferret_sera_escape": 0.005411, "mature_H5_site": 493, "mouse_sera_escape": -0.03353, "mutant": "Q", "mutation": "E493Q", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.1238, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.04886, "ferret_sera_escape": 0.02694, "mature_H5_site": 493, "mouse_sera_escape": 0.02908, "mutant": "S", "mutation": "E493S", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.01313, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06264, "ferret_sera_escape": -0.1339, "mature_H5_site": 493, "mouse_sera_escape": -0.0608, "mutant": "T", "mutation": "E493T", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.108, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1598, "ferret_sera_escape": 5.333e-05, "mature_H5_site": 493, "mouse_sera_escape": 0.03537, "mutant": "V", "mutation": "E493V", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": 0.1188, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9448, "ferret_sera_escape": 0.06824, "mature_H5_site": 493, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E493Y", "reference_site": "493", "region": "HA2", "sequential_site": 509, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3478, "ferret_sera_escape": -0.0607, "mature_H5_site": 494, "mouse_sera_escape": -0.05069, "mutant": "A", "mutation": "E494A", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.01482, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1606, "ferret_sera_escape": -0.1325, "mature_H5_site": 494, "mouse_sera_escape": -0.05403, "mutant": "C", "mutation": "E494C", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.03347, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7727, "ferret_sera_escape": 0.205, "mature_H5_site": 494, "mouse_sera_escape": 0.1005, "mutant": "D", "mutation": "E494D", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 494, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E494E", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1087, "ferret_sera_escape": 0.1699, "mature_H5_site": 494, "mouse_sera_escape": 0.09308, "mutant": "F", "mutation": "E494F", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.02558, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5398, "ferret_sera_escape": -0.0675, "mature_H5_site": 494, "mouse_sera_escape": -0.0364, "mutant": "G", "mutation": "E494G", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.01888, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.05363, "ferret_sera_escape": 0.02023, "mature_H5_site": 494, "mouse_sera_escape": 0.1831, "mutant": "H", "mutation": "E494H", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.02558, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2148, "ferret_sera_escape": 0.1172, "mature_H5_site": 494, "mouse_sera_escape": -0.04148, "mutant": "I", "mutation": "E494I", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": 0.02221, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3865, "ferret_sera_escape": 0.02701, "mature_H5_site": 494, "mouse_sera_escape": 0.08049, "mutant": "K", "mutation": "E494K", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.04477, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1426, "ferret_sera_escape": 0.01843, "mature_H5_site": 494, "mouse_sera_escape": 0.0003306, "mutant": "L", "mutation": "E494L", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.03609, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.19, "ferret_sera_escape": -0.182, "mature_H5_site": 494, "mouse_sera_escape": -0.1774, "mutant": "M", "mutation": "E494M", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.002752, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4734, "ferret_sera_escape": 0.1948, "mature_H5_site": 494, "mouse_sera_escape": 0.08114, "mutant": "N", "mutation": "E494N", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.03529, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.02692, "ferret_sera_escape": 0.01838, "mature_H5_site": 494, "mouse_sera_escape": 0.03283, "mutant": "P", "mutation": "E494P", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": 0.03233, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.005685, "ferret_sera_escape": -0.007367, "mature_H5_site": 494, "mouse_sera_escape": 0.01564, "mutant": "Q", "mutation": "E494Q", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.0003115, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4497, "ferret_sera_escape": -0.09871, "mature_H5_site": 494, "mouse_sera_escape": 0.1468, "mutant": "R", "mutation": "E494R", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.02833, "wildtype": "E"}, {"a26_usage": 0.115, "cell_entry": -0.1459, "ferret_sera_escape": -0.007721, "mature_H5_site": 494, "mouse_sera_escape": 0.1014, "mutant": "S", "mutation": "E494S", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": 0.0226, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.04645, "ferret_sera_escape": -0.1432, "mature_H5_site": 494, "mouse_sera_escape": -0.1108, "mutant": "T", "mutation": "E494T", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.0207, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01831, "ferret_sera_escape": -0.03138, "mature_H5_site": 494, "mouse_sera_escape": -0.01676, "mutant": "V", "mutation": "E494V", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": 0.02321, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3052, "ferret_sera_escape": null, "mature_H5_site": 494, "mouse_sera_escape": null, "mutant": "W", "mutation": "E494W", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.09479, "ferret_sera_escape": 0.03682, "mature_H5_site": 494, "mouse_sera_escape": 0.1577, "mutant": "Y", "mutation": "E494Y", "reference_site": "494", "region": "HA2", "sequential_site": 510, "stability": -0.2066, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 495, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A495A", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.95, "ferret_sera_escape": null, "mature_H5_site": 495, "mouse_sera_escape": null, "mutant": "D", "mutation": "A495D", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.461, "ferret_sera_escape": null, "mature_H5_site": 495, "mouse_sera_escape": null, "mutant": "E", "mutation": "A495E", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.558, "ferret_sera_escape": null, "mature_H5_site": 495, "mouse_sera_escape": null, "mutant": "F", "mutation": "A495F", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.236, "ferret_sera_escape": null, "mature_H5_site": 495, "mouse_sera_escape": null, "mutant": "H", "mutation": "A495H", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.00379, "ferret_sera_escape": -0.148, "mature_H5_site": 495, "mouse_sera_escape": -0.06656, "mutant": "I", "mutation": "A495I", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.1046, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.599, "ferret_sera_escape": -0.1602, "mature_H5_site": 495, "mouse_sera_escape": -0.03917, "mutant": "K", "mutation": "A495K", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.1843, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3244, "ferret_sera_escape": -0.04316, "mature_H5_site": 495, "mouse_sera_escape": -0.07021, "mutant": "L", "mutation": "A495L", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.04391, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2422, "ferret_sera_escape": -0.02921, "mature_H5_site": 495, "mouse_sera_escape": -0.06416, "mutant": "M", "mutation": "A495M", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.08084, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.904, "ferret_sera_escape": null, "mature_H5_site": 495, "mouse_sera_escape": null, "mutant": "P", "mutation": "A495P", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.445, "ferret_sera_escape": -0.2363, "mature_H5_site": 495, "mouse_sera_escape": -0.1034, "mutant": "Q", "mutation": "A495Q", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.2266, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.281, "ferret_sera_escape": 0.1069, "mature_H5_site": 495, "mouse_sera_escape": -0.05605, "mutant": "R", "mutation": "A495R", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.1804, "wildtype": "A"}, {"a26_usage": 0.2654, "cell_entry": -0.7931, "ferret_sera_escape": -0.05299, "mature_H5_site": 495, "mouse_sera_escape": 0.02797, "mutant": "S", "mutation": "A495S", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.03581, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.129, "ferret_sera_escape": 0.04064, "mature_H5_site": 495, "mouse_sera_escape": 0.0058, "mutant": "T", "mutation": "A495T", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.07746, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2765, "ferret_sera_escape": 0.008657, "mature_H5_site": 495, "mouse_sera_escape": -0.01175, "mutant": "V", "mutation": "A495V", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.07112, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.57, "ferret_sera_escape": -0.129, "mature_H5_site": 495, "mouse_sera_escape": 0.07449, "mutant": "W", "mutation": "A495W", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": -0.216, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.309, "ferret_sera_escape": 0.07837, "mature_H5_site": 495, "mouse_sera_escape": 0.07343, "mutant": "Y", "mutation": "A495Y", "reference_site": "495", "region": "HA2", "sequential_site": 511, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.583, "ferret_sera_escape": -0.03315, "mature_H5_site": 496, "mouse_sera_escape": -0.004372, "mutant": "C", "mutation": "R496C", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.1036, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1516, "ferret_sera_escape": 0.06152, "mature_H5_site": 496, "mouse_sera_escape": -0.04717, "mutant": "E", "mutation": "R496E", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.03159, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.21, "ferret_sera_escape": -0.08823, "mature_H5_site": 496, "mouse_sera_escape": -0.01108, "mutant": "F", "mutation": "R496F", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.07574, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.526, "ferret_sera_escape": 0.02566, "mature_H5_site": 496, "mouse_sera_escape": 0.05257, "mutant": "G", "mutation": "R496G", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.08315, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.757, "ferret_sera_escape": 0.07383, "mature_H5_site": 496, "mouse_sera_escape": 0.02623, "mutant": "H", "mutation": "R496H", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.02449, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.14, "ferret_sera_escape": -0.05312, "mature_H5_site": 496, "mouse_sera_escape": 0.008679, "mutant": "I", "mutation": "R496I", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": null, "wildtype": "R"}, {"a26_usage": 0.3851, "cell_entry": -0.5592, "ferret_sera_escape": -0.07896, "mature_H5_site": 496, "mouse_sera_escape": 8.375e-05, "mutant": "K", "mutation": "R496K", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.02942, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.9737, "ferret_sera_escape": null, "mature_H5_site": 496, "mouse_sera_escape": null, "mutant": "L", "mutation": "R496L", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1597, "ferret_sera_escape": 0.02108, "mature_H5_site": 496, "mouse_sera_escape": -0.03502, "mutant": "M", "mutation": "R496M", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.05652, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3315, "ferret_sera_escape": 0.1042, "mature_H5_site": 496, "mouse_sera_escape": -0.003181, "mutant": "N", "mutation": "R496N", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.01511, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.002, "ferret_sera_escape": null, "mature_H5_site": 496, "mouse_sera_escape": null, "mutant": "P", "mutation": "R496P", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.06183, "ferret_sera_escape": 0.06539, "mature_H5_site": 496, "mouse_sera_escape": 0.1002, "mutant": "Q", "mutation": "R496Q", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.003019, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 496, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R496R", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2787, "ferret_sera_escape": -0.1037, "mature_H5_site": 496, "mouse_sera_escape": -0.04402, "mutant": "S", "mutation": "R496S", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.02686, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.131, "ferret_sera_escape": 0.0916, "mature_H5_site": 496, "mouse_sera_escape": -0.03548, "mutant": "T", "mutation": "R496T", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.02779, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.166, "ferret_sera_escape": 0.08526, "mature_H5_site": 496, "mouse_sera_escape": 0.1357, "mutant": "V", "mutation": "R496V", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.06477, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.151, "ferret_sera_escape": -0.05887, "mature_H5_site": 496, "mouse_sera_escape": -0.1455, "mutant": "W", "mutation": "R496W", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": -0.09356, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4927, "ferret_sera_escape": -0.06816, "mature_H5_site": 496, "mouse_sera_escape": -0.01294, "mutant": "Y", "mutation": "R496Y", "reference_site": "496", "region": "HA2", "sequential_site": 512, "stability": 0.1228, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.008565, "ferret_sera_escape": 0.06321, "mature_H5_site": 497, "mouse_sera_escape": 0.08347, "mutant": "C", "mutation": "L497C", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.0508, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6236, "ferret_sera_escape": 0.1154, "mature_H5_site": 497, "mouse_sera_escape": 0.1496, "mutant": "D", "mutation": "L497D", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.006577, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4429, "ferret_sera_escape": 0.08356, "mature_H5_site": 497, "mouse_sera_escape": 0.1517, "mutant": "E", "mutation": "L497E", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.02115, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.235, "ferret_sera_escape": 0.04899, "mature_H5_site": 497, "mouse_sera_escape": 0.09433, "mutant": "F", "mutation": "L497F", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.02851, "wildtype": "L"}, {"a26_usage": 0.009325, "cell_entry": 0.06297, "ferret_sera_escape": -0.005041, "mature_H5_site": 497, "mouse_sera_escape": -0.02918, "mutant": "H", "mutation": "L497H", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.01789, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.05432, "ferret_sera_escape": 0.1455, "mature_H5_site": 497, "mouse_sera_escape": -0.03722, "mutant": "I", "mutation": "L497I", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.04074, "wildtype": "L"}, {"a26_usage": 0.1695, "cell_entry": 0.02366, "ferret_sera_escape": -0.002391, "mature_H5_site": 497, "mouse_sera_escape": 0.01489, "mutant": "K", "mutation": "L497K", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.01214, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 497, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L497L", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.0541, "ferret_sera_escape": -0.1003, "mature_H5_site": 497, "mouse_sera_escape": 0.08403, "mutant": "M", "mutation": "L497M", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.06037, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2107, "ferret_sera_escape": -0.1165, "mature_H5_site": 497, "mouse_sera_escape": -0.08121, "mutant": "N", "mutation": "L497N", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7451, "ferret_sera_escape": -0.1638, "mature_H5_site": 497, "mouse_sera_escape": 0.08131, "mutant": "P", "mutation": "L497P", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.03041, "wildtype": "L"}, {"a26_usage": 0.04594, "cell_entry": -1.244, "ferret_sera_escape": 0.1233, "mature_H5_site": 497, "mouse_sera_escape": 0.1481, "mutant": "Q", "mutation": "L497Q", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.04323, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.07033, "ferret_sera_escape": -0.008766, "mature_H5_site": 497, "mouse_sera_escape": -0.008842, "mutant": "R", "mutation": "L497R", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.03897, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2087, "ferret_sera_escape": -0.04179, "mature_H5_site": 497, "mouse_sera_escape": 0.01519, "mutant": "T", "mutation": "L497T", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.002994, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2893, "ferret_sera_escape": 0.02422, "mature_H5_site": 497, "mouse_sera_escape": 0.08137, "mutant": "V", "mutation": "L497V", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.01233, "wildtype": "L"}, {"a26_usage": 0.1774, "cell_entry": -0.2701, "ferret_sera_escape": -0.1625, "mature_H5_site": 497, "mouse_sera_escape": 0.1865, "mutant": "W", "mutation": "L497W", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": 0.01821, "wildtype": "L"}, {"a26_usage": 0.1022, "cell_entry": -0.00332, "ferret_sera_escape": 0.06122, "mature_H5_site": 497, "mouse_sera_escape": 0.0143, "mutant": "Y", "mutation": "L497Y", "reference_site": "497", "region": "HA2", "sequential_site": 513, "stability": -0.01715, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.03753, "ferret_sera_escape": null, "mature_H5_site": 498, "mouse_sera_escape": null, "mutant": "A", "mutation": "K498A", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4897, "ferret_sera_escape": 0.1583, "mature_H5_site": 498, "mouse_sera_escape": 0.04448, "mutant": "C", "mutation": "K498C", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.08597, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3524, "ferret_sera_escape": null, "mature_H5_site": 498, "mouse_sera_escape": null, "mutant": "E", "mutation": "K498E", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2255, "ferret_sera_escape": 0.1557, "mature_H5_site": 498, "mouse_sera_escape": 0.1221, "mutant": "F", "mutation": "K498F", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.01328, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3829, "ferret_sera_escape": 0.07204, "mature_H5_site": 498, "mouse_sera_escape": -0.1036, "mutant": "G", "mutation": "K498G", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.02262, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.06501, "ferret_sera_escape": 0.0437, "mature_H5_site": 498, "mouse_sera_escape": 0.1082, "mutant": "H", "mutation": "K498H", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": 0.007073, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.03191, "ferret_sera_escape": null, "mature_H5_site": 498, "mouse_sera_escape": null, "mutant": "I", "mutation": "K498I", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 498, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K498K", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0996, "cell_entry": -0.1194, "ferret_sera_escape": 0.01417, "mature_H5_site": 498, "mouse_sera_escape": 0.04639, "mutant": "L", "mutation": "K498L", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": 0.007424, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.01002, "ferret_sera_escape": -0.0007947, "mature_H5_site": 498, "mouse_sera_escape": 0.02899, "mutant": "M", "mutation": "K498M", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.02202, "wildtype": "K"}, {"a26_usage": 0.1855, "cell_entry": -0.09131, "ferret_sera_escape": 0.09979, "mature_H5_site": 498, "mouse_sera_escape": 0.02128, "mutant": "N", "mutation": "K498N", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.07246, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.386, "ferret_sera_escape": -0.05107, "mature_H5_site": 498, "mouse_sera_escape": 0.04971, "mutant": "P", "mutation": "K498P", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.1673, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1485, "ferret_sera_escape": 0.1388, "mature_H5_site": 498, "mouse_sera_escape": -0.02596, "mutant": "Q", "mutation": "K498Q", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.03113, "wildtype": "K"}, {"a26_usage": 0.02363, "cell_entry": -0.04749, "ferret_sera_escape": null, "mature_H5_site": 498, "mouse_sera_escape": null, "mutant": "R", "mutation": "K498R", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2218, "ferret_sera_escape": 0.001063, "mature_H5_site": 498, "mouse_sera_escape": -0.0595, "mutant": "S", "mutation": "K498S", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.1209, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.02015, "ferret_sera_escape": 0.06683, "mature_H5_site": 498, "mouse_sera_escape": 0.09578, "mutant": "T", "mutation": "K498T", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.05548, "wildtype": "K"}, {"a26_usage": 0.03131, "cell_entry": -0.6544, "ferret_sera_escape": -0.008566, "mature_H5_site": 498, "mouse_sera_escape": 0.01677, "mutant": "V", "mutation": "K498V", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.04272, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.145, "ferret_sera_escape": null, "mature_H5_site": 498, "mouse_sera_escape": null, "mutant": "W", "mutation": "K498W", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.07562, "ferret_sera_escape": -0.01475, "mature_H5_site": 498, "mouse_sera_escape": 0.05973, "mutant": "Y", "mutation": "K498Y", "reference_site": "498", "region": "HA2", "sequential_site": 514, "stability": -0.01622, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.041, "ferret_sera_escape": -0.0706, "mature_H5_site": 499, "mouse_sera_escape": -0.0345, "mutant": "A", "mutation": "R499A", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.08452, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.822, "ferret_sera_escape": null, "mature_H5_site": 499, "mouse_sera_escape": null, "mutant": "C", "mutation": "R499C", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.446, "ferret_sera_escape": -0.1759, "mature_H5_site": 499, "mouse_sera_escape": -0.2058, "mutant": "D", "mutation": "R499D", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.2941, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5095, "ferret_sera_escape": 0.006315, "mature_H5_site": 499, "mouse_sera_escape": -0.05333, "mutant": "E", "mutation": "R499E", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.07757, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3064, "ferret_sera_escape": -0.07939, "mature_H5_site": 499, "mouse_sera_escape": -0.05205, "mutant": "F", "mutation": "R499F", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.01785, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7239, "ferret_sera_escape": 0.09597, "mature_H5_site": 499, "mouse_sera_escape": 0.08157, "mutant": "G", "mutation": "R499G", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.1406, "cell_entry": -0.7707, "ferret_sera_escape": -0.07501, "mature_H5_site": 499, "mouse_sera_escape": -0.003245, "mutant": "H", "mutation": "R499H", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.02892, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2035, "ferret_sera_escape": -0.1753, "mature_H5_site": 499, "mouse_sera_escape": -0.06128, "mutant": "I", "mutation": "R499I", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4959, "ferret_sera_escape": -0.0256, "mature_H5_site": 499, "mouse_sera_escape": 0.07508, "mutant": "K", "mutation": "R499K", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5152, "ferret_sera_escape": 0.05444, "mature_H5_site": 499, "mouse_sera_escape": 0.1088, "mutant": "L", "mutation": "R499L", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": 0.02887, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.02553, "ferret_sera_escape": null, "mature_H5_site": 499, "mouse_sera_escape": null, "mutant": "M", "mutation": "R499M", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4061, "ferret_sera_escape": 0.1319, "mature_H5_site": 499, "mouse_sera_escape": 0.05889, "mutant": "N", "mutation": "R499N", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.1168, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.681, "ferret_sera_escape": null, "mature_H5_site": 499, "mouse_sera_escape": 0.01576, "mutant": "P", "mutation": "R499P", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3311, "ferret_sera_escape": -0.08897, "mature_H5_site": 499, "mouse_sera_escape": -0.008083, "mutant": "Q", "mutation": "R499Q", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.08045, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 499, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R499R", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3597, "ferret_sera_escape": null, "mature_H5_site": 499, "mouse_sera_escape": null, "mutant": "S", "mutation": "R499S", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.903, "ferret_sera_escape": -0.06766, "mature_H5_site": 499, "mouse_sera_escape": 0.05051, "mutant": "T", "mutation": "R499T", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.07565, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.189, "ferret_sera_escape": -0.08731, "mature_H5_site": 499, "mouse_sera_escape": -0.007919, "mutant": "V", "mutation": "R499V", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": 0.0181, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.6838, "ferret_sera_escape": 0.1142, "mature_H5_site": 499, "mouse_sera_escape": 0.08438, "mutant": "W", "mutation": "R499W", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": -0.09863, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2148, "ferret_sera_escape": 0.02855, "mature_H5_site": 499, "mouse_sera_escape": -0.0372, "mutant": "Y", "mutation": "R499Y", "reference_site": "499", "region": "HA2", "sequential_site": 515, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.8321, "ferret_sera_escape": 0.06205, "mature_H5_site": -6, "mouse_sera_escape": 0.03136, "mutant": "A", "mutation": "V5A", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": 0.01956, "wildtype": "V"}, {"a26_usage": 0.02815, "cell_entry": -0.1513, "ferret_sera_escape": -0.1393, "mature_H5_site": -6, "mouse_sera_escape": 0.01775, "mutant": "C", "mutation": "V5C", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.933, "ferret_sera_escape": null, "mature_H5_site": -6, "mouse_sera_escape": null, "mutant": "D", "mutation": "V5D", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.08, "ferret_sera_escape": -0.07795, "mature_H5_site": -6, "mouse_sera_escape": -0.1506, "mutant": "E", "mutation": "V5E", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4356, "ferret_sera_escape": null, "mature_H5_site": -6, "mouse_sera_escape": -0.01948, "mutant": "F", "mutation": "V5F", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.03311, "wildtype": "V"}, {"a26_usage": 0.1851, "cell_entry": -0.5053, "ferret_sera_escape": 0.004713, "mature_H5_site": -6, "mouse_sera_escape": 0.04949, "mutant": "G", "mutation": "V5G", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.05397, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.626, "ferret_sera_escape": -0.08917, "mature_H5_site": -6, "mouse_sera_escape": 0.02683, "mutant": "H", "mutation": "V5H", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.1906, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.745, "ferret_sera_escape": -0.03836, "mature_H5_site": -6, "mouse_sera_escape": -0.01961, "mutant": "L", "mutation": "V5L", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.05853, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.01567, "ferret_sera_escape": -0.0183, "mature_H5_site": -6, "mouse_sera_escape": -0.04618, "mutant": "M", "mutation": "V5M", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.05565, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.441, "ferret_sera_escape": null, "mature_H5_site": -6, "mouse_sera_escape": null, "mutant": "R", "mutation": "V5R", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.027, "ferret_sera_escape": null, "mature_H5_site": -6, "mouse_sera_escape": null, "mutant": "S", "mutation": "V5S", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": null, "wildtype": "V"}, {"a26_usage": 0.392, "cell_entry": -0.3184, "ferret_sera_escape": 0.01792, "mature_H5_site": -6, "mouse_sera_escape": -0.03739, "mutant": "T", "mutation": "V5T", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.02988, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -6, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V5V", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4115, "ferret_sera_escape": 0.02867, "mature_H5_site": -6, "mouse_sera_escape": 0.0395, "mutant": "W", "mutation": "V5W", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.1216, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1183, "ferret_sera_escape": -0.04423, "mature_H5_site": -6, "mouse_sera_escape": -0.06841, "mutant": "Y", "mutation": "V5Y", "reference_site": "5", "region": "HA1", "sequential_site": 11, "stability": -0.3741, "wildtype": "V"}, {"a26_usage": 0.01487, "cell_entry": 0.05976, "ferret_sera_escape": -0.0498, "mature_H5_site": 40, "mouse_sera_escape": 0.03119, "mutant": "A", "mutation": "K50A", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": 0.2145, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6661, "ferret_sera_escape": null, "mature_H5_site": 40, "mouse_sera_escape": null, "mutant": "C", "mutation": "K50C", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3111, "ferret_sera_escape": 0.004537, "mature_H5_site": 40, "mouse_sera_escape": null, "mutant": "E", "mutation": "K50E", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1095, "ferret_sera_escape": 0.08462, "mature_H5_site": 40, "mouse_sera_escape": null, "mutant": "F", "mutation": "K50F", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3245, "ferret_sera_escape": -0.09536, "mature_H5_site": 40, "mouse_sera_escape": -0.1453, "mutant": "I", "mutation": "K50I", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": -0.06722, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 40, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K50K", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.02824, "ferret_sera_escape": -0.1497, "mature_H5_site": 40, "mouse_sera_escape": -0.1647, "mutant": "L", "mutation": "K50L", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": -0.1958, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.183, "ferret_sera_escape": -0.06439, "mature_H5_site": 40, "mouse_sera_escape": -0.01998, "mutant": "N", "mutation": "K50N", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": 0.07, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1249, "ferret_sera_escape": 0.008873, "mature_H5_site": 40, "mouse_sera_escape": -0.02708, "mutant": "Q", "mutation": "K50Q", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": -0.02251, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.03866, "ferret_sera_escape": -0.2065, "mature_H5_site": 40, "mouse_sera_escape": -0.1086, "mutant": "R", "mutation": "K50R", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": -0.01151, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 40, "mouse_sera_escape": null, "mutant": "T", "mutation": "K50T", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4268, "ferret_sera_escape": 0.02995, "mature_H5_site": 40, "mouse_sera_escape": 0.005554, "mutant": "V", "mutation": "K50V", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": 0.05297, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.02721, "ferret_sera_escape": null, "mature_H5_site": 40, "mouse_sera_escape": null, "mutant": "W", "mutation": "K50W", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5956, "ferret_sera_escape": -0.08586, "mature_H5_site": 40, "mouse_sera_escape": -0.1402, "mutant": "Y", "mutation": "K50Y", "reference_site": "50", "region": "region-C", "sequential_site": 56, "stability": 0.09788, "wildtype": "K"}, {"a26_usage": 0.1248, "cell_entry": -0.1615, "ferret_sera_escape": -0.0005707, "mature_H5_site": 500, "mouse_sera_escape": -0.0645, "mutant": "A", "mutation": "E500A", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.002435, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.315, "ferret_sera_escape": null, "mature_H5_site": 500, "mouse_sera_escape": -0.3504, "mutant": "C", "mutation": "E500C", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.08881, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01179, "ferret_sera_escape": 0.02196, "mature_H5_site": 500, "mouse_sera_escape": 0.002811, "mutant": "D", "mutation": "E500D", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.05384, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 500, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E500E", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6934, "ferret_sera_escape": -0.01636, "mature_H5_site": 500, "mouse_sera_escape": 0.02578, "mutant": "F", "mutation": "E500F", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.02732, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.09315, "ferret_sera_escape": 0.08517, "mature_H5_site": 500, "mouse_sera_escape": 0.1007, "mutant": "G", "mutation": "E500G", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.01502, "wildtype": "E"}, {"a26_usage": 0.02207, "cell_entry": -0.02537, "ferret_sera_escape": 0.00696, "mature_H5_site": 500, "mouse_sera_escape": 0.008886, "mutant": "H", "mutation": "E500H", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.07797, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9311, "ferret_sera_escape": -0.008747, "mature_H5_site": 500, "mouse_sera_escape": -0.05978, "mutant": "I", "mutation": "E500I", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.00529, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1361, "ferret_sera_escape": 0.001789, "mature_H5_site": 500, "mouse_sera_escape": -0.01765, "mutant": "K", "mutation": "E500K", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.1091, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.45, "ferret_sera_escape": 0.09115, "mature_H5_site": 500, "mouse_sera_escape": null, "mutant": "L", "mutation": "E500L", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.06356, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.05083, "ferret_sera_escape": 0.156, "mature_H5_site": 500, "mouse_sera_escape": 0.06842, "mutant": "M", "mutation": "E500M", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.02426, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.092, "ferret_sera_escape": -0.0266, "mature_H5_site": 500, "mouse_sera_escape": -0.01786, "mutant": "N", "mutation": "E500N", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.06066, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2163, "ferret_sera_escape": 0.01699, "mature_H5_site": 500, "mouse_sera_escape": 0.1919, "mutant": "P", "mutation": "E500P", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.09694, "wildtype": "E"}, {"a26_usage": 0.3591, "cell_entry": -0.5321, "ferret_sera_escape": 0.02088, "mature_H5_site": 500, "mouse_sera_escape": -0.02506, "mutant": "Q", "mutation": "E500Q", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.03839, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.8014, "ferret_sera_escape": -0.03723, "mature_H5_site": 500, "mouse_sera_escape": -0.08727, "mutant": "R", "mutation": "E500R", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.08879, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1573, "ferret_sera_escape": 0.025, "mature_H5_site": 500, "mouse_sera_escape": 0.0946, "mutant": "S", "mutation": "E500S", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.002569, "wildtype": "E"}, {"a26_usage": 0.1059, "cell_entry": -0.4283, "ferret_sera_escape": -0.01768, "mature_H5_site": 500, "mouse_sera_escape": 0.008856, "mutant": "T", "mutation": "E500T", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.05948, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1775, "ferret_sera_escape": -0.06702, "mature_H5_site": 500, "mouse_sera_escape": 0.006827, "mutant": "V", "mutation": "E500V", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.02879, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.0, "ferret_sera_escape": 0.01342, "mature_H5_site": 500, "mouse_sera_escape": 0.03967, "mutant": "W", "mutation": "E500W", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": 0.05419, "wildtype": "E"}, {"a26_usage": 0.08013, "cell_entry": -0.4338, "ferret_sera_escape": 0.1247, "mature_H5_site": 500, "mouse_sera_escape": 0.2154, "mutant": "Y", "mutation": "E500Y", "reference_site": "500", "region": "HA2", "sequential_site": 516, "stability": -0.2655, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02073, "ferret_sera_escape": 0.03378, "mature_H5_site": 501, "mouse_sera_escape": 0.009169, "mutant": "A", "mutation": "E501A", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.545, "ferret_sera_escape": null, "mature_H5_site": 501, "mouse_sera_escape": null, "mutant": "C", "mutation": "E501C", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1677, "ferret_sera_escape": 0.1912, "mature_H5_site": 501, "mouse_sera_escape": 0.00433, "mutant": "D", "mutation": "E501D", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": 0.009861, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 501, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E501E", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5825, "ferret_sera_escape": -0.1017, "mature_H5_site": 501, "mouse_sera_escape": 0.006612, "mutant": "F", "mutation": "E501F", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.02993, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.04225, "ferret_sera_escape": 0.005582, "mature_H5_site": 501, "mouse_sera_escape": -0.004959, "mutant": "G", "mutation": "E501G", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.1043, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.698, "ferret_sera_escape": 0.015, "mature_H5_site": 501, "mouse_sera_escape": 0.07412, "mutant": "H", "mutation": "E501H", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.02581, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.364, "ferret_sera_escape": -0.02507, "mature_H5_site": 501, "mouse_sera_escape": 0.07509, "mutant": "I", "mutation": "E501I", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.02773, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4753, "ferret_sera_escape": -0.1548, "mature_H5_site": 501, "mouse_sera_escape": 0.1343, "mutant": "K", "mutation": "E501K", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.05335, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.00811, "ferret_sera_escape": 0.02485, "mature_H5_site": 501, "mouse_sera_escape": -0.01447, "mutant": "L", "mutation": "E501L", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": 0.01767, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4849, "ferret_sera_escape": -0.01883, "mature_H5_site": 501, "mouse_sera_escape": 0.05084, "mutant": "M", "mutation": "E501M", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.0579, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4322, "ferret_sera_escape": -0.0008437, "mature_H5_site": 501, "mouse_sera_escape": 0.01874, "mutant": "N", "mutation": "E501N", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.06068, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2273, "ferret_sera_escape": -0.0245, "mature_H5_site": 501, "mouse_sera_escape": -0.081, "mutant": "P", "mutation": "E501P", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.06289, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1893, "ferret_sera_escape": 0.1136, "mature_H5_site": 501, "mouse_sera_escape": 0.06409, "mutant": "Q", "mutation": "E501Q", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.474, "ferret_sera_escape": -0.1173, "mature_H5_site": 501, "mouse_sera_escape": -0.03919, "mutant": "R", "mutation": "E501R", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.05969, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4944, "ferret_sera_escape": -0.0352, "mature_H5_site": 501, "mouse_sera_escape": -0.06843, "mutant": "S", "mutation": "E501S", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.06384, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1152, "ferret_sera_escape": 0.008691, "mature_H5_site": 501, "mouse_sera_escape": 0.02445, "mutant": "T", "mutation": "E501T", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.02985, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4811, "ferret_sera_escape": -0.1554, "mature_H5_site": 501, "mouse_sera_escape": 0.0414, "mutant": "V", "mutation": "E501V", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.03421, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.315, "ferret_sera_escape": 0.02893, "mature_H5_site": 501, "mouse_sera_escape": 0.03215, "mutant": "W", "mutation": "E501W", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.07838, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9951, "ferret_sera_escape": 0.05194, "mature_H5_site": 501, "mouse_sera_escape": 0.06304, "mutant": "Y", "mutation": "E501Y", "reference_site": "501", "region": "HA2", "sequential_site": 517, "stability": -0.06391, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.71, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "A", "mutation": "I502A", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "C", "mutation": "I502C", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.563, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "D", "mutation": "I502D", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "E", "mutation": "I502E", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.855, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "F", "mutation": "I502F", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.787, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "G", "mutation": "I502G", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.894, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "H", "mutation": "I502H", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 502, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I502I", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.51, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "K", "mutation": "I502K", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.172, "cell_entry": 0.02552, "ferret_sera_escape": -0.01298, "mature_H5_site": 502, "mouse_sera_escape": 0.03653, "mutant": "L", "mutation": "I502L", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": 0.04969, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.629, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "M", "mutation": "I502M", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "N", "mutation": "I502N", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.754, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "P", "mutation": "I502P", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.996, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I502Q", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.994, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "R", "mutation": "I502R", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.848, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "S", "mutation": "I502S", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.789, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "T", "mutation": "I502T", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2473, "ferret_sera_escape": -0.01045, "mature_H5_site": 502, "mouse_sera_escape": -0.01908, "mutant": "V", "mutation": "I502V", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": -0.1084, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.752, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "W", "mutation": "I502W", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.779, "ferret_sera_escape": null, "mature_H5_site": 502, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I502Y", "reference_site": "502", "region": "HA2", "sequential_site": 518, "stability": null, "wildtype": "I"}, {"a26_usage": 0.1119, "cell_entry": -0.4825, "ferret_sera_escape": -0.03764, "mature_H5_site": 503, "mouse_sera_escape": -0.04009, "mutant": "A", "mutation": "S503A", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.05346, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.756, "ferret_sera_escape": null, "mature_H5_site": 503, "mouse_sera_escape": null, "mutant": "C", "mutation": "S503C", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.01054, "ferret_sera_escape": -0.003662, "mature_H5_site": 503, "mouse_sera_escape": -0.1065, "mutant": "D", "mutation": "S503D", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.01436, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2407, "ferret_sera_escape": 0.03193, "mature_H5_site": 503, "mouse_sera_escape": 0.06761, "mutant": "E", "mutation": "S503E", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.09155, "wildtype": "S"}, {"a26_usage": 0.03386, "cell_entry": -0.2629, "ferret_sera_escape": 0.04586, "mature_H5_site": 503, "mouse_sera_escape": 0.05471, "mutant": "F", "mutation": "S503F", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": -0.06583, "wildtype": "S"}, {"a26_usage": 0.1635, "cell_entry": 0.05104, "ferret_sera_escape": -0.01745, "mature_H5_site": 503, "mouse_sera_escape": -0.03265, "mutant": "G", "mutation": "S503G", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": -0.02308, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.003905, "ferret_sera_escape": -0.07855, "mature_H5_site": 503, "mouse_sera_escape": -0.09125, "mutant": "H", "mutation": "S503H", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.05291, "wildtype": "S"}, {"a26_usage": 0.7656, "cell_entry": -0.1962, "ferret_sera_escape": -0.07462, "mature_H5_site": 503, "mouse_sera_escape": -0.06238, "mutant": "I", "mutation": "S503I", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": -0.01172, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.917, "ferret_sera_escape": -0.1199, "mature_H5_site": 503, "mouse_sera_escape": null, "mutant": "L", "mutation": "S503L", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": null, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -1.132, "ferret_sera_escape": null, "mature_H5_site": 503, "mouse_sera_escape": null, "mutant": "M", "mutation": "S503M", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1007, "ferret_sera_escape": 0.02077, "mature_H5_site": 503, "mouse_sera_escape": -0.05164, "mutant": "N", "mutation": "S503N", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": -0.1379, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2142, "ferret_sera_escape": 0.01478, "mature_H5_site": 503, "mouse_sera_escape": 0.04623, "mutant": "P", "mutation": "S503P", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.001422, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.06417, "ferret_sera_escape": -0.001078, "mature_H5_site": 503, "mouse_sera_escape": -0.03393, "mutant": "Q", "mutation": "S503Q", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.04319, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1256, "ferret_sera_escape": 0.01205, "mature_H5_site": 503, "mouse_sera_escape": 0.04446, "mutant": "R", "mutation": "S503R", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": -0.03213, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 503, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S503S", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.05039, "ferret_sera_escape": 0.08302, "mature_H5_site": 503, "mouse_sera_escape": -0.04205, "mutant": "V", "mutation": "S503V", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": 0.04156, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -0.8107, "ferret_sera_escape": null, "mature_H5_site": 503, "mouse_sera_escape": null, "mutant": "W", "mutation": "S503W", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.01874, "ferret_sera_escape": -0.1036, "mature_H5_site": 503, "mouse_sera_escape": -0.02621, "mutant": "Y", "mutation": "S503Y", "reference_site": "503", "region": "HA2", "sequential_site": 519, "stability": -0.06744, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.05732, "ferret_sera_escape": 0.06392, "mature_H5_site": 504, "mouse_sera_escape": 0.06609, "mutant": "A", "mutation": "G504A", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.815, "ferret_sera_escape": null, "mature_H5_site": 504, "mouse_sera_escape": null, "mutant": "C", "mutation": "G504C", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3519, "ferret_sera_escape": -0.009363, "mature_H5_site": 504, "mouse_sera_escape": 0.02818, "mutant": "D", "mutation": "G504D", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": -0.04488, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4668, "ferret_sera_escape": 0.0523, "mature_H5_site": 504, "mouse_sera_escape": 0.07541, "mutant": "F", "mutation": "G504F", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": 0.04933, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 504, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G504G", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.069, "ferret_sera_escape": 0.08569, "mature_H5_site": 504, "mouse_sera_escape": -0.04596, "mutant": "I", "mutation": "G504I", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": 0.009294, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5598, "ferret_sera_escape": 0.2261, "mature_H5_site": 504, "mouse_sera_escape": 0.09849, "mutant": "K", "mutation": "G504K", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": -0.06818, "wildtype": "G"}, {"a26_usage": null, "cell_entry": -0.1267, "ferret_sera_escape": null, "mature_H5_site": 504, "mouse_sera_escape": null, "mutant": "L", "mutation": "G504L", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3764, "ferret_sera_escape": 0.008366, "mature_H5_site": 504, "mouse_sera_escape": 0.08214, "mutant": "M", "mutation": "G504M", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": -0.02725, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3606, "ferret_sera_escape": -0.2058, "mature_H5_site": 504, "mouse_sera_escape": -0.02896, "mutant": "N", "mutation": "G504N", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": -0.06239, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1082, "ferret_sera_escape": -0.0222, "mature_H5_site": 504, "mouse_sera_escape": -0.1717, "mutant": "P", "mutation": "G504P", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": -0.07532, "wildtype": "G"}, {"a26_usage": 0.1426, "cell_entry": -0.5511, "ferret_sera_escape": 0.01622, "mature_H5_site": 504, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G504Q", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.0628, "ferret_sera_escape": -0.06453, "mature_H5_site": 504, "mouse_sera_escape": -0.06225, "mutant": "R", "mutation": "G504R", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.05533, "ferret_sera_escape": 0.003407, "mature_H5_site": 504, "mouse_sera_escape": -0.001358, "mutant": "S", "mutation": "G504S", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.254, "ferret_sera_escape": -0.0273, "mature_H5_site": 504, "mouse_sera_escape": -0.08314, "mutant": "T", "mutation": "G504T", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": -0.03242, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2858, "ferret_sera_escape": 0.1493, "mature_H5_site": 504, "mouse_sera_escape": -0.005065, "mutant": "V", "mutation": "G504V", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": 3.585e-05, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.6058, "ferret_sera_escape": 0.01672, "mature_H5_site": 504, "mouse_sera_escape": 0.1636, "mutant": "W", "mutation": "G504W", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": 0.01375, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.7, "ferret_sera_escape": 0.1483, "mature_H5_site": 504, "mouse_sera_escape": 0.08495, "mutant": "Y", "mutation": "G504Y", "reference_site": "504", "region": "HA2", "sequential_site": 520, "stability": -0.03892, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.03402, "ferret_sera_escape": 0.0124, "mature_H5_site": 505, "mouse_sera_escape": 0.0944, "mutant": "A", "mutation": "V505A", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": -0.04235, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.535, "ferret_sera_escape": null, "mature_H5_site": 505, "mouse_sera_escape": null, "mutant": "D", "mutation": "V505D", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.102, "ferret_sera_escape": 0.2263, "mature_H5_site": 505, "mouse_sera_escape": 0.468, "mutant": "E", "mutation": "V505E", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1692, "ferret_sera_escape": 0.07562, "mature_H5_site": 505, "mouse_sera_escape": 0.03655, "mutant": "F", "mutation": "V505F", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": -0.08812, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.837, "ferret_sera_escape": 0.5868, "mature_H5_site": 505, "mouse_sera_escape": 0.1202, "mutant": "G", "mutation": "V505G", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3118, "ferret_sera_escape": 0.08436, "mature_H5_site": 505, "mouse_sera_escape": -0.00542, "mutant": "I", "mutation": "V505I", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": 0.01134, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.448, "ferret_sera_escape": -0.2066, "mature_H5_site": 505, "mouse_sera_escape": 0.2504, "mutant": "K", "mutation": "V505K", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": -0.02584, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.06217, "ferret_sera_escape": 0.009382, "mature_H5_site": 505, "mouse_sera_escape": 0.08648, "mutant": "L", "mutation": "V505L", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": -0.01124, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8361, "ferret_sera_escape": 0.1321, "mature_H5_site": 505, "mouse_sera_escape": 0.2844, "mutant": "M", "mutation": "V505M", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": 0.0294, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.893, "ferret_sera_escape": null, "mature_H5_site": 505, "mouse_sera_escape": null, "mutant": "N", "mutation": "V505N", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.583, "ferret_sera_escape": 0.435, "mature_H5_site": 505, "mouse_sera_escape": 0.2979, "mutant": "P", "mutation": "V505P", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.424, "ferret_sera_escape": null, "mature_H5_site": 505, "mouse_sera_escape": null, "mutant": "S", "mutation": "V505S", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.263, "ferret_sera_escape": 0.0613, "mature_H5_site": 505, "mouse_sera_escape": 0.1087, "mutant": "T", "mutation": "V505T", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": -0.02737, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 505, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V505V", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.982, "ferret_sera_escape": -0.08405, "mature_H5_site": 505, "mouse_sera_escape": 0.3145, "mutant": "W", "mutation": "V505W", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": 0.04164, "wildtype": "V"}, {"a26_usage": null, "cell_entry": -2.998, "ferret_sera_escape": null, "mature_H5_site": 505, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V505Y", "reference_site": "505", "region": "HA2", "sequential_site": 521, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2801, "ferret_sera_escape": 0.2156, "mature_H5_site": 506, "mouse_sera_escape": 0.1254, "mutant": "A", "mutation": "K506A", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.01909, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.901, "ferret_sera_escape": null, "mature_H5_site": 506, "mouse_sera_escape": null, "mutant": "C", "mutation": "K506C", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5555, "ferret_sera_escape": 0.01711, "mature_H5_site": 506, "mouse_sera_escape": 0.007777, "mutant": "D", "mutation": "K506D", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.02175, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.111, "ferret_sera_escape": -0.1844, "mature_H5_site": 506, "mouse_sera_escape": 0.03259, "mutant": "E", "mutation": "K506E", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": -0.02939, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8389, "ferret_sera_escape": -0.07956, "mature_H5_site": 506, "mouse_sera_escape": 0.1683, "mutant": "F", "mutation": "K506F", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.02451, "wildtype": "K"}, {"a26_usage": null, "cell_entry": -0.2566, "ferret_sera_escape": -0.123, "mature_H5_site": 506, "mouse_sera_escape": null, "mutant": "G", "mutation": "K506G", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1898, "ferret_sera_escape": -0.02713, "mature_H5_site": 506, "mouse_sera_escape": 0.004165, "mutant": "H", "mutation": "K506H", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": -0.05507, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8564, "ferret_sera_escape": 0.05164, "mature_H5_site": 506, "mouse_sera_escape": 0.02767, "mutant": "I", "mutation": "K506I", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": -0.08819, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 506, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K506K", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.9919, "cell_entry": -0.06916, "ferret_sera_escape": 0.2102, "mature_H5_site": 506, "mouse_sera_escape": 0.02239, "mutant": "M", "mutation": "K506M", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": -0.1297, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7509, "ferret_sera_escape": -0.02698, "mature_H5_site": 506, "mouse_sera_escape": 0.1334, "mutant": "N", "mutation": "K506N", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.09542, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.212, "ferret_sera_escape": 0.1471, "mature_H5_site": 506, "mouse_sera_escape": 0.08896, "mutant": "P", "mutation": "K506P", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.008369, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3191, "ferret_sera_escape": 0.08631, "mature_H5_site": 506, "mouse_sera_escape": 0.07484, "mutant": "Q", "mutation": "K506Q", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.0003654, "wildtype": "K"}, {"a26_usage": 0.05841, "cell_entry": -0.3658, "ferret_sera_escape": -0.01978, "mature_H5_site": 506, "mouse_sera_escape": -0.07413, "mutant": "R", "mutation": "K506R", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": -0.002218, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.9623, "ferret_sera_escape": null, "mature_H5_site": 506, "mouse_sera_escape": null, "mutant": "S", "mutation": "K506S", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": null, "wildtype": "K"}, {"a26_usage": 0.198, "cell_entry": -0.2971, "ferret_sera_escape": -0.0455, "mature_H5_site": 506, "mouse_sera_escape": 0.02168, "mutant": "T", "mutation": "K506T", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": -0.06678, "wildtype": "K"}, {"a26_usage": 0.1785, "cell_entry": -0.04565, "ferret_sera_escape": 0.06315, "mature_H5_site": 506, "mouse_sera_escape": 0.08551, "mutant": "V", "mutation": "K506V", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.02307, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.151, "ferret_sera_escape": 0.08529, "mature_H5_site": 506, "mouse_sera_escape": 0.02414, "mutant": "W", "mutation": "K506W", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.01206, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2867, "ferret_sera_escape": -0.1766, "mature_H5_site": 506, "mouse_sera_escape": -0.06706, "mutant": "Y", "mutation": "K506Y", "reference_site": "506", "region": "HA2", "sequential_site": 522, "stability": 0.01501, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7611, "ferret_sera_escape": -0.226, "mature_H5_site": 507, "mouse_sera_escape": 0.468, "mutant": "A", "mutation": "L507A", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.637, "ferret_sera_escape": null, "mature_H5_site": 507, "mouse_sera_escape": null, "mutant": "C", "mutation": "L507C", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.528, "ferret_sera_escape": null, "mature_H5_site": 507, "mouse_sera_escape": null, "mutant": "D", "mutation": "L507D", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.467, "ferret_sera_escape": null, "mature_H5_site": 507, "mouse_sera_escape": null, "mutant": "E", "mutation": "L507E", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.454, "ferret_sera_escape": -0.122, "mature_H5_site": 507, "mouse_sera_escape": null, "mutant": "G", "mutation": "L507G", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.02697, "ferret_sera_escape": -0.02433, "mature_H5_site": 507, "mouse_sera_escape": 0.006116, "mutant": "I", "mutation": "L507I", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": 0.03806, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.563, "ferret_sera_escape": 0.07523, "mature_H5_site": 507, "mouse_sera_escape": 0.5783, "mutant": "K", "mutation": "L507K", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": 0.1802, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 507, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L507L", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2904, "ferret_sera_escape": -0.08014, "mature_H5_site": 507, "mouse_sera_escape": -0.03673, "mutant": "M", "mutation": "L507M", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": -0.01705, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 507, "mouse_sera_escape": null, "mutant": "N", "mutation": "L507N", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.713, "ferret_sera_escape": null, "mature_H5_site": 507, "mouse_sera_escape": 0.1814, "mutant": "P", "mutation": "L507P", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": -0.0008649, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.672, "ferret_sera_escape": -0.262, "mature_H5_site": 507, "mouse_sera_escape": 0.09086, "mutant": "Q", "mutation": "L507Q", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": 0.04313, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.826, "ferret_sera_escape": 0.05231, "mature_H5_site": 507, "mouse_sera_escape": 0.5728, "mutant": "R", "mutation": "L507R", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": 0.07686, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.036, "ferret_sera_escape": -0.2052, "mature_H5_site": 507, "mouse_sera_escape": 0.2425, "mutant": "T", "mutation": "L507T", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": -0.01721, "wildtype": "L"}, {"a26_usage": 0.1517, "cell_entry": -0.2207, "ferret_sera_escape": 0.07788, "mature_H5_site": 507, "mouse_sera_escape": 0.04654, "mutant": "W", "mutation": "L507W", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": 0.02518, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3744, "ferret_sera_escape": 0.01269, "mature_H5_site": 507, "mouse_sera_escape": 0.01849, "mutant": "Y", "mutation": "L507Y", "reference_site": "507", "region": "HA2", "sequential_site": 523, "stability": -0.001028, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.006375, "ferret_sera_escape": 0.1201, "mature_H5_site": 508, "mouse_sera_escape": 0.1116, "mutant": "D", "mutation": "E508D", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -9.588e-05, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 508, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E508E", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1684, "ferret_sera_escape": -0.136, "mature_H5_site": 508, "mouse_sera_escape": 0.08272, "mutant": "F", "mutation": "E508F", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": 0.01314, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.057, "ferret_sera_escape": -0.03038, "mature_H5_site": 508, "mouse_sera_escape": 0.2883, "mutant": "G", "mutation": "E508G", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": 0.001093, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.381, "ferret_sera_escape": -0.1676, "mature_H5_site": 508, "mouse_sera_escape": 0.2847, "mutant": "H", "mutation": "E508H", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.05666, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.091, "ferret_sera_escape": -0.01054, "mature_H5_site": 508, "mouse_sera_escape": 0.1304, "mutant": "I", "mutation": "E508I", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.01765, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.386, "ferret_sera_escape": -0.1646, "mature_H5_site": 508, "mouse_sera_escape": 0.1333, "mutant": "K", "mutation": "E508K", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.04404, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.464, "ferret_sera_escape": 0.1714, "mature_H5_site": 508, "mouse_sera_escape": 0.3026, "mutant": "M", "mutation": "E508M", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.05226, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.3241, "ferret_sera_escape": 0.04772, "mature_H5_site": 508, "mouse_sera_escape": 0.2647, "mutant": "N", "mutation": "E508N", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.03382, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.48, "ferret_sera_escape": -0.2164, "mature_H5_site": 508, "mouse_sera_escape": 0.4627, "mutant": "P", "mutation": "E508P", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.899, "ferret_sera_escape": 0.1415, "mature_H5_site": 508, "mouse_sera_escape": 0.2939, "mutant": "R", "mutation": "E508R", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": null, "wildtype": "E"}, {"a26_usage": 0.1631, "cell_entry": -0.4898, "ferret_sera_escape": 0.001213, "mature_H5_site": 508, "mouse_sera_escape": 0.3305, "mutant": "S", "mutation": "E508S", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.04487, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5888, "ferret_sera_escape": -0.1116, "mature_H5_site": 508, "mouse_sera_escape": 0.176, "mutant": "T", "mutation": "E508T", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.08488, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.4438, "ferret_sera_escape": -0.01796, "mature_H5_site": 508, "mouse_sera_escape": -0.005396, "mutant": "V", "mutation": "E508V", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.07226, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.08527, "ferret_sera_escape": -0.00384, "mature_H5_site": 508, "mouse_sera_escape": 0.05229, "mutant": "W", "mutation": "E508W", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.09781, "wildtype": "E"}, {"a26_usage": 0.368, "cell_entry": -0.3224, "ferret_sera_escape": 0.1549, "mature_H5_site": 508, "mouse_sera_escape": 0.1134, "mutant": "Y", "mutation": "E508Y", "reference_site": "508", "region": "HA2", "sequential_site": 524, "stability": -0.01296, "wildtype": "E"}, {"a26_usage": 0.1364, "cell_entry": -0.7495, "ferret_sera_escape": null, "mature_H5_site": 509, "mouse_sera_escape": null, "mutant": "A", "mutation": "S509A", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.365, "ferret_sera_escape": 0.003113, "mature_H5_site": 509, "mouse_sera_escape": 0.03644, "mutant": "C", "mutation": "S509C", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": 0.007373, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2337, "ferret_sera_escape": -0.01025, "mature_H5_site": 509, "mouse_sera_escape": -0.0007425, "mutant": "D", "mutation": "S509D", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": 0.02555, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.003676, "ferret_sera_escape": 0.02664, "mature_H5_site": 509, "mouse_sera_escape": 0.01155, "mutant": "F", "mutation": "S509F", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": -0.003255, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.165, "ferret_sera_escape": -0.04879, "mature_H5_site": 509, "mouse_sera_escape": 0.05237, "mutant": "G", "mutation": "S509G", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": 0.01793, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4995, "ferret_sera_escape": 0.08269, "mature_H5_site": 509, "mouse_sera_escape": 0.009296, "mutant": "H", "mutation": "S509H", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": 0.0003993, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.000925, "ferret_sera_escape": -0.04515, "mature_H5_site": 509, "mouse_sera_escape": -0.004216, "mutant": "I", "mutation": "S509I", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": -0.03007, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3224, "ferret_sera_escape": -0.01915, "mature_H5_site": 509, "mouse_sera_escape": -0.08704, "mutant": "K", "mutation": "S509K", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": null, "wildtype": "S"}, {"a26_usage": 0.08801, "cell_entry": 0.05769, "ferret_sera_escape": 0.1405, "mature_H5_site": 509, "mouse_sera_escape": 0.03903, "mutant": "M", "mutation": "S509M", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": -0.04056, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.198, "ferret_sera_escape": 0.01604, "mature_H5_site": 509, "mouse_sera_escape": -0.0284, "mutant": "N", "mutation": "S509N", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": -0.01941, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4033, "ferret_sera_escape": -0.2101, "mature_H5_site": 509, "mouse_sera_escape": -0.0494, "mutant": "P", "mutation": "S509P", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": -0.04379, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.04827, "ferret_sera_escape": -0.07628, "mature_H5_site": 509, "mouse_sera_escape": -0.06158, "mutant": "Q", "mutation": "S509Q", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": 0.005277, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2289, "ferret_sera_escape": -0.0157, "mature_H5_site": 509, "mouse_sera_escape": -0.08389, "mutant": "R", "mutation": "S509R", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": -0.0473, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 509, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S509S", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.386, "ferret_sera_escape": -0.1378, "mature_H5_site": 509, "mouse_sera_escape": -0.07037, "mutant": "V", "mutation": "S509V", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": -0.03548, "wildtype": "S"}, {"a26_usage": 0.2096, "cell_entry": -0.1222, "ferret_sera_escape": 0.1182, "mature_H5_site": 509, "mouse_sera_escape": null, "mutant": "W", "mutation": "S509W", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0102, "cell_entry": 0.001205, "ferret_sera_escape": 0.02727, "mature_H5_site": 509, "mouse_sera_escape": -0.05867, "mutant": "Y", "mutation": "S509Y", "reference_site": "509", "region": "HA2", "sequential_site": 525, "stability": 0.002686, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.887, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "C", "mutation": "L51C", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "D", "mutation": "L51D", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.856, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "E", "mutation": "L51E", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1445, "ferret_sera_escape": 0.008463, "mature_H5_site": 41, "mouse_sera_escape": 0.1418, "mutant": "F", "mutation": "L51F", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": -0.403, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.524, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "G", "mutation": "L51G", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.897, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "H", "mutation": "L51H", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2439, "ferret_sera_escape": 0.0098, "mature_H5_site": 41, "mouse_sera_escape": 0.1449, "mutant": "I", "mutation": "L51I", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": 1.43, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "K", "mutation": "L51K", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 41, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L51L", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.04328, "ferret_sera_escape": -0.00247, "mature_H5_site": 41, "mouse_sera_escape": 0.2604, "mutant": "M", "mutation": "L51M", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": -0.01392, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.874, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "P", "mutation": "L51P", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L51Q", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "R", "mutation": "L51R", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": null, "cell_entry": -5.888, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "S", "mutation": "L51S", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.462, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "V", "mutation": "L51V", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.975, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "W", "mutation": "L51W", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": null, "cell_entry": -1.941, "ferret_sera_escape": null, "mature_H5_site": 41, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L51Y", "reference_site": "51", "region": "region-C", "sequential_site": 57, "stability": null, "wildtype": "L"}, {"a26_usage": 0.5245, "cell_entry": -1.859, "ferret_sera_escape": null, "mature_H5_site": 510, "mouse_sera_escape": null, "mutant": "A", "mutation": "V510A", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.15, "ferret_sera_escape": -0.04497, "mature_H5_site": 510, "mouse_sera_escape": -0.04155, "mutant": "C", "mutation": "V510C", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.9661, "ferret_sera_escape": 0.008653, "mature_H5_site": 510, "mouse_sera_escape": -0.01954, "mutant": "D", "mutation": "V510D", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": -0.0182, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3661, "ferret_sera_escape": -0.2229, "mature_H5_site": 510, "mouse_sera_escape": -0.1579, "mutant": "E", "mutation": "V510E", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": -0.02867, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6906, "ferret_sera_escape": 0.06481, "mature_H5_site": 510, "mouse_sera_escape": 0.02693, "mutant": "F", "mutation": "V510F", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": 0.002531, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2837, "ferret_sera_escape": 0.06022, "mature_H5_site": 510, "mouse_sera_escape": 0.05009, "mutant": "G", "mutation": "V510G", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": 0.0111, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.01828, "ferret_sera_escape": null, "mature_H5_site": 510, "mouse_sera_escape": null, "mutant": "I", "mutation": "V510I", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.607, "ferret_sera_escape": -0.04586, "mature_H5_site": 510, "mouse_sera_escape": 0.2198, "mutant": "K", "mutation": "V510K", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": -0.0009203, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.4676, "ferret_sera_escape": 0.09453, "mature_H5_site": 510, "mouse_sera_escape": 0.08553, "mutant": "L", "mutation": "V510L", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": 0.04141, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2118, "ferret_sera_escape": 0.06007, "mature_H5_site": 510, "mouse_sera_escape": 0.1131, "mutant": "M", "mutation": "V510M", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": -0.03658, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8712, "ferret_sera_escape": 0.1053, "mature_H5_site": 510, "mouse_sera_escape": 0.2842, "mutant": "N", "mutation": "V510N", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": null, "wildtype": "V"}, {"a26_usage": null, "cell_entry": -0.5764, "ferret_sera_escape": -0.1179, "mature_H5_site": 510, "mouse_sera_escape": -0.09466, "mutant": "P", "mutation": "V510P", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.04129, "ferret_sera_escape": 0.04684, "mature_H5_site": 510, "mouse_sera_escape": 0.06849, "mutant": "Q", "mutation": "V510Q", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": -0.04402, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.656, "ferret_sera_escape": -0.091, "mature_H5_site": 510, "mouse_sera_escape": 0.0402, "mutant": "R", "mutation": "V510R", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": -0.01594, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.459, "ferret_sera_escape": -0.002067, "mature_H5_site": 510, "mouse_sera_escape": -0.1239, "mutant": "S", "mutation": "V510S", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.03982, "ferret_sera_escape": -0.04552, "mature_H5_site": 510, "mouse_sera_escape": 0.002845, "mutant": "T", "mutation": "V510T", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": 0.02783, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 510, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V510V", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1841, "ferret_sera_escape": 0.1097, "mature_H5_site": 510, "mouse_sera_escape": null, "mutant": "W", "mutation": "V510W", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2478, "ferret_sera_escape": null, "mature_H5_site": 510, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V510Y", "reference_site": "510", "region": "HA2", "sequential_site": 526, "stability": null, "wildtype": "V"}, {"a26_usage": 0.2929, "cell_entry": 0.06809, "ferret_sera_escape": -0.03894, "mature_H5_site": 511, "mouse_sera_escape": 0.0508, "mutant": "A", "mutation": "G510aA", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.01433, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.375, "ferret_sera_escape": -0.1084, "mature_H5_site": 511, "mouse_sera_escape": -0.08608, "mutant": "C", "mutation": "G510aC", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1301, "ferret_sera_escape": -0.03727, "mature_H5_site": 511, "mouse_sera_escape": -0.01707, "mutant": "D", "mutation": "G510aD", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.05768, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5626, "ferret_sera_escape": null, "mature_H5_site": 511, "mouse_sera_escape": null, "mutant": "E", "mutation": "G510aE", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": null, "wildtype": "G"}, {"a26_usage": 0.3861, "cell_entry": -0.1437, "ferret_sera_escape": 0.007317, "mature_H5_site": 511, "mouse_sera_escape": 0.04277, "mutant": "F", "mutation": "G510aF", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 511, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G510aG", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.086, "ferret_sera_escape": 0.1483, "mature_H5_site": 511, "mouse_sera_escape": 0.06689, "mutant": "H", "mutation": "G510aH", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": 0.03107, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3814, "ferret_sera_escape": 0.03268, "mature_H5_site": 511, "mouse_sera_escape": 0.02375, "mutant": "I", "mutation": "G510aI", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.01112, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.003, "ferret_sera_escape": 0.2477, "mature_H5_site": 511, "mouse_sera_escape": 0.06612, "mutant": "K", "mutation": "G510aK", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.01837, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2961, "ferret_sera_escape": 0.07288, "mature_H5_site": 511, "mouse_sera_escape": 0.06369, "mutant": "L", "mutation": "G510aL", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.06493, "wildtype": "G"}, {"a26_usage": 0.3723, "cell_entry": 0.0516, "ferret_sera_escape": 0.1099, "mature_H5_site": 511, "mouse_sera_escape": 0.1376, "mutant": "M", "mutation": "G510aM", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.01059, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.09419, "ferret_sera_escape": 0.1027, "mature_H5_site": 511, "mouse_sera_escape": 0.01273, "mutant": "N", "mutation": "G510aN", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.04352, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.172, "ferret_sera_escape": -0.1075, "mature_H5_site": 511, "mouse_sera_escape": 0.08178, "mutant": "P", "mutation": "G510aP", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.08209, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5129, "ferret_sera_escape": 0.008033, "mature_H5_site": 511, "mouse_sera_escape": 0.09427, "mutant": "Q", "mutation": "G510aQ", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.01559, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.353, "ferret_sera_escape": 0.1284, "mature_H5_site": 511, "mouse_sera_escape": 0.1345, "mutant": "R", "mutation": "G510aR", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": 0.01657, "wildtype": "G"}, {"a26_usage": 0.1862, "cell_entry": -0.1341, "ferret_sera_escape": -0.06036, "mature_H5_site": 511, "mouse_sera_escape": 0.04504, "mutant": "S", "mutation": "G510aS", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.03931, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.07283, "ferret_sera_escape": -0.01964, "mature_H5_site": 511, "mouse_sera_escape": -0.08027, "mutant": "V", "mutation": "G510aV", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.01072, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3565, "ferret_sera_escape": -0.07072, "mature_H5_site": 511, "mouse_sera_escape": -0.07683, "mutant": "W", "mutation": "G510aW", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": -0.04715, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.916, "ferret_sera_escape": 0.01132, "mature_H5_site": 511, "mouse_sera_escape": 0.1039, "mutant": "Y", "mutation": "G510aY", "reference_site": "510a", "region": "HA2", "sequential_site": 527, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.05457, "ferret_sera_escape": null, "mature_H5_site": 512, "mouse_sera_escape": null, "mutant": "A", "mutation": "T511A", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.9057, "ferret_sera_escape": null, "mature_H5_site": 512, "mouse_sera_escape": null, "mutant": "C", "mutation": "T511C", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.437, "ferret_sera_escape": -0.1208, "mature_H5_site": 512, "mouse_sera_escape": -0.08603, "mutant": "D", "mutation": "T511D", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.1684, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -4.442, "ferret_sera_escape": null, "mature_H5_site": 512, "mouse_sera_escape": null, "mutant": "E", "mutation": "T511E", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": null, "wildtype": "T"}, {"a26_usage": 0.03281, "cell_entry": -0.01387, "ferret_sera_escape": -0.1172, "mature_H5_site": 512, "mouse_sera_escape": -0.1298, "mutant": "F", "mutation": "T511F", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.0748, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.508, "ferret_sera_escape": -0.2099, "mature_H5_site": 512, "mouse_sera_escape": 0.1008, "mutant": "G", "mutation": "T511G", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.06247, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.369, "ferret_sera_escape": -0.06052, "mature_H5_site": 512, "mouse_sera_escape": 0.1529, "mutant": "H", "mutation": "T511H", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.06475, "ferret_sera_escape": -0.05092, "mature_H5_site": 512, "mouse_sera_escape": -0.09524, "mutant": "I", "mutation": "T511I", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.1076, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.461, "ferret_sera_escape": -0.1218, "mature_H5_site": 512, "mouse_sera_escape": 0.04653, "mutant": "K", "mutation": "T511K", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.06592, "wildtype": "T"}, {"a26_usage": 0.1879, "cell_entry": -0.4985, "ferret_sera_escape": null, "mature_H5_site": 512, "mouse_sera_escape": null, "mutant": "L", "mutation": "T511L", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.2211, "ferret_sera_escape": 0.07193, "mature_H5_site": 512, "mouse_sera_escape": 0.05634, "mutant": "M", "mutation": "T511M", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": 0.0199, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.9485, "ferret_sera_escape": -0.2285, "mature_H5_site": 512, "mouse_sera_escape": -0.1905, "mutant": "N", "mutation": "T511N", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.09634, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.1322, "ferret_sera_escape": -0.08752, "mature_H5_site": 512, "mouse_sera_escape": -0.07357, "mutant": "P", "mutation": "T511P", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.1155, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.334, "ferret_sera_escape": null, "mature_H5_site": 512, "mouse_sera_escape": null, "mutant": "Q", "mutation": "T511Q", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.465, "ferret_sera_escape": -0.2832, "mature_H5_site": 512, "mouse_sera_escape": -0.06317, "mutant": "R", "mutation": "T511R", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.0492, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.01817, "ferret_sera_escape": -0.2837, "mature_H5_site": 512, "mouse_sera_escape": -0.1498, "mutant": "S", "mutation": "T511S", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.1041, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 512, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T511T", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.06309, "ferret_sera_escape": 0.1191, "mature_H5_site": 512, "mouse_sera_escape": 0.03597, "mutant": "V", "mutation": "T511V", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": 0.004565, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.07134, "ferret_sera_escape": -0.1377, "mature_H5_site": 512, "mouse_sera_escape": -0.1268, "mutant": "W", "mutation": "T511W", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.0296, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.09866, "ferret_sera_escape": -0.05766, "mature_H5_site": 512, "mouse_sera_escape": 0.04567, "mutant": "Y", "mutation": "T511Y", "reference_site": "511", "region": "HA2", "sequential_site": 528, "stability": -0.01649, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.883, "ferret_sera_escape": -0.1387, "mature_H5_site": 513, "mouse_sera_escape": 0.06671, "mutant": "A", "mutation": "Y512A", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.01577, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.566, "ferret_sera_escape": 0.006183, "mature_H5_site": 513, "mouse_sera_escape": 0.03772, "mutant": "C", "mutation": "Y512C", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": 0.04777, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.984, "ferret_sera_escape": 0.01782, "mature_H5_site": 513, "mouse_sera_escape": -0.1418, "mutant": "D", "mutation": "Y512D", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.1266, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.404, "ferret_sera_escape": -0.1593, "mature_H5_site": 513, "mouse_sera_escape": -0.1344, "mutant": "E", "mutation": "Y512E", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.2295, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.01194, "ferret_sera_escape": -0.02168, "mature_H5_site": 513, "mouse_sera_escape": 0.007416, "mutant": "F", "mutation": "Y512F", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.068, "ferret_sera_escape": -0.1544, "mature_H5_site": 513, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y512G", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.04843, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.412, "ferret_sera_escape": -0.1386, "mature_H5_site": 513, "mouse_sera_escape": 0.03352, "mutant": "H", "mutation": "Y512H", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.1151, "wildtype": "Y"}, {"a26_usage": 0.4196, "cell_entry": -0.5964, "ferret_sera_escape": -0.09143, "mature_H5_site": 513, "mouse_sera_escape": 0.008771, "mutant": "I", "mutation": "Y512I", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.02466, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 513, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y512K", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.00766, "ferret_sera_escape": 0.2784, "mature_H5_site": 513, "mouse_sera_escape": 0.09211, "mutant": "L", "mutation": "Y512L", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6298, "ferret_sera_escape": 0.0525, "mature_H5_site": 513, "mouse_sera_escape": -0.01134, "mutant": "M", "mutation": "Y512M", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.07149, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.681, "ferret_sera_escape": -0.2002, "mature_H5_site": 513, "mouse_sera_escape": -0.04486, "mutant": "P", "mutation": "Y512P", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7171, "ferret_sera_escape": -0.1043, "mature_H5_site": 513, "mouse_sera_escape": -0.08892, "mutant": "Q", "mutation": "Y512Q", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.1152, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.591, "ferret_sera_escape": null, "mature_H5_site": 513, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y512R", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.4365, "ferret_sera_escape": 0.002081, "mature_H5_site": 513, "mouse_sera_escape": 0.07524, "mutant": "T", "mutation": "Y512T", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.7799, "ferret_sera_escape": -0.1013, "mature_H5_site": 513, "mouse_sera_escape": 0.02572, "mutant": "V", "mutation": "Y512V", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.07286, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.06133, "ferret_sera_escape": -0.01216, "mature_H5_site": 513, "mouse_sera_escape": 0.01783, "mutant": "W", "mutation": "Y512W", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": -0.006573, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 513, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y512Y", "reference_site": "512", "region": "HA2", "sequential_site": 529, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.6407, "ferret_sera_escape": 0.01753, "mature_H5_site": 514, "mouse_sera_escape": 0.06685, "mutant": "A", "mutation": "Q513A", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.001842, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.848, "ferret_sera_escape": -0.01108, "mature_H5_site": 514, "mouse_sera_escape": -0.082, "mutant": "C", "mutation": "Q513C", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": 0.02226, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.837, "ferret_sera_escape": -0.2386, "mature_H5_site": 514, "mouse_sera_escape": 0.04464, "mutant": "D", "mutation": "Q513D", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.07119, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2224, "ferret_sera_escape": 0.02254, "mature_H5_site": 514, "mouse_sera_escape": 0.0514, "mutant": "E", "mutation": "Q513E", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.0005322, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2705, "ferret_sera_escape": 0.01134, "mature_H5_site": 514, "mouse_sera_escape": 0.01262, "mutant": "F", "mutation": "Q513F", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.00971, "wildtype": "Q"}, {"a26_usage": 0.05897, "cell_entry": -0.4027, "ferret_sera_escape": 0.09066, "mature_H5_site": 514, "mouse_sera_escape": 0.07207, "mutant": "H", "mutation": "Q513H", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.02499, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.166, "ferret_sera_escape": -0.1675, "mature_H5_site": 514, "mouse_sera_escape": -0.1703, "mutant": "I", "mutation": "Q513I", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.577, "ferret_sera_escape": -0.1852, "mature_H5_site": 514, "mouse_sera_escape": 0.07874, "mutant": "K", "mutation": "Q513K", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": 0.1466, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.03, "ferret_sera_escape": -0.09911, "mature_H5_site": 514, "mouse_sera_escape": 0.09479, "mutant": "L", "mutation": "Q513L", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.003031, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.02108, "ferret_sera_escape": 0.04419, "mature_H5_site": 514, "mouse_sera_escape": 0.05485, "mutant": "M", "mutation": "Q513M", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": 0.08596, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.7373, "ferret_sera_escape": -0.09377, "mature_H5_site": 514, "mouse_sera_escape": -0.07384, "mutant": "N", "mutation": "Q513N", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.1336, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.946, "ferret_sera_escape": -0.1685, "mature_H5_site": 514, "mouse_sera_escape": -0.02188, "mutant": "P", "mutation": "Q513P", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.1162, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 514, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q513Q", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.167, "ferret_sera_escape": -0.2429, "mature_H5_site": 514, "mouse_sera_escape": null, "mutant": "R", "mutation": "Q513R", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": 0.05072, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.828, "ferret_sera_escape": -0.1018, "mature_H5_site": 514, "mouse_sera_escape": 0.01658, "mutant": "S", "mutation": "Q513S", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.04283, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5694, "ferret_sera_escape": -0.0485, "mature_H5_site": 514, "mouse_sera_escape": 0.1052, "mutant": "T", "mutation": "Q513T", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.07026, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.8354, "ferret_sera_escape": -0.07323, "mature_H5_site": 514, "mouse_sera_escape": 0.007949, "mutant": "V", "mutation": "Q513V", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.8107, "cell_entry": -0.2589, "ferret_sera_escape": 0.09078, "mature_H5_site": 514, "mouse_sera_escape": 0.1974, "mutant": "W", "mutation": "Q513W", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": -0.02129, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.395, "ferret_sera_escape": 0.0579, "mature_H5_site": 514, "mouse_sera_escape": 0.1166, "mutant": "Y", "mutation": "Q513Y", "reference_site": "513", "region": "HA2", "sequential_site": 530, "stability": 0.05894, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5839, "ferret_sera_escape": 0.03564, "mature_H5_site": 515, "mouse_sera_escape": 0.2317, "mutant": "A", "mutation": "I514A", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": -0.0007493, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.082, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "C", "mutation": "I514C", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.793, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "D", "mutation": "I514D", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "E", "mutation": "I514E", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.5658, "cell_entry": -0.4273, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": -0.04841, "mutant": "F", "mutation": "I514F", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.463, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "G", "mutation": "I514G", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -5.825, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "H", "mutation": "I514H", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 515, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I514I", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6142, "ferret_sera_escape": -0.1402, "mature_H5_site": 515, "mouse_sera_escape": 0.03719, "mutant": "L", "mutation": "I514L", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": -0.08699, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.9195, "ferret_sera_escape": -0.042, "mature_H5_site": 515, "mouse_sera_escape": 0.1383, "mutant": "M", "mutation": "I514M", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": -0.03779, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.869, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "N", "mutation": "I514N", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "P", "mutation": "I514P", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.448, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I514Q", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.433, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "R", "mutation": "I514R", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.191, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "S", "mutation": "I514S", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.16, "ferret_sera_escape": null, "mature_H5_site": 515, "mouse_sera_escape": null, "mutant": "T", "mutation": "I514T", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3844, "ferret_sera_escape": -0.08591, "mature_H5_site": 515, "mouse_sera_escape": -0.05638, "mutant": "Y", "mutation": "I514Y", "reference_site": "514", "region": "HA2", "sequential_site": 531, "stability": -0.06811, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "A", "mutation": "L515A", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "C", "mutation": "L515C", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.887, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "D", "mutation": "L515D", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "E", "mutation": "L515E", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.748, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "F", "mutation": "L515F", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.274, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "G", "mutation": "L515G", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.565, "ferret_sera_escape": -0.3659, "mature_H5_site": 516, "mouse_sera_escape": -0.09073, "mutant": "I", "mutation": "L515I", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": -0.05267, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "K", "mutation": "L515K", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 516, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L515L", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.05149, "cell_entry": -0.01683, "ferret_sera_escape": -0.01808, "mature_H5_site": 516, "mouse_sera_escape": 0.08846, "mutant": "M", "mutation": "L515M", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": -0.004975, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.976, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "P", "mutation": "L515P", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.913, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L515Q", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "R", "mutation": "L515R", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.196, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "T", "mutation": "L515T", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.978, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "V", "mutation": "L515V", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.751, "ferret_sera_escape": null, "mature_H5_site": 516, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L515Y", "reference_site": "515", "region": "HA2", "sequential_site": 532, "stability": null, "wildtype": "L"}, {"a26_usage": 0.1984, "cell_entry": -0.6924, "ferret_sera_escape": null, "mature_H5_site": 517, "mouse_sera_escape": null, "mutant": "G", "mutation": "S516G", "reference_site": "516", "region": "HA2", "sequential_site": 533, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2904, "ferret_sera_escape": -0.00396, "mature_H5_site": 517, "mouse_sera_escape": -0.03884, "mutant": "N", "mutation": "S516N", "reference_site": "516", "region": "HA2", "sequential_site": 533, "stability": -0.02375, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.928, "ferret_sera_escape": null, "mature_H5_site": 517, "mouse_sera_escape": null, "mutant": "R", "mutation": "S516R", "reference_site": "516", "region": "HA2", "sequential_site": 533, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 517, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S516S", "reference_site": "516", "region": "HA2", "sequential_site": 533, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "C", "mutation": "I517C", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "D", "mutation": "I517D", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.867, "ferret_sera_escape": -0.07379, "mature_H5_site": 518, "mouse_sera_escape": -0.2079, "mutant": "F", "mutation": "I517F", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": -0.08813, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.89, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "G", "mutation": "I517G", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "H", "mutation": "I517H", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 518, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I517I", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "K", "mutation": "I517K", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.327, "ferret_sera_escape": -0.2523, "mature_H5_site": 518, "mouse_sera_escape": -0.2013, "mutant": "L", "mutation": "I517L", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.228, "ferret_sera_escape": -0.3295, "mature_H5_site": 518, "mouse_sera_escape": -0.2169, "mutant": "M", "mutation": "I517M", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": -0.09243, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.433, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "N", "mutation": "I517N", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "P", "mutation": "I517P", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I517Q", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.433, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "R", "mutation": "I517R", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.134, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "S", "mutation": "I517S", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.903, "ferret_sera_escape": null, "mature_H5_site": 518, "mouse_sera_escape": null, "mutant": "T", "mutation": "I517T", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3729, "ferret_sera_escape": 7.667e-05, "mature_H5_site": 518, "mouse_sera_escape": -0.01239, "mutant": "V", "mutation": "I517V", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": -0.05581, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4182, "ferret_sera_escape": -0.02016, "mature_H5_site": 518, "mouse_sera_escape": 0.008592, "mutant": "W", "mutation": "I517W", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": -0.1314, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.194, "ferret_sera_escape": -0.2095, "mature_H5_site": 518, "mouse_sera_escape": -0.06743, "mutant": "Y", "mutation": "I517Y", "reference_site": "517", "region": "HA2", "sequential_site": 534, "stability": -0.1527, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y518A", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.046, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y518C", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": null, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y518D", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.544, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y518E", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.479, "ferret_sera_escape": 0.04355, "mature_H5_site": 519, "mouse_sera_escape": -0.2162, "mutant": "F", "mutation": "Y518F", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": -0.0279, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y518G", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.449, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y518H", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y518I", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y518K", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y518L", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.765, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y518M", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y518N", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.918, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y518Q", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.989, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y518R", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.065, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y518S", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y518T", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.212, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y518V", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.01, "ferret_sera_escape": null, "mature_H5_site": 519, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y518W", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 519, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y518Y", "reference_site": "518", "region": "HA2", "sequential_site": 535, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.06183, "cell_entry": -0.2142, "ferret_sera_escape": 0.07071, "mature_H5_site": 520, "mouse_sera_escape": 0.1384, "mutant": "A", "mutation": "S519A", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -1.657, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "C", "mutation": "S519C", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "D", "mutation": "S519D", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "F", "mutation": "S519F", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6794, "ferret_sera_escape": -0.07214, "mature_H5_site": 520, "mouse_sera_escape": 0.02664, "mutant": "G", "mutation": "S519G", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": -0.05836, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.725, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "H", "mutation": "S519H", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.753, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "I", "mutation": "S519I", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "K", "mutation": "S519K", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "L", "mutation": "S519L", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.862, "ferret_sera_escape": -0.124, "mature_H5_site": 520, "mouse_sera_escape": 0.054, "mutant": "N", "mutation": "S519N", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": -0.1807, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "Q", "mutation": "S519Q", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.641, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "R", "mutation": "S519R", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 520, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S519S", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.469, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "W", "mutation": "S519W", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.897, "ferret_sera_escape": null, "mature_H5_site": 520, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S519Y", "reference_site": "519", "region": "HA2", "sequential_site": 536, "stability": null, "wildtype": "S"}, {"a26_usage": null, "cell_entry": -5.89, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "A", "mutation": "C52A", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 42, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C52C", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "D", "mutation": "C52D", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.724, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "E", "mutation": "C52E", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "F", "mutation": "C52F", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "G", "mutation": "C52G", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "H", "mutation": "C52H", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.789, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "K", "mutation": "C52K", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "L", "mutation": "C52L", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "N", "mutation": "C52N", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.894, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "P", "mutation": "C52P", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.821, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "R", "mutation": "C52R", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "S", "mutation": "C52S", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "V", "mutation": "C52V", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "W", "mutation": "C52W", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.05, "ferret_sera_escape": null, "mature_H5_site": 42, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C52Y", "reference_site": "52", "region": "region-C", "sequential_site": 58, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.3999, "ferret_sera_escape": 0.01435, "mature_H5_site": 521, "mouse_sera_escape": -0.004358, "mutant": "A", "mutation": "T520A", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": 0.01948, "wildtype": "T"}, {"a26_usage": 0.3566, "cell_entry": 0.003055, "ferret_sera_escape": 0.06554, "mature_H5_site": 521, "mouse_sera_escape": 0.1019, "mutant": "C", "mutation": "T520C", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": 0.004768, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.987, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": null, "mutant": "D", "mutation": "T520D", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.649, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": null, "mutant": "E", "mutation": "T520E", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -2.546, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": -0.05049, "mutant": "G", "mutation": "T520G", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": -0.06212, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.99, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": null, "mutant": "H", "mutation": "T520H", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.275, "ferret_sera_escape": 0.1865, "mature_H5_site": 521, "mouse_sera_escape": -0.01959, "mutant": "I", "mutation": "T520I", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": 0.06272, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.89, "ferret_sera_escape": 0.01933, "mature_H5_site": 521, "mouse_sera_escape": -0.03885, "mutant": "M", "mutation": "T520M", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": 0.07973, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -3.032, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": null, "mutant": "N", "mutation": "T520N", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -6.049, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": null, "mutant": "P", "mutation": "T520P", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.123, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": null, "mutant": "R", "mutation": "T520R", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -1.913, "ferret_sera_escape": 0.00059, "mature_H5_site": 521, "mouse_sera_escape": -0.04408, "mutant": "S", "mutation": "T520S", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": -0.1007, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 521, "mouse_sera_escape": 0.0, "mutant": "T", "mutation": "T520T", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": 0.0, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -0.7542, "ferret_sera_escape": 0.0003797, "mature_H5_site": 521, "mouse_sera_escape": -0.08142, "mutant": "V", "mutation": "T520V", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": -0.04749, "wildtype": "T"}, {"a26_usage": null, "cell_entry": -5.892, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": null, "mutant": "W", "mutation": "T520W", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 521, "mouse_sera_escape": null, "mutant": "Y", "mutation": "T520Y", "reference_site": "520", "region": "HA2", "sequential_site": 537, "stability": null, "wildtype": "T"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 522, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A521A", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2395, "ferret_sera_escape": -0.1913, "mature_H5_site": 522, "mouse_sera_escape": -0.08198, "mutant": "C", "mutation": "A521C", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "D", "mutation": "A521D", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.81, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "E", "mutation": "A521E", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.784, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "F", "mutation": "A521F", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7254, "ferret_sera_escape": -0.1418, "mature_H5_site": 522, "mouse_sera_escape": -0.1248, "mutant": "G", "mutation": "A521G", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": -0.08357, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "H", "mutation": "A521H", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "K", "mutation": "A521K", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.795, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "M", "mutation": "A521M", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.749, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "N", "mutation": "A521N", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "P", "mutation": "A521P", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A521Q", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.005, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "R", "mutation": "A521R", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.359, "ferret_sera_escape": -0.1845, "mature_H5_site": 522, "mouse_sera_escape": -0.2223, "mutant": "S", "mutation": "A521S", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": -0.06587, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.04, "ferret_sera_escape": 0.0144, "mature_H5_site": 522, "mouse_sera_escape": -0.01525, "mutant": "T", "mutation": "A521T", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": -0.09072, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5401, "ferret_sera_escape": 0.1352, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "V", "mutation": "A521V", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 522, "mouse_sera_escape": null, "mutant": "W", "mutation": "A521W", "reference_site": "521", "region": "HA2", "sequential_site": 538, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 523, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A522A", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.453, "ferret_sera_escape": 0.0169, "mature_H5_site": 523, "mouse_sera_escape": -0.03655, "mutant": "C", "mutation": "A522C", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": -0.05224, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "D", "mutation": "A522D", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "E", "mutation": "A522E", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "F", "mutation": "A522F", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "G", "mutation": "A522G", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.919, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "H", "mutation": "A522H", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.014, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "K", "mutation": "A522K", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.975, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "L", "mutation": "A522L", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.22, "ferret_sera_escape": -0.2558, "mature_H5_site": 523, "mouse_sera_escape": -0.2598, "mutant": "M", "mutation": "A522M", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": -0.149, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.881, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "N", "mutation": "A522N", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "P", "mutation": "A522P", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A522Q", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "R", "mutation": "A522R", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.862, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "S", "mutation": "A522S", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.805, "ferret_sera_escape": -0.1643, "mature_H5_site": 523, "mouse_sera_escape": 0.007194, "mutant": "T", "mutation": "A522T", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": -0.1423, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.237, "ferret_sera_escape": -0.07419, "mature_H5_site": 523, "mouse_sera_escape": -0.01635, "mutant": "V", "mutation": "A522V", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": -0.01953, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.013, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "W", "mutation": "A522W", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 523, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A522Y", "reference_site": "522", "region": "HA2", "sequential_site": 539, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1254, "ferret_sera_escape": 0.003079, "mature_H5_site": 524, "mouse_sera_escape": -0.04788, "mutant": "A", "mutation": "S523A", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": -0.06016, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -6.014, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "C", "mutation": "S523C", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "D", "mutation": "S523D", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "E", "mutation": "S523E", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "F", "mutation": "S523F", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.704, "ferret_sera_escape": 0.3775, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "G", "mutation": "S523G", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": -0.03557, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "H", "mutation": "S523H", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.542, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "I", "mutation": "S523I", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "K", "mutation": "S523K", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -6.009, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "L", "mutation": "S523L", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.563, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "M", "mutation": "S523M", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "N", "mutation": "S523N", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.019, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "P", "mutation": "S523P", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "R", "mutation": "S523R", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 524, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S523S", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "T", "mutation": "S523T", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.567, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "V", "mutation": "S523V", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "W", "mutation": "S523W", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.977, "ferret_sera_escape": null, "mature_H5_site": 524, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S523Y", "reference_site": "523", "region": "HA2", "sequential_site": 540, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "C", "mutation": "S524C", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "D", "mutation": "S524D", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "E", "mutation": "S524E", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.93, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "F", "mutation": "S524F", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "G", "mutation": "S524G", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.787, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "H", "mutation": "S524H", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "I", "mutation": "S524I", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "N", "mutation": "S524N", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.84, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "P", "mutation": "S524P", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.653, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "R", "mutation": "S524R", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 525, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S524S", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.587, "ferret_sera_escape": 0.03086, "mature_H5_site": 525, "mouse_sera_escape": -0.09942, "mutant": "T", "mutation": "S524T", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "V", "mutation": "S524V", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.917, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "W", "mutation": "S524W", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 525, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S524Y", "reference_site": "524", "region": "HA2", "sequential_site": 541, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 526, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L525L", "reference_site": "525", "region": "HA2", "sequential_site": 542, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.708, "ferret_sera_escape": null, "mature_H5_site": 526, "mouse_sera_escape": null, "mutant": "P", "mutation": "L525P", "reference_site": "525", "region": "HA2", "sequential_site": 542, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 527, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A526A", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.4592, "ferret_sera_escape": 0.0307, "mature_H5_site": 527, "mouse_sera_escape": -0.05847, "mutant": "C", "mutation": "A526C", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": -0.04216, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 527, "mouse_sera_escape": null, "mutant": "D", "mutation": "A526D", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 527, "mouse_sera_escape": null, "mutant": "E", "mutation": "A526E", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.688, "ferret_sera_escape": null, "mature_H5_site": 527, "mouse_sera_escape": null, "mutant": "F", "mutation": "A526F", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.5366, "ferret_sera_escape": -0.03084, "mature_H5_site": 527, "mouse_sera_escape": 0.0548, "mutant": "G", "mutation": "A526G", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": -0.4739, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.867, "ferret_sera_escape": null, "mature_H5_site": 527, "mouse_sera_escape": null, "mutant": "H", "mutation": "A526H", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.8662, "ferret_sera_escape": 0.03041, "mature_H5_site": 527, "mouse_sera_escape": -0.144, "mutant": "I", "mutation": "A526I", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": -0.05213, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 527, "mouse_sera_escape": null, "mutant": "K", "mutation": "A526K", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.476, "ferret_sera_escape": -0.3348, "mature_H5_site": 527, "mouse_sera_escape": 0.08335, "mutant": "N", "mutation": "A526N", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": -0.0727, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 527, "mouse_sera_escape": null, "mutant": "P", "mutation": "A526P", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 527, "mouse_sera_escape": null, "mutant": "R", "mutation": "A526R", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": null, "wildtype": "A"}, {"a26_usage": 0.07782, "cell_entry": -0.2572, "ferret_sera_escape": -0.07856, "mature_H5_site": 527, "mouse_sera_escape": -0.009656, "mutant": "S", "mutation": "A526S", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": -0.007198, "wildtype": "A"}, {"a26_usage": 0.05535, "cell_entry": -0.1571, "ferret_sera_escape": 0.01533, "mature_H5_site": 527, "mouse_sera_escape": 0.02439, "mutant": "T", "mutation": "A526T", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": -0.02197, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.6622, "ferret_sera_escape": -0.03508, "mature_H5_site": 527, "mouse_sera_escape": 0.0405, "mutant": "V", "mutation": "A526V", "reference_site": "526", "region": "HA2", "sequential_site": 543, "stability": -0.008279, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "A", "mutation": "L527A", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.034, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "C", "mutation": "L527C", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "D", "mutation": "L527D", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "E", "mutation": "L527E", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.041, "ferret_sera_escape": -0.5417, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "F", "mutation": "L527F", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.568, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "H", "mutation": "L527H", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.68, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "K", "mutation": "L527K", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 528, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L527L", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.603, "ferret_sera_escape": -0.0661, "mature_H5_site": 528, "mouse_sera_escape": 0.0348, "mutant": "M", "mutation": "L527M", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": -0.1064, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "N", "mutation": "L527N", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "P", "mutation": "L527P", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.993, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L527Q", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.533, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "R", "mutation": "L527R", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "S", "mutation": "L527S", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "T", "mutation": "L527T", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.365, "ferret_sera_escape": -0.2094, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "V", "mutation": "L527V", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.748, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "W", "mutation": "L527W", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 528, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L527Y", "reference_site": "527", "region": "HA2", "sequential_site": 544, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 529, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A528A", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.02856, "ferret_sera_escape": 0.01629, "mature_H5_site": 529, "mouse_sera_escape": -0.02121, "mutant": "C", "mutation": "A528C", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": 0.03738, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.796, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "D", "mutation": "A528D", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.007, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "E", "mutation": "A528E", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.349, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "F", "mutation": "A528F", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.384, "ferret_sera_escape": -0.01327, "mature_H5_site": 529, "mouse_sera_escape": 0.003502, "mutant": "G", "mutation": "A528G", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": -0.02057, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.389, "ferret_sera_escape": -0.00176, "mature_H5_site": 529, "mouse_sera_escape": 0.1245, "mutant": "I", "mutation": "A528I", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": 0.1434, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.013, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "K", "mutation": "A528K", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": null, "cell_entry": -0.6888, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "L", "mutation": "A528L", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A528Q", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.824, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "R", "mutation": "A528R", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.03506, "cell_entry": -0.06288, "ferret_sera_escape": 0.005613, "mature_H5_site": 529, "mouse_sera_escape": -0.02507, "mutant": "S", "mutation": "A528S", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": -0.06727, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.05315, "ferret_sera_escape": -0.06048, "mature_H5_site": 529, "mouse_sera_escape": 0.01973, "mutant": "T", "mutation": "A528T", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": -0.09065, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.339, "ferret_sera_escape": -0.1351, "mature_H5_site": 529, "mouse_sera_escape": 0.04747, "mutant": "V", "mutation": "A528V", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": 0.2381, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.863, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "W", "mutation": "A528W", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 529, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A528Y", "reference_site": "528", "region": "HA2", "sequential_site": 545, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.428, "ferret_sera_escape": null, "mature_H5_site": 530, "mouse_sera_escape": null, "mutant": "A", "mutation": "I529A", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4947, "ferret_sera_escape": -0.04742, "mature_H5_site": 530, "mouse_sera_escape": 0.2328, "mutant": "C", "mutation": "I529C", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.81, "ferret_sera_escape": null, "mature_H5_site": 530, "mouse_sera_escape": null, "mutant": "D", "mutation": "I529D", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.704, "ferret_sera_escape": null, "mature_H5_site": 530, "mouse_sera_escape": null, "mutant": "E", "mutation": "I529E", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.698, "ferret_sera_escape": null, "mature_H5_site": 530, "mouse_sera_escape": null, "mutant": "H", "mutation": "I529H", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 530, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I529I", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.453, "ferret_sera_escape": null, "mature_H5_site": 530, "mouse_sera_escape": null, "mutant": "K", "mutation": "I529K", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.193, "ferret_sera_escape": 0.06629, "mature_H5_site": 530, "mouse_sera_escape": -0.06689, "mutant": "L", "mutation": "I529L", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": -0.006619, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.323, "ferret_sera_escape": null, "mature_H5_site": 530, "mouse_sera_escape": null, "mutant": "N", "mutation": "I529N", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.016, "ferret_sera_escape": null, "mature_H5_site": 530, "mouse_sera_escape": null, "mutant": "P", "mutation": "I529P", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 530, "mouse_sera_escape": null, "mutant": "R", "mutation": "I529R", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5203, "ferret_sera_escape": 0.05232, "mature_H5_site": 530, "mouse_sera_escape": 0.08203, "mutant": "S", "mutation": "I529S", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": 0.02028, "wildtype": "I"}, {"a26_usage": 0.2004, "cell_entry": -0.09735, "ferret_sera_escape": 0.04679, "mature_H5_site": 530, "mouse_sera_escape": -0.01198, "mutant": "V", "mutation": "I529V", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": 0.003756, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6709, "ferret_sera_escape": -0.003102, "mature_H5_site": 530, "mouse_sera_escape": -0.01007, "mutant": "Y", "mutation": "I529Y", "reference_site": "529", "region": "HA2", "sequential_site": 546, "stability": -0.09582, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2831, "ferret_sera_escape": 0.05783, "mature_H5_site": 43, "mouse_sera_escape": -0.07813, "mutant": "A", "mutation": "D53A", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": -0.01888, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.06545, "ferret_sera_escape": 0.06806, "mature_H5_site": 43, "mouse_sera_escape": -0.0396, "mutant": "C", "mutation": "D53C", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 43, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D53D", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7098, "ferret_sera_escape": -0.01263, "mature_H5_site": 43, "mouse_sera_escape": -0.03004, "mutant": "E", "mutation": "D53E", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": -0.1291, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.426, "ferret_sera_escape": null, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "F", "mutation": "D53F", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6269, "ferret_sera_escape": -0.1145, "mature_H5_site": 43, "mouse_sera_escape": 0.07152, "mutant": "G", "mutation": "D53G", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": 0.6907, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1916, "ferret_sera_escape": -0.102, "mature_H5_site": 43, "mouse_sera_escape": -0.007991, "mutant": "H", "mutation": "D53H", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": -0.05533, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.727, "ferret_sera_escape": null, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "I", "mutation": "D53I", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.321, "ferret_sera_escape": -0.4272, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "L", "mutation": "D53L", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0379, "ferret_sera_escape": 0.01719, "mature_H5_site": 43, "mouse_sera_escape": 0.222, "mutant": "M", "mutation": "D53M", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": -0.01664, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4213, "ferret_sera_escape": -0.04095, "mature_H5_site": 43, "mouse_sera_escape": 0.0006729, "mutant": "N", "mutation": "D53N", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": -0.06689, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "P", "mutation": "D53P", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.128, "ferret_sera_escape": null, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "Q", "mutation": "D53Q", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7636, "ferret_sera_escape": -0.02886, "mature_H5_site": 43, "mouse_sera_escape": 0.06618, "mutant": "R", "mutation": "D53R", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": -0.0498, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1046, "ferret_sera_escape": 0.2311, "mature_H5_site": 43, "mouse_sera_escape": 0.1728, "mutant": "S", "mutation": "D53S", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": -0.0894, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.9862, "ferret_sera_escape": -0.3456, "mature_H5_site": 43, "mouse_sera_escape": 0.2474, "mutant": "T", "mutation": "D53T", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.373, "ferret_sera_escape": null, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "V", "mutation": "D53V", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.767, "ferret_sera_escape": -0.2256, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "W", "mutation": "D53W", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.189, "ferret_sera_escape": null, "mature_H5_site": 43, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D53Y", "reference_site": "53", "region": "region-C", "sequential_site": 59, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.304, "ferret_sera_escape": 0.06221, "mature_H5_site": 531, "mouse_sera_escape": 0.1029, "mutant": "C", "mutation": "M530C", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": 0.1741, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.628, "ferret_sera_escape": null, "mature_H5_site": 531, "mouse_sera_escape": 0.02637, "mutant": "D", "mutation": "M530D", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": -0.09658, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.846, "ferret_sera_escape": null, "mature_H5_site": 531, "mouse_sera_escape": null, "mutant": "E", "mutation": "M530E", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.649, "ferret_sera_escape": null, "mature_H5_site": 531, "mouse_sera_escape": 0.04029, "mutant": "G", "mutation": "M530G", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": 0.7557, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.702, "ferret_sera_escape": -0.08559, "mature_H5_site": 531, "mouse_sera_escape": -0.05258, "mutant": "H", "mutation": "M530H", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.07698, "ferret_sera_escape": 0.06039, "mature_H5_site": 531, "mouse_sera_escape": -0.04281, "mutant": "I", "mutation": "M530I", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": 0.04743, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.99, "ferret_sera_escape": null, "mature_H5_site": 531, "mouse_sera_escape": null, "mutant": "K", "mutation": "M530K", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.6774, "ferret_sera_escape": null, "mature_H5_site": 531, "mouse_sera_escape": null, "mutant": "L", "mutation": "M530L", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 531, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M530M", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.587, "ferret_sera_escape": -0.2225, "mature_H5_site": 531, "mouse_sera_escape": -0.1239, "mutant": "N", "mutation": "M530N", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": -0.06721, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.716, "ferret_sera_escape": 0.05918, "mature_H5_site": 531, "mouse_sera_escape": 0.09563, "mutant": "P", "mutation": "M530P", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": -0.1026, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.8279, "ferret_sera_escape": -0.2082, "mature_H5_site": 531, "mouse_sera_escape": -0.1303, "mutant": "Q", "mutation": "M530Q", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": -0.07697, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 531, "mouse_sera_escape": null, "mutant": "R", "mutation": "M530R", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.057, "ferret_sera_escape": -0.05606, "mature_H5_site": 531, "mouse_sera_escape": -0.2933, "mutant": "S", "mutation": "M530S", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": 0.4353, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.4919, "ferret_sera_escape": 0.0166, "mature_H5_site": 531, "mouse_sera_escape": 0.07412, "mutant": "T", "mutation": "M530T", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": 0.007967, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.06889, "ferret_sera_escape": 0.006183, "mature_H5_site": 531, "mouse_sera_escape": 0.0613, "mutant": "V", "mutation": "M530V", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": 0.05095, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.801, "ferret_sera_escape": null, "mature_H5_site": 531, "mouse_sera_escape": null, "mutant": "W", "mutation": "M530W", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.478, "ferret_sera_escape": -0.1717, "mature_H5_site": 531, "mouse_sera_escape": -0.2317, "mutant": "Y", "mutation": "M530Y", "reference_site": "530", "region": "HA2", "sequential_site": 547, "stability": -0.05, "wildtype": "M"}, {"a26_usage": 0.3367, "cell_entry": -0.06842, "ferret_sera_escape": -0.1249, "mature_H5_site": 532, "mouse_sera_escape": 0.02182, "mutant": "C", "mutation": "M531C", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": -0.04251, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 532, "mouse_sera_escape": null, "mutant": "D", "mutation": "M531D", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 532, "mouse_sera_escape": null, "mutant": "E", "mutation": "M531E", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.04019, "ferret_sera_escape": 0.09001, "mature_H5_site": 532, "mouse_sera_escape": -0.02754, "mutant": "F", "mutation": "M531F", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": 0.1519, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.1551, "ferret_sera_escape": -0.005767, "mature_H5_site": 532, "mouse_sera_escape": -0.07695, "mutant": "G", "mutation": "M531G", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": -0.08655, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.805, "ferret_sera_escape": null, "mature_H5_site": 532, "mouse_sera_escape": null, "mutant": "H", "mutation": "M531H", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.02984, "ferret_sera_escape": 0.02202, "mature_H5_site": 532, "mouse_sera_escape": -0.02259, "mutant": "I", "mutation": "M531I", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": 0.01229, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 532, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M531M", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 532, "mouse_sera_escape": null, "mutant": "N", "mutation": "M531N", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.996, "ferret_sera_escape": null, "mature_H5_site": 532, "mouse_sera_escape": null, "mutant": "Q", "mutation": "M531Q", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.933, "ferret_sera_escape": null, "mature_H5_site": 532, "mouse_sera_escape": null, "mutant": "R", "mutation": "M531R", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.288, "ferret_sera_escape": -0.09031, "mature_H5_site": 532, "mouse_sera_escape": -0.04637, "mutant": "S", "mutation": "M531S", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": -0.06977, "wildtype": "M"}, {"a26_usage": 0.4007, "cell_entry": -0.6916, "ferret_sera_escape": -0.02443, "mature_H5_site": 532, "mouse_sera_escape": 0.03536, "mutant": "T", "mutation": "M531T", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": 0.009667, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.1233, "ferret_sera_escape": -0.1064, "mature_H5_site": 532, "mouse_sera_escape": -0.01188, "mutant": "V", "mutation": "M531V", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": 0.009725, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.05344, "ferret_sera_escape": 0.04856, "mature_H5_site": 532, "mouse_sera_escape": -0.0749, "mutant": "W", "mutation": "M531W", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": 0.02207, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.896, "ferret_sera_escape": -0.06557, "mature_H5_site": 532, "mouse_sera_escape": -0.2372, "mutant": "Y", "mutation": "M531Y", "reference_site": "531", "region": "HA2", "sequential_site": 548, "stability": -0.02336, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 533, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A532A", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.7522, "cell_entry": -0.6583, "ferret_sera_escape": -0.00809, "mature_H5_site": 533, "mouse_sera_escape": 0.001117, "mutant": "C", "mutation": "A532C", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.1019, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.992, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "D", "mutation": "A532D", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -6.012, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "E", "mutation": "A532E", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.118, "ferret_sera_escape": 0.06909, "mature_H5_site": 533, "mouse_sera_escape": 0.05406, "mutant": "F", "mutation": "A532F", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.3115, "wildtype": "A"}, {"a26_usage": 0.03345, "cell_entry": 0.01457, "ferret_sera_escape": 0.1302, "mature_H5_site": 533, "mouse_sera_escape": 0.09268, "mutant": "G", "mutation": "A532G", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.01617, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.873, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "H", "mutation": "A532H", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.045, "ferret_sera_escape": -0.08966, "mature_H5_site": 533, "mouse_sera_escape": -0.05387, "mutant": "I", "mutation": "A532I", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.2505, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.696, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "K", "mutation": "A532K", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.426, "ferret_sera_escape": -0.1652, "mature_H5_site": 533, "mouse_sera_escape": 0.09695, "mutant": "L", "mutation": "A532L", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.09446, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.218, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "M", "mutation": "A532M", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.793, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "N", "mutation": "A532N", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.801, "ferret_sera_escape": -0.0951, "mature_H5_site": 533, "mouse_sera_escape": -0.08918, "mutant": "P", "mutation": "A532P", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": -0.01589, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.833, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "Q", "mutation": "A532Q", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": null, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "R", "mutation": "A532R", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.7084, "ferret_sera_escape": null, "mature_H5_site": 533, "mouse_sera_escape": null, "mutant": "S", "mutation": "A532S", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.6654, "ferret_sera_escape": -0.05233, "mature_H5_site": 533, "mouse_sera_escape": -0.05542, "mutant": "T", "mutation": "A532T", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": -0.02929, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.139, "ferret_sera_escape": -0.09568, "mature_H5_site": 533, "mouse_sera_escape": 0.1937, "mutant": "V", "mutation": "A532V", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.2529, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.568, "ferret_sera_escape": -0.1264, "mature_H5_site": 533, "mouse_sera_escape": -0.4083, "mutant": "W", "mutation": "A532W", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.5519, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -4.934, "ferret_sera_escape": -0.1987, "mature_H5_site": 533, "mouse_sera_escape": -0.444, "mutant": "Y", "mutation": "A532Y", "reference_site": "532", "region": "HA2", "sequential_site": 549, "stability": 0.392, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.812, "ferret_sera_escape": null, "mature_H5_site": 534, "mouse_sera_escape": null, "mutant": "C", "mutation": "G533C", "reference_site": "533", "region": "HA2", "sequential_site": 550, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.056, "ferret_sera_escape": null, "mature_H5_site": 534, "mouse_sera_escape": null, "mutant": "D", "mutation": "G533D", "reference_site": "533", "region": "HA2", "sequential_site": 550, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 534, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G533G", "reference_site": "533", "region": "HA2", "sequential_site": 550, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.1827, "cell_entry": -0.5002, "ferret_sera_escape": -0.006758, "mature_H5_site": 534, "mouse_sera_escape": 0.0401, "mutant": "S", "mutation": "G533S", "reference_site": "533", "region": "HA2", "sequential_site": 550, "stability": -0.02041, "wildtype": "G"}, {"a26_usage": null, "cell_entry": -3.605, "ferret_sera_escape": null, "mature_H5_site": 534, "mouse_sera_escape": null, "mutant": "V", "mutation": "G533V", "reference_site": "533", "region": "HA2", "sequential_site": 550, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 535, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L534L", "reference_site": "534", "region": "HA2", "sequential_site": 551, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.004685, "ferret_sera_escape": 0.07938, "mature_H5_site": 535, "mouse_sera_escape": 0.1405, "mutant": "M", "mutation": "L534M", "reference_site": "534", "region": "HA2", "sequential_site": 551, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.931, "ferret_sera_escape": null, "mature_H5_site": 535, "mouse_sera_escape": -0.3225, "mutant": "P", "mutation": "L534P", "reference_site": "534", "region": "HA2", "sequential_site": 551, "stability": null, "wildtype": "L"}, {"a26_usage": null, "cell_entry": -1.58, "ferret_sera_escape": null, "mature_H5_site": 536, "mouse_sera_escape": null, "mutant": "R", "mutation": "S535R", "reference_site": "535", "region": "HA2", "sequential_site": 552, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 536, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S535S", "reference_site": "535", "region": "HA2", "sequential_site": 552, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 537, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L536L", "reference_site": "536", "region": "HA2", "sequential_site": 553, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3951, "ferret_sera_escape": 0.003553, "mature_H5_site": 537, "mouse_sera_escape": null, "mutant": "M", "mutation": "L536M", "reference_site": "536", "region": "HA2", "sequential_site": 553, "stability": null, "wildtype": "L"}, {"a26_usage": null, "cell_entry": -3.31, "ferret_sera_escape": null, "mature_H5_site": 537, "mouse_sera_escape": null, "mutant": "P", "mutation": "L536P", "reference_site": "536", "region": "HA2", "sequential_site": 553, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.769, "ferret_sera_escape": -0.369, "mature_H5_site": 538, "mouse_sera_escape": -0.2625, "mutant": "C", "mutation": "W537C", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": 0.6363, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.614, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "D", "mutation": "W537D", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.399, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "E", "mutation": "W537E", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": null, "cell_entry": -3.659, "ferret_sera_escape": -0.2397, "mature_H5_site": 538, "mouse_sera_escape": -0.3102, "mutant": "G", "mutation": "W537G", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.529, "ferret_sera_escape": -0.1871, "mature_H5_site": 538, "mouse_sera_escape": -0.2676, "mutant": "H", "mutation": "W537H", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": 0.4161, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.212, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "I", "mutation": "W537I", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.967, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "K", "mutation": "W537K", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.393, "ferret_sera_escape": -0.0371, "mature_H5_site": 538, "mouse_sera_escape": -0.134, "mutant": "L", "mutation": "W537L", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": 0.2048, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.212, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "M", "mutation": "W537M", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.858, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "N", "mutation": "W537N", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.403, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W537Q", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -3.865, "ferret_sera_escape": null, "mature_H5_site": 538, "mouse_sera_escape": null, "mutant": "R", "mutation": "W537R", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -4.931, "ferret_sera_escape": -0.1829, "mature_H5_site": 538, "mouse_sera_escape": -0.1377, "mutant": "S", "mutation": "W537S", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.71, "ferret_sera_escape": -0.1242, "mature_H5_site": 538, "mouse_sera_escape": -0.02528, "mutant": "V", "mutation": "W537V", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": 0.1967, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 538, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W537W", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.573, "ferret_sera_escape": 0.1758, "mature_H5_site": 538, "mouse_sera_escape": 0.1255, "mutant": "Y", "mutation": "W537Y", "reference_site": "537", "region": "HA2", "sequential_site": 554, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.5521, "ferret_sera_escape": 0.02657, "mature_H5_site": 539, "mouse_sera_escape": 0.02564, "mutant": "A", "mutation": "M538A", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.05962, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.755, "ferret_sera_escape": -0.1838, "mature_H5_site": 539, "mouse_sera_escape": -0.5356, "mutant": "C", "mutation": "M538C", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.6566, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -6.003, "ferret_sera_escape": null, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "D", "mutation": "M538D", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.82, "ferret_sera_escape": null, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "E", "mutation": "M538E", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.306, "ferret_sera_escape": 0.006627, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "F", "mutation": "M538F", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.129, "ferret_sera_escape": -0.09007, "mature_H5_site": 539, "mouse_sera_escape": -0.08074, "mutant": "G", "mutation": "M538G", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.883, "ferret_sera_escape": null, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "H", "mutation": "M538H", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.467, "ferret_sera_escape": -0.3934, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "I", "mutation": "M538I", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.7884, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -3.311, "ferret_sera_escape": -0.2177, "mature_H5_site": 539, "mouse_sera_escape": -0.2676, "mutant": "K", "mutation": "M538K", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.3617, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.759, "ferret_sera_escape": -0.3669, "mature_H5_site": 539, "mouse_sera_escape": 0.2969, "mutant": "L", "mutation": "M538L", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 539, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M538M", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -2.338, "ferret_sera_escape": -0.0641, "mature_H5_site": 539, "mouse_sera_escape": -0.2345, "mutant": "N", "mutation": "M538N", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": -0.04382, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.535, "ferret_sera_escape": -0.03788, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "P", "mutation": "M538P", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.4395, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.749, "ferret_sera_escape": -0.1429, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "R", "mutation": "M538R", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.2833, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.5393, "ferret_sera_escape": -0.02672, "mature_H5_site": 539, "mouse_sera_escape": 0.1145, "mutant": "S", "mutation": "M538S", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.1178, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.533, "ferret_sera_escape": -0.1099, "mature_H5_site": 539, "mouse_sera_escape": -0.1403, "mutant": "T", "mutation": "M538T", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.01073, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.782, "ferret_sera_escape": 0.06823, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "V", "mutation": "M538V", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": 0.6945, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.257, "ferret_sera_escape": -0.2136, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "W", "mutation": "M538W", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -4.981, "ferret_sera_escape": null, "mature_H5_site": 539, "mouse_sera_escape": null, "mutant": "Y", "mutation": "M538Y", "reference_site": "538", "region": "HA2", "sequential_site": 555, "stability": null, "wildtype": "M"}, {"a26_usage": 0.07273, "cell_entry": -0.8099, "ferret_sera_escape": 0.1936, "mature_H5_site": 540, "mouse_sera_escape": 0.07541, "mutant": "A", "mutation": "C539A", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": 0.02277, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 540, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C539C", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.016, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "D", "mutation": "C539D", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "E", "mutation": "C539E", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -1.696, "ferret_sera_escape": -0.01097, "mature_H5_site": 540, "mouse_sera_escape": -0.1197, "mutant": "F", "mutation": "C539F", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": -0.03069, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.888, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "G", "mutation": "C539G", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.108, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "H", "mutation": "C539H", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.29, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "K", "mutation": "C539K", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.9479, "ferret_sera_escape": -0.1669, "mature_H5_site": 540, "mouse_sera_escape": -0.1796, "mutant": "M", "mutation": "C539M", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": -0.05143, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.969, "ferret_sera_escape": -0.2897, "mature_H5_site": 540, "mouse_sera_escape": -0.6414, "mutant": "N", "mutation": "C539N", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "P", "mutation": "C539P", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.653, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "R", "mutation": "C539R", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -1.778, "ferret_sera_escape": null, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "S", "mutation": "C539S", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.278, "ferret_sera_escape": -0.3505, "mature_H5_site": 540, "mouse_sera_escape": null, "mutant": "T", "mutation": "C539T", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": -0.03267, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.8322, "ferret_sera_escape": -0.02047, "mature_H5_site": 540, "mouse_sera_escape": -0.1233, "mutant": "V", "mutation": "C539V", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": -0.01822, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.528, "ferret_sera_escape": 0.07198, "mature_H5_site": 540, "mouse_sera_escape": -0.001145, "mutant": "Y", "mutation": "C539Y", "reference_site": "539", "region": "HA2", "sequential_site": 556, "stability": 0.05091, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.954, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "C", "mutation": "L54C", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.868, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "E", "mutation": "L54E", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.889, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "F", "mutation": "L54F", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.33, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "H", "mutation": "L54H", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06702, "ferret_sera_escape": -0.01081, "mature_H5_site": 44, "mouse_sera_escape": 0.124, "mutant": "I", "mutation": "L54I", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": 1.049, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.939, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "K", "mutation": "L54K", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 44, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L54L", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.04107, "ferret_sera_escape": -0.1426, "mature_H5_site": 44, "mouse_sera_escape": 0.02963, "mutant": "M", "mutation": "L54M", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": 1.11, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.929, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "N", "mutation": "L54N", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "P", "mutation": "L54P", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L54Q", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.961, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "R", "mutation": "L54R", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "S", "mutation": "L54S", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 44, "mouse_sera_escape": null, "mutant": "T", "mutation": "L54T", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.06016, "cell_entry": -0.2463, "ferret_sera_escape": -0.05204, "mature_H5_site": 44, "mouse_sera_escape": 0.08993, "mutant": "V", "mutation": "L54V", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": -0.1082, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.259, "ferret_sera_escape": 0.3533, "mature_H5_site": 44, "mouse_sera_escape": 0.05584, "mutant": "W", "mutation": "L54W", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06314, "ferret_sera_escape": -0.124, "mature_H5_site": 44, "mouse_sera_escape": 0.05207, "mutant": "Y", "mutation": "L54Y", "reference_site": "54", "region": "region-C", "sequential_site": 60, "stability": 2.069, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.648, "ferret_sera_escape": null, "mature_H5_site": 542, "mouse_sera_escape": null, "mutant": "D", "mutation": "N541D", "reference_site": "541", "region": "HA2", "sequential_site": 558, "stability": null, "wildtype": "N"}, {"a26_usage": null, "cell_entry": -0.2357, "ferret_sera_escape": null, "mature_H5_site": 542, "mouse_sera_escape": null, "mutant": "G", "mutation": "N541G", "reference_site": "541", "region": "HA2", "sequential_site": 558, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.729, "ferret_sera_escape": -0.1441, "mature_H5_site": 542, "mouse_sera_escape": 0.1496, "mutant": "K", "mutation": "N541K", "reference_site": "541", "region": "HA2", "sequential_site": 558, "stability": 0.1613, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 542, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N541N", "reference_site": "541", "region": "HA2", "sequential_site": 558, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.711, "ferret_sera_escape": null, "mature_H5_site": 543, "mouse_sera_escape": null, "mutant": "C", "mutation": "G542C", "reference_site": "542", "region": "HA2", "sequential_site": 559, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.421, "ferret_sera_escape": 0.619, "mature_H5_site": 543, "mouse_sera_escape": null, "mutant": "D", "mutation": "G542D", "reference_site": "542", "region": "HA2", "sequential_site": 559, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 543, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G542G", "reference_site": "542", "region": "HA2", "sequential_site": 559, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.5446, "ferret_sera_escape": null, "mature_H5_site": 543, "mouse_sera_escape": null, "mutant": "S", "mutation": "G542S", "reference_site": "542", "region": "HA2", "sequential_site": 559, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.265, "ferret_sera_escape": -0.1287, "mature_H5_site": 544, "mouse_sera_escape": -0.334, "mutant": "C", "mutation": "S543C", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.9252, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.125, "ferret_sera_escape": 0.0347, "mature_H5_site": 544, "mouse_sera_escape": null, "mutant": "E", "mutation": "S543E", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.64, "ferret_sera_escape": 0.1206, "mature_H5_site": 544, "mouse_sera_escape": -0.08128, "mutant": "F", "mutation": "S543F", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.05901, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.634, "ferret_sera_escape": null, "mature_H5_site": 544, "mouse_sera_escape": null, "mutant": "G", "mutation": "S543G", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.616, "ferret_sera_escape": null, "mature_H5_site": 544, "mouse_sera_escape": null, "mutant": "H", "mutation": "S543H", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.119, "ferret_sera_escape": null, "mature_H5_site": 544, "mouse_sera_escape": null, "mutant": "I", "mutation": "S543I", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.04634, "ferret_sera_escape": -0.07298, "mature_H5_site": 544, "mouse_sera_escape": 0.03777, "mutant": "L", "mutation": "S543L", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.1963, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.792, "ferret_sera_escape": -0.01437, "mature_H5_site": 544, "mouse_sera_escape": 0.01171, "mutant": "M", "mutation": "S543M", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.05089, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.267, "ferret_sera_escape": null, "mature_H5_site": 544, "mouse_sera_escape": null, "mutant": "N", "mutation": "S543N", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.09684, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.867, "ferret_sera_escape": null, "mature_H5_site": 544, "mouse_sera_escape": null, "mutant": "P", "mutation": "S543P", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.783, "ferret_sera_escape": -0.1701, "mature_H5_site": 544, "mouse_sera_escape": -0.3435, "mutant": "Q", "mutation": "S543Q", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.792, "ferret_sera_escape": null, "mature_H5_site": 544, "mouse_sera_escape": null, "mutant": "R", "mutation": "S543R", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 544, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S543S", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.06, "ferret_sera_escape": -0.06595, "mature_H5_site": 544, "mouse_sera_escape": -0.04285, "mutant": "T", "mutation": "S543T", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": -0.01016, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6961, "ferret_sera_escape": -0.06913, "mature_H5_site": 544, "mouse_sera_escape": -0.01143, "mutant": "V", "mutation": "S543V", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.01125, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4506, "ferret_sera_escape": -0.1059, "mature_H5_site": 544, "mouse_sera_escape": -0.07511, "mutant": "W", "mutation": "S543W", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": 0.04512, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.581, "ferret_sera_escape": -0.02505, "mature_H5_site": 544, "mouse_sera_escape": 0.09378, "mutant": "Y", "mutation": "S543Y", "reference_site": "543", "region": "HA2", "sequential_site": 560, "stability": -0.01074, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.878, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "A", "mutation": "L544A", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.712, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "C", "mutation": "L544C", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "D", "mutation": "L544D", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.549, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "E", "mutation": "L544E", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.8, "ferret_sera_escape": 0.06899, "mature_H5_site": 545, "mouse_sera_escape": -0.4364, "mutant": "G", "mutation": "L544G", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.076, "ferret_sera_escape": -0.1625, "mature_H5_site": 545, "mouse_sera_escape": -0.2437, "mutant": "I", "mutation": "L544I", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": 0.4127, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": -0.394, "mutant": "K", "mutation": "L544K", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 545, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L544L", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.7662, "cell_entry": -0.5561, "ferret_sera_escape": -0.0148, "mature_H5_site": 545, "mouse_sera_escape": 0.1285, "mutant": "M", "mutation": "L544M", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": 0.1557, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.779, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "N", "mutation": "L544N", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.931, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "P", "mutation": "L544P", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.239, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L544Q", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.448, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "R", "mutation": "L544R", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.782, "ferret_sera_escape": -0.0376, "mature_H5_site": 545, "mouse_sera_escape": -0.3414, "mutant": "S", "mutation": "L544S", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": 0.6127, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.176, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "T", "mutation": "L544T", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3333, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "V", "mutation": "L544V", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.504, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "W", "mutation": "L544W", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.845, "ferret_sera_escape": null, "mature_H5_site": 545, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L544Y", "reference_site": "544", "region": "HA2", "sequential_site": 561, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.6986, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "A", "mutation": "Q545A", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.899, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "C", "mutation": "Q545C", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.854, "ferret_sera_escape": 0.07849, "mature_H5_site": 546, "mouse_sera_escape": 0.2831, "mutant": "D", "mutation": "Q545D", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.359, "ferret_sera_escape": 0.02809, "mature_H5_site": 546, "mouse_sera_escape": 0.1153, "mutant": "E", "mutation": "Q545E", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": 0.06606, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.717, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": -0.2797, "mutant": "F", "mutation": "Q545F", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.277, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "G", "mutation": "Q545G", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": 0.6403, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.394, "ferret_sera_escape": -0.04155, "mature_H5_site": 546, "mouse_sera_escape": -0.08148, "mutant": "H", "mutation": "Q545H", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": 0.1347, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.162, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "I", "mutation": "Q545I", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.5215, "ferret_sera_escape": 0.1966, "mature_H5_site": 546, "mouse_sera_escape": 0.0885, "mutant": "K", "mutation": "Q545K", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.15, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "L", "mutation": "Q545L", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.071, "ferret_sera_escape": -0.1957, "mature_H5_site": 546, "mouse_sera_escape": -0.1221, "mutant": "M", "mutation": "Q545M", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -2.487, "ferret_sera_escape": 0.07356, "mature_H5_site": 546, "mouse_sera_escape": 0.1214, "mutant": "N", "mutation": "Q545N", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -1.809, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "P", "mutation": "Q545P", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 546, "mouse_sera_escape": 0.0, "mutant": "Q", "mutation": "Q545Q", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": 0.0, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -3.271, "ferret_sera_escape": 0.0511, "mature_H5_site": 546, "mouse_sera_escape": 0.1845, "mutant": "R", "mutation": "Q545R", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": 0.2185, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.2907, "ferret_sera_escape": 0.07921, "mature_H5_site": 546, "mouse_sera_escape": -0.01105, "mutant": "T", "mutation": "Q545T", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": -0.02822, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -0.59, "ferret_sera_escape": 0.02137, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "V", "mutation": "Q545V", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -5.499, "ferret_sera_escape": -0.06307, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "W", "mutation": "Q545W", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": -4.085, "ferret_sera_escape": null, "mature_H5_site": 546, "mouse_sera_escape": null, "mutant": "Y", "mutation": "Q545Y", "reference_site": "545", "region": "HA2", "sequential_site": 562, "stability": null, "wildtype": "Q"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 547, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C546C", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.035, "ferret_sera_escape": null, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "D", "mutation": "C546D", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.261, "ferret_sera_escape": -0.4003, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "E", "mutation": "C546E", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.31, "ferret_sera_escape": null, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "F", "mutation": "C546F", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.175, "ferret_sera_escape": null, "mature_H5_site": 547, "mouse_sera_escape": -0.4121, "mutant": "G", "mutation": "C546G", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.716, "ferret_sera_escape": -0.1805, "mature_H5_site": 547, "mouse_sera_escape": -0.3831, "mutant": "H", "mutation": "C546H", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": 0.9956, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.731, "ferret_sera_escape": 0.04827, "mature_H5_site": 547, "mouse_sera_escape": -0.1352, "mutant": "I", "mutation": "C546I", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": -0.08578, "wildtype": "C"}, {"a26_usage": 2.68, "cell_entry": -3.956, "ferret_sera_escape": -0.3257, "mature_H5_site": 547, "mouse_sera_escape": -0.3845, "mutant": "K", "mutation": "C546K", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.06454, "ferret_sera_escape": -0.1115, "mature_H5_site": 547, "mouse_sera_escape": -0.2498, "mutant": "L", "mutation": "C546L", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": -0.0209, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.5443, "ferret_sera_escape": null, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "M", "mutation": "C546M", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 2.157, "cell_entry": -5.104, "ferret_sera_escape": 0.04098, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "N", "mutation": "C546N", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": 0.8709, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.825, "ferret_sera_escape": -0.1173, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "P", "mutation": "C546P", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": 0.539, "wildtype": "C"}, {"a26_usage": null, "cell_entry": -4.028, "ferret_sera_escape": null, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C546Q", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.482, "ferret_sera_escape": -0.3981, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "R", "mutation": "C546R", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.422, "ferret_sera_escape": null, "mature_H5_site": 547, "mouse_sera_escape": null, "mutant": "S", "mutation": "C546S", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.131, "ferret_sera_escape": -0.06895, "mature_H5_site": 547, "mouse_sera_escape": -0.2063, "mutant": "T", "mutation": "C546T", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": 0.7328, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.583, "ferret_sera_escape": 0.06324, "mature_H5_site": 547, "mouse_sera_escape": 0.02411, "mutant": "W", "mutation": "C546W", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.469, "ferret_sera_escape": -0.07564, "mature_H5_site": 547, "mouse_sera_escape": -0.1486, "mutant": "Y", "mutation": "C546Y", "reference_site": "546", "region": "HA2", "sequential_site": 563, "stability": 0.4189, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.986, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "A", "mutation": "R547A", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": -0.1843, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "C", "mutation": "R547C", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.336, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "D", "mutation": "R547D", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "F", "mutation": "R547F", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.049, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "G", "mutation": "R547G", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3383, "ferret_sera_escape": -0.129, "mature_H5_site": 548, "mouse_sera_escape": -0.3507, "mutant": "H", "mutation": "R547H", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.854, "ferret_sera_escape": -0.2341, "mature_H5_site": 548, "mouse_sera_escape": -0.3252, "mutant": "I", "mutation": "R547I", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": -0.03129, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.4794, "ferret_sera_escape": 0.0487, "mature_H5_site": 548, "mouse_sera_escape": 0.04011, "mutant": "K", "mutation": "R547K", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": -0.09646, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.203, "ferret_sera_escape": -0.257, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "L", "mutation": "R547L", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.692, "ferret_sera_escape": -0.08179, "mature_H5_site": 548, "mouse_sera_escape": -0.1496, "mutant": "N", "mutation": "R547N", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": 0.009676, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -6.043, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "P", "mutation": "R547P", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.849, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "Q", "mutation": "R547Q", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 548, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R547R", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.223, "ferret_sera_escape": -0.02313, "mature_H5_site": 548, "mouse_sera_escape": -0.182, "mutant": "S", "mutation": "R547S", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7928, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "T", "mutation": "R547T", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7174, "ferret_sera_escape": -0.1016, "mature_H5_site": 548, "mouse_sera_escape": -0.2736, "mutant": "V", "mutation": "R547V", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": -0.007089, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.278, "ferret_sera_escape": -0.09222, "mature_H5_site": 548, "mouse_sera_escape": -0.2382, "mutant": "W", "mutation": "R547W", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": -0.01039, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -3.693, "ferret_sera_escape": null, "mature_H5_site": 548, "mouse_sera_escape": null, "mutant": "Y", "mutation": "R547Y", "reference_site": "547", "region": "HA2", "sequential_site": 564, "stability": 0.2115, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.143, "ferret_sera_escape": 0.0347, "mature_H5_site": 549, "mouse_sera_escape": -0.07756, "mutant": "F", "mutation": "I548F", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.1837, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.406, "ferret_sera_escape": null, "mature_H5_site": 549, "mouse_sera_escape": -0.2113, "mutant": "H", "mutation": "I548H", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.8306, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 549, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I548I", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.222, "ferret_sera_escape": null, "mature_H5_site": 549, "mouse_sera_escape": null, "mutant": "K", "mutation": "I548K", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.085, "ferret_sera_escape": -0.05205, "mature_H5_site": 549, "mouse_sera_escape": -0.0494, "mutant": "L", "mutation": "I548L", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.06557, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.614, "ferret_sera_escape": 0.03818, "mature_H5_site": 549, "mouse_sera_escape": 0.07939, "mutant": "M", "mutation": "I548M", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.3571, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.338, "ferret_sera_escape": null, "mature_H5_site": 549, "mouse_sera_escape": null, "mutant": "N", "mutation": "I548N", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.374, "ferret_sera_escape": null, "mature_H5_site": 549, "mouse_sera_escape": null, "mutant": "P", "mutation": "I548P", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.575, "ferret_sera_escape": null, "mature_H5_site": 549, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I548Q", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.403, "ferret_sera_escape": null, "mature_H5_site": 549, "mouse_sera_escape": null, "mutant": "R", "mutation": "I548R", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.458, "ferret_sera_escape": -0.1966, "mature_H5_site": 549, "mouse_sera_escape": -0.4688, "mutant": "S", "mutation": "I548S", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.7119, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.991, "ferret_sera_escape": -0.2548, "mature_H5_site": 549, "mouse_sera_escape": -0.6438, "mutant": "T", "mutation": "I548T", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.376, "ferret_sera_escape": -0.06604, "mature_H5_site": 549, "mouse_sera_escape": -0.06642, "mutant": "V", "mutation": "I548V", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.002286, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.622, "ferret_sera_escape": -0.415, "mature_H5_site": 549, "mouse_sera_escape": null, "mutant": "W", "mutation": "I548W", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.527, "ferret_sera_escape": null, "mature_H5_site": 549, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I548Y", "reference_site": "548", "region": "HA2", "sequential_site": 565, "stability": 0.4683, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.162, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "A", "mutation": "C549A", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 550, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C549C", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.409, "ferret_sera_escape": -0.2411, "mature_H5_site": 550, "mouse_sera_escape": -0.1855, "mutant": "E", "mutation": "C549E", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": -0.03652, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.021, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "F", "mutation": "C549F", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.237, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "G", "mutation": "C549G", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.513, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "H", "mutation": "C549H", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.553, "ferret_sera_escape": -0.02687, "mature_H5_site": 550, "mouse_sera_escape": -0.4756, "mutant": "I", "mutation": "C549I", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": -0.007486, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.61, "ferret_sera_escape": -0.4192, "mature_H5_site": 550, "mouse_sera_escape": -0.1494, "mutant": "K", "mutation": "C549K", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": 0.2909, "wildtype": "C"}, {"a26_usage": 1.224, "cell_entry": -1.981, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "L", "mutation": "C549L", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.611, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "M", "mutation": "C549M", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.514, "ferret_sera_escape": -0.1311, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "N", "mutation": "C549N", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": 0.08776, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.15, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": -0.2507, "mutant": "Q", "mutation": "C549Q", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": 0.1168, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.742, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": -0.6341, "mutant": "R", "mutation": "C549R", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": 0.3262, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.47, "ferret_sera_escape": null, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "S", "mutation": "C549S", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.755, "ferret_sera_escape": -0.05122, "mature_H5_site": 550, "mouse_sera_escape": null, "mutant": "T", "mutation": "C549T", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.071, "ferret_sera_escape": -0.3248, "mature_H5_site": 550, "mouse_sera_escape": -0.5157, "mutant": "W", "mutation": "C549W", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": -0.0148, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.96, "ferret_sera_escape": -0.1463, "mature_H5_site": 550, "mouse_sera_escape": -0.2332, "mutant": "Y", "mutation": "C549Y", "reference_site": "549", "region": "HA2", "sequential_site": 566, "stability": 0.1515, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.02412, "ferret_sera_escape": -0.04877, "mature_H5_site": 45, "mouse_sera_escape": -0.09587, "mutant": "A", "mutation": "N54aA", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 0.2352, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1681, "ferret_sera_escape": 0.1093, "mature_H5_site": 45, "mouse_sera_escape": 0.05432, "mutant": "D", "mutation": "N54aD", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 1.142, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.02728, "ferret_sera_escape": -0.1481, "mature_H5_site": 45, "mouse_sera_escape": 0.05633, "mutant": "G", "mutation": "N54aG", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 1.114, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6608, "ferret_sera_escape": -0.05254, "mature_H5_site": 45, "mouse_sera_escape": -0.001887, "mutant": "H", "mutation": "N54aH", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": -0.09564, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.5526, "ferret_sera_escape": 0.03023, "mature_H5_site": 45, "mouse_sera_escape": 0.3592, "mutant": "I", "mutation": "N54aI", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 1.246, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1417, "ferret_sera_escape": 0.2597, "mature_H5_site": 45, "mouse_sera_escape": 0.2502, "mutant": "K", "mutation": "N54aK", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": -0.08534, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2206, "ferret_sera_escape": -0.04947, "mature_H5_site": 45, "mouse_sera_escape": 0.2997, "mutant": "L", "mutation": "N54aL", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 1.565, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4132, "ferret_sera_escape": -0.04749, "mature_H5_site": 45, "mouse_sera_escape": -0.021, "mutant": "M", "mutation": "N54aM", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 1.577, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 45, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N54aN", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.887, "ferret_sera_escape": null, "mature_H5_site": 45, "mouse_sera_escape": null, "mutant": "P", "mutation": "N54aP", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.06754, "ferret_sera_escape": -0.1973, "mature_H5_site": 45, "mouse_sera_escape": null, "mutant": "Q", "mutation": "N54aQ", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": null, "wildtype": "N"}, {"a26_usage": 0.1646, "cell_entry": -1.1, "ferret_sera_escape": null, "mature_H5_site": 45, "mouse_sera_escape": null, "mutant": "R", "mutation": "N54aR", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.05747, "ferret_sera_escape": null, "mature_H5_site": 45, "mouse_sera_escape": null, "mutant": "S", "mutation": "N54aS", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4735, "ferret_sera_escape": -0.03226, "mature_H5_site": 45, "mouse_sera_escape": 0.01329, "mutant": "T", "mutation": "N54aT", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 0.9699, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -1.427, "ferret_sera_escape": null, "mature_H5_site": 45, "mouse_sera_escape": null, "mutant": "V", "mutation": "N54aV", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.472, "ferret_sera_escape": -0.03987, "mature_H5_site": 45, "mouse_sera_escape": -0.04295, "mutant": "W", "mutation": "N54aW", "reference_site": "54a", "region": "HA1", "sequential_site": 61, "stability": 0.1935, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.19, "ferret_sera_escape": 0.004011, "mature_H5_site": 46, "mouse_sera_escape": -0.1486, "mutant": "A", "mutation": "G55A", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.64, "ferret_sera_escape": 0.09657, "mature_H5_site": 46, "mouse_sera_escape": 0.218, "mutant": "C", "mutation": "G55C", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.03427, "ferret_sera_escape": 0.01877, "mature_H5_site": 46, "mouse_sera_escape": -0.01744, "mutant": "D", "mutation": "G55D", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": 0.01511, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4624, "ferret_sera_escape": -0.0467, "mature_H5_site": 46, "mouse_sera_escape": 0.04184, "mutant": "E", "mutation": "G55E", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.05817, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.03283, "ferret_sera_escape": 0.03549, "mature_H5_site": 46, "mouse_sera_escape": 0.06226, "mutant": "F", "mutation": "G55F", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.05752, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 46, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G55G", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.3858, "cell_entry": -0.3432, "ferret_sera_escape": 0.05976, "mature_H5_site": 46, "mouse_sera_escape": 0.005385, "mutant": "H", "mutation": "G55H", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.05903, "wildtype": "G"}, {"a26_usage": null, "cell_entry": -5.84, "ferret_sera_escape": null, "mature_H5_site": 46, "mouse_sera_escape": null, "mutant": "I", "mutation": "G55I", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.4657, "ferret_sera_escape": null, "mature_H5_site": 46, "mouse_sera_escape": null, "mutant": "K", "mutation": "G55K", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": null, "wildtype": "G"}, {"a26_usage": 0.7992, "cell_entry": -0.8, "ferret_sera_escape": -0.002113, "mature_H5_site": 46, "mouse_sera_escape": 0.05505, "mutant": "L", "mutation": "G55L", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.08646, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.07944, "ferret_sera_escape": -0.07824, "mature_H5_site": 46, "mouse_sera_escape": -0.06517, "mutant": "M", "mutation": "G55M", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.03099, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.976, "ferret_sera_escape": null, "mature_H5_site": 46, "mouse_sera_escape": null, "mutant": "P", "mutation": "G55P", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.02873, "ferret_sera_escape": null, "mature_H5_site": 46, "mouse_sera_escape": null, "mutant": "Q", "mutation": "G55Q", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.04183, "ferret_sera_escape": 0.062, "mature_H5_site": 46, "mouse_sera_escape": 0.04438, "mutant": "R", "mutation": "G55R", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.08027, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.6783, "ferret_sera_escape": -0.02597, "mature_H5_site": 46, "mouse_sera_escape": 0.05505, "mutant": "T", "mutation": "G55T", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.1702, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 46, "mouse_sera_escape": null, "mutant": "V", "mutation": "G55V", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.1528, "ferret_sera_escape": -0.06756, "mature_H5_site": 46, "mouse_sera_escape": 0.143, "mutant": "W", "mutation": "G55W", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": -0.007577, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.234, "ferret_sera_escape": null, "mature_H5_site": 46, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G55Y", "reference_site": "55", "region": "HA1", "sequential_site": 62, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.159, "ferret_sera_escape": -0.2644, "mature_H5_site": 551, "mouse_sera_escape": -0.2386, "mutant": "A", "mutation": "I550A", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": 0.4021, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.053, "ferret_sera_escape": -0.1035, "mature_H5_site": 551, "mouse_sera_escape": -0.01742, "mutant": "C", "mutation": "I550C", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": 0.2266, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.322, "ferret_sera_escape": null, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "D", "mutation": "I550D", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.861, "ferret_sera_escape": null, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "E", "mutation": "I550E", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.556, "ferret_sera_escape": 0.03118, "mature_H5_site": 551, "mouse_sera_escape": -0.03664, "mutant": "F", "mutation": "I550F", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.117, "ferret_sera_escape": -0.334, "mature_H5_site": 551, "mouse_sera_escape": -0.31, "mutant": "G", "mutation": "I550G", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": 0.3258, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 551, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I550I", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.091, "ferret_sera_escape": -0.4243, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "K", "mutation": "I550K", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": 0.4274, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2315, "ferret_sera_escape": -0.1686, "mature_H5_site": 551, "mouse_sera_escape": -0.06272, "mutant": "L", "mutation": "I550L", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": -0.02661, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.441, "ferret_sera_escape": null, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "P", "mutation": "I550P", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.671, "ferret_sera_escape": -0.2406, "mature_H5_site": 551, "mouse_sera_escape": -0.2331, "mutant": "Q", "mutation": "I550Q", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.968, "ferret_sera_escape": null, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "R", "mutation": "I550R", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.457, "ferret_sera_escape": -0.1842, "mature_H5_site": 551, "mouse_sera_escape": -0.3619, "mutant": "S", "mutation": "I550S", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": 0.3478, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.24, "ferret_sera_escape": null, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "T", "mutation": "I550T", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.5749, "ferret_sera_escape": 0.02231, "mature_H5_site": 551, "mouse_sera_escape": -0.04674, "mutant": "V", "mutation": "I550V", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": 0.07083, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.091, "ferret_sera_escape": null, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "W", "mutation": "I550W", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.306, "ferret_sera_escape": null, "mature_H5_site": 551, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I550Y", "reference_site": "550", "region": "HA2", "sequential_site": 567, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2791, "ferret_sera_escape": -0.00816, "mature_H5_site": 47, "mouse_sera_escape": -0.01906, "mutant": "A", "mutation": "V56A", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": 0.6075, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.04159, "ferret_sera_escape": -0.1572, "mature_H5_site": 47, "mouse_sera_escape": 0.04327, "mutant": "C", "mutation": "V56C", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.1564, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6607, "ferret_sera_escape": null, "mature_H5_site": 47, "mouse_sera_escape": null, "mutant": "E", "mutation": "V56E", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.597, "ferret_sera_escape": -0.01965, "mature_H5_site": 47, "mouse_sera_escape": 0.01713, "mutant": "F", "mutation": "V56F", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.1139, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6441, "ferret_sera_escape": 0.07279, "mature_H5_site": 47, "mouse_sera_escape": 0.107, "mutant": "G", "mutation": "V56G", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.09259, "wildtype": "V"}, {"a26_usage": 0.2024, "cell_entry": -0.2024, "ferret_sera_escape": 0.06058, "mature_H5_site": 47, "mouse_sera_escape": 0.05137, "mutant": "H", "mutation": "V56H", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.06264, "wildtype": "V"}, {"a26_usage": 0.02382, "cell_entry": 0.07137, "ferret_sera_escape": 0.1043, "mature_H5_site": 47, "mouse_sera_escape": -0.09101, "mutant": "I", "mutation": "V56I", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.1295, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.03821, "ferret_sera_escape": -0.02729, "mature_H5_site": 47, "mouse_sera_escape": -0.01838, "mutant": "K", "mutation": "V56K", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.4008, "wildtype": "V"}, {"a26_usage": 0.00573, "cell_entry": 0.005785, "ferret_sera_escape": -0.04317, "mature_H5_site": 47, "mouse_sera_escape": -0.07839, "mutant": "L", "mutation": "V56L", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.1666, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7313, "ferret_sera_escape": 0.0167, "mature_H5_site": 47, "mouse_sera_escape": 0.03699, "mutant": "N", "mutation": "V56N", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.1717, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 47, "mouse_sera_escape": null, "mutant": "P", "mutation": "V56P", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.00104, "ferret_sera_escape": -0.12, "mature_H5_site": 47, "mouse_sera_escape": -0.1321, "mutant": "Q", "mutation": "V56Q", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.0374, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8235, "ferret_sera_escape": 0.002975, "mature_H5_site": 47, "mouse_sera_escape": -0.03704, "mutant": "R", "mutation": "V56R", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.2486, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.04526, "ferret_sera_escape": -0.04823, "mature_H5_site": 47, "mouse_sera_escape": -0.01716, "mutant": "S", "mutation": "V56S", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": 1.531, "wildtype": "V"}, {"a26_usage": 0.09408, "cell_entry": -1.171, "ferret_sera_escape": -0.2128, "mature_H5_site": 47, "mouse_sera_escape": null, "mutant": "T", "mutation": "V56T", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.0506, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 47, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V56V", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1713, "ferret_sera_escape": -0.06065, "mature_H5_site": 47, "mouse_sera_escape": 0.01732, "mutant": "W", "mutation": "V56W", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.4468, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.06962, "ferret_sera_escape": -0.03541, "mature_H5_site": 47, "mouse_sera_escape": -0.001277, "mutant": "Y", "mutation": "V56Y", "reference_site": "56", "region": "HA1", "sequential_site": 63, "stability": -0.08799, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.07165, "ferret_sera_escape": -0.01859, "mature_H5_site": 48, "mouse_sera_escape": -0.02194, "mutant": "A", "mutation": "K57A", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 0.5823, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3998, "ferret_sera_escape": null, "mature_H5_site": 48, "mouse_sera_escape": null, "mutant": "C", "mutation": "K57C", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.938, "ferret_sera_escape": null, "mature_H5_site": 48, "mouse_sera_escape": null, "mutant": "D", "mutation": "K57D", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04136, "ferret_sera_escape": 0.04256, "mature_H5_site": 48, "mouse_sera_escape": 0.1967, "mutant": "E", "mutation": "K57E", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 1.773, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.708, "ferret_sera_escape": null, "mature_H5_site": 48, "mouse_sera_escape": null, "mutant": "F", "mutation": "K57F", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1721, "ferret_sera_escape": 0.1041, "mature_H5_site": 48, "mouse_sera_escape": 0.2271, "mutant": "G", "mutation": "K57G", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 1.583, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.7405, "ferret_sera_escape": -0.05997, "mature_H5_site": 48, "mouse_sera_escape": 0.01367, "mutant": "H", "mutation": "K57H", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 0.06808, "wildtype": "K"}, {"a26_usage": 0.4927, "cell_entry": -0.5732, "ferret_sera_escape": -0.228, "mature_H5_site": 48, "mouse_sera_escape": 0.09202, "mutant": "I", "mutation": "K57I", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 1.351, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 48, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K57K", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.13, "ferret_sera_escape": -0.09753, "mature_H5_site": 48, "mouse_sera_escape": 0.1495, "mutant": "L", "mutation": "K57L", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 0.7947, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.4456, "ferret_sera_escape": null, "mature_H5_site": 48, "mouse_sera_escape": null, "mutant": "N", "mutation": "K57N", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.173, "ferret_sera_escape": 0.1718, "mature_H5_site": 48, "mouse_sera_escape": 0.161, "mutant": "P", "mutation": "K57P", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.00593, "ferret_sera_escape": 0.002733, "mature_H5_site": 48, "mouse_sera_escape": 0.1647, "mutant": "Q", "mutation": "K57Q", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 1.502, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.6365, "ferret_sera_escape": 0.02305, "mature_H5_site": 48, "mouse_sera_escape": -0.06856, "mutant": "R", "mutation": "K57R", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 0.7983, "wildtype": "K"}, {"a26_usage": null, "cell_entry": -0.8016, "ferret_sera_escape": 0.01726, "mature_H5_site": 48, "mouse_sera_escape": 0.05666, "mutant": "S", "mutation": "K57S", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": 0.5816, "wildtype": "K"}, {"a26_usage": 0.3178, "cell_entry": 0.0466, "ferret_sera_escape": null, "mature_H5_site": 48, "mouse_sera_escape": null, "mutant": "T", "mutation": "K57T", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.621, "ferret_sera_escape": -0.4798, "mature_H5_site": 48, "mouse_sera_escape": 0.2599, "mutant": "W", "mutation": "K57W", "reference_site": "57", "region": "HA1", "sequential_site": 64, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2162, "ferret_sera_escape": -0.0813, "mature_H5_site": 49, "mouse_sera_escape": -0.00979, "mutant": "A", "mutation": "P58A", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "C", "mutation": "P58C", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.965, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "D", "mutation": "P58D", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "E", "mutation": "P58E", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.893, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "G", "mutation": "P58G", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "H", "mutation": "P58H", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.955, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "I", "mutation": "P58I", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "K", "mutation": "P58K", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.044, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "L", "mutation": "P58L", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.018, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "M", "mutation": "P58M", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "N", "mutation": "P58N", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 49, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P58P", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -6.016, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P58Q", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.863, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "R", "mutation": "P58R", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.99, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "S", "mutation": "P58S", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.797, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "T", "mutation": "P58T", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "W", "mutation": "P58W", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.733, "ferret_sera_escape": null, "mature_H5_site": 49, "mouse_sera_escape": null, "mutant": "Y", "mutation": "P58Y", "reference_site": "58", "region": "HA1", "sequential_site": 65, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.536, "ferret_sera_escape": -0.0673, "mature_H5_site": 50, "mouse_sera_escape": 0.2377, "mutant": "A", "mutation": "L59A", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.981, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "D", "mutation": "L59D", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "E", "mutation": "L59E", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2665, "ferret_sera_escape": 0.08708, "mature_H5_site": 50, "mouse_sera_escape": 0.3262, "mutant": "F", "mutation": "L59F", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": -0.01653, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.655, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "G", "mutation": "L59G", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.67, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "K", "mutation": "L59K", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 50, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L59L", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.09156, "ferret_sera_escape": 0.1712, "mature_H5_site": 50, "mouse_sera_escape": 0.3182, "mutant": "M", "mutation": "L59M", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": 0.2013, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.686, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "N", "mutation": "L59N", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.032, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "P", "mutation": "L59P", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.495, "ferret_sera_escape": -0.0779, "mature_H5_site": 50, "mouse_sera_escape": 0.3232, "mutant": "Q", "mutation": "L59Q", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": 0.7829, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.378, "ferret_sera_escape": 0.02459, "mature_H5_site": 50, "mouse_sera_escape": 0.414, "mutant": "R", "mutation": "L59R", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.777, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "S", "mutation": "L59S", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.266, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "T", "mutation": "L59T", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5635, "ferret_sera_escape": 0.1626, "mature_H5_site": 50, "mouse_sera_escape": 0.2518, "mutant": "V", "mutation": "L59V", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": -0.333, "wildtype": "L"}, {"a26_usage": 0.22, "cell_entry": -0.2226, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "W", "mutation": "L59W", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0897, "cell_entry": -0.03099, "ferret_sera_escape": null, "mature_H5_site": 50, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L59Y", "reference_site": "59", "region": "HA1", "sequential_site": 66, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5858, "ferret_sera_escape": 0.02391, "mature_H5_site": -5, "mouse_sera_escape": -0.08309, "mutant": "A", "mutation": "S6A", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.02374, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.01632, "ferret_sera_escape": 0.008693, "mature_H5_site": -5, "mouse_sera_escape": -0.0207, "mutant": "C", "mutation": "S6C", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.01022, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3197, "ferret_sera_escape": -0.04338, "mature_H5_site": -5, "mouse_sera_escape": 0.05026, "mutant": "D", "mutation": "S6D", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.06467, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.03886, "ferret_sera_escape": -0.03253, "mature_H5_site": -5, "mouse_sera_escape": -0.07238, "mutant": "E", "mutation": "S6E", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.1117, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.778, "ferret_sera_escape": null, "mature_H5_site": -5, "mouse_sera_escape": null, "mutant": "F", "mutation": "S6F", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.569, "ferret_sera_escape": 0.0298, "mature_H5_site": -5, "mouse_sera_escape": 0.04543, "mutant": "H", "mutation": "S6H", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": 0.001495, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.428, "ferret_sera_escape": null, "mature_H5_site": -5, "mouse_sera_escape": null, "mutant": "I", "mutation": "S6I", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.7833, "ferret_sera_escape": 0.00223, "mature_H5_site": -5, "mouse_sera_escape": -0.07554, "mutant": "K", "mutation": "S6K", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.1063, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.873, "ferret_sera_escape": null, "mature_H5_site": -5, "mouse_sera_escape": null, "mutant": "L", "mutation": "S6L", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.4491, "ferret_sera_escape": -0.2004, "mature_H5_site": -5, "mouse_sera_escape": -0.03534, "mutant": "M", "mutation": "S6M", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.1886, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.643, "ferret_sera_escape": null, "mature_H5_site": -5, "mouse_sera_escape": null, "mutant": "N", "mutation": "S6N", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3704, "ferret_sera_escape": -0.1131, "mature_H5_site": -5, "mouse_sera_escape": -0.1348, "mutant": "P", "mutation": "S6P", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.1384, "wildtype": "S"}, {"a26_usage": 0.3168, "cell_entry": -0.2005, "ferret_sera_escape": -0.01935, "mature_H5_site": -5, "mouse_sera_escape": 0.003384, "mutant": "Q", "mutation": "S6Q", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.05521, "wildtype": "S"}, {"a26_usage": 0.2977, "cell_entry": -0.149, "ferret_sera_escape": -0.09712, "mature_H5_site": -5, "mouse_sera_escape": -0.01473, "mutant": "R", "mutation": "S6R", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.05971, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -5, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S6S", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.06222, "ferret_sera_escape": null, "mature_H5_site": -5, "mouse_sera_escape": null, "mutant": "T", "mutation": "S6T", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1581, "ferret_sera_escape": -0.05078, "mature_H5_site": -5, "mouse_sera_escape": 0.03246, "mutant": "V", "mutation": "S6V", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": -0.3199, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.3823, "ferret_sera_escape": null, "mature_H5_site": -5, "mouse_sera_escape": null, "mutant": "W", "mutation": "S6W", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1547, "ferret_sera_escape": null, "mature_H5_site": -5, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S6Y", "reference_site": "6", "region": "HA1", "sequential_site": 12, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.736, "ferret_sera_escape": -0.04662, "mature_H5_site": 51, "mouse_sera_escape": 0.2298, "mutant": "A", "mutation": "I60A", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": 0.04208, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.9248, "ferret_sera_escape": 0.4594, "mature_H5_site": 51, "mouse_sera_escape": 0.4198, "mutant": "C", "mutation": "I60C", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.8294, "ferret_sera_escape": 0.0309, "mature_H5_site": 51, "mouse_sera_escape": 0.2008, "mutant": "F", "mutation": "I60F", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": 0.03614, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.018, "ferret_sera_escape": null, "mature_H5_site": 51, "mouse_sera_escape": null, "mutant": "G", "mutation": "I60G", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.888, "ferret_sera_escape": -0.03126, "mature_H5_site": 51, "mouse_sera_escape": 0.2491, "mutant": "H", "mutation": "I60H", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 51, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I60I", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.875, "ferret_sera_escape": null, "mature_H5_site": 51, "mouse_sera_escape": null, "mutant": "K", "mutation": "I60K", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.206, "ferret_sera_escape": null, "mature_H5_site": 51, "mouse_sera_escape": null, "mutant": "N", "mutation": "I60N", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.579, "ferret_sera_escape": null, "mature_H5_site": 51, "mouse_sera_escape": null, "mutant": "P", "mutation": "I60P", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.633, "ferret_sera_escape": -0.1783, "mature_H5_site": 51, "mouse_sera_escape": null, "mutant": "R", "mutation": "I60R", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.073, "ferret_sera_escape": null, "mature_H5_site": 51, "mouse_sera_escape": null, "mutant": "S", "mutation": "I60S", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3814, "ferret_sera_escape": null, "mature_H5_site": 51, "mouse_sera_escape": null, "mutant": "T", "mutation": "I60T", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.794, "ferret_sera_escape": 0.1144, "mature_H5_site": 51, "mouse_sera_escape": 0.07242, "mutant": "V", "mutation": "I60V", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.9885, "ferret_sera_escape": 0.07788, "mature_H5_site": 51, "mouse_sera_escape": 0.1646, "mutant": "W", "mutation": "I60W", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": -0.06035, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.458, "ferret_sera_escape": -0.007833, "mature_H5_site": 51, "mouse_sera_escape": 0.4154, "mutant": "Y", "mutation": "I60Y", "reference_site": "60", "region": "HA1", "sequential_site": 67, "stability": -0.09065, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.892, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "A", "mutation": "L61A", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.894, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "D", "mutation": "L61D", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "E", "mutation": "L61E", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.606, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "G", "mutation": "L61G", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.89, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "H", "mutation": "L61H", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "K", "mutation": "L61K", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 52, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L61L", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.599, "ferret_sera_escape": -0.2107, "mature_H5_site": 52, "mouse_sera_escape": 0.4235, "mutant": "M", "mutation": "L61M", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": 1.135, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.877, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "N", "mutation": "L61N", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "P", "mutation": "L61P", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.322, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L61Q", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.401, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "R", "mutation": "L61R", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.004, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "T", "mutation": "L61T", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.828, "ferret_sera_escape": -0.3912, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "V", "mutation": "L61V", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": 2.154, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "W", "mutation": "L61W", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.496, "ferret_sera_escape": null, "mature_H5_site": 52, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L61Y", "reference_site": "61", "region": "HA1", "sequential_site": 68, "stability": null, "wildtype": "L"}, {"a26_usage": 0.2103, "cell_entry": -0.3787, "ferret_sera_escape": -0.03482, "mature_H5_site": 53, "mouse_sera_escape": 0.1572, "mutant": "A", "mutation": "K62A", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 0.5095, "wildtype": "K"}, {"a26_usage": 0.3012, "cell_entry": -0.5895, "ferret_sera_escape": null, "mature_H5_site": 53, "mouse_sera_escape": null, "mutant": "C", "mutation": "K62C", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": null, "wildtype": "K"}, {"a26_usage": 0.544, "cell_entry": -0.6194, "ferret_sera_escape": -0.1863, "mature_H5_site": 53, "mouse_sera_escape": 0.1895, "mutant": "E", "mutation": "K62E", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 1.505, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2031, "ferret_sera_escape": -0.2362, "mature_H5_site": 53, "mouse_sera_escape": 0.1205, "mutant": "G", "mutation": "K62G", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 0.2384, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.02072, "ferret_sera_escape": null, "mature_H5_site": 53, "mouse_sera_escape": null, "mutant": "H", "mutation": "K62H", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1461, "ferret_sera_escape": -0.02224, "mature_H5_site": 53, "mouse_sera_escape": 0.7219, "mutant": "I", "mutation": "K62I", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 53, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K62K", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.584, "ferret_sera_escape": -0.1328, "mature_H5_site": 53, "mouse_sera_escape": 0.3492, "mutant": "L", "mutation": "K62L", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2155, "ferret_sera_escape": -0.1998, "mature_H5_site": 53, "mouse_sera_escape": 0.07909, "mutant": "M", "mutation": "K62M", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 0.7379, "wildtype": "K"}, {"a26_usage": 0.1345, "cell_entry": -0.1051, "ferret_sera_escape": -0.06532, "mature_H5_site": 53, "mouse_sera_escape": 0.2143, "mutant": "N", "mutation": "K62N", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": -0.1027, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.724, "ferret_sera_escape": -0.3693, "mature_H5_site": 53, "mouse_sera_escape": 0.6755, "mutant": "P", "mutation": "K62P", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.004185, "ferret_sera_escape": -0.00694, "mature_H5_site": 53, "mouse_sera_escape": 0.1509, "mutant": "R", "mutation": "K62R", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 0.1848, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.1897, "ferret_sera_escape": null, "mature_H5_site": 53, "mouse_sera_escape": null, "mutant": "S", "mutation": "K62S", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3188, "ferret_sera_escape": -0.2555, "mature_H5_site": 53, "mouse_sera_escape": 0.2395, "mutant": "T", "mutation": "K62T", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 1.534, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.3853, "ferret_sera_escape": -0.1277, "mature_H5_site": 53, "mouse_sera_escape": 0.4231, "mutant": "W", "mutation": "K62W", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 1.067, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.5438, "ferret_sera_escape": -0.04776, "mature_H5_site": 53, "mouse_sera_escape": 0.4437, "mutant": "Y", "mutation": "K62Y", "reference_site": "62", "region": "region-E", "sequential_site": 69, "stability": 1.357, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.433, "ferret_sera_escape": -0.1744, "mature_H5_site": 54, "mouse_sera_escape": 0.006536, "mutant": "A", "mutation": "D63A", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": -0.1776, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.06985, "ferret_sera_escape": -0.1425, "mature_H5_site": 54, "mouse_sera_escape": 0.2885, "mutant": "C", "mutation": "D63C", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": 0.07007, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 54, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D63D", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.06502, "ferret_sera_escape": 0.03186, "mature_H5_site": 54, "mouse_sera_escape": 0.06569, "mutant": "E", "mutation": "D63E", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": -0.3004, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.022, "ferret_sera_escape": 0.1418, "mature_H5_site": 54, "mouse_sera_escape": 0.3055, "mutant": "G", "mutation": "D63G", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": -0.03334, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.03997, "ferret_sera_escape": -0.1336, "mature_H5_site": 54, "mouse_sera_escape": -0.03243, "mutant": "H", "mutation": "D63H", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": -0.2683, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -4.183, "ferret_sera_escape": null, "mature_H5_site": 54, "mouse_sera_escape": null, "mutant": "I", "mutation": "D63I", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5555, "ferret_sera_escape": -0.1182, "mature_H5_site": 54, "mouse_sera_escape": 0.2177, "mutant": "K", "mutation": "D63K", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": 0.4305, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.0177, "ferret_sera_escape": -0.2387, "mature_H5_site": 54, "mouse_sera_escape": -0.02605, "mutant": "M", "mutation": "D63M", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": -0.1317, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1133, "ferret_sera_escape": -0.1989, "mature_H5_site": 54, "mouse_sera_escape": 0.0553, "mutant": "N", "mutation": "D63N", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": -0.1598, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.553, "ferret_sera_escape": null, "mature_H5_site": 54, "mouse_sera_escape": null, "mutant": "P", "mutation": "D63P", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.09643, "ferret_sera_escape": -0.1895, "mature_H5_site": 54, "mouse_sera_escape": -0.04479, "mutant": "Q", "mutation": "D63Q", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5269, "ferret_sera_escape": null, "mature_H5_site": 54, "mouse_sera_escape": null, "mutant": "R", "mutation": "D63R", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": null, "wildtype": "D"}, {"a26_usage": 0.3448, "cell_entry": -0.1572, "ferret_sera_escape": -0.01979, "mature_H5_site": 54, "mouse_sera_escape": 0.00411, "mutant": "S", "mutation": "D63S", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": -0.1181, "wildtype": "D"}, {"a26_usage": null, "cell_entry": -0.4875, "ferret_sera_escape": null, "mature_H5_site": 54, "mouse_sera_escape": null, "mutant": "T", "mutation": "D63T", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.287, "ferret_sera_escape": -0.3556, "mature_H5_site": 54, "mouse_sera_escape": null, "mutant": "V", "mutation": "D63V", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": 0.7025, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2922, "ferret_sera_escape": -0.0433, "mature_H5_site": 54, "mouse_sera_escape": 0.08071, "mutant": "W", "mutation": "D63W", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8444, "ferret_sera_escape": -0.2765, "mature_H5_site": 54, "mouse_sera_escape": 0.0941, "mutant": "Y", "mutation": "D63Y", "reference_site": "63", "region": "region-E", "sequential_site": 70, "stability": 0.4857, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.022, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "A", "mutation": "C64A", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 55, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C64C", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "D", "mutation": "C64D", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.668, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "E", "mutation": "C64E", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.988, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "F", "mutation": "C64F", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.997, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "G", "mutation": "C64G", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "K", "mutation": "C64K", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "L", "mutation": "C64L", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "M", "mutation": "C64M", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.026, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "N", "mutation": "C64N", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "P", "mutation": "C64P", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.951, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C64Q", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.752, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "R", "mutation": "C64R", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.594, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "S", "mutation": "C64S", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "T", "mutation": "C64T", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "V", "mutation": "C64V", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "W", "mutation": "C64W", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.943, "ferret_sera_escape": null, "mature_H5_site": 55, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C64Y", "reference_site": "64", "region": "region-E", "sequential_site": 71, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -1.616, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "A", "mutation": "S65A", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "C", "mutation": "S65C", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.3, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "D", "mutation": "S65D", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.969, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "E", "mutation": "S65E", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.2333, "ferret_sera_escape": 0.3734, "mature_H5_site": 56, "mouse_sera_escape": 0.4911, "mutant": "G", "mutation": "S65G", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": 1.436, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.855, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "I", "mutation": "S65I", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.632, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "K", "mutation": "S65K", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.701, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "L", "mutation": "S65L", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "M", "mutation": "S65M", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -2.102, "ferret_sera_escape": -0.1516, "mature_H5_site": 56, "mouse_sera_escape": 0.7722, "mutant": "N", "mutation": "S65N", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": 1.041, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "P", "mutation": "S65P", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "Q", "mutation": "S65Q", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "R", "mutation": "S65R", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 56, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S65S", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.986, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "V", "mutation": "S65V", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.863, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "W", "mutation": "S65W", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.513, "ferret_sera_escape": null, "mature_H5_site": 56, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S65Y", "reference_site": "65", "region": "region-E", "sequential_site": 72, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.934, "ferret_sera_escape": null, "mature_H5_site": 57, "mouse_sera_escape": null, "mutant": "D", "mutation": "V66D", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.696, "ferret_sera_escape": -0.4908, "mature_H5_site": 57, "mouse_sera_escape": -0.002361, "mutant": "F", "mutation": "V66F", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": 1.273, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.652, "ferret_sera_escape": null, "mature_H5_site": 57, "mouse_sera_escape": null, "mutant": "G", "mutation": "V66G", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5702, "ferret_sera_escape": 0.01875, "mature_H5_site": 57, "mouse_sera_escape": -0.01928, "mutant": "I", "mutation": "V66I", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": -0.1788, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.975, "ferret_sera_escape": null, "mature_H5_site": 57, "mouse_sera_escape": null, "mutant": "K", "mutation": "V66K", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.322, "ferret_sera_escape": -0.3046, "mature_H5_site": 57, "mouse_sera_escape": -0.09018, "mutant": "L", "mutation": "V66L", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": 1.49, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.5219, "ferret_sera_escape": -0.2045, "mature_H5_site": 57, "mouse_sera_escape": 0.09376, "mutant": "M", "mutation": "V66M", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": 1.407, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.927, "ferret_sera_escape": null, "mature_H5_site": 57, "mouse_sera_escape": null, "mutant": "N", "mutation": "V66N", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": null, "wildtype": "V"}, {"a26_usage": null, "cell_entry": 0.06935, "ferret_sera_escape": -0.09004, "mature_H5_site": 57, "mouse_sera_escape": -0.1215, "mutant": "P", "mutation": "V66P", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": -0.1265, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.968, "ferret_sera_escape": null, "mature_H5_site": 57, "mouse_sera_escape": null, "mutant": "R", "mutation": "V66R", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.577, "ferret_sera_escape": -0.121, "mature_H5_site": 57, "mouse_sera_escape": -0.02639, "mutant": "S", "mutation": "V66S", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": null, "wildtype": "V"}, {"a26_usage": 0.4886, "cell_entry": -0.08569, "ferret_sera_escape": 0.06963, "mature_H5_site": 57, "mouse_sera_escape": 0.1539, "mutant": "T", "mutation": "V66T", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": 0.7787, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 57, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V66V", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.671, "ferret_sera_escape": -0.1499, "mature_H5_site": 57, "mouse_sera_escape": 0.08761, "mutant": "Y", "mutation": "V66Y", "reference_site": "66", "region": "HA1", "sequential_site": 73, "stability": -0.1587, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 58, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A67A", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2758, "ferret_sera_escape": -0.1438, "mature_H5_site": 58, "mouse_sera_escape": 0.07305, "mutant": "D", "mutation": "A67D", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": 0.7784, "wildtype": "A"}, {"a26_usage": 0.143, "cell_entry": 0.01528, "ferret_sera_escape": -0.2151, "mature_H5_site": 58, "mouse_sera_escape": -0.05378, "mutant": "E", "mutation": "A67E", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": 0.9902, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.007, "ferret_sera_escape": -0.309, "mature_H5_site": 58, "mouse_sera_escape": 0.02903, "mutant": "F", "mutation": "A67F", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.07248, "ferret_sera_escape": 0.1896, "mature_H5_site": 58, "mouse_sera_escape": 0.3088, "mutant": "G", "mutation": "A67G", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": 1.123, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1648, "ferret_sera_escape": 0.1001, "mature_H5_site": 58, "mouse_sera_escape": 0.02667, "mutant": "H", "mutation": "A67H", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": -0.1972, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.615, "ferret_sera_escape": null, "mature_H5_site": 58, "mouse_sera_escape": null, "mutant": "I", "mutation": "A67I", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.442, "ferret_sera_escape": -0.3139, "mature_H5_site": 58, "mouse_sera_escape": -0.1918, "mutant": "K", "mutation": "A67K", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -2.125, "ferret_sera_escape": -0.2841, "mature_H5_site": 58, "mouse_sera_escape": -0.1758, "mutant": "L", "mutation": "A67L", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": -0.1967, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3121, "ferret_sera_escape": -0.4841, "mature_H5_site": 58, "mouse_sera_escape": -0.2866, "mutant": "M", "mutation": "A67M", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": -0.2438, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.8889, "ferret_sera_escape": -0.3201, "mature_H5_site": 58, "mouse_sera_escape": -0.1738, "mutant": "N", "mutation": "A67N", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": -0.1847, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2518, "ferret_sera_escape": -0.08807, "mature_H5_site": 58, "mouse_sera_escape": -0.003304, "mutant": "Q", "mutation": "A67Q", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": 1.157, "wildtype": "A"}, {"a26_usage": 0.1985, "cell_entry": 0.06757, "ferret_sera_escape": -0.1329, "mature_H5_site": 58, "mouse_sera_escape": -0.1357, "mutant": "R", "mutation": "A67R", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": 0.4634, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2181, "ferret_sera_escape": -0.01612, "mature_H5_site": 58, "mouse_sera_escape": -0.02439, "mutant": "S", "mutation": "A67S", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": -0.2217, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -3.87, "ferret_sera_escape": 0.0408, "mature_H5_site": 58, "mouse_sera_escape": -0.06765, "mutant": "T", "mutation": "A67T", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.9566, "ferret_sera_escape": -0.1212, "mature_H5_site": 58, "mouse_sera_escape": -0.1128, "mutant": "V", "mutation": "A67V", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": -0.2119, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.974, "ferret_sera_escape": null, "mature_H5_site": 58, "mouse_sera_escape": null, "mutant": "W", "mutation": "A67W", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.144, "ferret_sera_escape": null, "mature_H5_site": 58, "mouse_sera_escape": null, "mutant": "Y", "mutation": "A67Y", "reference_site": "67", "region": "HA1", "sequential_site": 74, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "C", "mutation": "G68C", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.995, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "D", "mutation": "G68D", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "E", "mutation": "G68E", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.768, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "F", "mutation": "G68F", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 59, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G68G", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.074, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "H", "mutation": "G68H", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.039, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "I", "mutation": "G68I", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.932, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "K", "mutation": "G68K", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.01, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "L", "mutation": "G68L", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -4.885, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "M", "mutation": "G68M", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "N", "mutation": "G68N", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "P", "mutation": "G68P", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.0, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "R", "mutation": "G68R", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.8814, "ferret_sera_escape": -0.3734, "mature_H5_site": 59, "mouse_sera_escape": 0.3833, "mutant": "S", "mutation": "G68S", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": 1.139, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -3.266, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "T", "mutation": "G68T", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.937, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "V", "mutation": "G68V", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "W", "mutation": "G68W", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 59, "mouse_sera_escape": null, "mutant": "Y", "mutation": "G68Y", "reference_site": "68", "region": "HA1", "sequential_site": 75, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.426, "ferret_sera_escape": 0.05604, "mature_H5_site": 60, "mouse_sera_escape": 0.6608, "mutant": "A", "mutation": "W69A", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": 1.962, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "D", "mutation": "W69D", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.889, "ferret_sera_escape": null, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "E", "mutation": "W69E", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.6777, "cell_entry": -0.6725, "ferret_sera_escape": -0.07382, "mature_H5_site": 60, "mouse_sera_escape": 0.3714, "mutant": "F", "mutation": "W69F", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": 0.8549, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.615, "ferret_sera_escape": null, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "H", "mutation": "W69H", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -1.392, "ferret_sera_escape": 0.2585, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "I", "mutation": "W69I", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "K", "mutation": "W69K", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -2.687, "ferret_sera_escape": 0.2357, "mature_H5_site": 60, "mouse_sera_escape": 0.5515, "mutant": "L", "mutation": "W69L", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": 0.8241, "wildtype": "W"}, {"a26_usage": 0.8409, "cell_entry": -0.4942, "ferret_sera_escape": 0.2727, "mature_H5_site": 60, "mouse_sera_escape": 0.3714, "mutant": "M", "mutation": "W69M", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": 0.7177, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.752, "ferret_sera_escape": null, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "N", "mutation": "W69N", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "P", "mutation": "W69P", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 60, "mouse_sera_escape": null, "mutant": "R", "mutation": "W69R", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 60, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W69W", "reference_site": "69", "region": "HA1", "sequential_site": 76, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -0.06333, "ferret_sera_escape": -0.04663, "mature_H5_site": -4, "mouse_sera_escape": -0.03246, "mutant": "A", "mutation": "L7A", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.0367, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06154, "ferret_sera_escape": -0.1037, "mature_H5_site": -4, "mouse_sera_escape": -0.01014, "mutant": "C", "mutation": "L7C", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": 0.06221, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.361, "ferret_sera_escape": null, "mature_H5_site": -4, "mouse_sera_escape": null, "mutant": "D", "mutation": "L7D", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.682, "ferret_sera_escape": null, "mature_H5_site": -4, "mouse_sera_escape": null, "mutant": "E", "mutation": "L7E", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1975, "ferret_sera_escape": 0.00554, "mature_H5_site": -4, "mouse_sera_escape": 0.04694, "mutant": "F", "mutation": "L7F", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": 0.02108, "wildtype": "L"}, {"a26_usage": 0.1611, "cell_entry": -0.4309, "ferret_sera_escape": -0.0517, "mature_H5_site": -4, "mouse_sera_escape": -0.08819, "mutant": "G", "mutation": "L7G", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.04793, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.852, "ferret_sera_escape": 0.01347, "mature_H5_site": -4, "mouse_sera_escape": -0.08026, "mutant": "H", "mutation": "L7H", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.1645, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06029, "ferret_sera_escape": 0.08019, "mature_H5_site": -4, "mouse_sera_escape": -0.02588, "mutant": "I", "mutation": "L7I", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.08033, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.435, "ferret_sera_escape": 0.02823, "mature_H5_site": -4, "mouse_sera_escape": -0.04386, "mutant": "K", "mutation": "L7K", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.06201, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -4, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L7L", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.08317, "cell_entry": -0.07169, "ferret_sera_escape": -0.2104, "mature_H5_site": -4, "mouse_sera_escape": 0.02169, "mutant": "M", "mutation": "L7M", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": 0.02411, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.061, "ferret_sera_escape": -0.0703, "mature_H5_site": -4, "mouse_sera_escape": -0.07288, "mutant": "N", "mutation": "L7N", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.682, "ferret_sera_escape": -0.07504, "mature_H5_site": -4, "mouse_sera_escape": -0.2655, "mutant": "P", "mutation": "L7P", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.2922, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1336, "ferret_sera_escape": 0.03865, "mature_H5_site": -4, "mouse_sera_escape": -0.1414, "mutant": "Q", "mutation": "L7Q", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.04259, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.316, "ferret_sera_escape": -0.01596, "mature_H5_site": -4, "mouse_sera_escape": 0.04856, "mutant": "R", "mutation": "L7R", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.0473, "wildtype": "L"}, {"a26_usage": 0.5066, "cell_entry": -0.1081, "ferret_sera_escape": 0.02302, "mature_H5_site": -4, "mouse_sera_escape": -0.015, "mutant": "S", "mutation": "L7S", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.1607, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.05344, "ferret_sera_escape": 0.03521, "mature_H5_site": -4, "mouse_sera_escape": -0.08046, "mutant": "T", "mutation": "L7T", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": 0.01666, "wildtype": "L"}, {"a26_usage": 0.1357, "cell_entry": -0.3272, "ferret_sera_escape": -0.01259, "mature_H5_site": -4, "mouse_sera_escape": -0.07177, "mutant": "W", "mutation": "L7W", "reference_site": "7", "region": "HA1", "sequential_site": 13, "stability": -0.02906, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -4.918, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "A", "mutation": "L70A", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.004, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "C", "mutation": "L70C", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.81, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "D", "mutation": "L70D", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "E", "mutation": "L70E", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.01501, "ferret_sera_escape": -0.1244, "mature_H5_site": 61, "mouse_sera_escape": -0.09554, "mutant": "F", "mutation": "L70F", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2067, "ferret_sera_escape": -0.06712, "mature_H5_site": 61, "mouse_sera_escape": -0.151, "mutant": "I", "mutation": "L70I", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": 1.535, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.341, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "K", "mutation": "L70K", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 61, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L70L", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1828, "ferret_sera_escape": -0.09763, "mature_H5_site": 61, "mouse_sera_escape": -0.1616, "mutant": "M", "mutation": "L70M", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": -0.3008, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.96, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "N", "mutation": "L70N", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.94, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "P", "mutation": "L70P", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.935, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L70Q", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "R", "mutation": "L70R", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.93, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "S", "mutation": "L70S", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.236, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "T", "mutation": "L70T", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.5242, "ferret_sera_escape": -0.17, "mature_H5_site": 61, "mouse_sera_escape": 0.005747, "mutant": "V", "mutation": "L70V", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": 1.643, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "W", "mutation": "L70W", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 61, "mouse_sera_escape": null, "mutant": "Y", "mutation": "L70Y", "reference_site": "70", "region": "HA1", "sequential_site": 77, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "D", "mutation": "L71D", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "E", "mutation": "L71E", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.389, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "F", "mutation": "L71F", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.978, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "G", "mutation": "L71G", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.079, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "H", "mutation": "L71H", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.02275, "ferret_sera_escape": -0.1148, "mature_H5_site": 62, "mouse_sera_escape": -0.04255, "mutant": "I", "mutation": "L71I", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": -0.2741, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "K", "mutation": "L71K", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 62, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L71L", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.05026, "ferret_sera_escape": 0.1284, "mature_H5_site": 62, "mouse_sera_escape": 0.001895, "mutant": "M", "mutation": "L71M", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": -0.05225, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.865, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "N", "mutation": "L71N", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.971, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "P", "mutation": "L71P", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.829, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "Q", "mutation": "L71Q", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "R", "mutation": "L71R", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.077, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "S", "mutation": "L71S", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.03558, "ferret_sera_escape": -0.01686, "mature_H5_site": 62, "mouse_sera_escape": -0.09367, "mutant": "T", "mutation": "L71T", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": -0.2097, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.293, "ferret_sera_escape": -0.3777, "mature_H5_site": 62, "mouse_sera_escape": -0.06395, "mutant": "V", "mutation": "L71V", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": -0.134, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 62, "mouse_sera_escape": null, "mutant": "W", "mutation": "L71W", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.06073, "ferret_sera_escape": -0.304, "mature_H5_site": 62, "mouse_sera_escape": -0.233, "mutant": "Y", "mutation": "L71Y", "reference_site": "71", "region": "HA1", "sequential_site": 78, "stability": -0.2854, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.013, "ferret_sera_escape": 0.08174, "mature_H5_site": 63, "mouse_sera_escape": -0.1052, "mutant": "A", "mutation": "G72A", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.965, "ferret_sera_escape": -0.3571, "mature_H5_site": 63, "mouse_sera_escape": null, "mutant": "C", "mutation": "G72C", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": -0.0969, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.338, "ferret_sera_escape": -0.3527, "mature_H5_site": 63, "mouse_sera_escape": 0.2, "mutant": "D", "mutation": "G72D", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": 1.808, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.219, "ferret_sera_escape": -0.3176, "mature_H5_site": 63, "mouse_sera_escape": 0.6928, "mutant": "E", "mutation": "G72E", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": 1.529, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.643, "ferret_sera_escape": -0.2867, "mature_H5_site": 63, "mouse_sera_escape": -0.3262, "mutant": "F", "mutation": "G72F", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": 0.3479, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 63, "mouse_sera_escape": 0.0, "mutant": "G", "mutation": "G72G", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": 0.0, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.042, "ferret_sera_escape": -0.09539, "mature_H5_site": 63, "mouse_sera_escape": -0.1862, "mutant": "H", "mutation": "G72H", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": 1.172, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -6.001, "ferret_sera_escape": null, "mature_H5_site": 63, "mouse_sera_escape": null, "mutant": "K", "mutation": "G72K", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2557, "ferret_sera_escape": -0.17, "mature_H5_site": 63, "mouse_sera_escape": -0.3164, "mutant": "L", "mutation": "G72L", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": -0.2503, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.2674, "ferret_sera_escape": -0.2161, "mature_H5_site": 63, "mouse_sera_escape": null, "mutant": "M", "mutation": "G72M", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.0276, "ferret_sera_escape": 0.174, "mature_H5_site": 63, "mouse_sera_escape": 0.08254, "mutant": "N", "mutation": "G72N", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": -0.1399, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -5.912, "ferret_sera_escape": null, "mature_H5_site": 63, "mouse_sera_escape": null, "mutant": "P", "mutation": "G72P", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": 0.05225, "ferret_sera_escape": 0.1331, "mature_H5_site": 63, "mouse_sera_escape": -0.02593, "mutant": "Q", "mutation": "G72Q", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": 0.2559, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.881, "ferret_sera_escape": -0.5647, "mature_H5_site": 63, "mouse_sera_escape": 0.1157, "mutant": "R", "mutation": "G72R", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": null, "wildtype": "G"}, {"a26_usage": 0.1762, "cell_entry": 0.003275, "ferret_sera_escape": 0.01064, "mature_H5_site": 63, "mouse_sera_escape": -0.02674, "mutant": "S", "mutation": "G72S", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": 0.5386, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -0.3665, "ferret_sera_escape": -0.1575, "mature_H5_site": 63, "mouse_sera_escape": -0.168, "mutant": "T", "mutation": "G72T", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": -0.1205, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.62, "ferret_sera_escape": -0.09771, "mature_H5_site": 63, "mouse_sera_escape": -0.03313, "mutant": "V", "mutation": "G72V", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -2.663, "ferret_sera_escape": null, "mature_H5_site": 63, "mouse_sera_escape": null, "mutant": "W", "mutation": "G72W", "reference_site": "72", "region": "HA1", "sequential_site": 79, "stability": null, "wildtype": "G"}, {"a26_usage": 0.0, "cell_entry": -1.662, "ferret_sera_escape": -0.1829, "mature_H5_site": 64, "mouse_sera_escape": 0.4092, "mutant": "C", "mutation": "N73C", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": 1.28, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -2.149, "ferret_sera_escape": 0.3016, "mature_H5_site": 64, "mouse_sera_escape": 0.626, "mutant": "D", "mutation": "N73D", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": 0.8173, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.567, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "E", "mutation": "N73E", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.424, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "F", "mutation": "N73F", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -4.495, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "G", "mutation": "N73G", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.006185, "ferret_sera_escape": -0.2072, "mature_H5_site": 64, "mouse_sera_escape": -0.1347, "mutant": "H", "mutation": "N73H", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": 0.3414, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3503, "ferret_sera_escape": -0.3071, "mature_H5_site": 64, "mouse_sera_escape": 0.04362, "mutant": "I", "mutation": "N73I", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.819, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "K", "mutation": "N73K", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6997, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": -0.3946, "mutant": "L", "mutation": "N73L", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 2.421, "cell_entry": -2.942, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "M", "mutation": "N73M", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 64, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N73N", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.492, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "P", "mutation": "N73P", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "R", "mutation": "N73R", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05303, "ferret_sera_escape": 0.2465, "mature_H5_site": 64, "mouse_sera_escape": 0.2993, "mutant": "S", "mutation": "N73S", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.00931, "ferret_sera_escape": 0.1238, "mature_H5_site": 64, "mouse_sera_escape": 0.3714, "mutant": "T", "mutation": "N73T", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": 0.9904, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.06935, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "V", "mutation": "N73V", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 64, "mouse_sera_escape": null, "mutant": "W", "mutation": "N73W", "reference_site": "73", "region": "HA1", "sequential_site": 80, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.344, "ferret_sera_escape": -0.2369, "mature_H5_site": 65, "mouse_sera_escape": -0.1285, "mutant": "A", "mutation": "P74A", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": 0.3172, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.973, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "D", "mutation": "P74D", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.69, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "E", "mutation": "P74E", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.409, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "G", "mutation": "P74G", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.422, "ferret_sera_escape": -0.3585, "mature_H5_site": 65, "mouse_sera_escape": 0.1228, "mutant": "H", "mutation": "P74H", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.046, "ferret_sera_escape": -0.7894, "mature_H5_site": 65, "mouse_sera_escape": -0.1107, "mutant": "I", "mutation": "P74I", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.1146, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "K", "mutation": "P74K", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.198, "ferret_sera_escape": -0.3777, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "L", "mutation": "P74L", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.6854, "ferret_sera_escape": -0.1324, "mature_H5_site": 65, "mouse_sera_escape": 0.385, "mutant": "M", "mutation": "P74M", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": 1.514, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.696, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "N", "mutation": "P74N", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 65, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P74P", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.642, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P74Q", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5766, "ferret_sera_escape": 0.177, "mature_H5_site": 65, "mouse_sera_escape": 0.4208, "mutant": "R", "mutation": "P74R", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": 0.6363, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5088, "ferret_sera_escape": -0.3128, "mature_H5_site": 65, "mouse_sera_escape": -0.09603, "mutant": "S", "mutation": "P74S", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": -0.1017, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.7262, "ferret_sera_escape": -0.1476, "mature_H5_site": 65, "mouse_sera_escape": 0.05828, "mutant": "T", "mutation": "P74T", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": -0.07082, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.865, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "V", "mutation": "P74V", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "W", "mutation": "P74W", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.927, "ferret_sera_escape": null, "mature_H5_site": 65, "mouse_sera_escape": null, "mutant": "Y", "mutation": "P74Y", "reference_site": "74", "region": "HA1", "sequential_site": 81, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.06545, "ferret_sera_escape": -0.005742, "mature_H5_site": 66, "mouse_sera_escape": -0.04899, "mutant": "A", "mutation": "M75A", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": -0.106, "wildtype": "M"}, {"a26_usage": 0.02184, "cell_entry": 0.02638, "ferret_sera_escape": -0.02638, "mature_H5_site": 66, "mouse_sera_escape": 0.02055, "mutant": "D", "mutation": "M75D", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": -0.09187, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.373, "ferret_sera_escape": 0.04231, "mature_H5_site": 66, "mouse_sera_escape": 0.1749, "mutant": "E", "mutation": "M75E", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": -0.0654, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.05476, "ferret_sera_escape": null, "mature_H5_site": 66, "mouse_sera_escape": null, "mutant": "G", "mutation": "M75G", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -0.1639, "ferret_sera_escape": -0.1004, "mature_H5_site": 66, "mouse_sera_escape": -0.0841, "mutant": "H", "mutation": "M75H", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.01932, "wildtype": "M"}, {"a26_usage": 0.3286, "cell_entry": 0.01358, "ferret_sera_escape": -0.06841, "mature_H5_site": 66, "mouse_sera_escape": 0.09065, "mutant": "I", "mutation": "M75I", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.6712, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.04086, "ferret_sera_escape": 0.01242, "mature_H5_site": 66, "mouse_sera_escape": 0.01147, "mutant": "L", "mutation": "M75L", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.06988, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 66, "mouse_sera_escape": 0.0, "mutant": "M", "mutation": "M75M", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.0, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.475, "ferret_sera_escape": null, "mature_H5_site": 66, "mouse_sera_escape": null, "mutant": "P", "mutation": "M75P", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": null, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.01276, "ferret_sera_escape": 0.00571, "mature_H5_site": 66, "mouse_sera_escape": -0.02447, "mutant": "Q", "mutation": "M75Q", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": -0.0009615, "wildtype": "M"}, {"a26_usage": 0.1558, "cell_entry": -0.3531, "ferret_sera_escape": 0.09155, "mature_H5_site": 66, "mouse_sera_escape": 0.05875, "mutant": "R", "mutation": "M75R", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.2389, "wildtype": "M"}, {"a26_usage": 0.006065, "cell_entry": -0.2357, "ferret_sera_escape": 0.04751, "mature_H5_site": 66, "mouse_sera_escape": 0.08668, "mutant": "T", "mutation": "M75T", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.3516, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -1.118, "ferret_sera_escape": 0.1301, "mature_H5_site": 66, "mouse_sera_escape": 0.329, "mutant": "V", "mutation": "M75V", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.454, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.03615, "ferret_sera_escape": 0.1724, "mature_H5_site": 66, "mouse_sera_escape": 0.03538, "mutant": "W", "mutation": "M75W", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": 0.01318, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": 0.01911, "ferret_sera_escape": -0.135, "mature_H5_site": 66, "mouse_sera_escape": -0.03256, "mutant": "Y", "mutation": "M75Y", "reference_site": "75", "region": "HA1", "sequential_site": 82, "stability": -0.002541, "wildtype": "M"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "A", "mutation": "C76A", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 67, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C76C", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "D", "mutation": "C76D", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "E", "mutation": "C76E", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.455, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "F", "mutation": "C76F", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "H", "mutation": "C76H", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.996, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "I", "mutation": "C76I", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.722, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "K", "mutation": "C76K", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "L", "mutation": "C76L", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "M", "mutation": "C76M", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "N", "mutation": "C76N", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C76Q", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.729, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "R", "mutation": "C76R", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.05, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "S", "mutation": "C76S", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -3.785, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "T", "mutation": "C76T", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "V", "mutation": "C76V", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 67, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C76Y", "reference_site": "76", "region": "HA1", "sequential_site": 83, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -0.6153, "ferret_sera_escape": -0.03662, "mature_H5_site": 68, "mouse_sera_escape": 0.3201, "mutant": "A", "mutation": "D77A", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.598, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.362, "ferret_sera_escape": null, "mature_H5_site": 68, "mouse_sera_escape": null, "mutant": "C", "mutation": "D77C", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 68, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D77D", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.1981, "cell_entry": -0.6577, "ferret_sera_escape": -0.03295, "mature_H5_site": 68, "mouse_sera_escape": 0.1682, "mutant": "E", "mutation": "D77E", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.544, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.8933, "ferret_sera_escape": 0.2073, "mature_H5_site": 68, "mouse_sera_escape": 0.2451, "mutant": "F", "mutation": "D77F", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.05326, "ferret_sera_escape": -0.05128, "mature_H5_site": 68, "mouse_sera_escape": 0.2024, "mutant": "G", "mutation": "D77G", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.334, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.517, "ferret_sera_escape": -0.05521, "mature_H5_site": 68, "mouse_sera_escape": 0.1575, "mutant": "H", "mutation": "D77H", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.577, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1036, "ferret_sera_escape": -0.02655, "mature_H5_site": 68, "mouse_sera_escape": 0.2202, "mutant": "I", "mutation": "D77I", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.375, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7425, "ferret_sera_escape": -0.0983, "mature_H5_site": 68, "mouse_sera_escape": 0.3103, "mutant": "L", "mutation": "D77L", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.079, "wildtype": "D"}, {"a26_usage": 0.783, "cell_entry": -0.2082, "ferret_sera_escape": 0.08637, "mature_H5_site": 68, "mouse_sera_escape": 0.1315, "mutant": "M", "mutation": "D77M", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.547, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.783, "ferret_sera_escape": -0.1739, "mature_H5_site": 68, "mouse_sera_escape": 0.2067, "mutant": "N", "mutation": "D77N", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.503, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.243, "ferret_sera_escape": 0.3696, "mature_H5_site": 68, "mouse_sera_escape": 0.2876, "mutant": "P", "mutation": "D77P", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.132, "ferret_sera_escape": -0.1025, "mature_H5_site": 68, "mouse_sera_escape": 0.3903, "mutant": "R", "mutation": "D77R", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.303, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.233, "ferret_sera_escape": -0.1561, "mature_H5_site": 68, "mouse_sera_escape": 0.1089, "mutant": "T", "mutation": "D77T", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 1.757, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6285, "ferret_sera_escape": null, "mature_H5_site": 68, "mouse_sera_escape": null, "mutant": "V", "mutation": "D77V", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.08095, "ferret_sera_escape": -0.05883, "mature_H5_site": 68, "mouse_sera_escape": 0.1731, "mutant": "W", "mutation": "D77W", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 0.5205, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3217, "ferret_sera_escape": 0.135, "mature_H5_site": 68, "mouse_sera_escape": 0.17, "mutant": "Y", "mutation": "D77Y", "reference_site": "77", "region": "HA1", "sequential_site": 84, "stability": 0.6854, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5079, "ferret_sera_escape": null, "mature_H5_site": 69, "mouse_sera_escape": null, "mutant": "C", "mutation": "E78C", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": null, "wildtype": "E"}, {"a26_usage": 0.5123, "cell_entry": -0.1552, "ferret_sera_escape": 0.2454, "mature_H5_site": 69, "mouse_sera_escape": 0.2811, "mutant": "D", "mutation": "E78D", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 2.109, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 69, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E78E", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.04897, "ferret_sera_escape": 0.2216, "mature_H5_site": 69, "mouse_sera_escape": 0.2759, "mutant": "F", "mutation": "E78F", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 1.936, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6919, "ferret_sera_escape": null, "mature_H5_site": 69, "mouse_sera_escape": null, "mutant": "G", "mutation": "E78G", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": null, "wildtype": "E"}, {"a26_usage": null, "cell_entry": -2.342, "ferret_sera_escape": null, "mature_H5_site": 69, "mouse_sera_escape": null, "mutant": "I", "mutation": "E78I", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5219, "ferret_sera_escape": 0.3476, "mature_H5_site": 69, "mouse_sera_escape": 0.3428, "mutant": "K", "mutation": "E78K", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 1.512, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01281, "ferret_sera_escape": 0.1221, "mature_H5_site": 69, "mouse_sera_escape": 0.2911, "mutant": "L", "mutation": "E78L", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 1.736, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.01331, "ferret_sera_escape": 0.2623, "mature_H5_site": 69, "mouse_sera_escape": 0.06854, "mutant": "M", "mutation": "E78M", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 1.066, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1523, "ferret_sera_escape": 0.369, "mature_H5_site": 69, "mouse_sera_escape": 0.2489, "mutant": "N", "mutation": "E78N", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 1.711, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5474, "ferret_sera_escape": 0.1977, "mature_H5_site": 69, "mouse_sera_escape": 0.07269, "mutant": "P", "mutation": "E78P", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 1.358, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.365, "ferret_sera_escape": null, "mature_H5_site": 69, "mouse_sera_escape": null, "mutant": "R", "mutation": "E78R", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7681, "ferret_sera_escape": 0.047, "mature_H5_site": 69, "mouse_sera_escape": 0.3357, "mutant": "T", "mutation": "E78T", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 2.0, "wildtype": "E"}, {"a26_usage": 0.4355, "cell_entry": -0.02172, "ferret_sera_escape": 0.07634, "mature_H5_site": 69, "mouse_sera_escape": 0.1223, "mutant": "W", "mutation": "E78W", "reference_site": "78", "region": "region-E", "sequential_site": 85, "stability": 1.148, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "A", "mutation": "F79A", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "C", "mutation": "F79C", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.691, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "D", "mutation": "F79D", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 70, "mouse_sera_escape": 0.0, "mutant": "F", "mutation": "F79F", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": 0.0, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.645, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "G", "mutation": "F79G", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.777, "ferret_sera_escape": -0.291, "mature_H5_site": 70, "mouse_sera_escape": 0.8872, "mutant": "H", "mutation": "F79H", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": 1.172, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.95, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "K", "mutation": "F79K", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -3.603, "ferret_sera_escape": -0.0318, "mature_H5_site": 70, "mouse_sera_escape": 0.2549, "mutant": "L", "mutation": "F79L", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -1.373, "ferret_sera_escape": -0.1432, "mature_H5_site": 70, "mouse_sera_escape": 0.4347, "mutant": "N", "mutation": "F79N", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": 1.24, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -6.009, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "R", "mutation": "F79R", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": null, "cell_entry": -4.704, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "S", "mutation": "F79S", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -2.91, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "T", "mutation": "F79T", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -5.807, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "V", "mutation": "F79V", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.07101, "cell_entry": -0.1011, "ferret_sera_escape": -0.05074, "mature_H5_site": 70, "mouse_sera_escape": 0.1443, "mutant": "W", "mutation": "F79W", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": 0.4188, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": 0.05304, "ferret_sera_escape": null, "mature_H5_site": 70, "mouse_sera_escape": null, "mutant": "Y", "mutation": "F79Y", "reference_site": "79", "region": "region-E", "sequential_site": 86, "stability": null, "wildtype": "F"}, {"a26_usage": 0.0, "cell_entry": -0.1565, "ferret_sera_escape": -0.0036, "mature_H5_site": -3, "mouse_sera_escape": -0.04694, "mutant": "A", "mutation": "V8A", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": -0.01449, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.01557, "ferret_sera_escape": -0.05161, "mature_H5_site": -3, "mouse_sera_escape": -0.08816, "mutant": "C", "mutation": "V8C", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": -0.01971, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "D", "mutation": "V8D", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "E", "mutation": "V8E", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.353, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "F", "mutation": "V8F", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8556, "ferret_sera_escape": -0.1166, "mature_H5_site": -3, "mouse_sera_escape": -0.1394, "mutant": "G", "mutation": "V8G", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": -0.02085, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "H", "mutation": "V8H", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -2.774, "ferret_sera_escape": -0.2188, "mature_H5_site": -3, "mouse_sera_escape": 0.1289, "mutant": "I", "mutation": "V8I", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": -0.1156, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.255, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "K", "mutation": "V8K", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "L", "mutation": "V8L", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.871, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "M", "mutation": "V8M", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "N", "mutation": "V8N", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "P", "mutation": "V8P", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.988, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V8Q", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.994, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "R", "mutation": "V8R", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.1548, "ferret_sera_escape": -0.01651, "mature_H5_site": -3, "mouse_sera_escape": -0.08609, "mutant": "S", "mutation": "V8S", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": -0.04475, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.258, "ferret_sera_escape": 0.06805, "mature_H5_site": -3, "mouse_sera_escape": 0.08082, "mutant": "T", "mutation": "V8T", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": -0.03567, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -3, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V8V", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.946, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "W", "mutation": "V8W", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.979, "ferret_sera_escape": null, "mature_H5_site": -3, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V8Y", "reference_site": "8", "region": "HA1", "sequential_site": 14, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.3806, "ferret_sera_escape": 0.6735, "mature_H5_site": 71, "mouse_sera_escape": 0.6624, "mutant": "C", "mutation": "I80C", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": -0.1342, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.00377, "ferret_sera_escape": null, "mature_H5_site": 71, "mouse_sera_escape": null, "mutant": "D", "mutation": "I80D", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": 0.1511, "cell_entry": 0.01899, "ferret_sera_escape": 0.1283, "mature_H5_site": 71, "mouse_sera_escape": 0.2557, "mutant": "E", "mutation": "I80E", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": -0.1354, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.885, "ferret_sera_escape": 0.4988, "mature_H5_site": 71, "mouse_sera_escape": 0.2651, "mutant": "F", "mutation": "I80F", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.2, "ferret_sera_escape": null, "mature_H5_site": 71, "mouse_sera_escape": null, "mutant": "G", "mutation": "I80G", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.4549, "ferret_sera_escape": 0.1637, "mature_H5_site": 71, "mouse_sera_escape": 0.171, "mutant": "H", "mutation": "I80H", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": -0.08091, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 71, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I80I", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.003725, "ferret_sera_escape": 0.3019, "mature_H5_site": 71, "mouse_sera_escape": 0.6913, "mutant": "K", "mutation": "I80K", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": -0.05519, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.03972, "ferret_sera_escape": 0.1242, "mature_H5_site": 71, "mouse_sera_escape": 0.1595, "mutant": "L", "mutation": "I80L", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": -0.2262, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -1.943, "ferret_sera_escape": null, "mature_H5_site": 71, "mouse_sera_escape": null, "mutant": "M", "mutation": "I80M", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": 0.3484, "cell_entry": -0.4484, "ferret_sera_escape": null, "mature_H5_site": 71, "mouse_sera_escape": null, "mutant": "N", "mutation": "I80N", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -0.1906, "ferret_sera_escape": 0.04648, "mature_H5_site": 71, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I80Q", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -0.7338, "ferret_sera_escape": 0.007693, "mature_H5_site": 71, "mouse_sera_escape": null, "mutant": "R", "mutation": "I80R", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.04411, "ferret_sera_escape": 0.09186, "mature_H5_site": 71, "mouse_sera_escape": 0.1016, "mutant": "S", "mutation": "I80S", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.9967, "ferret_sera_escape": 0.0979, "mature_H5_site": 71, "mouse_sera_escape": 0.02883, "mutant": "T", "mutation": "I80T", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": -0.08123, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.3472, "ferret_sera_escape": -0.007273, "mature_H5_site": 71, "mouse_sera_escape": 0.2241, "mutant": "V", "mutation": "I80V", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": 0.6831, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.755, "ferret_sera_escape": 0.1005, "mature_H5_site": 71, "mouse_sera_escape": -0.07252, "mutant": "W", "mutation": "I80W", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": 0.06834, "cell_entry": -0.8456, "ferret_sera_escape": 0.2098, "mature_H5_site": 71, "mouse_sera_escape": 0.1418, "mutant": "Y", "mutation": "I80Y", "reference_site": "80", "region": "region-E", "sequential_site": 87, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.884, "ferret_sera_escape": 0.1967, "mature_H5_site": 72, "mouse_sera_escape": 0.2311, "mutant": "C", "mutation": "R81C", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": -0.1769, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.09676, "ferret_sera_escape": 0.0621, "mature_H5_site": 72, "mouse_sera_escape": 0.2667, "mutant": "D", "mutation": "R81D", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": -0.06895, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.06783, "ferret_sera_escape": -0.1075, "mature_H5_site": 72, "mouse_sera_escape": 0.07587, "mutant": "E", "mutation": "R81E", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.04221, "ferret_sera_escape": null, "mature_H5_site": 72, "mouse_sera_escape": null, "mutant": "F", "mutation": "R81F", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.02404, "ferret_sera_escape": 0.06069, "mature_H5_site": 72, "mouse_sera_escape": 0.3494, "mutant": "G", "mutation": "R81G", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 1.144, "wildtype": "R"}, {"a26_usage": 0.2186, "cell_entry": 0.03342, "ferret_sera_escape": null, "mature_H5_site": 72, "mouse_sera_escape": null, "mutant": "H", "mutation": "R81H", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.7165, "ferret_sera_escape": 0.1269, "mature_H5_site": 72, "mouse_sera_escape": 0.3061, "mutant": "I", "mutation": "R81I", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 1.427, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.04894, "ferret_sera_escape": 0.1492, "mature_H5_site": 72, "mouse_sera_escape": 0.1148, "mutant": "K", "mutation": "R81K", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": -0.08659, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.1359, "ferret_sera_escape": 0.06017, "mature_H5_site": 72, "mouse_sera_escape": 0.274, "mutant": "L", "mutation": "R81L", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 1.45, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.01525, "ferret_sera_escape": 0.1394, "mature_H5_site": 72, "mouse_sera_escape": 0.275, "mutant": "M", "mutation": "R81M", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 1.066, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -5.824, "ferret_sera_escape": null, "mature_H5_site": 72, "mouse_sera_escape": null, "mutant": "P", "mutation": "R81P", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 72, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R81R", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.03213, "ferret_sera_escape": 0.1643, "mature_H5_site": 72, "mouse_sera_escape": 0.26, "mutant": "T", "mutation": "R81T", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 1.511, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.03643, "ferret_sera_escape": 0.03922, "mature_H5_site": 72, "mouse_sera_escape": 0.2774, "mutant": "V", "mutation": "R81V", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 1.127, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.03675, "ferret_sera_escape": 0.1474, "mature_H5_site": 72, "mouse_sera_escape": 0.4148, "mutant": "W", "mutation": "R81W", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 1.483, "wildtype": "R"}, {"a26_usage": 0.005742, "cell_entry": 0.03388, "ferret_sera_escape": 0.2099, "mature_H5_site": 72, "mouse_sera_escape": 0.2893, "mutant": "Y", "mutation": "R81Y", "reference_site": "81", "region": "region-E", "sequential_site": 88, "stability": 0.6215, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2373, "ferret_sera_escape": -0.0518, "mature_H5_site": 73, "mouse_sera_escape": 0.3827, "mutant": "A", "mutation": "V82A", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 1.405, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.412, "ferret_sera_escape": 0.1175, "mature_H5_site": 73, "mouse_sera_escape": 0.258, "mutant": "C", "mutation": "V82C", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 1.141, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.699, "ferret_sera_escape": -0.1723, "mature_H5_site": 73, "mouse_sera_escape": 0.7462, "mutant": "D", "mutation": "V82D", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 2.093, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.892, "ferret_sera_escape": null, "mature_H5_site": 73, "mouse_sera_escape": null, "mutant": "E", "mutation": "V82E", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.6677, "ferret_sera_escape": 0.1098, "mature_H5_site": 73, "mouse_sera_escape": 0.2463, "mutant": "F", "mutation": "V82F", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.03844, "ferret_sera_escape": -0.06904, "mature_H5_site": 73, "mouse_sera_escape": 0.2128, "mutant": "I", "mutation": "V82I", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 1.368, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.8081, "ferret_sera_escape": null, "mature_H5_site": 73, "mouse_sera_escape": null, "mutant": "K", "mutation": "V82K", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 1.22, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.7061, "ferret_sera_escape": -0.09897, "mature_H5_site": 73, "mouse_sera_escape": 0.4504, "mutant": "L", "mutation": "V82L", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 1.816, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.274, "ferret_sera_escape": null, "mature_H5_site": 73, "mouse_sera_escape": null, "mutant": "M", "mutation": "V82M", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": null, "wildtype": "V"}, {"a26_usage": null, "cell_entry": -0.04147, "ferret_sera_escape": -0.08231, "mature_H5_site": 73, "mouse_sera_escape": null, "mutant": "N", "mutation": "V82N", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.441, "ferret_sera_escape": null, "mature_H5_site": 73, "mouse_sera_escape": null, "mutant": "Q", "mutation": "V82Q", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.937, "ferret_sera_escape": 0.1199, "mature_H5_site": 73, "mouse_sera_escape": 0.5531, "mutant": "S", "mutation": "V82S", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 0.7293, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -0.2484, "ferret_sera_escape": 0.1038, "mature_H5_site": 73, "mouse_sera_escape": 0.1305, "mutant": "T", "mutation": "V82T", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 0.8718, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 73, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V82V", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.046, "ferret_sera_escape": 0.04015, "mature_H5_site": 73, "mouse_sera_escape": 0.3626, "mutant": "Y", "mutation": "V82Y", "reference_site": "82", "region": "region-E", "sequential_site": 89, "stability": 2.21, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.014, "ferret_sera_escape": -0.2447, "mature_H5_site": 74, "mouse_sera_escape": 0.3698, "mutant": "C", "mutation": "P82aC", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": 1.593, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.865, "ferret_sera_escape": null, "mature_H5_site": 74, "mouse_sera_escape": null, "mutant": "F", "mutation": "P82aF", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.474, "ferret_sera_escape": 0.05119, "mature_H5_site": 74, "mouse_sera_escape": 0.2173, "mutant": "G", "mutation": "P82aG", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": 1.374, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.56, "ferret_sera_escape": null, "mature_H5_site": 74, "mouse_sera_escape": null, "mutant": "H", "mutation": "P82aH", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.571, "ferret_sera_escape": null, "mature_H5_site": 74, "mouse_sera_escape": null, "mutant": "K", "mutation": "P82aK", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.52, "ferret_sera_escape": -0.09823, "mature_H5_site": 74, "mouse_sera_escape": 0.5226, "mutant": "L", "mutation": "P82aL", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.397, "ferret_sera_escape": null, "mature_H5_site": 74, "mouse_sera_escape": null, "mutant": "N", "mutation": "P82aN", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 74, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P82aP", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.4053, "ferret_sera_escape": null, "mature_H5_site": 74, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P82aQ", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.891, "ferret_sera_escape": null, "mature_H5_site": 74, "mouse_sera_escape": null, "mutant": "R", "mutation": "P82aR", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.722, "ferret_sera_escape": -0.006763, "mature_H5_site": 74, "mouse_sera_escape": 0.4022, "mutant": "S", "mutation": "P82aS", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": 1.929, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.909, "ferret_sera_escape": 0.05241, "mature_H5_site": 74, "mouse_sera_escape": 0.9441, "mutant": "T", "mutation": "P82aT", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.111, "ferret_sera_escape": null, "mature_H5_site": 74, "mouse_sera_escape": null, "mutant": "V", "mutation": "P82aV", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.255, "ferret_sera_escape": 0.1144, "mature_H5_site": 74, "mouse_sera_escape": 0.3791, "mutant": "W", "mutation": "P82aW", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": 2.235, "wildtype": "P"}, {"a26_usage": null, "cell_entry": -1.381, "ferret_sera_escape": null, "mature_H5_site": 74, "mouse_sera_escape": null, "mutant": "Y", "mutation": "P82aY", "reference_site": "82a", "region": "region-E", "sequential_site": 90, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.788, "ferret_sera_escape": null, "mature_H5_site": 75, "mouse_sera_escape": null, "mutant": "C", "mutation": "E83C", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.006, "ferret_sera_escape": -0.07149, "mature_H5_site": 75, "mouse_sera_escape": 0.1395, "mutant": "D", "mutation": "E83D", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": 2.221, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 75, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E83E", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.168, "ferret_sera_escape": null, "mature_H5_site": 75, "mouse_sera_escape": null, "mutant": "F", "mutation": "E83F", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.844, "ferret_sera_escape": null, "mature_H5_site": 75, "mouse_sera_escape": null, "mutant": "G", "mutation": "E83G", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5961, "ferret_sera_escape": -0.07813, "mature_H5_site": 75, "mouse_sera_escape": 0.2203, "mutant": "H", "mutation": "E83H", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.2619, "cell_entry": -0.5213, "ferret_sera_escape": 0.08397, "mature_H5_site": 75, "mouse_sera_escape": 0.1894, "mutant": "I", "mutation": "E83I", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": -0.2311, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.105, "ferret_sera_escape": -0.2138, "mature_H5_site": 75, "mouse_sera_escape": 0.6473, "mutant": "K", "mutation": "E83K", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": 1.337, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.01189, "ferret_sera_escape": 0.1383, "mature_H5_site": 75, "mouse_sera_escape": 0.0137, "mutant": "L", "mutation": "E83L", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": -0.4333, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1767, "ferret_sera_escape": -0.01532, "mature_H5_site": 75, "mouse_sera_escape": 0.007112, "mutant": "P", "mutation": "E83P", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": -0.1554, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.6468, "ferret_sera_escape": -0.004639, "mature_H5_site": 75, "mouse_sera_escape": 0.1346, "mutant": "Q", "mutation": "E83Q", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": 1.527, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.5903, "ferret_sera_escape": -0.1331, "mature_H5_site": 75, "mouse_sera_escape": 0.3771, "mutant": "R", "mutation": "E83R", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": 1.605, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.559, "ferret_sera_escape": -0.2933, "mature_H5_site": 75, "mouse_sera_escape": 0.666, "mutant": "S", "mutation": "E83S", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": 1.381, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.08, "ferret_sera_escape": null, "mature_H5_site": 75, "mouse_sera_escape": null, "mutant": "T", "mutation": "E83T", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.612, "ferret_sera_escape": -0.02366, "mature_H5_site": 75, "mouse_sera_escape": -0.05863, "mutant": "V", "mutation": "E83V", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.7414, "ferret_sera_escape": null, "mature_H5_site": 75, "mouse_sera_escape": null, "mutant": "W", "mutation": "E83W", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.038, "ferret_sera_escape": null, "mature_H5_site": 75, "mouse_sera_escape": null, "mutant": "Y", "mutation": "E83Y", "reference_site": "83", "region": "region-E", "sequential_site": 91, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.555, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "A", "mutation": "W84A", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.962, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "C", "mutation": "W84C", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "D", "mutation": "W84D", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "E", "mutation": "W84E", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.921, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "F", "mutation": "W84F", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.6, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "I", "mutation": "W84I", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.949, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "K", "mutation": "W84K", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.838, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "L", "mutation": "W84L", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "M", "mutation": "W84M", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": null, "cell_entry": -5.998, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "N", "mutation": "W84N", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.694, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "P", "mutation": "W84P", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.959, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "Q", "mutation": "W84Q", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.97, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "R", "mutation": "W84R", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.733, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "S", "mutation": "W84S", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": null, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "T", "mutation": "W84T", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.732, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "V", "mutation": "W84V", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 76, "mouse_sera_escape": 0.0, "mutant": "W", "mutation": "W84W", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": 0.0, "wildtype": "W"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 76, "mouse_sera_escape": null, "mutant": "Y", "mutation": "W84Y", "reference_site": "84", "region": "region-E", "sequential_site": 92, "stability": null, "wildtype": "W"}, {"a26_usage": 0.03109, "cell_entry": -0.08904, "ferret_sera_escape": -0.02275, "mature_H5_site": 77, "mouse_sera_escape": 0.1507, "mutant": "A", "mutation": "S85A", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": 0.8468, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -1.808, "ferret_sera_escape": -0.3724, "mature_H5_site": 77, "mouse_sera_escape": 0.09792, "mutant": "C", "mutation": "S85C", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.956, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "F", "mutation": "S85F", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.617, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "H", "mutation": "S85H", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6, "ferret_sera_escape": 0.1465, "mature_H5_site": 77, "mouse_sera_escape": 0.09174, "mutant": "K", "mutation": "S85K", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": -0.1947, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -4.312, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "L", "mutation": "S85L", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "M", "mutation": "S85M", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.325, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "N", "mutation": "S85N", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.6855, "ferret_sera_escape": 0.05342, "mature_H5_site": 77, "mouse_sera_escape": 0.138, "mutant": "P", "mutation": "S85P", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": 1.689, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.579, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "Q", "mutation": "S85Q", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.1737, "ferret_sera_escape": -0.1213, "mature_H5_site": 77, "mouse_sera_escape": 0.09699, "mutant": "R", "mutation": "S85R", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": -0.1319, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 77, "mouse_sera_escape": 0.0, "mutant": "S", "mutation": "S85S", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": 0.0, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -0.9012, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "T", "mutation": "S85T", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.554, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "V", "mutation": "S85V", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -3.344, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "W", "mutation": "S85W", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.944, "ferret_sera_escape": null, "mature_H5_site": 77, "mouse_sera_escape": null, "mutant": "Y", "mutation": "S85Y", "reference_site": "85", "region": "region-E", "sequential_site": 93, "stability": null, "wildtype": "S"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y86A", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.055, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y86C", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.955, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y86D", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y86E", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -0.1359, "ferret_sera_escape": -0.02704, "mature_H5_site": 78, "mouse_sera_escape": -0.04463, "mutant": "F", "mutation": "Y86F", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.899, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y86G", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.936, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y86H", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.854, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y86I", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.948, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y86K", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.004, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y86M", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y86Q", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "S", "mutation": "Y86S", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.774, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y86T", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.701, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y86V", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.846, "ferret_sera_escape": null, "mature_H5_site": 78, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y86W", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 78, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y86Y", "reference_site": "86", "region": "region-E", "sequential_site": 94, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.91, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "A", "mutation": "I87A", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.622, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "C", "mutation": "I87C", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.011, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "E", "mutation": "I87E", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.176, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "F", "mutation": "I87F", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.958, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "H", "mutation": "I87H", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 79, "mouse_sera_escape": 0.0, "mutant": "I", "mutation": "I87I", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": 0.0, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.999, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "K", "mutation": "I87K", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -2.216, "ferret_sera_escape": -0.4394, "mature_H5_site": 79, "mouse_sera_escape": 0.6257, "mutant": "L", "mutation": "I87L", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": 1.437, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -1.832, "ferret_sera_escape": -0.01664, "mature_H5_site": 79, "mouse_sera_escape": 0.1151, "mutant": "M", "mutation": "I87M", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": 1.132, "wildtype": "I"}, {"a26_usage": null, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "P", "mutation": "I87P", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -6.002, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "Q", "mutation": "I87Q", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.926, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "R", "mutation": "I87R", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -5.663, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "S", "mutation": "I87S", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.532, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "T", "mutation": "I87T", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -0.6854, "ferret_sera_escape": -0.02901, "mature_H5_site": 79, "mouse_sera_escape": 0.4797, "mutant": "V", "mutation": "I87V", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": 1.423, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -4.346, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "W", "mutation": "I87W", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.0, "cell_entry": -3.737, "ferret_sera_escape": null, "mature_H5_site": 79, "mouse_sera_escape": null, "mutant": "Y", "mutation": "I87Y", "reference_site": "87", "region": "region-E", "sequential_site": 95, "stability": null, "wildtype": "I"}, {"a26_usage": 0.4499, "cell_entry": -0.1599, "ferret_sera_escape": 0.1971, "mature_H5_site": 80, "mouse_sera_escape": 0.288, "mutant": "A", "mutation": "V88A", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": 0.0007368, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "D", "mutation": "V88D", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.923, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "E", "mutation": "V88E", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.938, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "F", "mutation": "V88F", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.121, "ferret_sera_escape": -0.03418, "mature_H5_site": 80, "mouse_sera_escape": 0.07144, "mutant": "H", "mutation": "V88H", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": -0.2429, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.028, "ferret_sera_escape": -0.1252, "mature_H5_site": 80, "mouse_sera_escape": -0.0744, "mutant": "I", "mutation": "V88I", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "K", "mutation": "V88K", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.843, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "L", "mutation": "V88L", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.16, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "M", "mutation": "V88M", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -4.402, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "N", "mutation": "V88N", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.15, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "P", "mutation": "V88P", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -3.526, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "R", "mutation": "V88R", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.031, "ferret_sera_escape": -0.01936, "mature_H5_site": 80, "mouse_sera_escape": 0.1696, "mutant": "S", "mutation": "V88S", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": 0.01622, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.033, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "T", "mutation": "V88T", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 80, "mouse_sera_escape": 0.0, "mutant": "V", "mutation": "V88V", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": 0.0, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.925, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "W", "mutation": "V88W", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -5.768, "ferret_sera_escape": null, "mature_H5_site": 80, "mouse_sera_escape": null, "mutant": "Y", "mutation": "V88Y", "reference_site": "88", "region": "region-E", "sequential_site": 96, "stability": null, "wildtype": "V"}, {"a26_usage": 0.0, "cell_entry": -1.947, "ferret_sera_escape": null, "mature_H5_site": 81, "mouse_sera_escape": null, "mutant": "C", "mutation": "E89C", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -5.651, "ferret_sera_escape": null, "mature_H5_site": 81, "mouse_sera_escape": null, "mutant": "D", "mutation": "E89D", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 81, "mouse_sera_escape": 0.0, "mutant": "E", "mutation": "E89E", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": 0.0, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.272, "ferret_sera_escape": -0.1997, "mature_H5_site": 81, "mouse_sera_escape": 0.3271, "mutant": "F", "mutation": "E89F", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": -0.19, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.956, "ferret_sera_escape": null, "mature_H5_site": 81, "mouse_sera_escape": null, "mutant": "G", "mutation": "E89G", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.008411, "ferret_sera_escape": 0.04595, "mature_H5_site": 81, "mouse_sera_escape": 0.001348, "mutant": "H", "mutation": "E89H", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": -0.04346, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.03879, "ferret_sera_escape": -0.2042, "mature_H5_site": 81, "mouse_sera_escape": 0.2914, "mutant": "I", "mutation": "E89I", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": -0.1547, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.528, "ferret_sera_escape": -0.3108, "mature_H5_site": 81, "mouse_sera_escape": 0.2449, "mutant": "K", "mutation": "E89K", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": 0.1029, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.9846, "ferret_sera_escape": -0.4687, "mature_H5_site": 81, "mouse_sera_escape": 0.4642, "mutant": "L", "mutation": "E89L", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": -0.1386, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -2.703, "ferret_sera_escape": null, "mature_H5_site": 81, "mouse_sera_escape": null, "mutant": "N", "mutation": "E89N", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -3.072, "ferret_sera_escape": null, "mature_H5_site": 81, "mouse_sera_escape": null, "mutant": "P", "mutation": "E89P", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": null, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.06451, "ferret_sera_escape": -0.1041, "mature_H5_site": 81, "mouse_sera_escape": 0.3792, "mutant": "Q", "mutation": "E89Q", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": 0.07143, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.333, "ferret_sera_escape": -0.3492, "mature_H5_site": 81, "mouse_sera_escape": 0.1435, "mutant": "R", "mutation": "E89R", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": -0.1462, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.1958, "ferret_sera_escape": -0.0895, "mature_H5_site": 81, "mouse_sera_escape": 0.03832, "mutant": "S", "mutation": "E89S", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": 0.168, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -0.2552, "ferret_sera_escape": -0.2829, "mature_H5_site": 81, "mouse_sera_escape": -0.05313, "mutant": "V", "mutation": "E89V", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": -0.1792, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": -1.2, "ferret_sera_escape": -0.4103, "mature_H5_site": 81, "mouse_sera_escape": 0.1816, "mutant": "W", "mutation": "E89W", "reference_site": "89", "region": "region-E", "sequential_site": 97, "stability": -0.09172, "wildtype": "E"}, {"a26_usage": 0.0, "cell_entry": 0.02409, "ferret_sera_escape": -0.2065, "mature_H5_site": -2, "mouse_sera_escape": -0.05827, "mutant": "A", "mutation": "K9A", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.1208, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2777, "ferret_sera_escape": -0.001903, "mature_H5_site": -2, "mouse_sera_escape": 0.06882, "mutant": "C", "mutation": "K9C", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.07552, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.05772, "ferret_sera_escape": -0.08895, "mature_H5_site": -2, "mouse_sera_escape": -0.06519, "mutant": "D", "mutation": "K9D", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.1281, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04559, "ferret_sera_escape": -0.03794, "mature_H5_site": -2, "mouse_sera_escape": -0.11, "mutant": "E", "mutation": "K9E", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.07152, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.8641, "ferret_sera_escape": -0.1181, "mature_H5_site": -2, "mouse_sera_escape": 0.0282, "mutant": "F", "mutation": "K9F", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.4066, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.06421, "ferret_sera_escape": 0.04203, "mature_H5_site": -2, "mouse_sera_escape": -0.009954, "mutant": "G", "mutation": "K9G", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.05109, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.0354, "ferret_sera_escape": -0.04165, "mature_H5_site": -2, "mouse_sera_escape": -0.01211, "mutant": "H", "mutation": "K9H", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.04262, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.947, "ferret_sera_escape": null, "mature_H5_site": -2, "mouse_sera_escape": null, "mutant": "I", "mutation": "K9I", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": -2, "mouse_sera_escape": 0.0, "mutant": "K", "mutation": "K9K", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": 0.0, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.706, "ferret_sera_escape": null, "mature_H5_site": -2, "mouse_sera_escape": null, "mutant": "L", "mutation": "K9L", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.9799, "ferret_sera_escape": -0.02426, "mature_H5_site": -2, "mouse_sera_escape": 0.02013, "mutant": "M", "mutation": "K9M", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.302, "wildtype": "K"}, {"a26_usage": 0.02526, "cell_entry": -0.1282, "ferret_sera_escape": -0.08313, "mature_H5_site": -2, "mouse_sera_escape": -0.04492, "mutant": "N", "mutation": "K9N", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.1692, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": -2, "mouse_sera_escape": null, "mutant": "P", "mutation": "K9P", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.2548, "ferret_sera_escape": 0.003389, "mature_H5_site": -2, "mouse_sera_escape": 0.001331, "mutant": "Q", "mutation": "K9Q", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.1652, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": 0.04892, "ferret_sera_escape": 0.05877, "mature_H5_site": -2, "mouse_sera_escape": -0.02869, "mutant": "R", "mutation": "K9R", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.02458, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.01926, "ferret_sera_escape": 0.03878, "mature_H5_site": -2, "mouse_sera_escape": -0.05172, "mutant": "S", "mutation": "K9S", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.03492, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.182, "ferret_sera_escape": -0.1582, "mature_H5_site": -2, "mouse_sera_escape": -0.08793, "mutant": "T", "mutation": "K9T", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": 0.01847, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.785, "ferret_sera_escape": -0.2118, "mature_H5_site": -2, "mouse_sera_escape": -0.03538, "mutant": "V", "mutation": "K9V", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.1962, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -0.04044, "ferret_sera_escape": -0.06008, "mature_H5_site": -2, "mouse_sera_escape": -0.02081, "mutant": "W", "mutation": "K9W", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": -0.6856, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -1.257, "ferret_sera_escape": 0.00219, "mature_H5_site": -2, "mouse_sera_escape": 0.008286, "mutant": "Y", "mutation": "K9Y", "reference_site": "9", "region": "HA1", "sequential_site": 15, "stability": null, "wildtype": "K"}, {"a26_usage": 0.0, "cell_entry": -2.479, "ferret_sera_escape": -0.04282, "mature_H5_site": 82, "mouse_sera_escape": 0.1932, "mutant": "A", "mutation": "R90A", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.931, "ferret_sera_escape": -0.04711, "mature_H5_site": 82, "mouse_sera_escape": 0.4739, "mutant": "C", "mutation": "R90C", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -2.348, "ferret_sera_escape": -0.06714, "mature_H5_site": 82, "mouse_sera_escape": 0.6008, "mutant": "D", "mutation": "R90D", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.097, "ferret_sera_escape": -0.07236, "mature_H5_site": 82, "mouse_sera_escape": 0.3488, "mutant": "E", "mutation": "R90E", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.427, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.124, "ferret_sera_escape": 0.09127, "mature_H5_site": 82, "mouse_sera_escape": 0.534, "mutant": "F", "mutation": "R90F", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.965, "wildtype": "R"}, {"a26_usage": 0.5904, "cell_entry": -0.1338, "ferret_sera_escape": -0.06523, "mature_H5_site": 82, "mouse_sera_escape": 0.1102, "mutant": "G", "mutation": "R90G", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 0.9196, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.325, "ferret_sera_escape": 0.1455, "mature_H5_site": 82, "mouse_sera_escape": 0.2861, "mutant": "H", "mutation": "R90H", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.257, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.3425, "ferret_sera_escape": 0.0349, "mature_H5_site": 82, "mouse_sera_escape": 0.245, "mutant": "I", "mutation": "R90I", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.341, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.05676, "ferret_sera_escape": 0.2348, "mature_H5_site": 82, "mouse_sera_escape": 0.2019, "mutant": "K", "mutation": "R90K", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 0.3, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.5606, "ferret_sera_escape": 0.2147, "mature_H5_site": 82, "mouse_sera_escape": 0.4919, "mutant": "L", "mutation": "R90L", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.381, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.07917, "ferret_sera_escape": 0.1774, "mature_H5_site": 82, "mouse_sera_escape": 0.4109, "mutant": "M", "mutation": "R90M", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.559, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.546, "ferret_sera_escape": -0.07824, "mature_H5_site": 82, "mouse_sera_escape": 0.2241, "mutant": "N", "mutation": "R90N", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.383, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.202, "ferret_sera_escape": 0.03246, "mature_H5_site": 82, "mouse_sera_escape": 0.4355, "mutant": "P", "mutation": "R90P", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.609, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.07714, "ferret_sera_escape": 0.04984, "mature_H5_site": 82, "mouse_sera_escape": 0.03498, "mutant": "Q", "mutation": "R90Q", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.214, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 82, "mouse_sera_escape": 0.0, "mutant": "R", "mutation": "R90R", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 0.0, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2434, "ferret_sera_escape": 0.1207, "mature_H5_site": 82, "mouse_sera_escape": 0.2605, "mutant": "S", "mutation": "R90S", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": null, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.006, "ferret_sera_escape": 0.1308, "mature_H5_site": 82, "mouse_sera_escape": 0.2331, "mutant": "T", "mutation": "R90T", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.181, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.2636, "ferret_sera_escape": -0.04335, "mature_H5_site": 82, "mouse_sera_escape": 0.2074, "mutant": "V", "mutation": "R90V", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.497, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -0.9419, "ferret_sera_escape": -0.01502, "mature_H5_site": 82, "mouse_sera_escape": 0.2531, "mutant": "W", "mutation": "R90W", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 1.533, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": -1.173, "ferret_sera_escape": -0.01533, "mature_H5_site": 82, "mouse_sera_escape": 0.5358, "mutant": "Y", "mutation": "R90Y", "reference_site": "90", "region": "region-E", "sequential_site": 98, "stability": 2.183, "wildtype": "R"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 83, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A91A", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.1046, "cell_entry": -0.04047, "ferret_sera_escape": -0.01384, "mature_H5_site": 83, "mouse_sera_escape": 0.06503, "mutant": "C", "mutation": "A91C", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.3771, "wildtype": "A"}, {"a26_usage": 0.01739, "cell_entry": -0.01268, "ferret_sera_escape": -0.2924, "mature_H5_site": 83, "mouse_sera_escape": 0.02946, "mutant": "D", "mutation": "A91D", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": 0.2697, "wildtype": "A"}, {"a26_usage": 0.02646, "cell_entry": -0.0737, "ferret_sera_escape": -0.04414, "mature_H5_site": 83, "mouse_sera_escape": 0.0889, "mutant": "E", "mutation": "A91E", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": 0.07027, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1452, "ferret_sera_escape": -0.0642, "mature_H5_site": 83, "mouse_sera_escape": -0.07819, "mutant": "F", "mutation": "A91F", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.04268, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1753, "ferret_sera_escape": -0.07769, "mature_H5_site": 83, "mouse_sera_escape": -0.03491, "mutant": "G", "mutation": "A91G", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": 0.6783, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.05037, "ferret_sera_escape": -0.01651, "mature_H5_site": 83, "mouse_sera_escape": 0.03365, "mutant": "H", "mutation": "A91H", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.1954, "wildtype": "A"}, {"a26_usage": 0.2829, "cell_entry": -0.03243, "ferret_sera_escape": 0.003617, "mature_H5_site": 83, "mouse_sera_escape": 0.0395, "mutant": "K", "mutation": "A91K", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.03953, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.624, "ferret_sera_escape": null, "mature_H5_site": 83, "mouse_sera_escape": null, "mutant": "L", "mutation": "A91L", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.0534, "ferret_sera_escape": -0.1375, "mature_H5_site": 83, "mouse_sera_escape": -0.01981, "mutant": "M", "mutation": "A91M", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.2062, "wildtype": "A"}, {"a26_usage": 0.1702, "cell_entry": -0.03413, "ferret_sera_escape": 0.002161, "mature_H5_site": 83, "mouse_sera_escape": -0.03905, "mutant": "P", "mutation": "A91P", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.06868, "ferret_sera_escape": 0.0102, "mature_H5_site": 83, "mouse_sera_escape": 0.1097, "mutant": "Q", "mutation": "A91Q", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": 0.00952, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3265, "ferret_sera_escape": -0.25, "mature_H5_site": 83, "mouse_sera_escape": 0.09561, "mutant": "R", "mutation": "A91R", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.03604, "wildtype": "A"}, {"a26_usage": 0.4829, "cell_entry": -0.1533, "ferret_sera_escape": 0.07202, "mature_H5_site": 83, "mouse_sera_escape": -0.02162, "mutant": "S", "mutation": "A91S", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.03657, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.01106, "ferret_sera_escape": null, "mature_H5_site": 83, "mouse_sera_escape": null, "mutant": "T", "mutation": "A91T", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": null, "wildtype": "A"}, {"a26_usage": 0.07312, "cell_entry": 0.03071, "ferret_sera_escape": 0.02608, "mature_H5_site": 83, "mouse_sera_escape": 0.04753, "mutant": "V", "mutation": "A91V", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.2985, "wildtype": "A"}, {"a26_usage": 0.07088, "cell_entry": 0.03401, "ferret_sera_escape": -0.06244, "mature_H5_site": 83, "mouse_sera_escape": 0.04923, "mutant": "W", "mutation": "A91W", "reference_site": "91", "region": "region-E", "sequential_site": 99, "stability": -0.2484, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.03381, "ferret_sera_escape": 0.03285, "mature_H5_site": 84, "mouse_sera_escape": -0.06676, "mutant": "A", "mutation": "N92A", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.01158, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04036, "ferret_sera_escape": 0.00243, "mature_H5_site": 84, "mouse_sera_escape": 0.007162, "mutant": "C", "mutation": "N92C", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": null, "wildtype": "N"}, {"a26_usage": null, "cell_entry": -0.05234, "ferret_sera_escape": 0.02423, "mature_H5_site": 84, "mouse_sera_escape": 0.1269, "mutant": "D", "mutation": "N92D", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1521, "ferret_sera_escape": -0.05327, "mature_H5_site": 84, "mouse_sera_escape": 0.09871, "mutant": "E", "mutation": "N92E", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1454, "ferret_sera_escape": 0.05997, "mature_H5_site": 84, "mouse_sera_escape": 0.07683, "mutant": "F", "mutation": "N92F", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.1609, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.06958, "ferret_sera_escape": -0.04046, "mature_H5_site": 84, "mouse_sera_escape": 0.02752, "mutant": "G", "mutation": "N92G", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.8499, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.00283, "ferret_sera_escape": -0.06135, "mature_H5_site": 84, "mouse_sera_escape": 0.09289, "mutant": "I", "mutation": "N92I", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.7655, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2718, "ferret_sera_escape": -0.03656, "mature_H5_site": 84, "mouse_sera_escape": -0.007106, "mutant": "K", "mutation": "N92K", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.2888, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.03568, "ferret_sera_escape": -0.02886, "mature_H5_site": 84, "mouse_sera_escape": -0.07042, "mutant": "L", "mutation": "N92L", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.3527, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3279, "ferret_sera_escape": 0.1347, "mature_H5_site": 84, "mouse_sera_escape": 0.1202, "mutant": "M", "mutation": "N92M", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.1826, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 84, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N92N", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.185, "ferret_sera_escape": 0.1355, "mature_H5_site": 84, "mouse_sera_escape": 0.1025, "mutant": "R", "mutation": "N92R", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.1344, "wildtype": "N"}, {"a26_usage": 1.848, "cell_entry": -0.1077, "ferret_sera_escape": 0.00557, "mature_H5_site": 84, "mouse_sera_escape": 0.09905, "mutant": "S", "mutation": "N92S", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.1109, "wildtype": "N"}, {"a26_usage": 0.6013, "cell_entry": -0.4673, "ferret_sera_escape": 0.1178, "mature_H5_site": 84, "mouse_sera_escape": 0.1485, "mutant": "T", "mutation": "N92T", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.3672, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.53, "ferret_sera_escape": 0.06629, "mature_H5_site": 84, "mouse_sera_escape": 0.01579, "mutant": "V", "mutation": "N92V", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.8143, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.04895, "ferret_sera_escape": 0.02039, "mature_H5_site": 84, "mouse_sera_escape": 0.08845, "mutant": "W", "mutation": "N92W", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.377, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1667, "ferret_sera_escape": -0.003991, "mature_H5_site": 84, "mouse_sera_escape": 0.01234, "mutant": "Y", "mutation": "N92Y", "reference_site": "92", "region": "region-E", "sequential_site": 100, "stability": 0.1971, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.001035, "ferret_sera_escape": 0.03716, "mature_H5_site": 85, "mouse_sera_escape": -0.005503, "mutant": "A", "mutation": "P92aA", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": -0.02773, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.121, "ferret_sera_escape": -0.0925, "mature_H5_site": 85, "mouse_sera_escape": 0.3635, "mutant": "C", "mutation": "P92aC", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 0.9959, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.373, "ferret_sera_escape": null, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "D", "mutation": "P92aD", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.265, "ferret_sera_escape": null, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "E", "mutation": "P92aE", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3433, "ferret_sera_escape": -0.01766, "mature_H5_site": 85, "mouse_sera_escape": 0.05171, "mutant": "F", "mutation": "P92aF", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 1.256, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.684, "ferret_sera_escape": -0.0165, "mature_H5_site": 85, "mouse_sera_escape": 0.8686, "mutant": "G", "mutation": "P92aG", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 0.6992, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.2487, "ferret_sera_escape": -0.1422, "mature_H5_site": 85, "mouse_sera_escape": 0.2346, "mutant": "H", "mutation": "P92aH", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 0.7532, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.926, "ferret_sera_escape": -0.2898, "mature_H5_site": 85, "mouse_sera_escape": 0.6361, "mutant": "I", "mutation": "P92aI", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 1.55, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.15, "ferret_sera_escape": null, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "K", "mutation": "P92aK", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.308, "ferret_sera_escape": null, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "L", "mutation": "P92aL", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -1.699, "ferret_sera_escape": null, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "M", "mutation": "P92aM", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 1.105, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -4.482, "ferret_sera_escape": null, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "N", "mutation": "P92aN", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 0.6513, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 85, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P92aP", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.805, "ferret_sera_escape": -0.1126, "mature_H5_site": 85, "mouse_sera_escape": 0.3577, "mutant": "Q", "mutation": "P92aQ", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 1.068, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -2.353, "ferret_sera_escape": null, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "R", "mutation": "P92aR", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.02319, "ferret_sera_escape": 0.1239, "mature_H5_site": 85, "mouse_sera_escape": 0.2493, "mutant": "S", "mutation": "P92aS", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 0.9196, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.4175, "ferret_sera_escape": 0.03485, "mature_H5_site": 85, "mouse_sera_escape": null, "mutant": "T", "mutation": "P92aT", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 1.481, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.4852, "ferret_sera_escape": -0.2195, "mature_H5_site": 85, "mouse_sera_escape": 0.2256, "mutant": "V", "mutation": "P92aV", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 1.321, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.3186, "ferret_sera_escape": -0.3302, "mature_H5_site": 85, "mouse_sera_escape": 0.03626, "mutant": "W", "mutation": "P92aW", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 0.8628, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -0.5346, "ferret_sera_escape": -0.1678, "mature_H5_site": 85, "mouse_sera_escape": 0.04441, "mutant": "Y", "mutation": "P92aY", "reference_site": "92a", "region": "region-E", "sequential_site": 101, "stability": 1.014, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 86, "mouse_sera_escape": 0.0, "mutant": "A", "mutation": "A93A", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.0, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.06434, "ferret_sera_escape": 0.03114, "mature_H5_site": 86, "mouse_sera_escape": 0.2188, "mutant": "C", "mutation": "A93C", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.06722, "wildtype": "A"}, {"a26_usage": 0.06098, "cell_entry": -0.03087, "ferret_sera_escape": -0.02311, "mature_H5_site": 86, "mouse_sera_escape": -0.05883, "mutant": "D", "mutation": "A93D", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.4464, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.1596, "ferret_sera_escape": -0.05893, "mature_H5_site": 86, "mouse_sera_escape": 0.01517, "mutant": "E", "mutation": "A93E", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.3244, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.05131, "ferret_sera_escape": 0.1578, "mature_H5_site": 86, "mouse_sera_escape": 0.09836, "mutant": "F", "mutation": "A93F", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.06585, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.04196, "ferret_sera_escape": 0.05988, "mature_H5_site": 86, "mouse_sera_escape": -0.05064, "mutant": "G", "mutation": "A93G", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.04509, "ferret_sera_escape": -0.00097, "mature_H5_site": 86, "mouse_sera_escape": 0.009424, "mutant": "H", "mutation": "A93H", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.1953, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.3655, "ferret_sera_escape": -0.007556, "mature_H5_site": 86, "mouse_sera_escape": -0.1184, "mutant": "I", "mutation": "A93I", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.002853, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.09542, "ferret_sera_escape": -0.1032, "mature_H5_site": 86, "mouse_sera_escape": 0.02245, "mutant": "L", "mutation": "A93L", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.2316, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.02594, "ferret_sera_escape": null, "mature_H5_site": 86, "mouse_sera_escape": null, "mutant": "M", "mutation": "A93M", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": null, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.00597, "ferret_sera_escape": 0.09649, "mature_H5_site": 86, "mouse_sera_escape": 0.03091, "mutant": "N", "mutation": "A93N", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.009551, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.07659, "ferret_sera_escape": -0.03717, "mature_H5_site": 86, "mouse_sera_escape": -0.1564, "mutant": "P", "mutation": "A93P", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.1338, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.29, "ferret_sera_escape": 0.04962, "mature_H5_site": 86, "mouse_sera_escape": -0.004996, "mutant": "Q", "mutation": "A93Q", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.02205, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.2769, "ferret_sera_escape": 0.04242, "mature_H5_site": 86, "mouse_sera_escape": -0.09915, "mutant": "R", "mutation": "A93R", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.07198, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.01831, "ferret_sera_escape": -0.03661, "mature_H5_site": 86, "mouse_sera_escape": 0.08262, "mutant": "S", "mutation": "A93S", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": -0.2433, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": 0.07981, "ferret_sera_escape": 0.18, "mature_H5_site": 86, "mouse_sera_escape": -0.05313, "mutant": "T", "mutation": "A93T", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.068, "wildtype": "A"}, {"a26_usage": 0.08987, "cell_entry": 0.0435, "ferret_sera_escape": -0.1577, "mature_H5_site": 86, "mouse_sera_escape": -0.2204, "mutant": "V", "mutation": "A93V", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.0005824, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -0.174, "ferret_sera_escape": -0.06061, "mature_H5_site": 86, "mouse_sera_escape": 0.07598, "mutant": "W", "mutation": "A93W", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.1865, "wildtype": "A"}, {"a26_usage": 0.04385, "cell_entry": -0.4142, "ferret_sera_escape": -0.004753, "mature_H5_site": 86, "mouse_sera_escape": -0.003453, "mutant": "Y", "mutation": "A93Y", "reference_site": "93", "region": "region-E", "sequential_site": 102, "stability": 0.1336, "wildtype": "A"}, {"a26_usage": 0.0, "cell_entry": -1.0, "ferret_sera_escape": 0.1946, "mature_H5_site": 87, "mouse_sera_escape": 0.1336, "mutant": "C", "mutation": "N94C", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": -0.107, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.05408, "ferret_sera_escape": -0.005107, "mature_H5_site": 87, "mouse_sera_escape": 0.0611, "mutant": "D", "mutation": "N94D", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": -0.253, "wildtype": "N"}, {"a26_usage": null, "cell_entry": -0.6562, "ferret_sera_escape": 0.1099, "mature_H5_site": 87, "mouse_sera_escape": 0.1267, "mutant": "E", "mutation": "N94E", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.1469, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.9141, "ferret_sera_escape": -0.06019, "mature_H5_site": 87, "mouse_sera_escape": 0.07287, "mutant": "G", "mutation": "N94G", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.002635, "ferret_sera_escape": 0.1769, "mature_H5_site": 87, "mouse_sera_escape": 0.07669, "mutant": "H", "mutation": "N94H", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.1637, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4251, "ferret_sera_escape": -0.3339, "mature_H5_site": 87, "mouse_sera_escape": -0.03446, "mutant": "I", "mutation": "N94I", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.2667, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.2878, "ferret_sera_escape": 0.1067, "mature_H5_site": 87, "mouse_sera_escape": 0.3909, "mutant": "K", "mutation": "N94K", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.07019, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1805, "ferret_sera_escape": 0.05545, "mature_H5_site": 87, "mouse_sera_escape": 0.2591, "mutant": "L", "mutation": "N94L", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.02268, "wildtype": "N"}, {"a26_usage": 0.1583, "cell_entry": -0.3004, "ferret_sera_escape": 0.1225, "mature_H5_site": 87, "mouse_sera_escape": 0.205, "mutant": "M", "mutation": "N94M", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": -0.01707, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 87, "mouse_sera_escape": 0.0, "mutant": "N", "mutation": "N94N", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.0, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -5.784, "ferret_sera_escape": null, "mature_H5_site": 87, "mouse_sera_escape": null, "mutant": "P", "mutation": "N94P", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": null, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1262, "ferret_sera_escape": 0.175, "mature_H5_site": 87, "mouse_sera_escape": 0.1033, "mutant": "R", "mutation": "N94R", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.002526, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.1472, "ferret_sera_escape": -0.02305, "mature_H5_site": 87, "mouse_sera_escape": 0.06187, "mutant": "S", "mutation": "N94S", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": -0.1288, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.4122, "ferret_sera_escape": -0.105, "mature_H5_site": 87, "mouse_sera_escape": 0.2665, "mutant": "T", "mutation": "N94T", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.1738, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.6813, "ferret_sera_escape": -0.1111, "mature_H5_site": 87, "mouse_sera_escape": 0.1075, "mutant": "V", "mutation": "N94V", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": 0.5225, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.03282, "ferret_sera_escape": -0.385, "mature_H5_site": 87, "mouse_sera_escape": -0.2446, "mutant": "W", "mutation": "N94W", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": -0.05892, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.3207, "ferret_sera_escape": 0.04425, "mature_H5_site": 87, "mouse_sera_escape": -0.00509, "mutant": "Y", "mutation": "N94Y", "reference_site": "94", "region": "region-E", "sequential_site": 103, "stability": -0.04178, "wildtype": "N"}, {"a26_usage": 0.0, "cell_entry": -0.7204, "ferret_sera_escape": 0.1747, "mature_H5_site": 88, "mouse_sera_escape": 0.1787, "mutant": "A", "mutation": "D95A", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": -0.02512, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.3233, "ferret_sera_escape": 0.04222, "mature_H5_site": 88, "mouse_sera_escape": 0.07396, "mutant": "C", "mutation": "D95C", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.31, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 88, "mouse_sera_escape": 0.0, "mutant": "D", "mutation": "D95D", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.0, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.02697, "ferret_sera_escape": 0.2668, "mature_H5_site": 88, "mouse_sera_escape": 0.1895, "mutant": "E", "mutation": "D95E", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 1.062, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.243, "ferret_sera_escape": -0.3263, "mature_H5_site": 88, "mouse_sera_escape": 0.2619, "mutant": "F", "mutation": "D95F", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1866, "ferret_sera_escape": 0.2795, "mature_H5_site": 88, "mouse_sera_escape": 0.1125, "mutant": "G", "mutation": "D95G", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.4527, "ferret_sera_escape": 0.236, "mature_H5_site": 88, "mouse_sera_escape": 0.1139, "mutant": "H", "mutation": "D95H", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.6422, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.321, "ferret_sera_escape": 0.1267, "mature_H5_site": 88, "mouse_sera_escape": 0.6562, "mutant": "I", "mutation": "D95I", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.9518, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2198, "ferret_sera_escape": 0.3124, "mature_H5_site": 88, "mouse_sera_escape": 0.1555, "mutant": "K", "mutation": "D95K", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.4244, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.247, "ferret_sera_escape": 0.06728, "mature_H5_site": 88, "mouse_sera_escape": 0.5683, "mutant": "L", "mutation": "D95L", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.8676, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.7498, "ferret_sera_escape": 0.1562, "mature_H5_site": 88, "mouse_sera_escape": 0.2742, "mutant": "M", "mutation": "D95M", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.6628, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.6782, "ferret_sera_escape": -0.09039, "mature_H5_site": 88, "mouse_sera_escape": -0.002238, "mutant": "N", "mutation": "D95N", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -3.202, "ferret_sera_escape": null, "mature_H5_site": 88, "mouse_sera_escape": null, "mutant": "P", "mutation": "D95P", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5195, "ferret_sera_escape": 0.2371, "mature_H5_site": 88, "mouse_sera_escape": 0.1071, "mutant": "Q", "mutation": "D95Q", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.774, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.5123, "ferret_sera_escape": 0.2653, "mature_H5_site": 88, "mouse_sera_escape": 0.1899, "mutant": "R", "mutation": "D95R", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.4291, "wildtype": "D"}, {"a26_usage": 0.1876, "cell_entry": -0.3749, "ferret_sera_escape": 0.5043, "mature_H5_site": 88, "mouse_sera_escape": 0.1399, "mutant": "S", "mutation": "D95S", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.03114, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.2005, "ferret_sera_escape": 0.1881, "mature_H5_site": 88, "mouse_sera_escape": 0.08901, "mutant": "T", "mutation": "D95T", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.3492, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -1.432, "ferret_sera_escape": 0.09108, "mature_H5_site": 88, "mouse_sera_escape": 0.1841, "mutant": "V", "mutation": "D95V", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -2.417, "ferret_sera_escape": null, "mature_H5_site": 88, "mouse_sera_escape": null, "mutant": "W", "mutation": "D95W", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": 0.03599, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -5.51, "ferret_sera_escape": null, "mature_H5_site": 88, "mouse_sera_escape": null, "mutant": "Y", "mutation": "D95Y", "reference_site": "95", "region": "HA1", "sequential_site": 104, "stability": null, "wildtype": "D"}, {"a26_usage": 0.0, "cell_entry": -0.1603, "ferret_sera_escape": -0.06225, "mature_H5_site": 89, "mouse_sera_escape": 0.02661, "mutant": "C", "mutation": "L96C", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": -0.2585, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.3283, "ferret_sera_escape": null, "mature_H5_site": 89, "mouse_sera_escape": null, "mutant": "D", "mutation": "L96D", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.02372, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4758, "ferret_sera_escape": null, "mature_H5_site": 89, "mouse_sera_escape": null, "mutant": "E", "mutation": "L96E", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4363, "ferret_sera_escape": -1.257, "mature_H5_site": 89, "mouse_sera_escape": -0.6859, "mutant": "F", "mutation": "L96F", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.6679, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.1441, "ferret_sera_escape": -0.5612, "mature_H5_site": 89, "mouse_sera_escape": -0.4146, "mutant": "H", "mutation": "L96H", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.2343, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.7077, "ferret_sera_escape": 0.2639, "mature_H5_site": 89, "mouse_sera_escape": 0.1538, "mutant": "I", "mutation": "L96I", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": -0.2918, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -1.036, "ferret_sera_escape": -0.4523, "mature_H5_site": 89, "mouse_sera_escape": -0.3201, "mutant": "K", "mutation": "L96K", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": -0.04678, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 89, "mouse_sera_escape": 0.0, "mutant": "L", "mutation": "L96L", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.0, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.03343, "ferret_sera_escape": -0.3026, "mature_H5_site": 89, "mouse_sera_escape": -0.1258, "mutant": "M", "mutation": "L96M", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.4629, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.2566, "ferret_sera_escape": 0.191, "mature_H5_site": 89, "mouse_sera_escape": 0.05342, "mutant": "N", "mutation": "L96N", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": -0.009696, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.31, "ferret_sera_escape": null, "mature_H5_site": 89, "mouse_sera_escape": null, "mutant": "P", "mutation": "L96P", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4283, "ferret_sera_escape": 0.2563, "mature_H5_site": 89, "mouse_sera_escape": 0.1389, "mutant": "Q", "mutation": "L96Q", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.3271, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0235, "ferret_sera_escape": 0.02392, "mature_H5_site": 89, "mouse_sera_escape": 0.04089, "mutant": "R", "mutation": "L96R", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.07256, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -3.129, "ferret_sera_escape": null, "mature_H5_site": 89, "mouse_sera_escape": null, "mutant": "S", "mutation": "L96S", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -2.114, "ferret_sera_escape": -0.8503, "mature_H5_site": 89, "mouse_sera_escape": -0.4039, "mutant": "T", "mutation": "L96T", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": null, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.4146, "ferret_sera_escape": 0.5171, "mature_H5_site": 89, "mouse_sera_escape": 0.1705, "mutant": "V", "mutation": "L96V", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": -0.2321, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": -0.9464, "ferret_sera_escape": -1.749, "mature_H5_site": 89, "mouse_sera_escape": -0.8922, "mutant": "W", "mutation": "L96W", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.8274, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.03098, "ferret_sera_escape": -1.324, "mature_H5_site": 89, "mouse_sera_escape": -0.7274, "mutant": "Y", "mutation": "L96Y", "reference_site": "96", "region": "HA1", "sequential_site": 105, "stability": 0.1603, "wildtype": "L"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 90, "mouse_sera_escape": 0.0, "mutant": "C", "mutation": "C97C", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": 0.0, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.909, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "D", "mutation": "C97D", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.088, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "E", "mutation": "C97E", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.982, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "F", "mutation": "C97F", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.154, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "G", "mutation": "C97G", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.849, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "H", "mutation": "C97H", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.668, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "I", "mutation": "C97I", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.922, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "K", "mutation": "C97K", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.608, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "L", "mutation": "C97L", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.84, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "M", "mutation": "C97M", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.92, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "N", "mutation": "C97N", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.897, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "P", "mutation": "C97P", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -4.228, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "Q", "mutation": "C97Q", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.928, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "R", "mutation": "C97R", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.94, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "S", "mutation": "C97S", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -6.015, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "T", "mutation": "C97T", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -2.729, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "V", "mutation": "C97V", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "W", "mutation": "C97W", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.902, "ferret_sera_escape": null, "mature_H5_site": 90, "mouse_sera_escape": null, "mutant": "Y", "mutation": "C97Y", "reference_site": "97", "region": "HA1", "sequential_site": 106, "stability": null, "wildtype": "C"}, {"a26_usage": 0.0, "cell_entry": -5.98, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "A", "mutation": "Y98A", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.774, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "C", "mutation": "Y98C", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.778, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "D", "mutation": "Y98D", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -6.012, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "E", "mutation": "Y98E", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -4.357, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "F", "mutation": "Y98F", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.942, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "G", "mutation": "Y98G", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.723, "ferret_sera_escape": -0.89, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "H", "mutation": "Y98H", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.065, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "I", "mutation": "Y98I", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.439, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "K", "mutation": "Y98K", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.707, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "L", "mutation": "Y98L", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -3.874, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "M", "mutation": "Y98M", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.793, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "N", "mutation": "Y98N", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.905, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "P", "mutation": "Y98P", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.547, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "Q", "mutation": "Y98Q", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -2.83, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "R", "mutation": "Y98R", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.966, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "T", "mutation": "Y98T", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": null, "cell_entry": -5.545, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "V", "mutation": "Y98V", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -5.05, "ferret_sera_escape": null, "mature_H5_site": 91, "mouse_sera_escape": null, "mutant": "W", "mutation": "Y98W", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": null, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 91, "mouse_sera_escape": 0.0, "mutant": "Y", "mutation": "Y98Y", "reference_site": "98", "region": "HA1", "sequential_site": 107, "stability": 0.0, "wildtype": "Y"}, {"a26_usage": 0.0, "cell_entry": -1.033, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": -0.2423, "mutant": "A", "mutation": "P99A", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.615, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "C", "mutation": "P99C", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.915, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "D", "mutation": "P99D", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.953, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "E", "mutation": "P99E", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.339, "ferret_sera_escape": 0.3873, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "G", "mutation": "P99G", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.916, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "H", "mutation": "P99H", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.887, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "I", "mutation": "P99I", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.952, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "K", "mutation": "P99K", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.388, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "L", "mutation": "P99L", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.963, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "M", "mutation": "P99M", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": 0.0, "ferret_sera_escape": 0.0, "mature_H5_site": 92, "mouse_sera_escape": 0.0, "mutant": "P", "mutation": "P99P", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": 0.0, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -3.04, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "Q", "mutation": "P99Q", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.957, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "R", "mutation": "P99R", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.911, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "S", "mutation": "P99S", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.298, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "T", "mutation": "P99T", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.941, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "V", "mutation": "P99V", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.175, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "W", "mutation": "P99W", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}, {"a26_usage": 0.0, "cell_entry": -5.896, "ferret_sera_escape": null, "mature_H5_site": 92, "mouse_sera_escape": null, "mutant": "Y", "mutation": "P99Y", "reference_site": "99", "region": "HA1", "sequential_site": 108, "stability": null, "wildtype": "P"}], "negative_condition_colors": null, "pdb": "HEADER VIRAL PROTEIN 24-MAY-13 XXXX \nTITLE STRUCTURE OF A/ANHUI/5/2005 H5 HA \nKEYWDS VIRAL PROTEIN \nEXPDTA X-RAY DIFFRACTION \nAUTHOR H.YANG,D.A.SHORE,P.J.CARNEY,J.C.CHANG,J.STEVENS \nJRNL AUTH D.A.SHORE,H.YANG,A.L.BALISH,S.S.SHEPARD,P.J.CARNEY, \nJRNL AUTH 2 J.C.CHANG,C.T.DAVIS,R.O.DONIS,J.M.VILLANUEVA,A.I.KLIMOV, \nJRNL AUTH 3 J.STEVENS \nJRNL TITL STRUCTURAL AND ANTIGENIC VARIATION AMONG DIVERSE CLADE 2 \nJRNL TITL 2 H5N1 VIRUSES. \nJRNL REF PLOS ONE V. 8 75209 2013 \nJRNL REFN ESSN 1932-6203 \nJRNL PMID 24086467 \nJRNL DOI 10.1371/JOURNAL.PONE.0075209 \nSEQRES 1 A 329 ALA ASP PRO GLY ASP GLN ILE CYS ILE GLY TYR HIS ALA \nSEQRES 2 A 329 ASN ASN SER THR GLU GLN VAL ASP THR ILE MET GLU LYS \nSEQRES 3 A 329 ASN VAL THR VAL THR HIS ALA GLN ASP ILE LEU GLU LYS \nSEQRES 4 A 329 THR HIS ASN GLY LYS LEU CYS ASP LEU ASP GLY VAL LYS \nSEQRES 5 A 329 PRO LEU ILE LEU ARG ASP CYS SER VAL ALA GLY TRP LEU \nSEQRES 6 A 329 LEU GLY ASN PRO MET CYS ASP GLU PHE ILE ASN VAL PRO \nSEQRES 7 A 329 GLU TRP SER TYR ILE VAL GLU LYS ALA ASN PRO ALA ASN \nSEQRES 8 A 329 ASP LEU CYS TYR PRO GLY ASN PHE ASN ASP TYR GLU GLU \nSEQRES 9 A 329 LEU LYS HIS LEU LEU SER ARG ILE ASN HIS PHE GLU LYS \nSEQRES 10 A 329 ILE GLN ILE ILE PRO LYS SER SER TRP SER ASP HIS GLU \nSEQRES 11 A 329 ALA SER SER GLY VAL SER SER ALA CYS PRO TYR GLN GLY \nSEQRES 12 A 329 THR PRO SER PHE PHE ARG ASN VAL VAL TRP LEU ILE LYS \nSEQRES 13 A 329 LYS ASN ASN THR TYR PRO THR ILE LYS ARG SER TYR ASN \nSEQRES 14 A 329 ASN THR ASN GLN GLU ASP LEU LEU ILE LEU TRP GLY ILE \nSEQRES 15 A 329 HIS HIS SER ASN ASP ALA ALA GLU GLN THR LYS LEU TYR \nSEQRES 16 A 329 GLN ASN PRO THR THR TYR ILE SER VAL GLY THR SER THR \nSEQRES 17 A 329 LEU ASN GLN ARG LEU VAL PRO LYS ILE ALA THR ARG SER \nSEQRES 18 A 329 LYS VAL ASN GLY GLN SER GLY ARG MET ASP PHE PHE TRP \nSEQRES 19 A 329 THR ILE LEU LYS PRO ASN ASP ALA ILE ASN PHE GLU SER \nSEQRES 20 A 329 ASN GLY ASN PHE ILE ALA PRO GLU TYR ALA TYR LYS ILE \nSEQRES 21 A 329 VAL LYS LYS GLY ASP SER ALA ILE VAL LYS SER GLU VAL \nSEQRES 22 A 329 GLU TYR GLY ASN CYS ASN THR LYS CYS GLN THR PRO ILE \nSEQRES 23 A 329 GLY ALA ILE ASN SER SER MET PRO PHE HIS ASN ILE HIS \nSEQRES 24 A 329 PRO LEU THR ILE GLY GLU CYS PRO LYS TYR VAL LYS SER \nSEQRES 25 A 329 ASN LYS LEU VAL LEU ALA THR GLY LEU ARG ASN SER PRO \nSEQRES 26 A 329 LEU ARG GLU ARG \nSEQRES 1 B 174 GLY LEU PHE GLY ALA ILE ALA GLY PHE ILE GLU GLY GLY \nSEQRES 2 B 174 TRP GLN GLY MET VAL ASP GLY TRP TYR GLY TYR HIS HIS \nSEQRES 3 B 174 SER ASN GLU GLN GLY SER GLY TYR ALA ALA ASP LYS GLU \nSEQRES 4 B 174 SER THR GLN LYS ALA ILE ASP GLY VAL THR ASN LYS VAL \nSEQRES 5 B 174 ASN SER ILE ILE ASP LYS MET ASN THR GLN PHE GLU ALA \nSEQRES 6 B 174 VAL GLY ARG GLU PHE ASN ASN LEU GLU ARG ARG ILE GLU \nSEQRES 7 B 174 ASN LEU ASN LYS LYS MET GLU ASP GLY PHE LEU ASP VAL \nSEQRES 8 B 174 TRP THR TYR ASN ALA GLU LEU LEU VAL LEU MET GLU ASN \nSEQRES 9 B 174 GLU ARG THR LEU ASP PHE HIS ASP SER ASN VAL LYS ASN \nSEQRES 10 B 174 LEU TYR ASP LYS VAL ARG LEU GLN LEU ARG ASP ASN ALA \nSEQRES 11 B 174 LYS GLU LEU GLY ASN GLY CYS PHE GLU PHE TYR HIS LYS \nSEQRES 12 B 174 CYS ASP ASN GLU CYS MET GLU SER VAL ARG ASN GLY THR \nSEQRES 13 B 174 TYR ASP TYR PRO GLN TYR SER GLU GLU ALA ARG LEU LYS \nSEQRES 14 B 174 ARG GLU GLU ILE SER \nSEQRES 1 C 329 ALA ASP PRO GLY ASP GLN ILE CYS ILE GLY TYR HIS ALA \nSEQRES 2 C 329 ASN ASN SER THR GLU GLN VAL ASP THR ILE MET GLU LYS \nSEQRES 3 C 329 ASN VAL THR VAL THR HIS ALA GLN ASP ILE LEU GLU LYS \nSEQRES 4 C 329 THR HIS ASN GLY LYS LEU CYS ASP LEU ASP GLY VAL LYS \nSEQRES 5 C 329 PRO LEU ILE LEU ARG ASP CYS SER VAL ALA GLY TRP LEU \nSEQRES 6 C 329 LEU GLY ASN PRO MET CYS ASP GLU PHE ILE ASN VAL PRO \nSEQRES 7 C 329 GLU TRP SER TYR ILE VAL GLU LYS ALA ASN PRO ALA ASN \nSEQRES 8 C 329 ASP LEU CYS TYR PRO GLY ASN PHE ASN ASP TYR GLU GLU \nSEQRES 9 C 329 LEU LYS HIS LEU LEU SER ARG ILE ASN HIS PHE GLU LYS \nSEQRES 10 C 329 ILE GLN ILE ILE PRO LYS SER SER TRP SER ASP HIS GLU \nSEQRES 11 C 329 ALA SER SER GLY VAL SER SER ALA CYS PRO TYR GLN GLY \nSEQRES 12 C 329 THR PRO SER PHE PHE ARG ASN VAL VAL TRP LEU ILE LYS \nSEQRES 13 C 329 LYS ASN ASN THR TYR PRO THR ILE LYS ARG SER TYR ASN \nSEQRES 14 C 329 ASN THR ASN GLN GLU ASP LEU LEU ILE LEU TRP GLY ILE \nSEQRES 15 C 329 HIS HIS SER ASN ASP ALA ALA GLU GLN THR LYS LEU TYR \nSEQRES 16 C 329 GLN ASN PRO THR THR TYR ILE SER VAL GLY THR SER THR \nSEQRES 17 C 329 LEU ASN GLN ARG LEU VAL PRO LYS ILE ALA THR ARG SER \nSEQRES 18 C 329 LYS VAL ASN GLY GLN SER GLY ARG MET ASP PHE PHE TRP \nSEQRES 19 C 329 THR ILE LEU LYS PRO ASN ASP ALA ILE ASN PHE GLU SER \nSEQRES 20 C 329 ASN GLY ASN PHE ILE ALA PRO GLU TYR ALA TYR LYS ILE \nSEQRES 21 C 329 VAL LYS LYS GLY ASP SER ALA ILE VAL LYS SER GLU VAL \nSEQRES 22 C 329 GLU TYR GLY ASN CYS ASN THR LYS CYS GLN THR PRO ILE \nSEQRES 23 C 329 GLY ALA ILE ASN SER SER MET PRO PHE HIS ASN ILE HIS \nSEQRES 24 C 329 PRO LEU THR ILE GLY GLU CYS PRO LYS TYR VAL LYS SER \nSEQRES 25 C 329 ASN LYS LEU VAL LEU ALA THR GLY LEU ARG ASN SER PRO \nSEQRES 26 C 329 LEU ARG GLU ARG \nSEQRES 1 D 174 GLY LEU PHE GLY ALA ILE ALA GLY PHE ILE GLU GLY GLY \nSEQRES 2 D 174 TRP GLN GLY MET VAL ASP GLY TRP TYR GLY TYR HIS HIS \nSEQRES 3 D 174 SER ASN GLU GLN GLY SER GLY TYR ALA ALA ASP LYS GLU \nSEQRES 4 D 174 SER THR GLN LYS ALA ILE ASP GLY VAL THR ASN LYS VAL \nSEQRES 5 D 174 ASN SER ILE ILE ASP LYS MET ASN THR GLN PHE GLU ALA \nSEQRES 6 D 174 VAL GLY ARG GLU PHE ASN ASN LEU GLU ARG ARG ILE GLU \nSEQRES 7 D 174 ASN LEU ASN LYS LYS MET GLU ASP GLY PHE LEU ASP VAL \nSEQRES 8 D 174 TRP THR TYR ASN ALA GLU LEU LEU VAL LEU MET GLU ASN \nSEQRES 9 D 174 GLU ARG THR LEU ASP PHE HIS ASP SER ASN VAL LYS ASN \nSEQRES 10 D 174 LEU TYR ASP LYS VAL ARG LEU GLN LEU ARG ASP ASN ALA \nSEQRES 11 D 174 LYS GLU LEU GLY ASN GLY CYS PHE GLU PHE TYR HIS LYS \nSEQRES 12 D 174 CYS ASP ASN GLU CYS MET GLU SER VAL ARG ASN GLY THR \nSEQRES 13 D 174 TYR ASP TYR PRO GLN TYR SER GLU GLU ALA ARG LEU LYS \nSEQRES 14 D 174 ARG GLU GLU ILE SER \nSEQRES 1 E 329 ALA ASP PRO GLY ASP GLN ILE CYS ILE GLY TYR HIS ALA \nSEQRES 2 E 329 ASN ASN SER THR GLU GLN VAL ASP THR ILE MET GLU LYS \nSEQRES 3 E 329 ASN VAL THR VAL THR HIS ALA GLN ASP ILE LEU GLU LYS \nSEQRES 4 E 329 THR HIS ASN GLY LYS LEU CYS ASP LEU ASP GLY VAL LYS \nSEQRES 5 E 329 PRO LEU ILE LEU ARG ASP CYS SER VAL ALA GLY TRP LEU \nSEQRES 6 E 329 LEU GLY ASN PRO MET CYS ASP GLU PHE ILE ASN VAL PRO \nSEQRES 7 E 329 GLU TRP SER TYR ILE VAL GLU LYS ALA ASN PRO ALA ASN \nSEQRES 8 E 329 ASP LEU CYS TYR PRO GLY ASN PHE ASN ASP TYR GLU GLU \nSEQRES 9 E 329 LEU LYS HIS LEU LEU SER ARG ILE ASN HIS PHE GLU LYS \nSEQRES 10 E 329 ILE GLN ILE ILE PRO LYS SER SER TRP SER ASP HIS GLU \nSEQRES 11 E 329 ALA SER SER GLY VAL SER SER ALA CYS PRO TYR GLN GLY \nSEQRES 12 E 329 THR PRO SER PHE PHE ARG ASN VAL VAL TRP LEU ILE LYS \nSEQRES 13 E 329 LYS ASN ASN THR TYR PRO THR ILE LYS ARG SER TYR ASN \nSEQRES 14 E 329 ASN THR ASN GLN GLU ASP LEU LEU ILE LEU TRP GLY ILE \nSEQRES 15 E 329 HIS HIS SER ASN ASP ALA ALA GLU GLN THR LYS LEU TYR \nSEQRES 16 E 329 GLN ASN PRO THR THR TYR ILE SER VAL GLY THR SER THR \nSEQRES 17 E 329 LEU ASN GLN ARG LEU VAL PRO LYS ILE ALA THR ARG SER \nSEQRES 18 E 329 LYS VAL ASN GLY GLN SER GLY ARG MET ASP PHE PHE TRP \nSEQRES 19 E 329 THR ILE LEU LYS PRO ASN ASP ALA ILE ASN PHE GLU SER \nSEQRES 20 E 329 ASN GLY ASN PHE ILE ALA PRO GLU TYR ALA TYR LYS ILE \nSEQRES 21 E 329 VAL LYS LYS GLY ASP SER ALA ILE VAL LYS SER GLU VAL \nSEQRES 22 E 329 GLU TYR GLY ASN CYS ASN THR LYS CYS GLN THR PRO ILE \nSEQRES 23 E 329 GLY ALA ILE ASN SER SER MET PRO PHE HIS ASN ILE HIS \nSEQRES 24 E 329 PRO LEU THR ILE GLY GLU CYS PRO LYS TYR VAL LYS SER \nSEQRES 25 E 329 ASN LYS LEU VAL LEU ALA THR GLY LEU ARG ASN SER PRO \nSEQRES 26 E 329 LEU ARG GLU ARG \nSEQRES 1 F 174 GLY LEU PHE GLY ALA ILE ALA GLY PHE ILE GLU GLY GLY \nSEQRES 2 F 174 TRP GLN GLY MET VAL ASP GLY TRP TYR GLY TYR HIS HIS \nSEQRES 3 F 174 SER ASN GLU GLN GLY SER GLY TYR ALA ALA ASP LYS GLU \nSEQRES 4 F 174 SER THR GLN LYS ALA ILE ASP GLY VAL THR ASN LYS VAL \nSEQRES 5 F 174 ASN SER ILE ILE ASP LYS MET ASN THR GLN PHE GLU ALA \nSEQRES 6 F 174 VAL GLY ARG GLU PHE ASN ASN LEU GLU ARG ARG ILE GLU \nSEQRES 7 F 174 ASN LEU ASN LYS LYS MET GLU ASP GLY PHE LEU ASP VAL \nSEQRES 8 F 174 TRP THR TYR ASN ALA GLU LEU LEU VAL LEU MET GLU ASN \nSEQRES 9 F 174 GLU ARG THR LEU ASP PHE HIS ASP SER ASN VAL LYS ASN \nSEQRES 10 F 174 LEU TYR ASP LYS VAL ARG LEU GLN LEU ARG ASP ASN ALA \nSEQRES 11 F 174 LYS GLU LEU GLY ASN GLY CYS PHE GLU PHE TYR HIS LYS \nSEQRES 12 F 174 CYS ASP ASN GLU CYS MET GLU SER VAL ARG ASN GLY THR \nSEQRES 13 F 174 TYR ASP TYR PRO GLN TYR SER GLU GLU ALA ARG LEU LYS \nSEQRES 14 F 174 ARG GLU GLU ILE SER \nHETNAM NAG 2-ACETAMIDO-2-DEOXY-BETA-D-GLUCOPYRANOSE \nHETSYN NAG N-ACETYL-BETA-D-GLUCOSAMINE; 2-ACETAMIDO-2-DEOXY-BETA- \nHETSYN 2 NAG D-GLUCOSE; 2-ACETAMIDO-2-DEOXY-D-GLUCOSE; 2-ACETAMIDO- \nHETSYN 3 NAG 2-DEOXY-GLUCOSE; N-ACETYL-D-GLUCOSAMINE \nFORMUL 7 NAG 4(C8 H15 N O6) \nFORMUL 11 HOH *155(H2 O) \nHELIX 1 1 SER A 56 LEU A 62 1 7 \nHELIX 2 2 ASN A 64 ILE A 71 5 8 \nHELIX 3 3 ASP A 97 LEU A 105 1 9 \nHELIX 4 4 ASP A 183 GLN A 192 1 10 \nHELIX 5 5 ASP B 37 LYS B 58 1 22 \nHELIX 6 6 GLU B 74 LEU B 126 1 53 \nHELIX 7 7 ASP B 145 ASN B 154 1 10 \nHELIX 8 8 TYR B 159 GLN B 161 5 3 \nHELIX 9 9 TYR B 162 GLU B 171 1 10 \nHELIX 10 10 SER C 56 GLY C 63 1 8 \nHELIX 11 11 ASN C 64 ILE C 71 5 8 \nHELIX 12 12 ASP C 97 LEU C 105 1 9 \nHELIX 13 13 ASP C 183 TYR C 191 1 9 \nHELIX 14 14 ASP D 37 LYS D 58 1 22 \nHELIX 15 15 GLU D 74 LEU D 126 1 53 \nHELIX 16 16 ASP D 145 ASN D 154 1 10 \nHELIX 17 17 TYR D 159 GLN D 161 5 3 \nHELIX 18 18 TYR D 162 GLU D 171 1 10 \nHELIX 19 19 SER E 56 GLY E 63 1 8 \nHELIX 20 20 CYS E 67 ILE E 71 5 5 \nHELIX 21 21 ASP E 97 LEU E 105 1 9 \nHELIX 22 22 PRO E 118 TRP E 122 5 5 \nHELIX 23 23 ASP E 183 TYR E 191 1 9 \nHELIX 24 24 ASP F 37 LYS F 58 1 22 \nHELIX 25 25 GLU F 74 LEU F 126 1 53 \nHELIX 26 26 ASP F 145 ASN F 154 1 10 \nHELIX 27 27 TYR F 159 GLN F 161 5 3 \nHELIX 28 28 TYR F 162 GLU F 171 1 10 \nSHEET 1 A 5 GLY B 31 ALA B 36 0 \nSHEET 2 A 5 TYR B 22 ASN B 28 -1 N TYR B 24 O ALA B 35 \nSHEET 3 A 5 GLN A 2 TYR A 7 -1 N GLN A 2 O SER B 27 \nSHEET 4 A 5 CYS B 137 PHE B 140 -1 O PHE B 138 N ILE A 3 \nSHEET 5 A 5 ALA B 130 GLU B 132 -1 N LYS B 131 O GLU B 139 \nSHEET 1 B 2 GLN A 15 VAL A 16 0 \nSHEET 2 B 2 VAL A 24 THR A 25 -1 O VAL A 24 N VAL A 16 \nSHEET 1 C 2 ALA A 29 ASP A 31 0 \nSHEET 2 C 2 VAL A 312 ALA A 314 -1 O LEU A 313 N GLN A 30 \nSHEET 1 D 3 LEU A 33 GLU A 34 0 \nSHEET 2 D 3 PHE A 291 HIS A 292 1 O PHE A 291 N GLU A 34 \nSHEET 3 D 3 LYS A 304 TYR A 305 1 O LYS A 304 N HIS A 292 \nSHEET 1 E 2 LEU A 41 LEU A 44 0 \nSHEET 2 E 2 TYR A 271 THR A 276 1 O CYS A 274 N ASP A 43 \nSHEET 1 F 3 LEU A 50 ILE A 51 0 \nSHEET 2 F 3 ILE A 79 VAL A 80 1 O VAL A 80 N LEU A 50 \nSHEET 3 F 3 ILE A 264 VAL A 265 1 O VAL A 265 N ILE A 79 \nSHEET 1 G 5 PHE A 111 GLN A 115 0 \nSHEET 2 G 5 TYR A 252 ILE A 256 -1 O ALA A 253 N ILE A 114 \nSHEET 3 G 5 LEU A 172 HIS A 180 -1 N LEU A 173 O TYR A 254 \nSHEET 4 G 5 PHE A 247 PRO A 250 -1 O ILE A 248 N GLY A 177 \nSHEET 5 G 5 VAL A 147 TRP A 149 -1 N VAL A 148 O ALA A 249 \nSHEET 1 H 4 PHE A 111 GLN A 115 0 \nSHEET 2 H 4 TYR A 252 ILE A 256 -1 O ALA A 253 N ILE A 114 \nSHEET 3 H 4 LEU A 172 HIS A 180 -1 N LEU A 173 O TYR A 254 \nSHEET 4 H 4 ARG A 225 LEU A 233 -1 O PHE A 229 N TRP A 176 \nSHEET 1 I 2 HIS A 125 GLU A 126 0 \nSHEET 2 I 2 ILE A 151 LYS A 152 -1 O ILE A 151 N GLU A 126 \nSHEET 1 J 2 SER A 132 PRO A 136 0 \nSHEET 2 J 2 PRO A 141 SER A 142 -1 O SER A 142 N CYS A 135 \nSHEET 1 K 4 ILE A 160 ASN A 165 0 \nSHEET 2 K 4 ALA A 238 SER A 243 -1 O SER A 243 N ILE A 160 \nSHEET 3 K 4 ILE A 198 GLY A 201 -1 N GLY A 201 O ASN A 240 \nSHEET 4 K 4 ASN A 206 LEU A 209 -1 O LEU A 209 N ILE A 198 \nSHEET 1 L 3 GLY A 283 ALA A 284 0 \nSHEET 2 L 3 CYS A 278 THR A 280 -1 N THR A 280 O GLY A 283 \nSHEET 3 L 3 ILE A 299 GLY A 300 -1 O ILE A 299 N GLN A 279 \nSHEET 1 M 5 GLY D 31 ALA D 36 0 \nSHEET 2 M 5 TYR D 22 ASN D 28 -1 N TYR D 24 O ALA D 35 \nSHEET 3 M 5 GLN C 2 TYR C 7 -1 N GLY C 6 O GLY D 23 \nSHEET 4 M 5 CYS D 137 PHE D 140 -1 O PHE D 138 N ILE C 3 \nSHEET 5 M 5 ALA D 130 GLU D 132 -1 N LYS D 131 O GLU D 139 \nSHEET 1 N 2 GLN C 15 VAL C 16 0 \nSHEET 2 N 2 VAL C 24 THR C 25 -1 O VAL C 24 N VAL C 16 \nSHEET 1 O 2 ALA C 29 ASP C 31 0 \nSHEET 2 O 2 VAL C 312 ALA C 314 -1 O LEU C 313 N GLN C 30 \nSHEET 1 P 3 LEU C 33 GLU C 34 0 \nSHEET 2 P 3 PHE C 291 HIS C 292 1 O PHE C 291 N GLU C 34 \nSHEET 3 P 3 LYS C 304 TYR C 305 1 O LYS C 304 N HIS C 292 \nSHEET 1 Q 2 LEU C 41 LEU C 44 0 \nSHEET 2 Q 2 TYR C 271 THR C 276 1 O CYS C 274 N ASP C 43 \nSHEET 1 R 3 LEU C 50 ILE C 51 0 \nSHEET 2 R 3 ILE C 79 GLU C 81 1 O VAL C 80 N LEU C 50 \nSHEET 3 R 3 ILE C 264 LYS C 266 1 O VAL C 265 N GLU C 81 \nSHEET 1 S 5 PHE C 111 GLN C 115 0 \nSHEET 2 S 5 TYR C 252 ILE C 256 -1 O ALA C 253 N ILE C 114 \nSHEET 3 S 5 LEU C 172 HIS C 180 -1 N LEU C 173 O TYR C 254 \nSHEET 4 S 5 PHE C 247 PRO C 250 -1 O ILE C 248 N GLY C 177 \nSHEET 5 S 5 VAL C 147 TRP C 149 -1 N VAL C 148 O ALA C 249 \nSHEET 1 T 4 PHE C 111 GLN C 115 0 \nSHEET 2 T 4 TYR C 252 ILE C 256 -1 O ALA C 253 N ILE C 114 \nSHEET 3 T 4 LEU C 172 HIS C 180 -1 N LEU C 173 O TYR C 254 \nSHEET 4 T 4 ARG C 225 LEU C 233 -1 O PHE C 229 N TRP C 176 \nSHEET 1 U 2 HIS C 125 GLU C 126 0 \nSHEET 2 U 2 ILE C 151 LYS C 152 -1 O ILE C 151 N GLU C 126 \nSHEET 1 V 2 SER C 132 PRO C 136 0 \nSHEET 2 V 2 PRO C 141 SER C 142 -1 O SER C 142 N CYS C 135 \nSHEET 1 W 4 ILE C 160 ASN C 165 0 \nSHEET 2 W 4 ALA C 238 SER C 243 -1 O SER C 243 N ILE C 160 \nSHEET 3 W 4 ILE C 198 GLY C 201 -1 N GLY C 201 O ASN C 240 \nSHEET 4 W 4 ASN C 206 LEU C 209 -1 O LEU C 209 N ILE C 198 \nSHEET 1 X 3 GLY C 283 ALA C 284 0 \nSHEET 2 X 3 CYS C 278 THR C 280 -1 N THR C 280 O GLY C 283 \nSHEET 3 X 3 ILE C 299 GLY C 300 -1 O ILE C 299 N GLN C 279 \nSHEET 1 Y 5 GLY F 31 ALA F 36 0 \nSHEET 2 Y 5 TYR F 22 ASN F 28 -1 N TYR F 24 O ALA F 35 \nSHEET 3 Y 5 GLN E 2 TYR E 7 -1 N GLN E 2 O SER F 27 \nSHEET 4 Y 5 CYS F 137 PHE F 140 -1 O PHE F 138 N ILE E 3 \nSHEET 5 Y 5 ALA F 130 GLU F 132 -1 N LYS F 131 O GLU F 139 \nSHEET 1 Z 2 GLN E 15 VAL E 16 0 \nSHEET 2 Z 2 VAL E 24 THR E 25 -1 O VAL E 24 N VAL E 16 \nSHEET 1 AA 2 ALA E 29 ASP E 31 0 \nSHEET 2 AA 2 VAL E 312 ALA E 314 -1 O LEU E 313 N GLN E 30 \nSHEET 1 AB 3 LEU E 33 GLU E 34 0 \nSHEET 2 AB 3 PHE E 291 HIS E 292 1 O PHE E 291 N GLU E 34 \nSHEET 3 AB 3 LYS E 304 TYR E 305 1 O LYS E 304 N HIS E 292 \nSHEET 1 AC 2 LEU E 41 LEU E 44 0 \nSHEET 2 AC 2 TYR E 271 THR E 276 1 O CYS E 274 N ASP E 43 \nSHEET 1 AD 3 LEU E 50 ILE E 51 0 \nSHEET 2 AD 3 ILE E 79 VAL E 80 1 O VAL E 80 N LEU E 50 \nSHEET 3 AD 3 ILE E 264 VAL E 265 1 O VAL E 265 N ILE E 79 \nSHEET 1 AE 5 PHE E 111 GLN E 115 0 \nSHEET 2 AE 5 TYR E 252 ILE E 256 -1 O ALA E 253 N ILE E 114 \nSHEET 3 AE 5 LEU E 172 HIS E 180 -1 N LEU E 173 O TYR E 254 \nSHEET 4 AE 5 PHE E 247 PRO E 250 -1 O ILE E 248 N GLY E 177 \nSHEET 5 AE 5 VAL E 147 TRP E 149 -1 N VAL E 148 O ALA E 249 \nSHEET 1 AF 4 PHE E 111 GLN E 115 0 \nSHEET 2 AF 4 TYR E 252 ILE E 256 -1 O ALA E 253 N ILE E 114 \nSHEET 3 AF 4 LEU E 172 HIS E 180 -1 N LEU E 173 O TYR E 254 \nSHEET 4 AF 4 ARG E 225 LEU E 233 -1 O PHE E 229 N TRP E 176 \nSHEET 1 AG 2 HIS E 125 GLU E 126 0 \nSHEET 2 AG 2 ILE E 151 LYS E 152 -1 O ILE E 151 N GLU E 126 \nSHEET 1 AH 2 SER E 132 PRO E 136 0 \nSHEET 2 AH 2 PRO E 141 SER E 142 -1 O SER E 142 N CYS E 135 \nSHEET 1 AI 4 ILE E 160 ASN E 165 0 \nSHEET 2 AI 4 ALA E 238 SER E 243 -1 O PHE E 241 N ARG E 162 \nSHEET 3 AI 4 ILE E 198 GLY E 201 -1 N GLY E 201 O ASN E 240 \nSHEET 4 AI 4 ASN E 206 LEU E 209 -1 O LEU E 209 N ILE E 198 \nSHEET 1 AJ 3 GLY E 283 ALA E 284 0 \nSHEET 2 AJ 3 CYS E 278 THR E 280 -1 N THR E 280 O GLY E 283 \nSHEET 3 AJ 3 ILE E 299 GLY E 300 -1 O ILE E 299 N GLN E 279 \nSSBOND 1 CYS A 4 CYS B 137 1555 1555 2.05 \nSSBOND 2 CYS A 42 CYS A 274 1555 1555 2.04 \nSSBOND 3 CYS A 55 CYS A 67 1555 1555 2.01 \nSSBOND 4 CYS A 90 CYS A 135 1555 1555 2.02 \nSSBOND 5 CYS A 278 CYS A 302 1555 1555 2.03 \nSSBOND 6 CYS B 144 CYS B 148 1555 1555 2.06 \nSSBOND 7 CYS C 4 CYS D 137 1555 1555 2.07 \nSSBOND 8 CYS C 42 CYS C 274 1555 1555 2.04 \nSSBOND 9 CYS C 55 CYS C 67 1555 1555 2.03 \nSSBOND 10 CYS C 90 CYS C 135 1555 1555 2.05 \nSSBOND 11 CYS C 278 CYS C 302 1555 1555 2.05 \nSSBOND 12 CYS D 144 CYS D 148 1555 1555 2.04 \nSSBOND 13 CYS E 4 CYS F 137 1555 1555 2.02 \nSSBOND 14 CYS E 42 CYS E 274 1555 1555 2.08 \nSSBOND 15 CYS E 55 CYS E 67 1555 1555 2.03 \nSSBOND 16 CYS E 90 CYS E 135 1555 1555 2.03 \nSSBOND 17 CYS E 278 CYS E 302 1555 1555 2.08 \nSSBOND 18 CYS F 144 CYS F 148 1555 1555 2.06 \nLINK ND2 ASN A 165 C1 NAG A 401 1555 1555 1.46 \nLINK ND2 ASN B 154 C1 NAG B 201 1555 1555 1.45 \nLINK ND2 ASN D 154 C1 NAG D 201 1555 1555 1.46 \nLINK ND2 ASN E 165 C1 NAG E 401 1555 1555 1.44 \nCISPEP 1 VAL A 257 LYS A 258 0 15.39 \nCISPEP 2 VAL C 257 LYS C 258 0 13.75 \nCISPEP 3 VAL E 257 LYS E 258 0 10.40 \nCRYST1 114.372 114.372 134.890 90.00 90.00 120.00 P 3 9 \nORIGX1 1.000000 0.000000 0.000000 0.00000 \nORIGX2 0.000000 1.000000 0.000000 0.00000 \nORIGX3 0.000000 0.000000 1.000000 0.00000 \nSCALE1 0.008743 0.005048 0.000000 0.00000 \nSCALE2 0.000000 0.010096 0.000000 0.00000 \nSCALE3 0.000000 0.000000 0.007413 0.00000 \nMTRIX1 1 1.000000 0.000000 0.000000 0.00000 1 \nMTRIX2 1 0.000000 1.000000 0.000000 0.00000 1 \nMTRIX3 1 0.000000 0.000000 1.000000 0.00000 1 \nMTRIX1 2 -0.493840 -0.869547 -0.003120 57.20964 1 \nMTRIX2 2 -0.869551 0.493843 -0.000016 33.16819 1 \nMTRIX3 2 0.001555 0.002705 -0.999995 -14.45997 1 \nMTRIX1 3 -0.152916 0.988204 0.008384 42.31437 1 \nMTRIX2 3 -0.988239 -0.152915 -0.000832 51.06919 1 \nMTRIX3 3 0.000460 -0.008412 0.999965 25.02433 1 \nMODEL 1 \nATOM 1 N PRO A -1 16.518 15.021 33.812 1.00108.74 N \nANISOU 1 N PRO A -1 13644 13962 13711 -3983 -1018 181 N \nATOM 2 CA PRO A -1 15.417 14.440 33.040 1.00107.88 C \nANISOU 2 CA PRO A -1 13518 13817 13656 -3861 -1014 198 C \nATOM 3 C PRO A -1 15.488 12.899 33.107 1.00112.82 C \nANISOU 3 C PRO A -1 14031 14488 14346 -3841 -1113 272 C \nATOM 4 O PRO A -1 15.678 12.359 34.202 1.00118.90 O \nANISOU 4 O PRO A -1 14761 15326 15088 -3913 -1170 308 O \nATOM 5 CB PRO A -1 15.690 14.975 31.636 1.00101.66 C \nANISOU 5 CB PRO A -1 12763 12951 12912 -3793 -964 163 C \nATOM 6 CG PRO A -1 17.191 14.936 31.560 1.00104.61 C \nANISOU 6 CG PRO A -1 13094 13350 13303 -3869 -1001 171 C \nATOM 7 CD PRO A -1 17.688 15.291 32.955 1.00106.32 C \nANISOU 7 CD PRO A -1 13326 13631 13440 -3997 -1015 167 C \nATOM 8 N GLY A 0 15.332 12.204 31.973 1.00102.11 N \nANISOU 8 N GLY A 0 12632 13095 13071 -3746 -1132 293 N \nATOM 9 CA GLY A 0 15.599 10.768 31.903 1.00 89.42 C \nANISOU 9 CA GLY A 0 10930 11519 11529 -3726 -1226 361 C \nATOM 10 C GLY A 0 16.242 10.421 30.578 1.00 79.86 C \nANISOU 10 C GLY A 0 9680 10264 10401 -3657 -1239 366 C \nATOM 11 O GLY A 0 16.192 11.208 29.641 1.00 73.60 O \nANISOU 11 O GLY A 0 8934 9413 9619 -3611 -1172 320 O \nATOM 12 N ASP A 1 16.844 9.237 30.515 1.00 76.06 N \nANISOU 12 N ASP A 1 9117 9808 9973 -3648 -1324 421 N \nATOM 13 CA ASP A 1 17.537 8.781 29.313 1.00 76.02 C \nANISOU 13 CA ASP A 1 9067 9771 10046 -3582 -1346 430 C \nATOM 14 C ASP A 1 16.538 8.578 28.209 1.00 72.75 C \nANISOU 14 C ASP A 1 8670 9292 9681 -3475 -1313 423 C \nATOM 15 O ASP A 1 15.358 8.348 28.463 1.00 79.13 O \nANISOU 15 O ASP A 1 9497 10097 10471 -3450 -1304 433 O \nATOM 16 CB ASP A 1 18.302 7.472 29.566 1.00 76.89 C \nANISOU 16 CB ASP A 1 9092 9925 10199 -3584 -1449 495 C \nATOM 17 CG ASP A 1 19.290 7.573 30.712 1.00 77.18 C \nANISOU 17 CG ASP A 1 9101 10039 10185 -3688 -1489 509 C \nATOM 18 OD1 ASP A 1 19.705 8.701 31.093 1.00 79.02 O \nANISOU 18 OD1 ASP A 1 9375 10290 10361 -3763 -1437 463 O \nATOM 19 OD2 ASP A 1 19.656 6.508 31.224 1.00 76.73 O \nANISOU 19 OD2 ASP A 1 8986 10024 10142 -3696 -1573 566 O \nATOM 20 N GLN A 2 17.019 8.638 26.977 1.00 73.15 N \nANISOU 20 N GLN A 2 8707 9298 9789 -3414 -1298 407 N \nATOM 21 CA GLN A 2 16.152 8.561 25.812 1.00 68.19 C \nANISOU 21 CA GLN A 2 8096 8606 9206 -3312 -1260 395 C \nATOM 22 C GLN A 2 16.748 7.741 24.695 1.00 65.93 C \nANISOU 22 C GLN A 2 7752 8293 9004 -3243 -1301 418 C \nATOM 23 O GLN A 2 17.939 7.833 24.441 1.00 72.46 O \nANISOU 23 O GLN A 2 8547 9134 9850 -3264 -1318 413 O \nATOM 24 CB GLN A 2 15.868 9.969 25.288 1.00 67.85 C \nANISOU 24 CB GLN A 2 8133 8516 9130 -3299 -1160 329 C \nATOM 25 CG GLN A 2 14.845 10.734 26.117 1.00 69.48 C \nANISOU 25 CG GLN A 2 8410 8731 9258 -3326 -1106 302 C \nATOM 26 CD GLN A 2 14.368 11.987 25.426 1.00 65.59 C \nANISOU 26 CD GLN A 2 8003 8178 8739 -3282 -1008 241 C \nATOM 27 OE1 GLN A 2 14.484 12.121 24.205 1.00 59.84 O \nANISOU 27 OE1 GLN A 2 7279 7399 8061 -3215 -981 225 O \nATOM 28 NE2 GLN A 2 13.859 12.932 26.210 1.00 66.69 N \nANISOU 28 NE2 GLN A 2 8217 8324 8798 -3321 -953 206 N \nATOM 29 N ILE A 3 15.908 6.985 23.994 1.00 63.89 N \nANISOU 29 N ILE A 3 7482 8001 8793 -3162 -1313 439 N \nATOM 30 CA ILE A 3 16.275 6.459 22.689 1.00 60.05 C \nANISOU 30 CA ILE A 3 6961 7472 8383 -3081 -1327 445 C \nATOM 31 C ILE A 3 15.267 6.938 21.677 1.00 60.33 C \nANISOU 31 C ILE A 3 7039 7450 8432 -3006 -1257 411 C \nATOM 32 O ILE A 3 14.092 7.059 21.989 1.00 63.82 O \nANISOU 32 O ILE A 3 7515 7895 8840 -2996 -1229 409 O \nATOM 33 CB ILE A 3 16.437 4.924 22.695 1.00 57.90 C \nANISOU 33 CB ILE A 3 6627 7209 8161 -3052 -1421 507 C \nATOM 34 CG1 ILE A 3 17.252 4.495 21.484 1.00 57.67 C \nANISOU 34 CG1 ILE A 3 6557 7149 8205 -2984 -1439 508 C \nATOM 35 CG2 ILE A 3 15.085 4.224 22.699 1.00 58.66 C \nANISOU 35 CG2 ILE A 3 6737 7290 8259 -3016 -1431 534 C \nATOM 36 CD1 ILE A 3 17.940 3.172 21.654 1.00 56.73 C \nANISOU 36 CD1 ILE A 3 6379 7050 8126 -2969 -1535 564 C \nATOM 37 N CYS A 4 15.722 7.175 20.451 1.00 66.68 N \nANISOU 37 N CYS A 4 7838 8211 9285 -2950 -1229 387 N \nATOM 38 CA CYS A 4 14.839 7.666 19.354 1.00 68.22 C \nANISOU 38 CA CYS A 4 8074 8351 9496 -2871 -1161 354 C \nATOM 39 C CYS A 4 14.941 6.833 18.070 1.00 66.44 C \nANISOU 39 C CYS A 4 7806 8088 9352 -2786 -1186 371 C \nATOM 40 O CYS A 4 15.971 6.268 17.766 1.00 63.02 O \nANISOU 40 O CYS A 4 7322 7659 8963 -2783 -1234 388 O \nATOM 41 CB CYS A 4 15.148 9.116 19.046 1.00 68.04 C \nANISOU 41 CB CYS A 4 8113 8301 9438 -2886 -1078 295 C \nATOM 42 SG CYS A 4 14.910 10.244 20.454 1.00 72.81 S \nANISOU 42 SG CYS A 4 8788 8937 9940 -2979 -1034 266 S \nATOM 43 N ILE A 5 13.835 6.731 17.338 1.00 72.56 N \nANISOU 43 N ILE A 5 8599 8830 10141 -2715 -1154 366 N \nATOM 44 CA ILE A 5 13.835 6.092 16.024 1.00 67.14 C \nANISOU 44 CA ILE A 5 7882 8102 9526 -2634 -1165 374 C \nATOM 45 C ILE A 5 13.760 7.161 14.990 1.00 62.66 C \nANISOU 45 C ILE A 5 7355 7489 8962 -2588 -1084 323 C \nATOM 46 O ILE A 5 12.931 8.045 15.079 1.00 64.50 O \nANISOU 46 O ILE A 5 7645 7715 9148 -2579 -1019 293 O \nATOM 47 CB ILE A 5 12.651 5.132 15.852 1.00 73.95 C \nANISOU 47 CB ILE A 5 8733 8963 10403 -2590 -1191 408 C \nATOM 48 CG1 ILE A 5 12.552 4.184 17.057 1.00 81.95 C \nANISOU 48 CG1 ILE A 5 9723 10022 11395 -2648 -1266 458 C \nATOM 49 CG2 ILE A 5 12.804 4.319 14.577 1.00 71.79 C \nANISOU 49 CG2 ILE A 5 8426 8648 10204 -2515 -1215 420 C \nATOM 50 CD1 ILE A 5 13.823 3.424 17.403 1.00 84.12 C \nANISOU 50 CD1 ILE A 5 9952 10309 11701 -2678 -1343 491 C \nATOM 51 N GLY A 6 14.661 7.099 14.021 1.00 66.85 N \nANISOU 51 N GLY A 6 7860 7994 9546 -2558 -1087 312 N \nATOM 52 CA GLY A 6 14.773 8.148 13.008 1.00 68.04 C \nANISOU 52 CA GLY A 6 8051 8100 9699 -2523 -1012 263 C \nATOM 53 C GLY A 6 15.334 7.627 11.691 1.00 69.78 C \nANISOU 53 C GLY A 6 8229 8289 9993 -2460 -1027 265 C \nATOM 54 O GLY A 6 15.523 6.411 11.511 1.00 67.75 O \nANISOU 54 O GLY A 6 7915 8041 9788 -2433 -1095 303 O \nATOM 55 N TYR A 7 15.638 8.553 10.782 1.00 68.78 N \nANISOU 55 N TYR A 7 8135 8127 9871 -2439 -965 222 N \nATOM 56 CA TYR A 7 16.085 8.185 9.436 1.00 69.70 C \nANISOU 56 CA TYR A 7 8216 8213 10053 -2375 -969 217 C \nATOM 57 C TYR A 7 17.058 9.194 8.808 1.00 78.28 C \nANISOU 57 C TYR A 7 9324 9284 11134 -2397 -921 174 C \nATOM 58 O TYR A 7 17.287 10.279 9.331 1.00 82.04 O \nANISOU 58 O TYR A 7 9857 9763 11553 -2459 -876 145 O \nATOM 59 CB TYR A 7 14.881 7.955 8.514 1.00 65.47 C \nANISOU 59 CB TYR A 7 7695 7638 9542 -2288 -940 218 C \nATOM 60 CG TYR A 7 13.932 9.139 8.370 1.00 64.07 C \nANISOU 60 CG TYR A 7 7597 7434 9313 -2268 -855 182 C \nATOM 61 CD1 TYR A 7 14.075 10.036 7.325 1.00 66.90 C \nANISOU 61 CD1 TYR A 7 7996 7747 9675 -2232 -791 142 C \nATOM 62 CD2 TYR A 7 12.885 9.335 9.249 1.00 60.43 C \nANISOU 62 CD2 TYR A 7 7170 6993 8796 -2279 -840 188 C \nATOM 63 CE1 TYR A 7 13.204 11.085 7.157 1.00 68.07 C \nANISOU 63 CE1 TYR A 7 8222 7867 9774 -2202 -715 111 C \nATOM 64 CE2 TYR A 7 12.015 10.401 9.099 1.00 65.66 C \nANISOU 64 CE2 TYR A 7 7906 7634 9408 -2248 -763 154 C \nATOM 65 CZ TYR A 7 12.181 11.271 8.043 1.00 68.68 C \nANISOU 65 CZ TYR A 7 8332 7966 9796 -2206 -701 117 C \nATOM 66 OH TYR A 7 11.342 12.353 7.881 1.00 76.12 O \nANISOU 66 OH TYR A 7 9355 8882 10685 -2166 -624 84 O \nATOM 67 N HIS A 8 17.635 8.802 7.683 1.00 80.73 N \nANISOU 67 N HIS A 8 9591 9578 11502 -2350 -932 172 N \nATOM 68 CA HIS A 8 18.655 9.591 7.013 1.00 81.79 C \nANISOU 68 CA HIS A 8 9733 9708 11637 -2373 -896 135 C \nATOM 69 C HIS A 8 18.142 10.946 6.552 1.00 85.24 C \nANISOU 69 C HIS A 8 10264 10094 12031 -2370 -805 90 C \nATOM 70 O HIS A 8 16.978 11.103 6.186 1.00 95.04 O \nANISOU 70 O HIS A 8 11547 11295 13269 -2309 -768 86 O \nATOM 71 CB HIS A 8 19.199 8.805 5.829 1.00 83.51 C \nANISOU 71 CB HIS A 8 9884 9919 11926 -2309 -926 143 C \nATOM 72 CG HIS A 8 20.552 9.243 5.358 1.00 94.32 C \nANISOU 72 CG HIS A 8 11226 11313 13298 -2347 -919 117 C \nATOM 73 ND1 HIS A 8 20.858 10.547 5.043 1.00 95.94 N \nANISOU 73 ND1 HIS A 8 11492 11500 13461 -2391 -849 73 N \nATOM 74 CD2 HIS A 8 21.677 8.529 5.110 1.00 99.29 C \nANISOU 74 CD2 HIS A 8 11772 11989 13964 -2344 -973 130 C \nATOM 75 CE1 HIS A 8 22.111 10.622 4.640 1.00 99.71 C \nANISOU 75 CE1 HIS A 8 11923 12016 13947 -2424 -860 60 C \nATOM 76 NE2 HIS A 8 22.631 9.409 4.673 1.00 98.21 N \nANISOU 76 NE2 HIS A 8 11640 11870 13804 -2392 -935 93 N \nATOM 77 N ALA A 9 19.010 11.943 6.622 1.00 85.74 N \nANISOU 77 N ALA A 9 10362 10161 12054 -2440 -769 57 N \nATOM 78 CA ALA A 9 18.755 13.232 5.988 1.00 91.53 C \nANISOU 78 CA ALA A 9 11189 10838 12750 -2437 -684 12 C \nATOM 79 C ALA A 9 20.056 13.719 5.370 1.00 94.22 C \nANISOU 79 C ALA A 9 11518 11190 13091 -2487 -671 -14 C \nATOM 80 O ALA A 9 21.132 13.266 5.751 1.00 97.60 O \nANISOU 80 O ALA A 9 11875 11680 13527 -2543 -722 -2 O \nATOM 81 CB ALA A 9 18.228 14.253 6.982 1.00 92.44 C \nANISOU 81 CB ALA A 9 11401 10939 12783 -2489 -637 -8 C \nATOM 82 N ASN A 10 19.941 14.609 4.390 1.00 88.75 N \nANISOU 82 N ASN A 10 10892 10441 12388 -2465 -604 -49 N \nATOM 83 CA ASN A 10 21.103 15.247 3.791 1.00 87.25 C \nANISOU 83 CA ASN A 10 10708 10258 12185 -2524 -581 -79 C \nATOM 84 C ASN A 10 20.744 16.612 3.170 1.00 93.65 C \nANISOU 84 C ASN A 10 11643 10993 12947 -2526 -492 -122 C \nATOM 85 O ASN A 10 19.696 17.188 3.465 1.00100.06 O \nANISOU 85 O ASN A 10 12544 11753 13720 -2495 -447 -131 O \nATOM 86 CB ASN A 10 21.861 14.308 2.830 1.00 76.62 C \nANISOU 86 CB ASN A 10 9253 8947 10913 -2482 -627 -66 C \nATOM 87 CG ASN A 10 21.032 13.880 1.615 1.00 81.72 C \nANISOU 87 CG ASN A 10 9892 9539 11618 -2365 -612 -61 C \nATOM 88 OD1 ASN A 10 20.071 14.541 1.239 1.00 84.90 O \nANISOU 88 OD1 ASN A 10 10379 9879 12001 -2322 -554 -77 O \nATOM 89 ND2 ASN A 10 21.438 12.779 0.968 1.00 70.36 N \nANISOU 89 ND2 ASN A 10 8355 8130 10249 -2312 -665 -40 N \nATOM 90 N ASN A 11 21.638 17.133 2.348 1.00102.82 N \nANISOU 90 N ASN A 11 12812 12150 14103 -2563 -466 -148 N \nATOM 91 CA ASN A 11 21.475 18.446 1.731 1.00112.57 C \nANISOU 91 CA ASN A 11 14172 13312 15287 -2577 -384 -189 C \nATOM 92 C ASN A 11 21.015 18.320 0.275 1.00117.73 C \nANISOU 92 C ASN A 11 14824 13916 15993 -2474 -358 -193 C \nATOM 93 O ASN A 11 20.905 19.316 -0.443 1.00120.99 O \nANISOU 93 O ASN A 11 15333 14266 16372 -2472 -293 -223 O \nATOM 94 CB ASN A 11 22.793 19.231 1.820 1.00113.91 C \nANISOU 94 CB ASN A 11 14367 13512 15403 -2706 -368 -218 C \nATOM 95 CG ASN A 11 24.001 18.415 1.369 1.00110.15 C \nANISOU 95 CG ASN A 11 13756 13120 14975 -2731 -424 -206 C \nATOM 96 OD1 ASN A 11 23.864 17.336 0.779 1.00 99.60 O \nANISOU 96 OD1 ASN A 11 12323 11804 13718 -2641 -467 -181 O \nATOM 97 ND2 ASN A 11 25.198 18.924 1.663 1.00109.74 N \nANISOU 97 ND2 ASN A 11 13700 13123 14872 -2853 -423 -225 N \nATOM 98 N SER A 12 20.758 17.084 -0.147 1.00118.09 N \nANISOU 98 N SER A 12 14763 13989 16117 -2391 -410 -161 N \nATOM 99 CA SER A 12 20.288 16.789 -1.496 1.00111.27 C \nANISOU 99 CA SER A 12 13883 13087 15309 -2291 -394 -161 C \nATOM 100 C SER A 12 19.043 17.597 -1.814 1.00106.06 C \nANISOU 100 C SER A 12 13335 12348 14616 -2225 -326 -175 C \nATOM 101 O SER A 12 18.191 17.807 -0.945 1.00108.41 O \nANISOU 101 O SER A 12 13683 12633 14876 -2214 -315 -169 O \nATOM 102 CB SER A 12 19.995 15.293 -1.642 1.00113.56 C \nANISOU 102 CB SER A 12 14055 13414 15678 -2214 -463 -122 C \nATOM 103 OG SER A 12 19.128 15.056 -2.720 1.00121.50 O \nANISOU 103 OG SER A 12 15064 14374 16725 -2110 -441 -119 O \nATOM 104 N THR A 13 18.956 18.045 -3.062 1.00 99.86 N \nANISOU 104 N THR A 13 12587 11515 13842 -2179 -281 -194 N \nATOM 105 CA THR A 13 17.843 18.880 -3.524 1.00 98.16 C \nANISOU 105 CA THR A 13 12482 11224 13591 -2107 -213 -209 C \nATOM 106 C THR A 13 17.087 18.224 -4.687 1.00 91.16 C \nANISOU 106 C THR A 13 11547 10322 12768 -1989 -215 -195 C \nATOM 107 O THR A 13 16.189 18.821 -5.260 1.00 86.71 O \nANISOU 107 O THR A 13 11059 9704 12182 -1917 -162 -205 O \nATOM 108 CB THR A 13 18.359 20.235 -4.013 1.00 98.65 C \nANISOU 108 CB THR A 13 12661 11229 13593 -2161 -146 -249 C \nATOM 109 OG1 THR A 13 19.414 19.998 -4.946 1.00103.60 O \nANISOU 109 OG1 THR A 13 13225 11879 14259 -2193 -160 -256 O \nATOM 110 CG2 THR A 13 18.878 21.065 -2.861 1.00101.45 C \nANISOU 110 CG2 THR A 13 13093 11583 13869 -2275 -130 -267 C \nATOM 111 N GLU A 14 17.464 17.002 -5.027 1.00 88.48 N \nANISOU 111 N GLU A 14 11084 10032 12503 -1969 -277 -171 N \nATOM 112 CA GLU A 14 16.789 16.250 -6.066 1.00 93.03 C \nANISOU 112 CA GLU A 14 11606 10600 13140 -1865 -286 -155 C \nATOM 113 C GLU A 14 15.335 16.013 -5.663 1.00 95.31 C \nANISOU 113 C GLU A 14 11914 10882 13418 -1790 -281 -135 C \nATOM 114 O GLU A 14 15.034 15.483 -4.585 1.00 96.87 O \nANISOU 114 O GLU A 14 12081 11115 13609 -1809 -320 -113 O \nATOM 115 CB GLU A 14 17.479 14.914 -6.331 1.00 94.45 C \nANISOU 115 CB GLU A 14 11656 10834 13396 -1862 -359 -133 C \nATOM 116 CG GLU A 14 18.901 15.049 -6.864 1.00 99.20 C \nANISOU 116 CG GLU A 14 12222 11459 14012 -1923 -366 -152 C \nATOM 117 CD GLU A 14 19.695 13.755 -6.777 1.00 97.35 C \nANISOU 117 CD GLU A 14 11861 11289 13837 -1927 -444 -129 C \nATOM 118 OE1 GLU A 14 19.481 12.989 -5.821 1.00 87.98 O \nANISOU 118 OE1 GLU A 14 10633 10135 12662 -1930 -495 -101 O \nATOM 119 OE2 GLU A 14 20.533 13.502 -7.665 1.00 98.69 O \nANISOU 119 OE2 GLU A 14 11977 11479 14042 -1925 -453 -139 O \nATOM 120 N GLN A 15 14.441 16.467 -6.527 1.00 87.84 N \nANISOU 120 N GLN A 15 11020 9892 12462 -1708 -230 -144 N \nATOM 121 CA GLN A 15 13.026 16.298 -6.326 1.00 82.06 C \nANISOU 121 CA GLN A 15 10301 9163 11715 -1628 -219 -128 C \nATOM 122 C GLN A 15 12.528 15.083 -7.099 1.00 84.99 C \nANISOU 122 C GLN A 15 10576 9561 12155 -1557 -258 -101 C \nATOM 123 O GLN A 15 13.221 14.536 -7.956 1.00 86.16 O \nANISOU 123 O GLN A 15 10664 9712 12361 -1556 -282 -101 O \nATOM 124 CB GLN A 15 12.286 17.539 -6.751 1.00 80.23 C \nANISOU 124 CB GLN A 15 10186 8875 11422 -1575 -139 -152 C \nATOM 125 CG GLN A 15 12.428 18.682 -5.772 1.00 90.71 C \nANISOU 125 CG GLN A 15 11624 10174 12669 -1633 -100 -175 C \nATOM 126 CD GLN A 15 11.778 19.960 -6.280 1.00 94.03 C \nANISOU 126 CD GLN A 15 12175 10528 13026 -1573 -19 -201 C \nATOM 127 OE1 GLN A 15 11.161 19.973 -7.350 1.00 90.17 O \nANISOU 127 OE1 GLN A 15 11688 10021 12553 -1483 7 -199 O \nATOM 128 NE2 GLN A 15 11.902 21.035 -5.508 1.00 93.41 N \nANISOU 128 NE2 GLN A 15 12209 10411 12870 -1620 21 -224 N \nATOM 129 N VAL A 16 11.307 14.674 -6.785 1.00 78.41 N \nANISOU 129 N VAL A 16 9730 8751 11310 -1500 -264 -80 N \nATOM 130 CA VAL A 16 10.742 13.448 -7.319 1.00 70.53 C \nANISOU 130 CA VAL A 16 8645 7785 10368 -1446 -306 -52 C \nATOM 131 C VAL A 16 9.255 13.559 -7.235 1.00 72.90 C \nANISOU 131 C VAL A 16 8968 8102 10628 -1375 -278 -42 C \nATOM 132 O VAL A 16 8.733 14.246 -6.359 1.00 80.06 O \nANISOU 132 O VAL A 16 9935 9014 11471 -1380 -250 -48 O \nATOM 133 CB VAL A 16 11.245 12.234 -6.517 1.00 73.84 C \nANISOU 133 CB VAL A 16 8980 8248 10828 -1501 -387 -23 C \nATOM 134 CG1 VAL A 16 10.112 11.312 -6.126 1.00 75.37 C \nANISOU 134 CG1 VAL A 16 9131 8483 11023 -1466 -420 9 C \nATOM 135 CG2 VAL A 16 12.316 11.493 -7.287 1.00 69.16 C \nANISOU 135 CG2 VAL A 16 8318 7653 10305 -1513 -427 -22 C \nATOM 136 N ASP A 17 8.565 12.931 -8.171 1.00 73.77 N \nANISOU 136 N ASP A 17 9033 8226 10771 -1306 -283 -29 N \nATOM 137 CA ASP A 17 7.095 13.008 -8.170 1.00 79.02 C \nANISOU 137 CA ASP A 17 9709 8923 11392 -1234 -256 -19 C \nATOM 138 C ASP A 17 6.342 11.744 -7.765 1.00 71.97 C \nANISOU 138 C ASP A 17 8738 8093 10516 -1233 -312 17 C \nATOM 139 O ASP A 17 6.902 10.636 -7.713 1.00 67.50 O \nANISOU 139 O ASP A 17 8103 7536 10006 -1274 -375 37 O \nATOM 140 CB ASP A 17 6.609 13.453 -9.541 1.00 87.52 C \nANISOU 140 CB ASP A 17 10808 9976 12470 -1150 -206 -32 C \nATOM 141 CG ASP A 17 6.770 14.933 -9.745 1.00 88.39 C \nANISOU 141 CG ASP A 17 11026 10030 12527 -1130 -134 -64 C \nATOM 142 OD1 ASP A 17 7.915 15.426 -9.833 1.00 93.76 O \nANISOU 142 OD1 ASP A 17 11741 10663 13219 -1186 -127 -85 O \nATOM 143 OD2 ASP A 17 5.725 15.609 -9.807 1.00 89.54 O \nANISOU 143 OD2 ASP A 17 11224 10182 12614 -1058 -85 -70 O \nATOM 144 N THR A 18 5.063 11.980 -7.480 1.00 66.87 N \nANISOU 144 N THR A 18 8107 7488 9812 -1184 -284 24 N \nATOM 145 CA THR A 18 4.141 10.993 -6.957 1.00 66.87 C \nANISOU 145 CA THR A 18 8046 7558 9803 -1186 -326 56 C \nATOM 146 C THR A 18 2.749 11.341 -7.481 1.00 70.20 C \nANISOU 146 C THR A 18 8476 8024 10174 -1098 -278 55 C \nATOM 147 O THR A 18 2.461 12.501 -7.830 1.00 72.57 O \nANISOU 147 O THR A 18 8845 8301 10429 -1038 -212 31 O \nATOM 148 CB THR A 18 4.170 11.032 -5.404 1.00 68.47 C \nANISOU 148 CB THR A 18 8262 7789 9966 -1252 -349 64 C \nATOM 149 OG1 THR A 18 5.349 10.372 -4.927 1.00 76.74 O \nANISOU 149 OG1 THR A 18 9277 8816 11064 -1333 -408 75 O \nATOM 150 CG2 THR A 18 2.997 10.363 -4.780 1.00 74.10 C \nANISOU 150 CG2 THR A 18 8933 8581 10641 -1248 -372 92 C \nATOM 151 N ILE A 19 1.872 10.348 -7.509 1.00 75.39 N \nANISOU 151 N ILE A 19 9067 8747 10831 -1090 -312 84 N \nATOM 152 CA ILE A 19 0.471 10.535 -7.965 1.00 82.57 C \nANISOU 152 CA ILE A 19 9967 9721 11685 -1011 -274 88 C \nATOM 153 C ILE A 19 -0.319 11.525 -7.118 1.00 86.42 C \nANISOU 153 C ILE A 19 10506 10248 12083 -975 -226 76 C \nATOM 154 O ILE A 19 -1.249 12.135 -7.605 1.00 94.85 O \nANISOU 154 O ILE A 19 11592 11350 13098 -889 -174 67 O \nATOM 155 CB ILE A 19 -0.293 9.195 -8.091 1.00 83.86 C \nANISOU 155 CB ILE A 19 10047 9956 11861 -1028 -324 121 C \nATOM 156 CG1 ILE A 19 -0.350 8.497 -6.748 1.00 93.97 C \nANISOU 156 CG1 ILE A 19 11301 11277 13125 -1108 -378 145 C \nATOM 157 CG2 ILE A 19 0.393 8.279 -9.096 1.00 79.08 C \nANISOU 157 CG2 ILE A 19 9400 9307 11339 -1044 -363 129 C \nATOM 158 CD1 ILE A 19 -1.642 8.756 -6.023 1.00 99.86 C \nANISOU 158 CD1 ILE A 19 12042 12118 13783 -1086 -355 153 C \nATOM 159 N MET A 20 0.080 11.696 -5.862 1.00 92.36 N \nANISOU 159 N MET A 20 11284 10996 12815 -1038 -242 75 N \nATOM 160 CA MET A 20 -0.584 12.605 -4.921 1.00 91.38 C \nANISOU 160 CA MET A 20 11212 10906 12603 -1013 -200 62 C \nATOM 161 C MET A 20 0.252 13.815 -4.544 1.00 89.12 C \nANISOU 161 C MET A 20 11023 10539 12298 -1024 -160 29 C \nATOM 162 O MET A 20 -0.265 14.754 -3.941 1.00 88.33 O \nANISOU 162 O MET A 20 10987 10451 12123 -986 -113 12 O \nATOM 163 CB MET A 20 -0.931 11.865 -3.624 1.00 96.50 C \nANISOU 163 CB MET A 20 11816 11624 13227 -1083 -249 87 C \nATOM 164 CG MET A 20 -2.187 11.027 -3.683 1.00 94.25 C \nANISOU 164 CG MET A 20 11455 11443 12911 -1064 -269 114 C \nATOM 165 SD MET A 20 -2.379 10.214 -2.096 1.00105.99 S \nANISOU 165 SD MET A 20 12903 12999 14371 -1164 -329 143 S \nATOM 166 CE MET A 20 -3.773 9.152 -2.447 1.00114.92 C \nANISOU 166 CE MET A 20 13945 14249 15472 -1150 -353 175 C \nATOM 167 N GLU A 21 1.545 13.774 -4.841 1.00 91.25 N \nANISOU 167 N GLU A 21 11307 10733 12632 -1079 -179 21 N \nATOM 168 CA GLU A 21 2.456 14.855 -4.446 1.00 95.53 C \nANISOU 168 CA GLU A 21 11940 11201 13156 -1111 -146 -9 C \nATOM 169 C GLU A 21 3.468 15.180 -5.544 1.00 81.26 C \nANISOU 169 C GLU A 21 10159 9314 11402 -1112 -131 -27 C \nATOM 170 O GLU A 21 4.061 14.289 -6.133 1.00 69.74 O \nANISOU 170 O GLU A 21 8633 7848 10016 -1141 -176 -13 O \nATOM 171 CB GLU A 21 3.201 14.490 -3.155 1.00107.67 C \nANISOU 171 CB GLU A 21 13464 12743 14701 -1217 -195 -1 C \nATOM 172 CG GLU A 21 2.405 14.676 -1.873 1.00115.80 C \nANISOU 172 CG GLU A 21 14509 13833 15658 -1226 -190 4 C \nATOM 173 CD GLU A 21 3.263 14.529 -0.620 1.00122.34 C \nANISOU 173 CD GLU A 21 15341 14654 16488 -1333 -230 7 C \nATOM 174 OE1 GLU A 21 3.588 15.564 -0.001 1.00126.19 O \nANISOU 174 OE1 GLU A 21 15913 15106 16926 -1353 -192 -19 O \nATOM 175 OE2 GLU A 21 3.628 13.386 -0.258 1.00114.17 O \nANISOU 175 OE2 GLU A 21 14229 13649 15503 -1397 -300 37 O \nATOM 176 N LYS A 22 3.669 16.468 -5.771 1.00 83.38 N \nANISOU 176 N LYS A 22 10531 9521 11628 -1082 -68 -59 N \nATOM 177 CA LYS A 22 4.558 16.959 -6.795 1.00 92.47 C \nANISOU 177 CA LYS A 22 11723 10598 12814 -1083 -44 -79 C \nATOM 178 C LYS A 22 5.720 17.677 -6.113 1.00102.06 C \nANISOU 178 C LYS A 22 13009 11755 14014 -1172 -37 -102 C \nATOM 179 O LYS A 22 5.533 18.329 -5.091 1.00109.16 O \nANISOU 179 O LYS A 22 13973 12654 14850 -1191 -16 -114 O \nATOM 180 CB LYS A 22 3.771 17.883 -7.743 1.00103.61 C \nANISOU 180 CB LYS A 22 13204 11984 14180 -972 26 -96 C \nATOM 181 CG LYS A 22 4.609 18.848 -8.611 1.00110.35 C \nANISOU 181 CG LYS A 22 14146 12746 15036 -972 71 -125 C \nATOM 182 CD LYS A 22 5.135 18.134 -9.860 1.00110.72 C \nANISOU 182 CD LYS A 22 14121 12784 15164 -973 46 -116 C \nATOM 183 CE LYS A 22 6.046 18.989 -10.759 1.00105.57 C \nANISOU 183 CE LYS A 22 13544 12048 14518 -985 85 -143 C \nATOM 184 NZ LYS A 22 7.148 18.165 -11.356 1.00 97.45 N \nANISOU 184 NZ LYS A 22 12435 11016 13575 -1050 38 -138 N \nATOM 185 N ASN A 23 6.920 17.545 -6.683 1.00110.43 N \nANISOU 185 N ASN A 23 14055 12775 15130 -1229 -55 -110 N \nATOM 186 CA ASN A 23 8.122 18.267 -6.215 1.00110.96 C \nANISOU 186 CA ASN A 23 14187 12793 15181 -1320 -45 -134 C \nATOM 187 C ASN A 23 8.499 17.899 -4.782 1.00105.13 C \nANISOU 187 C ASN A 23 13422 12091 14431 -1408 -90 -124 C \nATOM 188 O ASN A 23 8.568 18.746 -3.902 1.00 99.02 O \nANISOU 188 O ASN A 23 12731 11297 13594 -1445 -61 -142 O \nATOM 189 CB ASN A 23 7.976 19.797 -6.373 1.00107.65 C \nANISOU 189 CB ASN A 23 13914 12304 14685 -1290 35 -168 C \nATOM 190 CG ASN A 23 7.906 20.250 -7.831 1.00114.09 C \nANISOU 190 CG ASN A 23 14766 13072 15513 -1221 78 -180 C \nATOM 191 OD1 ASN A 23 6.920 20.872 -8.250 1.00123.92 O \nANISOU 191 OD1 ASN A 23 16073 14301 16711 -1122 129 -186 O \nATOM 192 ND2 ASN A 23 8.950 19.962 -8.606 1.00113.90 N \nANISOU 192 ND2 ASN A 23 14702 13027 15546 -1269 58 -184 N \nATOM 193 N VAL A 24 8.726 16.610 -4.565 1.00106.45 N \nANISOU 193 N VAL A 24 13477 12311 14660 -1441 -161 -94 N \nATOM 194 CA VAL A 24 9.065 16.088 -3.235 1.00 97.07 C \nANISOU 194 CA VAL A 24 12251 11164 13468 -1521 -212 -78 C \nATOM 195 C VAL A 24 10.551 15.817 -3.109 1.00 85.94 C \nANISOU 195 C VAL A 24 10807 9748 12100 -1615 -252 -81 C \nATOM 196 O VAL A 24 11.085 14.935 -3.788 1.00 77.13 O \nANISOU 196 O VAL A 24 9610 8642 11053 -1615 -295 -67 O \nATOM 197 CB VAL A 24 8.297 14.787 -2.941 1.00 98.85 C \nANISOU 197 CB VAL A 24 12379 11456 13725 -1498 -269 -39 C \nATOM 198 CG1 VAL A 24 8.851 14.094 -1.699 1.00 96.83 C \nANISOU 198 CG1 VAL A 24 12075 11238 13477 -1587 -332 -19 C \nATOM 199 CG2 VAL A 24 6.820 15.106 -2.785 1.00 97.62 C \nANISOU 199 CG2 VAL A 24 12252 11327 13510 -1420 -230 -37 C \nATOM 200 N THR A 25 11.210 16.570 -2.227 1.00 82.14 N \nANISOU 200 N THR A 25 10386 9253 11572 -1694 -239 -99 N \nATOM 201 CA THR A 25 12.655 16.506 -2.112 1.00 77.97 C \nANISOU 201 CA THR A 25 9832 8725 11068 -1788 -269 -106 C \nATOM 202 C THR A 25 13.062 15.164 -1.519 1.00 75.38 C \nANISOU 202 C THR A 25 9390 8457 10792 -1826 -353 -71 C \nATOM 203 O THR A 25 12.438 14.681 -0.582 1.00 75.32 O \nANISOU 203 O THR A 25 9361 8488 10770 -1829 -382 -49 O \nATOM 204 CB THR A 25 13.195 17.670 -1.275 1.00 73.10 C \nANISOU 204 CB THR A 25 9314 8084 10378 -1869 -232 -135 C \nATOM 205 OG1 THR A 25 12.419 18.849 -1.535 1.00 78.39 O \nANISOU 205 OG1 THR A 25 10104 8696 10984 -1816 -155 -162 O \nATOM 206 CG2 THR A 25 14.653 17.932 -1.607 1.00 67.26 C \nANISOU 206 CG2 THR A 25 8568 7335 9652 -1954 -238 -153 C \nATOM 207 N VAL A 26 14.098 14.556 -2.079 1.00 71.56 N \nANISOU 207 N VAL A 26 8837 7985 10367 -1851 -392 -66 N \nATOM 208 CA VAL A 26 14.470 13.208 -1.695 1.00 72.27 C \nANISOU 208 CA VAL A 26 8822 8127 10511 -1868 -474 -32 C \nATOM 209 C VAL A 26 15.961 13.134 -1.388 1.00 80.10 C \nANISOU 209 C VAL A 26 9776 9144 11514 -1953 -508 -37 C \nATOM 210 O VAL A 26 16.721 14.032 -1.747 1.00 84.30 O \nANISOU 210 O VAL A 26 10352 9657 12023 -1995 -469 -68 O \nATOM 211 CB VAL A 26 14.049 12.185 -2.787 1.00 75.81 C \nANISOU 211 CB VAL A 26 9203 8574 11028 -1786 -499 -12 C \nATOM 212 CG1 VAL A 26 15.229 11.727 -3.653 1.00 76.72 C \nANISOU 212 CG1 VAL A 26 9257 8692 11202 -1794 -527 -17 C \nATOM 213 CG2 VAL A 26 13.342 10.993 -2.168 1.00 76.17 C \nANISOU 213 CG2 VAL A 26 9189 8657 11093 -1768 -558 28 C \nATOM 214 N THR A 27 16.360 12.058 -0.713 1.00 80.37 N \nANISOU 214 N THR A 27 9730 9228 11579 -1980 -582 -5 N \nATOM 215 CA THR A 27 17.709 11.889 -0.239 1.00 74.19 C \nANISOU 215 CA THR A 27 8901 8487 10800 -2057 -623 -5 C \nATOM 216 C THR A 27 18.602 11.289 -1.329 1.00 78.11 C \nANISOU 216 C THR A 27 9325 8994 11360 -2030 -649 -6 C \nATOM 217 O THR A 27 19.713 11.764 -1.538 1.00 79.94 O \nANISOU 217 O THR A 27 9549 9244 11581 -2083 -640 -28 O \nATOM 218 CB THR A 27 17.695 11.126 1.089 1.00 76.71 C \nANISOU 218 CB THR A 27 9180 8855 11113 -2097 -686 29 C \nATOM 219 OG1 THR A 27 18.606 11.732 2.009 1.00 87.66 O \nANISOU 219 OG1 THR A 27 10581 10274 12451 -2195 -688 17 O \nATOM 220 CG2 THR A 27 17.998 9.655 0.938 1.00 73.22 C \nANISOU 220 CG2 THR A 27 8640 8443 10736 -2062 -765 66 C \nATOM 221 N HIS A 28 18.107 10.277 -2.042 1.00 84.49 N \nANISOU 221 N HIS A 28 10083 9793 12227 -1949 -679 15 N \nATOM 222 CA HIS A 28 18.805 9.668 -3.183 1.00 80.07 C \nANISOU 222 CA HIS A 28 9459 9237 11728 -1908 -700 12 C \nATOM 223 C HIS A 28 17.777 9.373 -4.272 1.00 82.77 C \nANISOU 223 C HIS A 28 9810 9535 12105 -1816 -676 14 C \nATOM 224 O HIS A 28 16.648 8.954 -3.995 1.00 71.41 O \nANISOU 224 O HIS A 28 8384 8085 10665 -1779 -684 36 O \nATOM 225 CB HIS A 28 19.508 8.348 -2.816 1.00 81.45 C \nANISOU 225 CB HIS A 28 9541 9459 11946 -1905 -785 44 C \nATOM 226 CG HIS A 28 20.639 8.475 -1.841 1.00 88.38 C \nANISOU 226 CG HIS A 28 10390 10395 12796 -1988 -818 46 C \nATOM 227 ND1 HIS A 28 21.859 7.859 -2.037 1.00 89.12 N \nANISOU 227 ND1 HIS A 28 10404 10540 12920 -1993 -866 50 N \nATOM 228 CD2 HIS A 28 20.725 9.100 -0.644 1.00 91.11 C \nANISOU 228 CD2 HIS A 28 10772 10762 13082 -2067 -811 44 C \nATOM 229 CE1 HIS A 28 22.652 8.124 -1.012 1.00 91.86 C \nANISOU 229 CE1 HIS A 28 10737 10942 13226 -2073 -887 52 C \nATOM 230 NE2 HIS A 28 21.989 8.876 -0.155 1.00 91.06 N \nANISOU 230 NE2 HIS A 28 10707 10822 13071 -2123 -854 48 N \nATOM 231 N ALA A 29 18.197 9.536 -5.520 1.00 89.36 N \nANISOU 231 N ALA A 29 10633 10352 12969 -1783 -651 -7 N \nATOM 232 CA ALA A 29 17.316 9.306 -6.643 1.00 91.12 C \nANISOU 232 CA ALA A 29 10862 10536 13224 -1699 -627 -8 C \nATOM 233 C ALA A 29 18.083 8.829 -7.874 1.00 93.60 C \nANISOU 233 C ALA A 29 11119 10851 13594 -1663 -639 -18 C \nATOM 234 O ALA A 29 19.300 8.977 -7.948 1.00 98.89 O \nANISOU 234 O ALA A 29 11756 11551 14266 -1705 -650 -33 O \nATOM 235 CB ALA A 29 16.540 10.578 -6.945 1.00 88.96 C \nANISOU 235 CB ALA A 29 10682 10220 12901 -1688 -546 -33 C \nATOM 236 N GLN A 30 17.357 8.243 -8.825 1.00 92.96 N \nANISOU 236 N GLN A 30 11023 10744 13552 -1586 -638 -11 N \nATOM 237 CA GLN A 30 17.919 7.868 -10.122 1.00 89.35 C \nANISOU 237 CA GLN A 30 10521 10282 13145 -1543 -640 -24 C \nATOM 238 C GLN A 30 17.114 8.475 -11.274 1.00 94.69 C \nANISOU 238 C GLN A 30 11244 10915 13819 -1489 -576 -43 C \nATOM 239 O GLN A 30 15.917 8.241 -11.416 1.00 92.94 O \nANISOU 239 O GLN A 30 11043 10674 13597 -1441 -566 -28 O \nATOM 240 CB GLN A 30 17.980 6.360 -10.290 1.00 84.39 C \nANISOU 240 CB GLN A 30 9823 9667 12575 -1497 -710 3 C \nATOM 241 CG GLN A 30 19.303 5.748 -9.897 1.00 84.48 C \nANISOU 241 CG GLN A 30 9768 9724 12608 -1524 -768 9 C \nATOM 242 CD GLN A 30 19.530 4.389 -10.552 1.00 82.37 C \nANISOU 242 CD GLN A 30 9438 9456 12402 -1459 -824 24 C \nATOM 243 OE1 GLN A 30 19.625 4.285 -11.773 1.00 88.05 O \nANISOU 243 OE1 GLN A 30 10142 10159 13153 -1411 -804 6 O \nATOM 244 NE2 GLN A 30 19.641 3.347 -9.742 1.00 78.42 N \nANISOU 244 NE2 GLN A 30 8908 8972 11915 -1457 -893 57 N \nATOM 245 N ASP A 31 17.784 9.291 -12.073 1.00 95.43 N \nANISOU 245 N ASP A 31 11355 10998 13905 -1503 -532 -75 N \nATOM 246 CA ASP A 31 17.246 9.722 -13.348 1.00 93.72 C \nANISOU 246 CA ASP A 31 11169 10744 13697 -1447 -479 -92 C \nATOM 247 C ASP A 31 17.416 8.523 -14.262 1.00 85.58 C \nANISOU 247 C ASP A 31 10061 9722 12733 -1390 -521 -83 C \nATOM 248 O ASP A 31 18.502 7.936 -14.317 1.00 90.46 O \nANISOU 248 O ASP A 31 10615 10372 13382 -1406 -563 -85 O \nATOM 249 CB ASP A 31 18.011 10.941 -13.897 1.00 91.48 C \nANISOU 249 CB ASP A 31 10930 10447 13381 -1489 -423 -128 C \nATOM 250 CG ASP A 31 17.336 11.572 -15.119 1.00 93.00 C \nANISOU 250 CG ASP A 31 11173 10594 13568 -1433 -361 -145 C \nATOM 251 OD1 ASP A 31 16.113 11.425 -15.288 1.00 94.87 O \nANISOU 251 OD1 ASP A 31 11433 10809 13804 -1371 -347 -130 O \nATOM 252 OD2 ASP A 31 18.027 12.230 -15.931 1.00 99.73 O \nANISOU 252 OD2 ASP A 31 12042 11436 14413 -1453 -326 -172 O \nATOM 253 N ILE A 32 16.348 8.165 -14.962 1.00 75.45 N \nANISOU 253 N ILE A 32 8785 8415 11468 -1322 -508 -73 N \nATOM 254 CA ILE A 32 16.419 7.122 -15.991 1.00 74.12 C \nANISOU 254 CA ILE A 32 8558 8247 11360 -1265 -538 -69 C \nATOM 255 C ILE A 32 16.246 7.679 -17.430 1.00 76.04 C \nANISOU 255 C ILE A 32 8819 8464 11610 -1223 -482 -94 C \nATOM 256 O ILE A 32 16.666 7.058 -18.378 1.00 68.42 O \nANISOU 256 O ILE A 32 7805 7500 10690 -1189 -498 -101 O \nATOM 257 CB ILE A 32 15.391 6.004 -15.708 1.00 75.54 C \nANISOU 257 CB ILE A 32 8719 8425 11558 -1227 -580 -35 C \nATOM 258 CG1 ILE A 32 13.970 6.579 -15.488 1.00 68.92 C \nANISOU 258 CG1 ILE A 32 7939 7574 10675 -1209 -537 -27 C \nATOM 259 CG2 ILE A 32 15.852 5.177 -14.514 1.00 75.50 C \nANISOU 259 CG2 ILE A 32 8680 8446 11561 -1264 -649 -10 C \nATOM 260 CD1 ILE A 32 12.922 5.528 -15.200 1.00 60.33 C \nANISOU 260 CD1 ILE A 32 6833 6496 9595 -1183 -576 6 C \nATOM 261 N LEU A 33 15.616 8.849 -17.574 1.00 79.05 N \nANISOU 261 N LEU A 33 9274 8819 11944 -1221 -417 -107 N \nATOM 262 CA LEU A 33 15.525 9.559 -18.865 1.00 78.69 C \nANISOU 262 CA LEU A 33 9258 8746 11895 -1188 -359 -130 C \nATOM 263 C LEU A 33 16.835 10.183 -19.363 1.00 76.79 C \nANISOU 263 C LEU A 33 9015 8510 11654 -1234 -340 -161 C \nATOM 264 O LEU A 33 17.360 11.134 -18.781 1.00 84.27 O \nANISOU 264 O LEU A 33 10009 9454 12555 -1297 -315 -175 O \nATOM 265 CB LEU A 33 14.474 10.664 -18.771 1.00 82.59 C \nANISOU 265 CB LEU A 33 9842 9210 12330 -1169 -297 -133 C \nATOM 266 CG LEU A 33 14.207 11.481 -20.028 1.00 79.39 C \nANISOU 266 CG LEU A 33 9482 8772 11911 -1128 -234 -154 C \nATOM 267 CD1 LEU A 33 13.507 10.645 -21.053 1.00 81.35 C \nANISOU 267 CD1 LEU A 33 9684 9026 12201 -1056 -244 -143 C \nATOM 268 CD2 LEU A 33 13.370 12.700 -19.723 1.00 84.77 C \nANISOU 268 CD2 LEU A 33 10263 9422 12522 -1115 -173 -158 C \nATOM 269 N GLU A 34 17.362 9.656 -20.456 1.00 80.36 N \nANISOU 269 N GLU A 34 9412 8971 12151 -1206 -350 -172 N \nATOM 270 CA GLU A 34 18.605 10.198 -21.053 1.00 79.29 C \nANISOU 270 CA GLU A 34 9263 8849 12012 -1249 -331 -203 C \nATOM 271 C GLU A 34 18.293 11.396 -21.933 1.00 71.49 C \nANISOU 271 C GLU A 34 8353 7822 10989 -1243 -257 -224 C \nATOM 272 O GLU A 34 17.338 11.366 -22.684 1.00 70.67 O \nANISOU 272 O GLU A 34 8269 7690 10892 -1178 -232 -218 O \nATOM 273 CB GLU A 34 19.317 9.139 -21.867 1.00 83.60 C \nANISOU 273 CB GLU A 34 9719 9427 12619 -1216 -372 -208 C \nATOM 274 CG GLU A 34 20.546 9.649 -22.589 1.00 88.35 C \nANISOU 274 CG GLU A 34 10298 10054 13216 -1256 -351 -240 C \nATOM 275 CD GLU A 34 21.563 10.212 -21.630 1.00 97.59 C \nANISOU 275 CD GLU A 34 11471 11263 14347 -1346 -358 -249 C \nATOM 276 OE1 GLU A 34 21.806 9.529 -20.612 1.00108.34 O \nANISOU 276 OE1 GLU A 34 12791 12655 15719 -1359 -412 -230 O \nATOM 277 OE2 GLU A 34 22.110 11.307 -21.895 1.00 89.27 O \nANISOU 277 OE2 GLU A 34 10460 10209 13249 -1405 -312 -274 O \nATOM 278 N LYS A 35 19.071 12.468 -21.800 1.00 67.54 N \nANISOU 278 N LYS A 35 7900 7319 10442 -1315 -222 -247 N \nATOM 279 CA LYS A 35 18.750 13.740 -22.467 1.00 69.50 C \nANISOU 279 CA LYS A 35 8245 7519 10643 -1317 -150 -265 C \nATOM 280 C LYS A 35 19.888 14.355 -23.293 1.00 73.33 C \nANISOU 280 C LYS A 35 8733 8016 11115 -1372 -122 -296 C \nATOM 281 O LYS A 35 19.708 15.391 -23.906 1.00 70.62 O \nANISOU 281 O LYS A 35 8473 7629 10731 -1379 -64 -311 O \nATOM 282 CB LYS A 35 18.280 14.748 -21.430 1.00 70.11 C \nANISOU 282 CB LYS A 35 8424 7563 10653 -1354 -117 -263 C \nATOM 283 CG LYS A 35 16.875 14.495 -20.906 1.00 73.32 C \nANISOU 283 CG LYS A 35 8856 7949 11054 -1287 -119 -237 C \nATOM 284 CD LYS A 35 16.577 15.285 -19.630 1.00 73.99 C \nANISOU 284 CD LYS A 35 9022 8016 11076 -1329 -101 -234 C \nATOM 285 CE LYS A 35 17.339 14.694 -18.447 1.00 72.43 C \nANISOU 285 CE LYS A 35 8766 7865 10889 -1397 -159 -225 C \nATOM 286 NZ LYS A 35 17.253 15.550 -17.251 1.00 74.90 N \nANISOU 286 NZ LYS A 35 9159 8161 11136 -1454 -139 -228 N \nATOM 287 N THR A 36 21.046 13.709 -23.324 1.00 74.68 N \nANISOU 287 N THR A 36 8811 8246 11316 -1409 -165 -305 N \nATOM 288 CA THR A 36 22.216 14.301 -23.928 1.00 76.50 C \nANISOU 288 CA THR A 36 9035 8505 11525 -1477 -142 -334 C \nATOM 289 C THR A 36 22.680 13.504 -25.111 1.00 82.70 C \nANISOU 289 C THR A 36 9730 9327 12366 -1432 -161 -344 C \nATOM 290 O THR A 36 22.645 12.281 -25.078 1.00 93.31 O \nANISOU 290 O THR A 36 10987 10700 13767 -1376 -214 -330 O \nATOM 291 CB THR A 36 23.381 14.380 -22.906 1.00 80.83 C \nANISOU 291 CB THR A 36 9551 9115 12048 -1574 -172 -341 C \nATOM 292 OG1 THR A 36 22.877 14.780 -21.629 1.00 87.60 O \nANISOU 292 OG1 THR A 36 10472 9946 12866 -1604 -172 -326 O \nATOM 293 CG2 THR A 36 24.442 15.382 -23.349 1.00 83.00 C \nANISOU 293 CG2 THR A 36 9854 9411 12269 -1669 -133 -373 C \nATOM 294 N HIS A 37 23.177 14.191 -26.138 1.00 84.03 N \nANISOU 294 N HIS A 37 9920 9493 12514 -1459 -118 -369 N \nATOM 295 CA HIS A 37 23.785 13.529 -27.293 1.00 75.86 C \nANISOU 295 CA HIS A 37 8798 8502 11525 -1428 -132 -384 C \nATOM 296 C HIS A 37 24.993 14.277 -27.773 1.00 77.47 C \nANISOU 296 C HIS A 37 8998 8749 11687 -1516 -105 -416 C \nATOM 297 O HIS A 37 25.101 15.474 -27.542 1.00 78.25 O \nANISOU 297 O HIS A 37 9192 8819 11720 -1592 -59 -426 O \nATOM 298 CB HIS A 37 22.762 13.423 -28.410 1.00 74.18 C \nANISOU 298 CB HIS A 37 8611 8236 11339 -1340 -104 -380 C \nATOM 299 CG HIS A 37 22.251 14.734 -28.906 1.00 67.63 C \nANISOU 299 CG HIS A 37 7900 7343 10454 -1358 -33 -388 C \nATOM 300 ND1 HIS A 37 22.722 15.317 -30.058 1.00 65.45 N \nANISOU 300 ND1 HIS A 37 7641 7067 10161 -1380 7 -411 N \nATOM 301 CD2 HIS A 37 21.264 15.535 -28.453 1.00 68.45 C \nANISOU 301 CD2 HIS A 37 8113 7381 10515 -1346 4 -375 C \nATOM 302 CE1 HIS A 37 22.056 16.429 -30.288 1.00 69.90 C \nANISOU 302 CE1 HIS A 37 8325 7561 10673 -1382 65 -411 C \nATOM 303 NE2 HIS A 37 21.172 16.594 -29.319 1.00 72.47 N \nANISOU 303 NE2 HIS A 37 8709 7847 10981 -1359 65 -390 N \nATOM 304 N ASN A 38 25.881 13.587 -28.485 1.00 77.50 N \nANISOU 304 N ASN A 38 8899 8823 11727 -1506 -131 -431 N \nATOM 305 CA ASN A 38 27.163 14.180 -28.905 1.00 72.29 C \nANISOU 305 CA ASN A 38 8214 8228 11025 -1597 -113 -462 C \nATOM 306 C ASN A 38 27.096 15.045 -30.158 1.00 76.18 C \nANISOU 306 C ASN A 38 8769 8687 11491 -1613 -51 -482 C \nATOM 307 O ASN A 38 28.120 15.457 -30.685 1.00 81.37 O \nANISOU 307 O ASN A 38 9400 9402 12116 -1685 -35 -509 O \nATOM 308 CB ASN A 38 28.226 13.089 -29.073 1.00 70.63 C \nANISOU 308 CB ASN A 38 7860 8121 10856 -1579 -168 -472 C \nATOM 309 CG ASN A 38 28.150 12.394 -30.401 1.00 71.46 C \nANISOU 309 CG ASN A 38 7905 8233 11014 -1496 -170 -482 C \nATOM 310 OD1 ASN A 38 27.120 12.418 -31.068 1.00 81.12 O \nANISOU 310 OD1 ASN A 38 9181 9382 12260 -1432 -144 -474 O \nATOM 311 ND2 ASN A 38 29.235 11.760 -30.790 1.00 65.50 N \nANISOU 311 ND2 ASN A 38 7039 7572 10276 -1494 -200 -501 N \nATOM 312 N GLY A 39 25.891 15.303 -30.644 1.00 80.17 N \nANISOU 312 N GLY A 39 9352 9104 12004 -1547 -18 -470 N \nATOM 313 CA GLY A 39 25.667 16.209 -31.773 1.00 73.42 C \nANISOU 313 CA GLY A 39 8575 8203 11118 -1556 44 -484 C \nATOM 314 C GLY A 39 26.309 15.798 -33.083 1.00 68.53 C \nANISOU 314 C GLY A 39 7875 7636 10527 -1540 44 -505 C \nATOM 315 O GLY A 39 26.322 16.593 -34.016 1.00 65.38 O \nANISOU 315 O GLY A 39 7536 7210 10094 -1565 94 -520 O \nATOM 316 N LYS A 40 26.868 14.584 -33.161 1.00 70.71 N \nANISOU 316 N LYS A 40 8020 7987 10860 -1499 -10 -509 N \nATOM 317 CA LYS A 40 27.616 14.150 -34.364 1.00 71.54 C \nANISOU 317 CA LYS A 40 8038 8155 10989 -1486 -12 -534 C \nATOM 318 C LYS A 40 27.091 12.850 -34.922 1.00 69.08 C \nANISOU 318 C LYS A 40 7649 7841 10757 -1366 -49 -524 C \nATOM 319 O LYS A 40 26.411 12.129 -34.233 1.00 92.50 O \nANISOU 319 O LYS A 40 10607 10779 13760 -1307 -85 -500 O \nATOM 320 CB LYS A 40 29.117 13.988 -34.066 1.00 69.88 C \nANISOU 320 CB LYS A 40 7733 8060 10759 -1562 -40 -556 C \nATOM 321 CG LYS A 40 29.857 15.287 -33.821 1.00 71.60 C \nANISOU 321 CG LYS A 40 8016 8299 10891 -1699 0 -574 C \nATOM 322 CD LYS A 40 29.794 16.213 -35.019 1.00 76.80 C \nANISOU 322 CD LYS A 40 8746 8923 11511 -1733 62 -591 C \nATOM 323 CE LYS A 40 29.475 17.644 -34.599 1.00 82.52 C \nANISOU 323 CE LYS A 40 9626 9571 12158 -1822 115 -588 C \nATOM 324 NZ LYS A 40 29.245 18.530 -35.785 1.00 89.51 N \nANISOU 324 NZ LYS A 40 10598 10404 13007 -1841 176 -599 N \nATOM 325 N LEU A 41 27.434 12.557 -36.169 1.00 58.71 N \nANISOU 325 N LEU A 41 6282 6559 9465 -1337 -39 -545 N \nATOM 326 CA LEU A 41 27.192 11.276 -36.747 1.00 55.01 C \nANISOU 326 CA LEU A 41 5732 6103 9067 -1235 -77 -543 C \nATOM 327 C LEU A 41 28.445 10.426 -36.554 1.00 60.81 C \nANISOU 327 C LEU A 41 6344 6942 9821 -1238 -127 -561 C \nATOM 328 O LEU A 41 29.551 10.849 -36.861 1.00 62.15 O \nANISOU 328 O LEU A 41 6471 7188 9954 -1305 -115 -588 O \nATOM 329 CB LEU A 41 26.873 11.363 -38.238 1.00 51.69 C \nANISOU 329 CB LEU A 41 5318 5662 8659 -1196 -40 -557 C \nATOM 330 CG LEU A 41 25.668 12.211 -38.644 1.00 53.22 C \nANISOU 330 CG LEU A 41 5629 5763 8831 -1182 13 -542 C \nATOM 331 CD1 LEU A 41 25.388 12.009 -40.122 1.00 52.82 C \nANISOU 331 CD1 LEU A 41 5561 5705 8803 -1129 37 -554 C \nATOM 332 CD2 LEU A 41 24.419 11.917 -37.830 1.00 50.58 C \nANISOU 332 CD2 LEU A 41 5343 5360 8514 -1125 -2 -507 C \nATOM 333 N CYS A 42 28.251 9.218 -36.033 1.00 63.73 N \nANISOU 333 N CYS A 42 6657 7314 10242 -1163 -185 -545 N \nATOM 334 CA CYS A 42 29.368 8.363 -35.650 1.00 72.51 C \nANISOU 334 CA CYS A 42 7660 8521 11371 -1152 -239 -556 C \nATOM 335 C CYS A 42 29.270 6.989 -36.263 1.00 68.05 C \nANISOU 335 C CYS A 42 7023 7961 10871 -1042 -280 -559 C \nATOM 336 O CYS A 42 28.219 6.628 -36.807 1.00 71.39 O \nANISOU 336 O CYS A 42 7486 8310 11329 -978 -271 -547 O \nATOM 337 CB CYS A 42 29.417 8.249 -34.122 1.00 78.66 C \nANISOU 337 CB CYS A 42 8445 9304 12138 -1180 -277 -532 C \nATOM 338 SG CYS A 42 29.304 9.819 -33.246 1.00 98.90 S \nANISOU 338 SG CYS A 42 11115 11838 14624 -1305 -230 -525 S \nATOM 339 N ASP A 43 30.341 6.212 -36.120 1.00 64.35 N \nANISOU 339 N ASP A 43 6454 7582 10413 -1018 -325 -573 N \nATOM 340 CA ASP A 43 30.293 4.811 -36.516 1.00 75.14 C \nANISOU 340 CA ASP A 43 7761 8949 11840 -907 -372 -574 C \nATOM 341 C ASP A 43 29.273 4.059 -35.669 1.00 77.96 C \nANISOU 341 C ASP A 43 8164 9226 12233 -854 -411 -536 C \nATOM 342 O ASP A 43 28.812 4.577 -34.656 1.00 86.10 O \nANISOU 342 O ASP A 43 9252 10221 13242 -903 -408 -511 O \nATOM 343 CB ASP A 43 31.645 4.152 -36.364 1.00 75.10 C \nANISOU 343 CB ASP A 43 7645 9058 11833 -887 -416 -594 C \nATOM 344 CG ASP A 43 32.710 4.864 -37.154 1.00 83.21 C \nANISOU 344 CG ASP A 43 8617 10182 12817 -946 -379 -632 C \nATOM 345 OD1 ASP A 43 32.339 5.838 -37.851 1.00 90.38 O \nANISOU 345 OD1 ASP A 43 9583 11056 13701 -1002 -320 -641 O \nATOM 346 OD2 ASP A 43 33.892 4.460 -37.094 1.00 78.93 O \nANISOU 346 OD2 ASP A 43 7975 9752 12262 -936 -409 -652 O \nATOM 347 N LEU A 44 28.886 2.873 -36.123 1.00 78.04 N \nANISOU 347 N LEU A 44 8153 9204 12295 -758 -444 -532 N \nATOM 348 CA LEU A 44 28.239 1.889 -35.263 1.00 78.33 C \nANISOU 348 CA LEU A 44 8211 9186 12363 -705 -497 -499 C \nATOM 349 C LEU A 44 29.181 0.717 -35.097 1.00 82.47 C \nANISOU 349 C LEU A 44 8654 9769 12911 -637 -559 -508 C \nATOM 350 O LEU A 44 29.513 0.046 -36.087 1.00 86.28 O \nANISOU 350 O LEU A 44 9092 10270 13419 -570 -565 -532 O \nATOM 351 CB LEU A 44 26.932 1.351 -35.861 1.00 78.90 C \nANISOU 351 CB LEU A 44 8339 9168 12472 -648 -491 -485 C \nATOM 352 CG LEU A 44 25.646 2.171 -35.753 1.00 77.92 C \nANISOU 352 CG LEU A 44 8305 8969 12330 -686 -447 -462 C \nATOM 353 CD1 LEU A 44 24.459 1.387 -36.324 1.00 60.88 C \nANISOU 353 CD1 LEU A 44 6182 6741 10208 -622 -453 -448 C \nATOM 354 CD2 LEU A 44 25.395 2.559 -34.304 1.00 79.31 C \nANISOU 354 CD2 LEU A 44 8521 9133 12482 -737 -462 -433 C \nATOM 355 N ASP A 45 29.554 0.425 -33.853 1.00 80.61 N \nANISOU 355 N ASP A 45 8404 9558 12667 -647 -605 -487 N \nATOM 356 CA ASP A 45 30.297 -0.799 -33.547 1.00 90.22 C \nANISOU 356 CA ASP A 45 9557 10817 13906 -568 -671 -487 C \nATOM 357 C ASP A 45 31.526 -0.892 -34.432 1.00 84.94 C \nANISOU 357 C ASP A 45 8795 10249 13230 -540 -666 -528 C \nATOM 358 O ASP A 45 31.727 -1.889 -35.120 1.00 82.09 O \nANISOU 358 O ASP A 45 8401 9888 12900 -447 -691 -543 O \nATOM 359 CB ASP A 45 29.408 -2.042 -33.759 1.00 97.87 C \nANISOU 359 CB ASP A 45 10566 11696 14924 -478 -707 -469 C \nATOM 360 CG ASP A 45 27.970 -1.841 -33.248 1.00102.52 C \nANISOU 360 CG ASP A 45 11250 12185 15517 -510 -695 -433 C \nATOM 361 OD1 ASP A 45 27.791 -1.266 -32.151 1.00 93.69 O \nANISOU 361 OD1 ASP A 45 10159 11065 14372 -573 -696 -410 O \nATOM 362 OD2 ASP A 45 27.031 -2.261 -33.959 1.00111.66 O \nANISOU 362 OD2 ASP A 45 12452 13273 16702 -473 -684 -430 O \nATOM 363 N GLY A 46 32.306 0.190 -34.454 1.00 80.99 N \nANISOU 363 N GLY A 46 8259 9832 12682 -624 -630 -549 N \nATOM 364 CA GLY A 46 33.540 0.266 -35.244 1.00 77.84 C \nANISOU 364 CA GLY A 46 7765 9549 12263 -617 -620 -590 C \nATOM 365 C GLY A 46 33.381 0.277 -36.753 1.00 80.35 C \nANISOU 365 C GLY A 46 8077 9854 12599 -585 -580 -620 C \nATOM 366 O GLY A 46 34.369 0.157 -37.481 1.00 81.20 O \nANISOU 366 O GLY A 46 8101 10057 12694 -563 -576 -655 O \nATOM 367 N VAL A 47 32.139 0.398 -37.228 1.00 85.68 N \nANISOU 367 N VAL A 47 8837 10418 13301 -581 -550 -607 N \nATOM 368 CA VAL A 47 31.850 0.453 -38.665 1.00 81.17 C \nANISOU 368 CA VAL A 47 8270 9826 12746 -555 -509 -633 C \nATOM 369 C VAL A 47 31.259 1.794 -39.111 1.00 81.80 C \nANISOU 369 C VAL A 47 8416 9870 12797 -645 -440 -634 C \nATOM 370 O VAL A 47 30.142 2.152 -38.758 1.00 85.16 O \nANISOU 370 O VAL A 47 8927 10204 13226 -668 -423 -606 O \nATOM 371 CB VAL A 47 30.886 -0.676 -39.093 1.00 82.91 C \nANISOU 371 CB VAL A 47 8531 9950 13021 -458 -534 -621 C \nATOM 372 CG1 VAL A 47 30.486 -0.515 -40.554 1.00 81.30 C \nANISOU 372 CG1 VAL A 47 8338 9722 12829 -442 -487 -645 C \nATOM 373 CG2 VAL A 47 31.534 -2.040 -38.852 1.00 78.85 C \nANISOU 373 CG2 VAL A 47 7961 9467 12533 -358 -600 -625 C \nATOM 374 N LYS A 48 32.016 2.494 -39.949 1.00 80.05 N \nANISOU 374 N LYS A 48 8151 9721 12542 -691 -399 -668 N \nATOM 375 CA LYS A 48 31.649 3.812 -40.429 1.00 75.42 C \nANISOU 375 CA LYS A 48 7627 9110 11920 -779 -333 -672 C \nATOM 376 C LYS A 48 30.375 3.740 -41.261 1.00 74.19 C \nANISOU 376 C LYS A 48 7542 8850 11795 -738 -304 -662 C \nATOM 377 O LYS A 48 30.045 2.665 -41.793 1.00 79.50 O \nANISOU 377 O LYS A 48 8196 9496 12516 -646 -330 -665 O \nATOM 378 CB LYS A 48 32.784 4.360 -41.269 1.00 75.07 C \nANISOU 378 CB LYS A 48 7515 9173 11837 -827 -302 -712 C \nATOM 379 CG LYS A 48 32.686 5.828 -41.642 1.00 80.20 C \nANISOU 379 CG LYS A 48 8227 9814 12433 -937 -236 -719 C \nATOM 380 CD LYS A 48 34.005 6.345 -42.227 1.00 83.56 C \nANISOU 380 CD LYS A 48 8575 10366 12809 -1002 -214 -757 C \nATOM 381 CE LYS A 48 33.742 7.417 -43.277 1.00 85.67 C \nANISOU 381 CE LYS A 48 8901 10608 13043 -1069 -147 -771 C \nATOM 382 NZ LYS A 48 33.110 8.632 -42.693 1.00 87.11 N \nANISOU 382 NZ LYS A 48 9200 10713 13184 -1160 -108 -747 N \nATOM 383 N PRO A 49 29.624 4.864 -41.332 1.00 61.62 N \nANISOU 383 N PRO A 49 6037 7200 10174 -803 -252 -649 N \nATOM 384 CA PRO A 49 28.483 4.860 -42.223 1.00 59.03 C \nANISOU 384 CA PRO A 49 5767 6791 9869 -764 -222 -642 C \nATOM 385 C PRO A 49 28.848 5.314 -43.604 1.00 66.71 C \nANISOU 385 C PRO A 49 6721 7798 10828 -778 -176 -674 C \nATOM 386 O PRO A 49 30.011 5.605 -43.890 1.00 77.54 O \nANISOU 386 O PRO A 49 8029 9260 12172 -819 -169 -704 O \nATOM 387 CB PRO A 49 27.543 5.875 -41.604 1.00 58.26 C \nANISOU 387 CB PRO A 49 5774 6622 9742 -819 -188 -612 C \nATOM 388 CG PRO A 49 28.428 6.797 -40.847 1.00 57.39 C \nANISOU 388 CG PRO A 49 5662 6564 9578 -914 -178 -618 C \nATOM 389 CD PRO A 49 29.591 5.994 -40.392 1.00 55.42 C \nANISOU 389 CD PRO A 49 5312 6404 9340 -898 -230 -633 C \nATOM 390 N LEU A 50 27.856 5.336 -44.476 1.00 68.84 N \nANISOU 390 N LEU A 50 7038 8002 11115 -743 -147 -668 N \nATOM 391 CA LEU A 50 28.060 5.737 -45.843 1.00 69.08 C \nANISOU 391 CA LEU A 50 7058 8057 11134 -752 -104 -696 C \nATOM 392 C LEU A 50 27.481 7.112 -46.046 1.00 66.84 C \nANISOU 392 C LEU A 50 6867 7726 10804 -821 -43 -684 C \nATOM 393 O LEU A 50 26.262 7.264 -46.220 1.00 75.30 O \nANISOU 393 O LEU A 50 8009 8717 11883 -792 -24 -660 O \nATOM 394 CB LEU A 50 27.393 4.738 -46.790 1.00 76.64 C \nANISOU 394 CB LEU A 50 8001 8979 12141 -661 -114 -700 C \nATOM 395 CG LEU A 50 27.407 5.114 -48.278 1.00 79.56 C \nANISOU 395 CG LEU A 50 8365 9362 12501 -663 -67 -725 C \nATOM 396 CD1 LEU A 50 28.820 5.245 -48.785 1.00 86.25 C \nANISOU 396 CD1 LEU A 50 9130 10315 13327 -695 -61 -765 C \nATOM 397 CD2 LEU A 50 26.683 4.070 -49.097 1.00 82.63 C \nANISOU 397 CD2 LEU A 50 8745 9714 12938 -575 -80 -727 C \nATOM 398 N ILE A 51 28.332 8.134 -46.024 1.00 60.37 N \nANISOU 398 N ILE A 51 6052 6957 9931 -912 -13 -700 N \nATOM 399 CA ILE A 51 27.852 9.502 -46.220 1.00 57.64 C \nANISOU 399 CA ILE A 51 5808 6560 9533 -980 46 -689 C \nATOM 400 C ILE A 51 27.874 9.874 -47.681 1.00 62.46 C \nANISOU 400 C ILE A 51 6421 7179 10131 -983 90 -710 C \nATOM 401 O ILE A 51 28.933 10.100 -48.248 1.00 73.30 O \nANISOU 401 O ILE A 51 7740 8631 11478 -1031 102 -741 O \nATOM 402 CB ILE A 51 28.607 10.546 -45.391 1.00 62.41 C \nANISOU 402 CB ILE A 51 6444 7195 10075 -1090 61 -691 C \nATOM 403 CG1 ILE A 51 28.629 10.201 -43.877 1.00 58.48 C \nANISOU 403 CG1 ILE A 51 5941 6694 9586 -1092 16 -670 C \nATOM 404 CG2 ILE A 51 27.916 11.892 -45.522 1.00 71.53 C \nANISOU 404 CG2 ILE A 51 7726 8274 11177 -1145 119 -676 C \nATOM 405 CD1 ILE A 51 29.857 9.442 -43.449 1.00 61.05 C \nANISOU 405 CD1 ILE A 51 6151 7123 9922 -1094 -32 -690 C \nATOM 406 N LEU A 52 26.702 9.872 -48.325 1.00 65.42 N \nANISOU 406 N LEU A 52 6852 7480 10523 -929 112 -693 N \nATOM 407 CA LEU A 52 26.561 10.532 -49.627 1.00 69.17 C \nANISOU 407 CA LEU A 52 7360 7949 10974 -944 164 -706 C \nATOM 408 C LEU A 52 26.367 12.005 -49.254 1.00 74.12 C \nANISOU 408 C LEU A 52 8100 8529 11532 -1027 210 -690 C \nATOM 409 O LEU A 52 25.486 12.351 -48.432 1.00 97.83 O \nANISOU 409 O LEU A 52 11183 11461 14527 -1016 213 -658 O \nATOM 410 CB LEU A 52 25.369 9.997 -50.422 1.00 67.42 C \nANISOU 410 CB LEU A 52 7155 7671 10789 -856 169 -692 C \nATOM 411 CG LEU A 52 25.156 8.579 -50.982 1.00 59.80 C \nANISOU 411 CG LEU A 52 6111 6721 9888 -765 132 -702 C \nATOM 412 CD1 LEU A 52 26.016 7.557 -50.314 1.00 58.22 C \nANISOU 412 CD1 LEU A 52 5822 6576 9722 -745 76 -717 C \nATOM 413 CD2 LEU A 52 23.683 8.187 -50.862 1.00 56.12 C \nANISOU 413 CD2 LEU A 52 5696 6179 9447 -698 126 -668 C \nATOM 414 N ARG A 53 27.200 12.879 -49.765 1.00 61.50 N \nANISOU 414 N ARG A 53 6515 6970 9882 -1112 246 -712 N \nATOM 415 CA ARG A 53 27.227 14.192 -49.168 1.00 65.20 C \nANISOU 415 CA ARG A 53 7091 7399 10282 -1201 281 -699 C \nATOM 416 C ARG A 53 26.110 15.018 -49.751 1.00 58.81 C \nANISOU 416 C ARG A 53 6401 6498 9446 -1180 330 -677 C \nATOM 417 O ARG A 53 25.198 15.374 -49.039 1.00 59.12 O \nANISOU 417 O ARG A 53 6524 6464 9477 -1156 336 -647 O \nATOM 418 CB ARG A 53 28.637 14.884 -49.191 1.00 67.81 C \nANISOU 418 CB ARG A 53 7400 7812 10553 -1323 296 -729 C \nATOM 419 CG ARG A 53 29.286 15.068 -50.549 1.00 75.18 C \nANISOU 419 CG ARG A 53 8295 8804 11467 -1356 325 -759 C \nATOM 420 CD ARG A 53 30.575 15.888 -50.458 1.00 71.51 C \nANISOU 420 CD ARG A 53 7824 8417 10930 -1491 343 -784 C \nATOM 421 NE ARG A 53 31.649 15.103 -49.850 1.00 68.90 N \nANISOU 421 NE ARG A 53 7365 8198 10617 -1503 296 -806 N \nATOM 422 CZ ARG A 53 32.335 15.453 -48.759 1.00 80.26 C \nANISOU 422 CZ ARG A 53 8802 9677 12016 -1585 281 -806 C \nATOM 423 NH1 ARG A 53 32.078 16.609 -48.137 1.00 83.18 N \nANISOU 423 NH1 ARG A 53 9299 9979 12325 -1669 313 -789 N \nATOM 424 NH2 ARG A 53 33.303 14.661 -48.286 1.00 78.88 N \nANISOU 424 NH2 ARG A 53 8500 9614 11858 -1582 236 -825 N \nATOM 425 N ASP A 54 26.206 15.348 -51.023 1.00 58.64 N \nANISOU 425 N ASP A 54 6386 6486 9407 -1189 365 -691 N \nATOM 426 CA ASP A 54 25.149 16.071 -51.705 1.00 62.14 C \nANISOU 426 CA ASP A 54 6936 6849 9826 -1157 410 -669 C \nATOM 427 C ASP A 54 24.522 15.175 -52.750 1.00 59.54 C \nANISOU 427 C ASP A 54 6545 6526 9551 -1061 402 -670 C \nATOM 428 O ASP A 54 23.705 15.619 -53.534 1.00 59.26 O \nANISOU 428 O ASP A 54 6575 6442 9499 -1026 437 -656 O \nATOM 429 CB ASP A 54 25.730 17.328 -52.356 1.00 70.55 C \nANISOU 429 CB ASP A 54 8079 7912 10815 -1255 462 -682 C \nATOM 430 CG ASP A 54 25.787 18.489 -51.396 1.00 81.97 C \nANISOU 430 CG ASP A 54 9646 9304 12193 -1335 485 -668 C \nATOM 431 OD1 ASP A 54 24.803 18.644 -50.621 1.00 85.96 O \nANISOU 431 OD1 ASP A 54 10224 9735 12702 -1283 484 -638 O \nATOM 432 OD2 ASP A 54 26.805 19.230 -51.415 1.00 81.82 O \nANISOU 432 OD2 ASP A 54 9650 9320 12115 -1450 505 -688 O \nATOM 433 N CYS A 55 24.920 13.902 -52.751 1.00 63.62 N \nANISOU 433 N CYS A 55 6940 7104 10130 -1017 356 -688 N \nATOM 434 CA CYS A 55 24.369 12.900 -53.670 1.00 66.71 C \nANISOU 434 CA CYS A 55 7268 7503 10575 -927 342 -692 C \nATOM 435 C CYS A 55 23.192 12.101 -53.075 1.00 51.29 C \nANISOU 435 C CYS A 55 5319 5501 8668 -838 311 -662 C \nATOM 436 O CYS A 55 23.136 11.867 -51.871 1.00 43.03 O \nANISOU 436 O CYS A 55 4275 4443 7633 -838 280 -648 O \nATOM 437 CB CYS A 55 25.483 11.974 -54.171 1.00 69.45 C \nANISOU 437 CB CYS A 55 7488 7943 10956 -927 313 -731 C \nATOM 438 SG CYS A 55 26.505 12.820 -55.388 1.00 75.47 S \nANISOU 438 SG CYS A 55 8245 8767 11665 -1012 360 -765 S \nATOM 439 N SER A 56 22.259 11.722 -53.928 1.00 48.75 N \nANISOU 439 N SER A 56 5000 5156 8368 -769 320 -652 N \nATOM 440 CA SER A 56 21.139 10.845 -53.526 1.00 55.29 C \nANISOU 440 CA SER A 56 5819 5950 9237 -688 289 -627 C \nATOM 441 C SER A 56 21.398 9.420 -53.895 1.00 54.32 C \nANISOU 441 C SER A 56 5595 5870 9175 -638 246 -648 C \nATOM 442 O SER A 56 22.315 9.128 -54.676 1.00 69.05 O \nANISOU 442 O SER A 56 7395 7788 11051 -652 246 -682 O \nATOM 443 CB SER A 56 19.858 11.289 -54.217 1.00 57.07 C \nANISOU 443 CB SER A 56 6112 6130 9441 -641 326 -602 C \nATOM 444 OG SER A 56 19.935 10.990 -55.598 1.00 61.85 O \nANISOU 444 OG SER A 56 6677 6764 10059 -621 341 -621 O \nATOM 445 N VAL A 57 20.560 8.521 -53.396 1.00 53.50 N \nANISOU 445 N VAL A 57 5479 5740 9107 -579 211 -628 N \nATOM 446 CA VAL A 57 20.754 7.067 -53.674 1.00 46.53 C \nANISOU 446 CA VAL A 57 4512 4886 8282 -528 165 -646 C \nATOM 447 C VAL A 57 20.737 6.754 -55.159 1.00 43.40 C \nANISOU 447 C VAL A 57 4081 4513 7896 -501 185 -669 C \nATOM 448 O VAL A 57 21.581 5.972 -55.697 1.00 48.93 O \nANISOU 448 O VAL A 57 4706 5259 8626 -488 165 -703 O \nATOM 449 CB VAL A 57 19.718 6.217 -52.982 1.00 41.07 C \nANISOU 449 CB VAL A 57 3829 4157 7617 -477 129 -617 C \nATOM 450 CG1 VAL A 57 19.779 4.806 -53.467 1.00 37.55 C \nANISOU 450 CG1 VAL A 57 3319 3728 7222 -426 90 -635 C \nATOM 451 CG2 VAL A 57 19.943 6.224 -51.482 1.00 41.39 C \nANISOU 451 CG2 VAL A 57 3882 4186 7658 -501 97 -601 C \nATOM 452 N ALA A 58 19.877 7.455 -55.871 1.00 37.79 N \nANISOU 452 N ALA A 58 3427 3776 7155 -495 228 -652 N \nATOM 453 CA ALA A 58 19.834 7.270 -57.316 1.00 34.55 C \nANISOU 453 CA ALA A 58 2989 3389 6749 -475 252 -672 C \nATOM 454 C ALA A 58 21.044 7.831 -58.014 1.00 35.15 C \nANISOU 454 C ALA A 58 3038 3513 6806 -526 277 -707 C \nATOM 455 O ALA A 58 21.711 7.153 -58.808 1.00 35.21 O \nANISOU 455 O ALA A 58 2974 3568 6838 -514 267 -741 O \nATOM 456 CB ALA A 58 18.592 7.881 -57.859 1.00 34.81 C \nANISOU 456 CB ALA A 58 3088 3387 6751 -452 290 -643 C \nATOM 457 N GLY A 59 21.345 9.102 -57.711 1.00 39.95 N \nANISOU 457 N GLY A 59 3707 4109 7363 -589 311 -698 N \nATOM 458 CA GLY A 59 22.643 9.746 -58.149 1.00 40.19 C \nANISOU 458 CA GLY A 59 3716 4193 7363 -661 334 -730 C \nATOM 459 C GLY A 59 23.878 8.887 -57.907 1.00 36.07 C \nANISOU 459 C GLY A 59 3091 3739 6873 -668 294 -767 C \nATOM 460 O GLY A 59 24.681 8.734 -58.763 1.00 34.26 O \nANISOU 460 O GLY A 59 2804 3570 6643 -682 302 -801 O \nATOM 461 N TRP A 60 23.926 8.228 -56.778 1.00 35.57 N \nANISOU 461 N TRP A 60 3006 3670 6840 -647 248 -758 N \nATOM 462 CA TRP A 60 25.008 7.342 -56.443 1.00 37.68 C \nANISOU 462 CA TRP A 60 3180 4000 7137 -638 205 -788 C \nATOM 463 C TRP A 60 24.981 6.074 -57.247 1.00 43.88 C \nANISOU 463 C TRP A 60 3896 4807 7971 -564 180 -811 C \nATOM 464 O TRP A 60 26.012 5.664 -57.808 1.00 44.98 O \nANISOU 464 O TRP A 60 3957 5018 8116 -562 173 -850 O \nATOM 465 CB TRP A 60 25.004 7.022 -54.933 1.00 38.49 C \nANISOU 465 CB TRP A 60 3287 4083 7254 -635 163 -767 C \nATOM 466 CG TRP A 60 25.768 5.776 -54.558 1.00 39.91 C \nANISOU 466 CG TRP A 60 3376 4309 7476 -591 107 -789 C \nATOM 467 CD1 TRP A 60 26.982 5.416 -54.988 1.00 43.25 C \nANISOU 467 CD1 TRP A 60 3714 4816 7902 -594 97 -829 C \nATOM 468 CD2 TRP A 60 25.393 4.813 -53.585 1.00 40.79 C \nANISOU 468 CD2 TRP A 60 3482 4390 7628 -539 55 -771 C \nATOM 469 NE1 TRP A 60 27.396 4.238 -54.393 1.00 47.19 N \nANISOU 469 NE1 TRP A 60 4152 5337 8440 -537 40 -838 N \nATOM 470 CE2 TRP A 60 26.402 3.825 -53.559 1.00 43.83 C \nANISOU 470 CE2 TRP A 60 3779 4836 8040 -503 14 -801 C \nATOM 471 CE3 TRP A 60 24.280 4.658 -52.771 1.00 40.17 C \nANISOU 471 CE3 TRP A 60 3463 4239 7560 -518 39 -732 C \nATOM 472 CZ2 TRP A 60 26.314 2.695 -52.793 1.00 45.83 C \nANISOU 472 CZ2 TRP A 60 4010 5070 8332 -444 -42 -793 C \nATOM 473 CZ3 TRP A 60 24.192 3.516 -51.987 1.00 42.54 C \nANISOU 473 CZ3 TRP A 60 3738 4525 7900 -468 -17 -723 C \nATOM 474 CH2 TRP A 60 25.202 2.565 -51.982 1.00 46.73 C \nANISOU 474 CH2 TRP A 60 4190 5107 8457 -432 -57 -752 C \nATOM 475 N LEU A 61 23.806 5.426 -57.339 1.00 48.90 N \nANISOU 475 N LEU A 61 4559 5385 8636 -502 168 -789 N \nATOM 476 CA LEU A 61 23.767 4.087 -58.003 1.00 40.09 C \nANISOU 476 CA LEU A 61 3385 4281 7567 -431 138 -811 C \nATOM 477 C LEU A 61 23.877 4.218 -59.497 1.00 41.42 C \nANISOU 477 C LEU A 61 3531 4481 7725 -429 175 -838 C \nATOM 478 O LEU A 61 24.463 3.355 -60.156 1.00 48.33 O \nANISOU 478 O LEU A 61 4340 5398 8626 -391 158 -874 O \nATOM 479 CB LEU A 61 22.533 3.311 -57.620 1.00 37.98 C \nANISOU 479 CB LEU A 61 3154 3950 7328 -378 111 -781 C \nATOM 480 CG LEU A 61 22.453 2.805 -56.195 1.00 38.55 C \nANISOU 480 CG LEU A 61 3234 3995 7419 -366 64 -759 C \nATOM 481 CD1 LEU A 61 21.138 2.059 -55.993 1.00 36.18 C \nANISOU 481 CD1 LEU A 61 2972 3636 7140 -322 42 -730 C \nATOM 482 CD2 LEU A 61 23.602 1.867 -55.895 1.00 40.12 C \nANISOU 482 CD2 LEU A 61 3359 4238 7647 -339 18 -790 C \nATOM 483 N LEU A 62 23.359 5.286 -60.054 1.00 38.39 N \nANISOU 483 N LEU A 62 3204 4078 7303 -466 224 -822 N \nATOM 484 CA LEU A 62 23.468 5.449 -61.526 1.00 46.23 C \nANISOU 484 CA LEU A 62 4178 5103 8284 -467 260 -847 C \nATOM 485 C LEU A 62 24.757 6.158 -61.959 1.00 49.07 C \nANISOU 485 C LEU A 62 4501 5534 8609 -532 286 -879 C \nATOM 486 O LEU A 62 24.970 6.382 -63.134 1.00 43.42 O \nANISOU 486 O LEU A 62 3768 4853 7878 -543 317 -901 O \nATOM 487 CB LEU A 62 22.249 6.245 -62.040 1.00 43.82 C \nANISOU 487 CB LEU A 62 3953 4747 7949 -471 303 -813 C \nATOM 488 CG LEU A 62 20.893 5.655 -61.807 1.00 39.28 C \nANISOU 488 CG LEU A 62 3412 4118 7396 -414 286 -781 C \nATOM 489 CD1 LEU A 62 19.845 6.663 -62.132 1.00 37.53 C \nANISOU 489 CD1 LEU A 62 3269 3859 7133 -422 329 -745 C \nATOM 490 CD2 LEU A 62 20.750 4.436 -62.677 1.00 40.11 C \nANISOU 490 CD2 LEU A 62 3463 4240 7539 -361 266 -805 C \nATOM 491 N GLY A 63 25.533 6.628 -60.985 1.00 55.29 N \nANISOU 491 N GLY A 63 5285 6344 9378 -582 276 -879 N \nATOM 492 CA GLY A 63 26.815 7.256 -61.247 1.00 57.27 C \nANISOU 492 CA GLY A 63 5495 6674 9590 -653 295 -910 C \nATOM 493 C GLY A 63 26.713 8.669 -61.780 1.00 60.84 C \nANISOU 493 C GLY A 63 6021 7114 9982 -731 352 -899 C \nATOM 494 O GLY A 63 27.401 9.034 -62.722 1.00 57.30 O \nANISOU 494 O GLY A 63 5542 6725 9505 -773 381 -927 O \nATOM 495 N ASN A 64 25.840 9.476 -61.200 1.00 64.41 N \nANISOU 495 N ASN A 64 6573 7489 10411 -749 370 -857 N \nATOM 496 CA ASN A 64 25.814 10.896 -61.536 1.00 65.85 C \nANISOU 496 CA ASN A 64 6842 7651 10528 -826 423 -845 C \nATOM 497 C ASN A 64 27.265 11.415 -61.430 1.00 63.41 C \nANISOU 497 C ASN A 64 6493 7423 10178 -920 430 -876 C \nATOM 498 O ASN A 64 27.898 11.205 -60.416 1.00 57.59 O \nANISOU 498 O ASN A 64 5720 6715 9446 -941 400 -881 O \nATOM 499 CB ASN A 64 24.878 11.646 -60.567 1.00 64.44 C \nANISOU 499 CB ASN A 64 6773 7383 10327 -830 432 -799 C \nATOM 500 CG ASN A 64 24.832 13.153 -60.810 1.00 61.36 C \nANISOU 500 CG ASN A 64 6492 6959 9865 -906 485 -784 C \nATOM 501 OD1 ASN A 64 25.850 13.811 -60.867 1.00 67.28 O \nANISOU 501 OD1 ASN A 64 7241 7752 10570 -994 503 -804 O \nATOM 502 ND2 ASN A 64 23.636 13.706 -60.889 1.00 59.44 N \nANISOU 502 ND2 ASN A 64 6345 6637 9603 -871 511 -747 N \nATOM 503 N PRO A 65 27.749 12.144 -62.454 1.00 62.05 N \nANISOU 503 N PRO A 65 6330 7287 9958 -982 472 -894 N \nATOM 504 CA PRO A 65 29.115 12.638 -62.597 1.00 66.49 C \nANISOU 504 CA PRO A 65 6849 7942 10473 -1080 484 -927 C \nATOM 505 C PRO A 65 29.683 13.415 -61.403 1.00 71.44 C \nANISOU 505 C PRO A 65 7519 8571 11055 -1168 482 -917 C \nATOM 506 O PRO A 65 30.913 13.490 -61.227 1.00 77.49 O \nANISOU 506 O PRO A 65 8217 9434 11792 -1239 475 -947 O \nATOM 507 CB PRO A 65 29.035 13.561 -63.803 1.00 64.14 C \nANISOU 507 CB PRO A 65 6609 7639 10123 -1134 538 -928 C \nATOM 508 CG PRO A 65 27.913 13.063 -64.599 1.00 59.21 C \nANISOU 508 CG PRO A 65 5999 6961 9538 -1040 543 -914 C \nATOM 509 CD PRO A 65 26.910 12.583 -63.580 1.00 62.75 C \nANISOU 509 CD PRO A 65 6480 7331 10031 -964 512 -880 C \nATOM 510 N MET A 66 28.798 13.954 -60.576 1.00 69.01 N \nANISOU 510 N MET A 66 7316 8164 10739 -1163 487 -877 N \nATOM 511 CA MET A 66 29.191 14.707 -59.396 1.00 68.48 C \nANISOU 511 CA MET A 66 7305 8085 10630 -1242 487 -865 C \nATOM 512 C MET A 66 29.266 13.840 -58.159 1.00 63.34 C \nANISOU 512 C MET A 66 6596 7444 10027 -1196 433 -860 C \nATOM 513 O MET A 66 29.557 14.298 -57.076 1.00 72.96 O \nANISOU 513 O MET A 66 7848 8654 11218 -1252 425 -850 O \nATOM 514 CB MET A 66 28.227 15.870 -59.222 1.00 76.72 C \nANISOU 514 CB MET A 66 8506 9016 11629 -1264 526 -825 C \nATOM 515 CG MET A 66 28.187 16.727 -60.507 1.00 89.60 C \nANISOU 515 CG MET A 66 10199 10637 13207 -1309 579 -829 C \nATOM 516 SD MET A 66 27.568 18.408 -60.333 1.00115.98 S \nANISOU 516 SD MET A 66 13738 13867 16463 -1375 633 -792 S \nATOM 517 CE MET A 66 25.788 18.137 -60.559 1.00123.35 C \nANISOU 517 CE MET A 66 14733 14696 17439 -1234 637 -750 C \nATOM 518 N CYS A 67 29.057 12.552 -58.337 1.00 67.35 N \nANISOU 518 N CYS A 67 7014 7971 10604 -1096 395 -870 N \nATOM 519 CA CYS A 67 29.021 11.586 -57.244 1.00 60.23 C \nANISOU 519 CA CYS A 67 6061 7070 9754 -1038 341 -863 C \nATOM 520 C CYS A 67 30.210 10.629 -57.347 1.00 57.63 C \nANISOU 520 C CYS A 67 5594 6855 9449 -1022 304 -904 C \nATOM 521 O CYS A 67 30.293 9.651 -56.611 1.00 51.53 O \nANISOU 521 O CYS A 67 4764 6094 8722 -961 255 -903 O \nATOM 522 CB CYS A 67 27.673 10.815 -57.303 1.00 56.76 C \nANISOU 522 CB CYS A 67 5645 6549 9373 -928 324 -836 C \nATOM 523 SG CYS A 67 26.196 11.863 -57.128 1.00 61.86 S \nANISOU 523 SG CYS A 67 6444 7073 9989 -927 364 -787 S \nATOM 524 N ASP A 68 31.152 10.968 -58.208 1.00 63.28 N \nANISOU 524 N ASP A 68 6260 7658 10126 -1080 329 -937 N \nATOM 525 CA ASP A 68 32.350 10.134 -58.428 1.00 71.76 C \nANISOU 525 CA ASP A 68 7198 8857 11212 -1064 299 -980 C \nATOM 526 C ASP A 68 33.065 9.624 -57.188 1.00 73.29 C \nANISOU 526 C ASP A 68 7327 9104 11415 -1059 251 -984 C \nATOM 527 O ASP A 68 33.676 8.561 -57.230 1.00 70.50 O \nANISOU 527 O ASP A 68 6867 8824 11095 -992 212 -1010 O \nATOM 528 CB ASP A 68 33.349 10.851 -59.321 1.00 78.87 C \nANISOU 528 CB ASP A 68 8063 9853 12049 -1157 337 -1013 C \nATOM 529 CG ASP A 68 33.135 10.541 -60.779 1.00 79.49 C \nANISOU 529 CG ASP A 68 8116 9943 12143 -1114 360 -1034 C \nATOM 530 OD1 ASP A 68 32.471 11.352 -61.464 1.00 82.21 O \nANISOU 530 OD1 ASP A 68 8551 10224 12462 -1148 404 -1017 O \nATOM 531 OD2 ASP A 68 33.629 9.486 -61.235 1.00 84.84 O \nANISOU 531 OD2 ASP A 68 8685 10694 12856 -1043 333 -1067 O \nATOM 532 N GLU A 69 32.992 10.363 -56.089 1.00 75.05 N \nANISOU 532 N GLU A 69 7617 9292 11607 -1126 252 -958 N \nATOM 533 CA GLU A 69 33.619 9.907 -54.852 1.00 72.76 C \nANISOU 533 CA GLU A 69 7270 9051 11324 -1124 205 -957 C \nATOM 534 C GLU A 69 33.035 8.622 -54.315 1.00 76.33 C \nANISOU 534 C GLU A 69 7694 9457 11852 -1001 153 -943 C \nATOM 535 O GLU A 69 33.522 8.068 -53.324 1.00 67.01 O \nANISOU 535 O GLU A 69 6461 8315 10684 -981 108 -942 O \nATOM 536 CB GLU A 69 33.545 10.991 -53.780 1.00 76.02 C \nANISOU 536 CB GLU A 69 7774 9424 11687 -1223 220 -930 C \nATOM 537 CG GLU A 69 32.179 11.582 -53.535 1.00 80.19 C \nANISOU 537 CG GLU A 69 8439 9808 12221 -1213 244 -889 C \nATOM 538 CD GLU A 69 32.172 12.588 -52.387 1.00 92.21 C \nANISOU 538 CD GLU A 69 10049 11293 13692 -1305 255 -865 C \nATOM 539 OE1 GLU A 69 32.715 12.285 -51.276 1.00 74.16 O \nANISOU 539 OE1 GLU A 69 7719 9051 11407 -1319 217 -864 O \nATOM 540 OE2 GLU A 69 31.628 13.698 -52.629 1.00101.36 O \nANISOU 540 OE2 GLU A 69 11326 12379 14806 -1361 302 -849 O \nATOM 541 N PHE A 70 31.938 8.175 -54.936 1.00 86.21 N \nANISOU 541 N PHE A 70 8986 10620 13148 -922 158 -930 N \nATOM 542 CA PHE A 70 31.216 6.965 -54.480 1.00 80.85 C \nANISOU 542 CA PHE A 70 8299 9883 12538 -812 111 -913 C \nATOM 543 C PHE A 70 31.222 5.927 -55.582 1.00 83.94 C \nANISOU 543 C PHE A 70 8626 10296 12970 -723 101 -941 C \nATOM 544 O PHE A 70 30.342 5.051 -55.638 1.00 83.07 O \nANISOU 544 O PHE A 70 8534 10116 12911 -638 78 -927 O \nATOM 545 CB PHE A 70 29.772 7.290 -54.045 1.00 76.85 C \nANISOU 545 CB PHE A 70 7905 9248 12044 -798 122 -868 C \nATOM 546 CG PHE A 70 29.664 8.482 -53.123 1.00 67.09 C \nANISOU 546 CG PHE A 70 6752 7979 10759 -888 144 -842 C \nATOM 547 CD1 PHE A 70 30.173 8.422 -51.816 1.00 60.56 C \nANISOU 547 CD1 PHE A 70 5908 7178 9926 -915 110 -833 C \nATOM 548 CD2 PHE A 70 29.070 9.672 -53.573 1.00 62.31 C \nANISOU 548 CD2 PHE A 70 6246 7318 10111 -944 198 -826 C \nATOM 549 CE1 PHE A 70 30.071 9.522 -50.950 1.00 59.80 C \nANISOU 549 CE1 PHE A 70 5893 7049 9781 -1000 130 -811 C \nATOM 550 CE2 PHE A 70 28.990 10.778 -52.734 1.00 62.29 C \nANISOU 550 CE2 PHE A 70 6329 7280 10059 -1024 220 -805 C \nATOM 551 CZ PHE A 70 29.495 10.698 -51.412 1.00 61.54 C \nANISOU 551 CZ PHE A 70 6216 7210 9958 -1055 186 -798 C \nATOM 552 N ILE A 71 32.228 6.032 -56.455 1.00 84.95 N \nANISOU 552 N ILE A 71 8680 10526 13072 -749 118 -981 N \nATOM 553 CA ILE A 71 32.371 5.116 -57.554 1.00 83.54 C \nANISOU 553 CA ILE A 71 8436 10381 12926 -671 112 -1014 C \nATOM 554 C ILE A 71 32.630 3.690 -57.019 1.00 87.10 C \nANISOU 554 C ILE A 71 8822 10846 13426 -565 50 -1023 C \nATOM 555 O ILE A 71 32.212 2.731 -57.640 1.00 89.58 O \nANISOU 555 O ILE A 71 9124 11129 13783 -478 35 -1033 O \nATOM 556 CB ILE A 71 33.482 5.550 -58.538 1.00 88.90 C \nANISOU 556 CB ILE A 71 9041 11178 13558 -724 143 -1057 C \nATOM 557 CG1 ILE A 71 33.434 4.714 -59.818 1.00 89.04 C \nANISOU 557 CG1 ILE A 71 9010 11216 13607 -644 146 -1089 C \nATOM 558 CG2 ILE A 71 34.862 5.393 -57.900 1.00 97.13 C \nANISOU 558 CG2 ILE A 71 9985 12348 14573 -747 115 -1082 C \nATOM 559 CD1 ILE A 71 34.294 5.274 -60.938 1.00 90.94 C \nANISOU 559 CD1 ILE A 71 9195 11560 13799 -704 187 -1128 C \nATOM 560 N ASN A 72 33.314 3.549 -55.882 1.00 84.62 N \nANISOU 560 N ASN A 72 8470 10578 13104 -574 14 -1019 N \nATOM 561 CA ASN A 72 33.609 2.215 -55.326 1.00 86.61 C \nANISOU 561 CA ASN A 72 8667 10843 13399 -471 -47 -1025 C \nATOM 562 C ASN A 72 33.778 2.223 -53.823 1.00 86.19 C \nANISOU 562 C ASN A 72 8622 10785 13343 -488 -85 -998 C \nATOM 563 O ASN A 72 34.856 2.047 -53.284 1.00 93.92 O \nANISOU 563 O ASN A 72 9522 11862 14300 -490 -112 -1014 O \nATOM 564 CB ASN A 72 34.788 1.562 -56.042 1.00 86.21 C \nANISOU 564 CB ASN A 72 8500 10914 13342 -420 -59 -1076 C \nATOM 565 CG ASN A 72 34.345 0.412 -56.907 1.00 89.59 C \nANISOU 565 CG ASN A 72 8923 11300 13819 -309 -73 -1094 C \nATOM 566 OD1 ASN A 72 33.704 -0.537 -56.430 1.00108.30 O \nANISOU 566 OD1 ASN A 72 11329 13587 16234 -230 -113 -1075 O \nATOM 567 ND2 ASN A 72 34.662 0.479 -58.183 1.00 91.89 N \nANISOU 567 ND2 ASN A 72 9173 11644 14096 -307 -41 -1130 N \nATOM 568 N VAL A 73 32.655 2.441 -53.164 1.00 89.20 N \nANISOU 568 N VAL A 73 9098 11052 13741 -500 -86 -955 N \nATOM 569 CA VAL A 73 32.615 2.528 -51.722 1.00 82.56 C \nANISOU 569 CA VAL A 73 8282 10190 12897 -522 -118 -923 C \nATOM 570 C VAL A 73 32.843 1.146 -51.081 1.00 78.32 C \nANISOU 570 C VAL A 73 7700 9655 12401 -420 -184 -923 C \nATOM 571 O VAL A 73 32.608 0.118 -51.711 1.00 67.51 O \nANISOU 571 O VAL A 73 6318 8261 11072 -328 -203 -937 O \nATOM 572 CB VAL A 73 31.269 3.142 -51.233 1.00 80.74 C \nANISOU 572 CB VAL A 73 8168 9837 12670 -558 -98 -878 C \nATOM 573 CG1 VAL A 73 31.067 4.535 -51.808 1.00 82.94 C \nANISOU 573 CG1 VAL A 73 8502 10108 12902 -653 -34 -877 C \nATOM 574 CG2 VAL A 73 30.076 2.243 -51.553 1.00 77.31 C \nANISOU 574 CG2 VAL A 73 7780 9304 12288 -473 -114 -861 C \nATOM 575 N PRO A 74 33.255 1.132 -49.807 1.00 80.98 N \nANISOU 575 N PRO A 74 8024 10016 12728 -437 -219 -905 N \nATOM 576 CA PRO A 74 33.358 -0.084 -49.020 1.00 80.10 C \nANISOU 576 CA PRO A 74 7891 9892 12652 -346 -284 -895 C \nATOM 577 C PRO A 74 32.200 -0.260 -48.073 1.00 82.69 C \nANISOU 577 C PRO A 74 8310 10102 13007 -342 -305 -848 C \nATOM 578 O PRO A 74 31.247 0.507 -48.114 1.00 84.95 O \nANISOU 578 O PRO A 74 8676 10316 13287 -398 -268 -825 O \nATOM 579 CB PRO A 74 34.652 0.132 -48.232 1.00 86.45 C \nANISOU 579 CB PRO A 74 8614 10817 13418 -379 -306 -906 C \nATOM 580 CG PRO A 74 34.767 1.612 -48.071 1.00 86.55 C \nANISOU 580 CG PRO A 74 8653 10855 13376 -512 -257 -900 C \nATOM 581 CD PRO A 74 33.909 2.267 -49.131 1.00 87.25 C \nANISOU 581 CD PRO A 74 8810 10875 13466 -547 -200 -901 C \nATOM 582 N GLU A 75 32.293 -1.282 -47.227 1.00 86.70 N \nANISOU 582 N GLU A 75 8807 10594 13541 -273 -364 -834 N \nATOM 583 CA GLU A 75 31.197 -1.678 -46.345 1.00 84.61 C \nANISOU 583 CA GLU A 75 8624 10219 13303 -258 -392 -791 C \nATOM 584 C GLU A 75 30.724 -0.549 -45.439 1.00 83.01 C \nANISOU 584 C GLU A 75 8479 9988 13072 -357 -369 -758 C \nATOM 585 O GLU A 75 31.501 0.322 -45.089 1.00 97.18 O \nANISOU 585 O GLU A 75 10241 11857 14825 -429 -352 -765 O \nATOM 586 CB GLU A 75 31.655 -2.864 -45.518 1.00 83.48 C \nANISOU 586 CB GLU A 75 8451 10086 13182 -178 -461 -784 C \nATOM 587 CG GLU A 75 30.615 -3.412 -44.565 1.00 91.48 C \nANISOU 587 CG GLU A 75 9544 10993 14220 -160 -497 -739 C \nATOM 588 CD GLU A 75 31.097 -4.660 -43.857 1.00101.19 C \nANISOU 588 CD GLU A 75 10751 12227 15470 -73 -567 -734 C \nATOM 589 OE1 GLU A 75 32.119 -5.246 -44.299 1.00 98.84 O \nANISOU 589 OE1 GLU A 75 10380 12004 15172 -5 -586 -767 O \nATOM 590 OE2 GLU A 75 30.427 -5.055 -42.868 1.00116.84 O \nANISOU 590 OE2 GLU A 75 12791 14137 17464 -71 -602 -695 O \nATOM 591 N TRP A 76 29.451 -0.579 -45.041 1.00 75.90 N \nANISOU 591 N TRP A 76 7665 8984 12189 -360 -369 -721 N \nATOM 592 CA TRP A 76 28.890 0.484 -44.210 1.00 70.83 C \nANISOU 592 CA TRP A 76 7087 8308 11519 -445 -345 -690 C \nATOM 593 C TRP A 76 27.876 0.005 -43.166 1.00 74.52 C \nANISOU 593 C TRP A 76 7619 8691 12007 -427 -379 -648 C \nATOM 594 O TRP A 76 27.215 -1.008 -43.350 1.00 84.77 O \nANISOU 594 O TRP A 76 8938 9932 13340 -361 -407 -638 O \nATOM 595 CB TRP A 76 28.241 1.566 -45.091 1.00 70.33 C \nANISOU 595 CB TRP A 76 7075 8214 11434 -498 -277 -693 C \nATOM 596 CG TRP A 76 26.937 1.091 -45.779 1.00 65.53 C \nANISOU 596 CG TRP A 76 6522 7520 10856 -448 -268 -679 C \nATOM 597 CD1 TRP A 76 25.731 0.973 -45.210 1.00 58.45 C \nANISOU 597 CD1 TRP A 76 5695 6543 9970 -442 -275 -643 C \nATOM 598 CD2 TRP A 76 26.780 0.676 -47.143 1.00 54.58 C \nANISOU 598 CD2 TRP A 76 5117 6131 9489 -402 -249 -704 C \nATOM 599 NE1 TRP A 76 24.839 0.496 -46.113 1.00 56.48 N \nANISOU 599 NE1 TRP A 76 5471 6247 9743 -398 -264 -642 N \nATOM 600 CE2 TRP A 76 25.462 0.316 -47.314 1.00 56.28 C \nANISOU 600 CE2 TRP A 76 5395 6265 9725 -373 -248 -679 C \nATOM 601 CE3 TRP A 76 27.638 0.575 -48.221 1.00 49.71 C \nANISOU 601 CE3 TRP A 76 4437 5580 8871 -385 -234 -745 C \nATOM 602 CZ2 TRP A 76 24.967 -0.122 -48.534 1.00 56.17 C \nANISOU 602 CZ2 TRP A 76 5383 6230 9729 -331 -231 -694 C \nATOM 603 CZ3 TRP A 76 27.162 0.154 -49.416 1.00 50.61 C \nANISOU 603 CZ3 TRP A 76 4554 5669 9005 -341 -217 -760 C \nATOM 604 CH2 TRP A 76 25.847 -0.203 -49.570 1.00 52.81 C \nANISOU 604 CH2 TRP A 76 4897 5864 9304 -314 -216 -735 C \nATOM 605 N SER A 77 27.719 0.795 -42.101 1.00 71.33 N \nANISOU 605 N SER A 77 7252 8278 11574 -495 -373 -623 N \nATOM 606 CA SER A 77 26.785 0.502 -41.038 1.00 72.43 C \nANISOU 606 CA SER A 77 7450 8347 11722 -492 -401 -582 C \nATOM 607 C SER A 77 25.385 1.081 -41.325 1.00 67.20 C \nANISOU 607 C SER A 77 6872 7608 11055 -512 -359 -560 C \nATOM 608 O SER A 77 24.393 0.369 -41.218 1.00 70.95 O \nANISOU 608 O SER A 77 7383 8021 11553 -472 -379 -538 O \nATOM 609 CB SER A 77 27.341 1.016 -39.706 1.00 78.18 C \nANISOU 609 CB SER A 77 8173 9110 12421 -551 -418 -567 C \nATOM 610 OG SER A 77 27.563 2.420 -39.716 1.00 81.24 O \nANISOU 610 OG SER A 77 8582 9523 12762 -640 -365 -574 O \nATOM 611 N TYR A 78 25.324 2.344 -41.738 1.00 64.36 N \nANISOU 611 N TYR A 78 6540 7255 10659 -573 -300 -568 N \nATOM 612 CA TYR A 78 24.070 2.961 -42.235 1.00 64.38 C \nANISOU 612 CA TYR A 78 6617 7195 10651 -581 -254 -551 C \nATOM 613 C TYR A 78 24.369 4.010 -43.294 1.00 59.79 C \nANISOU 613 C TYR A 78 6041 6637 10039 -619 -193 -576 C \nATOM 614 O TYR A 78 25.505 4.218 -43.634 1.00 64.05 O \nANISOU 614 O TYR A 78 6527 7242 10567 -644 -188 -605 O \nATOM 615 CB TYR A 78 23.258 3.575 -41.094 1.00 69.85 C \nANISOU 615 CB TYR A 78 7380 7843 11318 -619 -248 -516 C \nATOM 616 CG TYR A 78 24.000 4.672 -40.333 1.00 73.98 C \nANISOU 616 CG TYR A 78 7915 8399 11796 -699 -230 -519 C \nATOM 617 CD1 TYR A 78 23.680 6.007 -40.548 1.00 78.78 C \nANISOU 617 CD1 TYR A 78 8588 8986 12359 -753 -170 -518 C \nATOM 618 CD2 TYR A 78 25.006 4.367 -39.424 1.00 69.12 C \nANISOU 618 CD2 TYR A 78 7250 7833 11179 -720 -271 -523 C \nATOM 619 CE1 TYR A 78 24.341 7.008 -39.882 1.00 78.76 C \nANISOU 619 CE1 TYR A 78 8608 9008 12310 -832 -152 -522 C \nATOM 620 CE2 TYR A 78 25.665 5.351 -38.739 1.00 78.22 C \nANISOU 620 CE2 TYR A 78 8414 9020 12287 -800 -254 -526 C \nATOM 621 CZ TYR A 78 25.335 6.675 -38.978 1.00 84.91 C \nANISOU 621 CZ TYR A 78 9332 9841 13089 -860 -194 -527 C \nATOM 622 OH TYR A 78 25.979 7.665 -38.292 1.00 89.70 O \nANISOU 622 OH TYR A 78 9962 10476 13645 -947 -176 -531 O \nATOM 623 N ILE A 79 23.336 4.621 -43.863 1.00 55.85 N \nANISOU 623 N ILE A 79 5606 6089 9526 -621 -149 -564 N \nATOM 624 CA ILE A 79 23.496 5.545 -44.971 1.00 49.94 C \nANISOU 624 CA ILE A 79 4872 5354 8750 -650 -92 -584 C \nATOM 625 C ILE A 79 22.865 6.850 -44.569 1.00 56.21 C \nANISOU 625 C ILE A 79 5756 6106 9495 -701 -46 -563 C \nATOM 626 O ILE A 79 21.809 6.887 -43.981 1.00 67.96 O \nANISOU 626 O ILE A 79 7298 7543 10980 -683 -48 -532 O \nATOM 627 CB ILE A 79 22.840 5.026 -46.276 1.00 51.42 C \nANISOU 627 CB ILE A 79 5052 5522 8962 -591 -77 -592 C \nATOM 628 CG1 ILE A 79 23.574 3.746 -46.795 1.00 51.56 C \nANISOU 628 CG1 ILE A 79 4985 5581 9025 -537 -119 -619 C \nATOM 629 CG2 ILE A 79 22.853 6.102 -47.375 1.00 50.58 C \nANISOU 629 CG2 ILE A 79 4976 5421 8821 -623 -15 -606 C \nATOM 630 CD1 ILE A 79 22.810 2.984 -47.857 1.00 49.26 C \nANISOU 630 CD1 ILE A 79 4690 5262 8763 -475 -117 -623 C \nATOM 631 N VAL A 80 23.549 7.934 -44.878 1.00 56.68 N \nANISOU 631 N VAL A 80 5835 6190 9512 -766 -5 -580 N \nATOM 632 CA VAL A 80 23.044 9.232 -44.504 1.00 53.74 C \nANISOU 632 CA VAL A 80 5559 5772 9085 -816 40 -563 C \nATOM 633 C VAL A 80 22.921 10.061 -45.754 1.00 48.98 C \nANISOU 633 C VAL A 80 4996 5160 8453 -829 96 -575 C \nATOM 634 O VAL A 80 23.859 10.137 -46.538 1.00 40.49 O \nANISOU 634 O VAL A 80 3875 4137 7374 -858 107 -605 O \nATOM 635 CB VAL A 80 23.937 9.924 -43.426 1.00 59.73 C \nANISOU 635 CB VAL A 80 6332 6558 9806 -900 36 -566 C \nATOM 636 CG1 VAL A 80 25.326 9.291 -43.377 1.00 59.03 C \nANISOU 636 CG1 VAL A 80 6140 6556 9734 -920 -1 -595 C \nATOM 637 CG2 VAL A 80 24.003 11.440 -43.619 1.00 54.63 C \nANISOU 637 CG2 VAL A 80 5777 5887 9092 -974 97 -569 C \nATOM 638 N GLU A 81 21.753 10.681 -45.894 1.00 46.50 N \nANISOU 638 N GLU A 81 4768 4783 8116 -807 131 -551 N \nATOM 639 CA GLU A 81 21.383 11.404 -47.074 1.00 53.06 C \nANISOU 639 CA GLU A 81 5647 5595 8920 -802 184 -555 C \nATOM 640 C GLU A 81 20.829 12.692 -46.585 1.00 56.55 C \nANISOU 640 C GLU A 81 6205 5980 9302 -834 226 -534 C \nATOM 641 O GLU A 81 20.413 12.782 -45.425 1.00 72.75 O \nANISOU 641 O GLU A 81 8293 8005 11345 -835 211 -513 O \nATOM 642 CB GLU A 81 20.302 10.617 -47.814 1.00 56.46 C \nANISOU 642 CB GLU A 81 6058 6008 9387 -715 178 -542 C \nATOM 643 CG GLU A 81 20.116 10.989 -49.278 1.00 53.56 C \nANISOU 643 CG GLU A 81 5703 5641 9007 -701 220 -554 C \nATOM 644 CD GLU A 81 19.030 10.163 -49.937 1.00 47.54 C \nANISOU 644 CD GLU A 81 4918 4868 8278 -620 211 -541 C \nATOM 645 OE1 GLU A 81 18.138 9.732 -49.187 1.00 40.79 O \nANISOU 645 OE1 GLU A 81 4076 3989 7434 -582 188 -514 O \nATOM 646 OE2 GLU A 81 19.027 10.027 -51.185 1.00 42.65 O \nANISOU 646 OE2 GLU A 81 4274 4264 7665 -600 230 -556 O \nATOM 647 N LYS A 82 20.865 13.716 -47.392 1.00 58.93 N \nANISOU 647 N LYS A 82 6571 6262 9557 -862 278 -540 N \nATOM 648 CA LYS A 82 20.303 14.975 -46.949 1.00 72.32 C \nANISOU 648 CA LYS A 82 8393 7895 11190 -884 320 -520 C \nATOM 649 C LYS A 82 18.841 14.910 -47.284 1.00 74.24 C \nANISOU 649 C LYS A 82 8676 8096 11436 -794 334 -492 C \nATOM 650 O LYS A 82 18.382 13.944 -47.904 1.00 84.02 O \nANISOU 650 O LYS A 82 9845 9357 12721 -731 314 -491 O \nATOM 651 CB LYS A 82 20.988 16.167 -47.619 1.00 81.91 C \nANISOU 651 CB LYS A 82 9675 9101 12344 -959 370 -538 C \nATOM 652 CG LYS A 82 22.518 16.069 -47.499 1.00 86.38 C \nANISOU 652 CG LYS A 82 10175 9736 12911 -1051 353 -570 C \nATOM 653 CD LYS A 82 23.204 17.277 -46.877 1.00 89.80 C \nANISOU 653 CD LYS A 82 10696 10153 13272 -1158 380 -576 C \nATOM 654 CE LYS A 82 24.604 16.900 -46.372 1.00 89.84 C \nANISOU 654 CE LYS A 82 10609 10242 13283 -1238 347 -603 C \nATOM 655 NZ LYS A 82 24.572 16.115 -45.088 1.00 89.87 N \nANISOU 655 NZ LYS A 82 10559 10262 13325 -1215 295 -592 N \nATOM 656 N ALA A 83 18.099 15.923 -46.879 1.00 77.01 N \nANISOU 656 N ALA A 83 9140 8389 11732 -786 370 -470 N \nATOM 657 CA ALA A 83 16.667 15.953 -47.160 1.00 78.31 C \nANISOU 657 CA ALA A 83 9344 8523 11888 -696 387 -441 C \nATOM 658 C ALA A 83 16.423 16.252 -48.648 1.00 78.77 C \nANISOU 658 C ALA A 83 9416 8579 11933 -666 424 -446 C \nATOM 659 O ALA A 83 15.569 15.614 -49.274 1.00 71.15 O \nANISOU 659 O ALA A 83 8410 7630 10994 -592 418 -434 O \nATOM 660 CB ALA A 83 15.989 16.985 -46.292 1.00 82.82 C \nANISOU 660 CB ALA A 83 10033 9035 12398 -688 415 -419 C \nATOM 661 N ASN A 84 17.175 17.207 -49.206 1.00 81.27 N \nANISOU 661 N ASN A 84 9791 8880 12207 -728 462 -462 N \nATOM 662 CA ASN A 84 17.098 17.542 -50.638 1.00 88.11 C \nANISOU 662 CA ASN A 84 10673 9747 13058 -712 498 -468 C \nATOM 663 C ASN A 84 18.471 17.583 -51.320 1.00 86.62 C \nANISOU 663 C ASN A 84 10440 9598 12873 -796 501 -503 C \nATOM 664 O ASN A 84 19.013 18.670 -51.574 1.00 93.94 O \nANISOU 664 O ASN A 84 11451 10499 13742 -863 540 -511 O \nATOM 665 CB ASN A 84 16.411 18.896 -50.848 1.00 99.95 C \nANISOU 665 CB ASN A 84 12318 11178 14481 -693 553 -447 C \nATOM 666 CG ASN A 84 14.923 18.865 -50.553 1.00101.26 C \nANISOU 666 CG ASN A 84 12519 11320 14636 -590 558 -412 C \nATOM 667 OD1 ASN A 84 14.429 18.009 -49.832 1.00109.47 O \nANISOU 667 OD1 ASN A 84 13494 12383 15715 -552 520 -402 O \nATOM 668 ND2 ASN A 84 14.203 19.817 -51.117 1.00110.90 N \nANISOU 668 ND2 ASN A 84 13842 12496 15798 -544 604 -394 N \nATOM 669 N PRO A 85 19.052 16.404 -51.599 1.00 81.09 N \nANISOU 669 N PRO A 85 9610 8963 12236 -795 461 -525 N \nATOM 670 CA PRO A 85 20.361 16.303 -52.246 1.00 73.66 C \nANISOU 670 CA PRO A 85 8609 8078 11302 -866 460 -561 C \nATOM 671 C PRO A 85 20.386 17.021 -53.554 1.00 71.71 C \nANISOU 671 C PRO A 85 8408 7822 11017 -879 507 -567 C \nATOM 672 O PRO A 85 19.453 16.892 -54.348 1.00 74.50 O \nANISOU 672 O PRO A 85 8772 8159 11377 -806 522 -552 O \nATOM 673 CB PRO A 85 20.533 14.795 -52.476 1.00 73.98 C \nANISOU 673 CB PRO A 85 8511 8178 11419 -818 410 -576 C \nATOM 674 CG PRO A 85 19.333 14.125 -51.886 1.00 74.51 C \nANISOU 674 CG PRO A 85 8574 8218 11518 -736 384 -547 C \nATOM 675 CD PRO A 85 18.655 15.119 -51.006 1.00 78.92 C \nANISOU 675 CD PRO A 85 9246 8714 12025 -739 408 -518 C \nATOM 676 N ALA A 86 21.443 17.782 -53.787 1.00 75.69 N \nANISOU 676 N ALA A 86 8942 8341 11477 -975 530 -589 N \nATOM 677 CA ALA A 86 21.542 18.573 -55.010 1.00 78.23 C \nANISOU 677 CA ALA A 86 9320 8651 11752 -1001 577 -595 C \nATOM 678 C ALA A 86 21.879 17.706 -56.225 1.00 79.05 C \nANISOU 678 C ALA A 86 9311 8822 11901 -978 567 -619 C \nATOM 679 O ALA A 86 21.629 18.095 -57.367 1.00 85.29 O \nANISOU 679 O ALA A 86 10134 9605 12669 -967 601 -618 O \nATOM 680 CB ALA A 86 22.575 19.674 -54.846 1.00 81.05 C \nANISOU 680 CB ALA A 86 9750 9004 12040 -1124 606 -610 C \nATOM 681 N ASN A 87 22.430 16.525 -55.980 1.00 69.72 N \nANISOU 681 N ASN A 87 8002 7708 10782 -966 520 -640 N \nATOM 682 CA ASN A 87 22.874 15.657 -57.041 1.00 67.26 C \nANISOU 682 CA ASN A 87 7582 7464 10512 -945 507 -668 C \nATOM 683 C ASN A 87 22.068 14.362 -57.108 1.00 70.42 C \nANISOU 683 C ASN A 87 7905 7868 10981 -842 470 -661 C \nATOM 684 O ASN A 87 22.491 13.312 -56.646 1.00 68.35 O \nANISOU 684 O ASN A 87 7550 7648 10770 -823 424 -676 O \nATOM 685 CB ASN A 87 24.343 15.340 -56.838 1.00 75.95 C \nANISOU 685 CB ASN A 87 8592 8647 11618 -1019 485 -706 C \nATOM 686 CG ASN A 87 25.202 16.588 -56.825 1.00 70.63 C \nANISOU 686 CG ASN A 87 7989 7980 10869 -1137 521 -716 C \nATOM 687 OD1 ASN A 87 25.036 17.483 -57.661 1.00 63.42 O \nANISOU 687 OD1 ASN A 87 7155 7037 9905 -1167 567 -712 O \nATOM 688 ND2 ASN A 87 26.158 16.629 -55.905 1.00 69.58 N \nANISOU 688 ND2 ASN A 87 7825 7891 10723 -1208 501 -731 N \nATOM 689 N ASP A 88 20.898 14.453 -57.724 1.00 70.49 N \nANISOU 689 N ASP A 88 7959 7837 10988 -776 491 -637 N \nATOM 690 CA ASP A 88 19.997 13.340 -57.849 1.00 61.21 C \nANISOU 690 CA ASP A 88 6728 6663 9866 -686 461 -626 C \nATOM 691 C ASP A 88 20.053 12.828 -59.290 1.00 61.48 C \nANISOU 691 C ASP A 88 6702 6737 9920 -660 470 -647 C \nATOM 692 O ASP A 88 21.126 12.485 -59.839 1.00 56.82 O \nANISOU 692 O ASP A 88 6040 6205 9344 -697 464 -684 O \nATOM 693 CB ASP A 88 18.592 13.812 -57.468 1.00 73.38 C \nANISOU 693 CB ASP A 88 8357 8141 11382 -630 477 -583 C \nATOM 694 CG ASP A 88 17.622 12.662 -57.179 1.00 80.61 C \nANISOU 694 CG ASP A 88 9221 9060 12347 -551 440 -567 C \nATOM 695 OD1 ASP A 88 18.018 11.467 -57.202 1.00 92.05 O \nANISOU 695 OD1 ASP A 88 10576 10549 13852 -538 398 -587 O \nATOM 696 OD2 ASP A 88 16.448 12.971 -56.953 1.00 80.03 O \nANISOU 696 OD2 ASP A 88 9205 8951 12251 -502 453 -533 O \nATOM 697 N LEU A 89 18.911 12.769 -59.942 1.00 55.22 N \nANISOU 697 N LEU A 89 5935 5921 9124 -597 486 -625 N \nATOM 698 CA LEU A 89 18.911 12.577 -61.379 1.00 53.39 C \nANISOU 698 CA LEU A 89 5669 5721 8895 -582 506 -641 C \nATOM 699 C LEU A 89 19.351 13.897 -62.019 1.00 50.38 C \nANISOU 699 C LEU A 89 5363 5328 8450 -643 558 -643 C \nATOM 700 O LEU A 89 19.206 14.957 -61.466 1.00 54.28 O \nANISOU 700 O LEU A 89 5954 5774 8894 -672 582 -622 O \nATOM 701 CB LEU A 89 17.508 12.165 -61.902 1.00 47.51 C \nANISOU 701 CB LEU A 89 4931 4961 8160 -500 509 -615 C \nATOM 702 CG LEU A 89 16.862 11.000 -61.169 1.00 46.50 C \nANISOU 702 CG LEU A 89 4754 4834 8081 -447 462 -604 C \nATOM 703 CD1 LEU A 89 15.503 10.668 -61.763 1.00 41.47 C \nANISOU 703 CD1 LEU A 89 4122 4193 7440 -378 469 -579 C \nATOM 704 CD2 LEU A 89 17.807 9.763 -61.172 1.00 43.06 C \nANISOU 704 CD2 LEU A 89 4215 4443 7705 -454 418 -643 C \nATOM 705 N CYS A 90 19.841 13.803 -63.223 1.00 55.37 N \nANISOU 705 N CYS A 90 5953 6002 9081 -661 574 -669 N \nATOM 706 CA CYS A 90 20.267 14.963 -63.967 1.00 60.82 C \nANISOU 706 CA CYS A 90 6712 6687 9711 -722 622 -672 C \nATOM 707 C CYS A 90 19.401 15.159 -65.204 1.00 61.07 C \nANISOU 707 C CYS A 90 6772 6709 9724 -674 653 -656 C \nATOM 708 O CYS A 90 19.439 16.186 -65.894 1.00 74.54 O \nANISOU 708 O CYS A 90 8555 8396 11372 -707 696 -648 O \nATOM 709 CB CYS A 90 21.727 14.761 -64.353 1.00 62.18 C \nANISOU 709 CB CYS A 90 6807 6931 9888 -796 616 -718 C \nATOM 710 SG CYS A 90 22.144 13.279 -65.285 1.00 70.46 S \nANISOU 710 SG CYS A 90 7708 8061 11002 -754 586 -759 S \nATOM 711 N TYR A 91 18.650 14.136 -65.524 1.00 57.38 N \nANISOU 711 N TYR A 91 6240 6259 9302 -598 630 -653 N \nATOM 712 CA TYR A 91 17.578 14.286 -66.443 1.00 59.22 C \nANISOU 712 CA TYR A 91 6505 6480 9516 -541 655 -629 C \nATOM 713 C TYR A 91 16.322 14.136 -65.601 1.00 55.15 C \nANISOU 713 C TYR A 91 6023 5925 9004 -470 641 -590 C \nATOM 714 O TYR A 91 16.271 13.278 -64.730 1.00 62.43 O \nANISOU 714 O TYR A 91 6894 6853 9972 -452 600 -593 O \nATOM 715 CB TYR A 91 17.666 13.200 -67.503 1.00 57.43 C \nANISOU 715 CB TYR A 91 6176 6312 9334 -515 641 -658 C \nATOM 716 CG TYR A 91 17.468 13.678 -68.916 1.00 56.27 C \nANISOU 716 CG TYR A 91 6049 6180 9151 -515 681 -657 C \nATOM 717 CD1 TYR A 91 18.464 14.415 -69.584 1.00 49.98 C \nANISOU 717 CD1 TYR A 91 5271 5401 8318 -589 711 -679 C \nATOM 718 CD2 TYR A 91 16.300 13.322 -69.633 1.00 48.12 C \nANISOU 718 CD2 TYR A 91 5011 5152 8119 -445 686 -636 C \nATOM 719 CE1 TYR A 91 18.271 14.814 -70.910 1.00 53.69 C \nANISOU 719 CE1 TYR A 91 5759 5887 8755 -590 746 -678 C \nATOM 720 CE2 TYR A 91 16.103 13.704 -70.988 1.00 54.47 C \nANISOU 720 CE2 TYR A 91 5828 5976 8891 -443 721 -635 C \nATOM 721 CZ TYR A 91 17.076 14.436 -71.615 1.00 58.73 C \nANISOU 721 CZ TYR A 91 6390 6527 9398 -513 750 -656 C \nATOM 722 OH TYR A 91 16.847 14.824 -72.921 1.00 69.93 O \nANISOU 722 OH TYR A 91 7826 7963 10782 -510 784 -652 O \nATOM 723 N PRO A 92 15.316 14.977 -65.832 1.00 51.57 N \nANISOU 723 N PRO A 92 5659 5436 8500 -430 674 -552 N \nATOM 724 CA PRO A 92 14.063 14.812 -65.087 1.00 50.97 C \nANISOU 724 CA PRO A 92 5606 5336 8421 -357 661 -515 C \nATOM 725 C PRO A 92 13.293 13.532 -65.478 1.00 44.32 C \nANISOU 725 C PRO A 92 4674 4541 7626 -299 632 -516 C \nATOM 726 O PRO A 92 13.361 13.091 -66.606 1.00 48.35 O \nANISOU 726 O PRO A 92 5134 5089 8149 -294 637 -533 O \nATOM 727 CB PRO A 92 13.243 16.058 -65.477 1.00 50.16 C \nANISOU 727 CB PRO A 92 5619 5196 8246 -322 708 -478 C \nATOM 728 CG PRO A 92 13.759 16.451 -66.827 1.00 51.28 C \nANISOU 728 CG PRO A 92 5766 5354 8365 -354 740 -494 C \nATOM 729 CD PRO A 92 15.152 15.863 -66.986 1.00 55.64 C \nANISOU 729 CD PRO A 92 6236 5944 8962 -432 720 -543 C \nATOM 730 N GLY A 93 12.601 12.927 -64.527 1.00 38.26 N \nANISOU 730 N GLY A 93 3887 3769 6879 -261 600 -498 N \nATOM 731 CA GLY A 93 11.963 11.665 -64.780 1.00 39.91 C \nANISOU 731 CA GLY A 93 4015 4019 7129 -221 569 -501 C \nATOM 732 C GLY A 93 11.684 10.889 -63.536 1.00 43.49 C \nANISOU 732 C GLY A 93 4440 4466 7616 -210 525 -493 C \nATOM 733 O GLY A 93 11.981 11.328 -62.425 1.00 45.79 O \nANISOU 733 O GLY A 93 4772 4725 7903 -231 518 -486 O \nATOM 734 N ASN A 94 11.057 9.730 -63.721 1.00 45.00 N \nANISOU 734 N ASN A 94 4568 4691 7839 -180 495 -494 N \nATOM 735 CA ASN A 94 10.704 8.884 -62.609 1.00 51.33 C \nANISOU 735 CA ASN A 94 5344 5490 8671 -171 451 -485 C \nATOM 736 C ASN A 94 11.757 7.796 -62.352 1.00 52.85 C \nANISOU 736 C ASN A 94 5468 5684 8926 -204 408 -523 C \nATOM 737 O ASN A 94 12.273 7.156 -63.278 1.00 70.53 O \nANISOU 737 O ASN A 94 7656 7949 11195 -212 403 -555 O \nATOM 738 CB ASN A 94 9.353 8.211 -62.926 1.00 60.33 C \nANISOU 738 CB ASN A 94 6457 6665 9799 -124 442 -461 C \nATOM 739 CG ASN A 94 8.741 7.514 -61.719 1.00 74.23 C \nANISOU 739 CG ASN A 94 8206 8423 11573 -115 402 -442 C \nATOM 740 OD1 ASN A 94 8.498 6.294 -61.762 1.00 69.04 O \nANISOU 740 OD1 ASN A 94 7496 7787 10948 -116 366 -451 O \nATOM 741 ND2 ASN A 94 8.524 8.264 -60.626 1.00 81.60 N \nANISOU 741 ND2 ASN A 94 9195 9330 12481 -109 408 -418 N \nATOM 742 N PHE A 95 12.031 7.532 -61.090 1.00 51.55 N \nANISOU 742 N PHE A 95 5306 5499 8784 -219 375 -519 N \nATOM 743 CA PHE A 95 12.750 6.339 -60.705 1.00 36.28 C \nANISOU 743 CA PHE A 95 3311 3568 6906 -233 326 -547 C \nATOM 744 C PHE A 95 11.749 5.374 -60.139 1.00 34.40 C \nANISOU 744 C PHE A 95 3058 3331 6680 -206 290 -526 C \nATOM 745 O PHE A 95 11.331 5.477 -58.975 1.00 38.15 O \nANISOU 745 O PHE A 95 3560 3788 7147 -205 274 -500 O \nATOM 746 CB PHE A 95 13.815 6.650 -59.702 1.00 40.50 C \nANISOU 746 CB PHE A 95 3852 4082 7454 -271 312 -559 C \nATOM 747 CG PHE A 95 14.895 5.620 -59.595 1.00 37.50 C \nANISOU 747 CG PHE A 95 3406 3716 7126 -285 271 -595 C \nATOM 748 CD1 PHE A 95 16.177 5.955 -59.827 1.00 46.25 C \nANISOU 748 CD1 PHE A 95 4492 4841 8241 -321 279 -627 C \nATOM 749 CD2 PHE A 95 14.638 4.367 -59.150 1.00 38.92 C \nANISOU 749 CD2 PHE A 95 3551 3892 7343 -263 223 -596 C \nATOM 750 CE1 PHE A 95 17.211 5.015 -59.729 1.00 49.79 C \nANISOU 750 CE1 PHE A 95 4875 5311 8734 -324 242 -662 C \nATOM 751 CE2 PHE A 95 15.658 3.400 -59.006 1.00 43.63 C \nANISOU 751 CE2 PHE A 95 4093 4497 7986 -265 183 -630 C \nATOM 752 CZ PHE A 95 16.958 3.725 -59.322 1.00 45.16 C \nANISOU 752 CZ PHE A 95 4257 4716 8187 -291 193 -664 C \nATOM 753 N ASN A 96 11.341 4.381 -60.949 1.00 33.07 N \nANISOU 753 N ASN A 96 2848 3187 6530 -188 276 -537 N \nATOM 754 CA ASN A 96 10.345 3.379 -60.555 1.00 33.01 C \nANISOU 754 CA ASN A 96 2829 3186 6528 -172 242 -518 C \nATOM 755 C ASN A 96 10.698 2.630 -59.253 1.00 33.89 C \nANISOU 755 C ASN A 96 2934 3270 6673 -186 191 -517 C \nATOM 756 O ASN A 96 11.844 2.284 -58.995 1.00 45.85 O \nANISOU 756 O ASN A 96 4425 4768 8225 -201 168 -546 O \nATOM 757 CB ASN A 96 10.127 2.412 -61.680 1.00 36.62 C \nANISOU 757 CB ASN A 96 3246 3668 7000 -163 235 -538 C \nATOM 758 CG ASN A 96 8.754 1.765 -61.629 1.00 41.93 C \nANISOU 758 CG ASN A 96 3919 4363 7650 -151 221 -510 C \nATOM 759 OD1 ASN A 96 7.722 2.470 -61.628 1.00 38.89 O \nANISOU 759 OD1 ASN A 96 3558 4004 7215 -134 248 -476 O \nATOM 760 ND2 ASN A 96 8.722 0.420 -61.528 1.00 45.59 N \nANISOU 760 ND2 ASN A 96 4359 4820 8144 -160 177 -524 N \nATOM 761 N ASP A 97 9.685 2.405 -58.419 1.00 36.12 N \nANISOU 761 N ASP A 97 3235 3552 6937 -180 173 -484 N \nATOM 762 CA ASP A 97 9.786 1.768 -57.099 1.00 31.35 C \nANISOU 762 CA ASP A 97 2633 2923 6354 -194 126 -474 C \nATOM 763 C ASP A 97 11.042 2.190 -56.385 1.00 32.58 C \nANISOU 763 C ASP A 97 2793 3052 6534 -213 118 -491 C \nATOM 764 O ASP A 97 11.762 1.383 -55.826 1.00 40.77 O \nANISOU 764 O ASP A 97 3809 4072 7611 -222 75 -507 O \nATOM 765 CB ASP A 97 9.718 0.245 -57.229 1.00 32.25 C \nANISOU 765 CB ASP A 97 2719 3033 6503 -196 79 -488 C \nATOM 766 CG ASP A 97 8.373 -0.257 -57.672 1.00 36.04 C \nANISOU 766 CG ASP A 97 3198 3543 6950 -191 80 -467 C \nATOM 767 OD1 ASP A 97 7.319 0.040 -57.021 1.00 33.92 O \nANISOU 767 OD1 ASP A 97 2951 3294 6643 -191 83 -430 O \nATOM 768 OD2 ASP A 97 8.346 -0.939 -58.670 1.00 45.68 O \nANISOU 768 OD2 ASP A 97 4399 4776 8183 -188 78 -488 O \nATOM 769 N TYR A 98 11.269 3.483 -56.332 1.00 33.33 N \nANISOU 769 N TYR A 98 2920 3144 6601 -220 158 -484 N \nATOM 770 CA TYR A 98 12.424 4.080 -55.615 1.00 33.40 C \nANISOU 770 CA TYR A 98 2938 3132 6619 -249 157 -497 C \nATOM 771 C TYR A 98 12.496 3.748 -54.204 1.00 35.19 C \nANISOU 771 C TYR A 98 3172 3340 6858 -262 117 -483 C \nATOM 772 O TYR A 98 13.534 3.318 -53.716 1.00 44.12 O \nANISOU 772 O TYR A 98 4277 4464 8024 -279 86 -503 O \nATOM 773 CB TYR A 98 12.405 5.634 -55.815 1.00 33.46 C \nANISOU 773 CB TYR A 98 2999 3135 6579 -258 212 -486 C \nATOM 774 CG TYR A 98 13.708 6.292 -55.464 1.00 40.52 C \nANISOU 774 CG TYR A 98 3900 4018 7476 -299 220 -508 C \nATOM 775 CD1 TYR A 98 14.942 5.594 -55.577 1.00 36.40 C \nANISOU 775 CD1 TYR A 98 3321 3511 6998 -319 191 -544 C \nATOM 776 CD2 TYR A 98 13.737 7.618 -54.988 1.00 41.16 C \nANISOU 776 CD2 TYR A 98 4048 4078 7513 -321 255 -492 C \nATOM 777 CE1 TYR A 98 16.140 6.205 -55.193 1.00 37.65 C \nANISOU 777 CE1 TYR A 98 3479 3674 7154 -363 196 -563 C \nATOM 778 CE2 TYR A 98 14.933 8.215 -54.633 1.00 44.18 C \nANISOU 778 CE2 TYR A 98 4438 4455 7893 -370 261 -512 C \nATOM 779 CZ TYR A 98 16.124 7.515 -54.778 1.00 41.44 C \nANISOU 779 CZ TYR A 98 4025 4134 7587 -394 232 -547 C \nATOM 780 OH TYR A 98 17.299 8.154 -54.467 1.00 47.79 O \nANISOU 780 OH TYR A 98 4833 4946 8381 -448 240 -567 O \nATOM 781 N GLU A 99 11.352 3.941 -53.507 1.00 36.43 N \nANISOU 781 N GLU A 99 3364 3494 6985 -251 118 -446 N \nATOM 782 CA GLU A 99 11.299 3.795 -52.041 1.00 36.32 C \nANISOU 782 CA GLU A 99 3365 3461 6972 -267 85 -426 C \nATOM 783 C GLU A 99 11.473 2.343 -51.654 1.00 36.83 C \nANISOU 783 C GLU A 99 3392 3520 7080 -269 26 -433 C \nATOM 784 O GLU A 99 12.039 2.044 -50.617 1.00 45.25 O \nANISOU 784 O GLU A 99 4456 4569 8167 -286 -10 -433 O \nATOM 785 CB GLU A 99 9.998 4.329 -51.495 1.00 37.33 C \nANISOU 785 CB GLU A 99 3535 3596 7052 -251 102 -387 C \nATOM 786 CG GLU A 99 9.769 5.801 -51.730 1.00 37.12 C \nANISOU 786 CG GLU A 99 3561 3567 6976 -240 159 -377 C \nATOM 787 CD GLU A 99 9.346 6.118 -53.137 1.00 45.73 C \nANISOU 787 CD GLU A 99 4651 4680 8046 -212 198 -381 C \nATOM 788 OE1 GLU A 99 8.930 5.196 -53.885 1.00 43.44 O \nANISOU 788 OE1 GLU A 99 4319 4415 7773 -198 184 -386 O \nATOM 789 OE2 GLU A 99 9.421 7.319 -53.515 1.00 58.19 O \nANISOU 789 OE2 GLU A 99 6275 6248 9588 -205 245 -378 O \nATOM 790 N GLU A 100 11.073 1.451 -52.533 1.00 35.41 N \nANISOU 790 N GLU A 100 3188 3353 6915 -252 16 -442 N \nATOM 791 CA GLU A 100 11.277 0.005 -52.270 1.00 37.89 C \nANISOU 791 CA GLU A 100 3477 3652 7268 -252 -41 -452 C \nATOM 792 C GLU A 100 12.683 -0.373 -52.420 1.00 36.62 C \nANISOU 792 C GLU A 100 3285 3481 7150 -251 -61 -488 C \nATOM 793 O GLU A 100 13.249 -1.092 -51.579 1.00 50.09 O \nANISOU 793 O GLU A 100 4982 5167 8883 -255 -107 -492 O \nATOM 794 CB GLU A 100 10.390 -0.826 -53.208 1.00 43.53 C \nANISOU 794 CB GLU A 100 4181 4381 7976 -239 -43 -451 C \nATOM 795 CG GLU A 100 8.927 -0.909 -52.761 1.00 41.40 C \nANISOU 795 CG GLU A 100 3934 4130 7665 -245 -45 -412 C \nATOM 796 CD GLU A 100 8.742 -1.910 -51.669 1.00 44.03 C \nANISOU 796 CD GLU A 100 4277 4442 8011 -264 -101 -397 C \nATOM 797 OE1 GLU A 100 9.493 -2.937 -51.721 1.00 49.52 O \nANISOU 797 OE1 GLU A 100 4960 5107 8747 -264 -140 -420 O \nATOM 798 OE2 GLU A 100 7.892 -1.638 -50.755 1.00 34.34 O \nANISOU 798 OE2 GLU A 100 3071 3227 6749 -277 -104 -363 O \nATOM 799 N LEU A 101 13.315 0.165 -53.442 1.00 37.39 N \nANISOU 799 N LEU A 101 3363 3596 7249 -246 -25 -516 N \nATOM 800 CA LEU A 101 14.852 0.092 -53.589 1.00 38.64 C \nANISOU 800 CA LEU A 101 3482 3760 7438 -249 -35 -554 C \nATOM 801 C LEU A 101 15.569 0.649 -52.372 1.00 39.59 C \nANISOU 801 C LEU A 101 3610 3875 7557 -275 -47 -547 C \nATOM 802 O LEU A 101 16.395 -0.011 -51.768 1.00 40.24 O \nANISOU 802 O LEU A 101 3667 3954 7668 -272 -89 -560 O \nATOM 803 CB LEU A 101 15.315 0.842 -54.807 1.00 33.86 C \nANISOU 803 CB LEU A 101 2861 3181 6822 -251 13 -579 C \nATOM 804 CG LEU A 101 16.790 0.771 -55.075 1.00 37.64 C \nANISOU 804 CG LEU A 101 3293 3682 7324 -256 7 -619 C \nATOM 805 CD1 LEU A 101 17.347 -0.666 -55.037 1.00 40.88 C \nANISOU 805 CD1 LEU A 101 3665 4089 7778 -223 -46 -643 C \nATOM 806 CD2 LEU A 101 17.131 1.424 -56.417 1.00 35.79 C \nANISOU 806 CD2 LEU A 101 3044 3479 7076 -261 55 -644 C \nATOM 807 N LYS A 102 15.229 1.869 -52.013 1.00 37.69 N \nANISOU 807 N LYS A 102 3408 3633 7278 -299 -10 -526 N \nATOM 808 CA LYS A 102 15.767 2.482 -50.813 1.00 40.86 C \nANISOU 808 CA LYS A 102 3827 4028 7671 -330 -18 -517 C \nATOM 809 C LYS A 102 15.610 1.553 -49.591 1.00 42.17 C \nANISOU 809 C LYS A 102 3991 4176 7858 -327 -75 -499 C \nATOM 810 O LYS A 102 16.487 1.410 -48.727 1.00 45.62 O \nANISOU 810 O LYS A 102 4411 4613 8309 -343 -105 -504 O \nATOM 811 CB LYS A 102 15.051 3.816 -50.525 1.00 41.20 C \nANISOU 811 CB LYS A 102 3930 4061 7663 -348 28 -490 C \nATOM 812 CG LYS A 102 15.839 5.048 -50.950 1.00 45.48 C \nANISOU 812 CG LYS A 102 4490 4613 8180 -380 74 -507 C \nATOM 813 CD LYS A 102 14.933 6.272 -50.990 1.00 46.81 C \nANISOU 813 CD LYS A 102 4729 4763 8294 -380 124 -481 C \nATOM 814 CE LYS A 102 15.748 7.518 -51.044 1.00 47.93 C \nANISOU 814 CE LYS A 102 4906 4902 8403 -424 163 -493 C \nATOM 815 NZ LYS A 102 16.313 7.803 -49.717 1.00 48.21 N \nANISOU 815 NZ LYS A 102 4958 4927 8433 -464 143 -488 N \nATOM 816 N HIS A 103 14.449 0.954 -49.463 1.00 39.58 N \nANISOU 816 N HIS A 103 3682 3833 7525 -310 -90 -474 N \nATOM 817 CA HIS A 103 14.178 0.120 -48.281 1.00 35.63 C \nANISOU 817 CA HIS A 103 3188 3312 7036 -314 -142 -452 C \nATOM 818 C HIS A 103 15.028 -1.157 -48.384 1.00 38.16 C \nANISOU 818 C HIS A 103 3471 3625 7402 -293 -192 -477 C \nATOM 819 O HIS A 103 15.438 -1.755 -47.442 1.00 33.51 O \nANISOU 819 O HIS A 103 2879 3022 6831 -296 -238 -471 O \nATOM 820 CB HIS A 103 12.725 -0.276 -48.225 1.00 32.71 C \nANISOU 820 CB HIS A 103 2845 2938 6646 -307 -146 -421 C \nATOM 821 CG HIS A 103 12.423 -1.200 -47.117 1.00 32.27 C \nANISOU 821 CG HIS A 103 2800 2863 6599 -316 -200 -400 C \nATOM 822 ND1 HIS A 103 12.144 -2.536 -47.312 1.00 31.62 N \nANISOU 822 ND1 HIS A 103 2712 2764 6536 -305 -242 -401 N \nATOM 823 CD2 HIS A 103 12.351 -0.990 -45.783 1.00 33.33 C \nANISOU 823 CD2 HIS A 103 2954 2987 6721 -338 -220 -376 C \nATOM 824 CE1 HIS A 103 11.941 -3.122 -46.143 1.00 33.11 C \nANISOU 824 CE1 HIS A 103 2919 2934 6726 -321 -287 -378 C \nATOM 825 NE2 HIS A 103 12.023 -2.194 -45.199 1.00 33.28 N \nANISOU 825 NE2 HIS A 103 2954 2963 6730 -341 -274 -362 N \nATOM 826 N LEU A 104 15.306 -1.573 -49.566 1.00 39.07 N \nANISOU 826 N LEU A 104 3561 3750 7535 -269 -183 -505 N \nATOM 827 CA LEU A 104 16.138 -2.733 -49.714 1.00 45.13 C \nANISOU 827 CA LEU A 104 4297 4510 8341 -241 -228 -531 C \nATOM 828 C LEU A 104 17.570 -2.494 -49.213 1.00 52.71 C \nANISOU 828 C LEU A 104 5220 5491 9316 -244 -242 -552 C \nATOM 829 O LEU A 104 18.189 -3.389 -48.619 1.00 54.75 O \nANISOU 829 O LEU A 104 5464 5740 9599 -223 -292 -558 O \nATOM 830 CB LEU A 104 16.143 -3.040 -51.191 1.00 46.51 C \nANISOU 830 CB LEU A 104 4451 4696 8524 -216 -205 -560 C \nATOM 831 CG LEU A 104 16.905 -4.248 -51.647 1.00 50.41 C \nANISOU 831 CG LEU A 104 4917 5183 9054 -176 -242 -593 C \nATOM 832 CD1 LEU A 104 16.356 -5.510 -51.041 1.00 50.33 C \nANISOU 832 CD1 LEU A 104 4940 5128 9055 -163 -296 -576 C \nATOM 833 CD2 LEU A 104 16.823 -4.288 -53.167 1.00 52.08 C \nANISOU 833 CD2 LEU A 104 5110 5412 9266 -158 -208 -622 C \nATOM 834 N LEU A 105 18.069 -1.270 -49.390 1.00 54.01 N \nANISOU 834 N LEU A 105 5374 5686 9460 -272 -198 -562 N \nATOM 835 CA LEU A 105 19.364 -0.890 -48.813 1.00 55.08 C \nANISOU 835 CA LEU A 105 5476 5853 9598 -290 -208 -578 C \nATOM 836 C LEU A 105 19.396 -0.751 -47.342 1.00 57.60 C \nANISOU 836 C LEU A 105 5815 6161 9910 -315 -236 -551 C \nATOM 837 O LEU A 105 20.232 -0.007 -46.804 1.00 73.55 O \nANISOU 837 O LEU A 105 7820 8209 11915 -349 -228 -557 O \nATOM 838 CB LEU A 105 19.815 0.457 -49.329 1.00 52.18 C \nANISOU 838 CB LEU A 105 5106 5520 9202 -328 -152 -592 C \nATOM 839 CG LEU A 105 19.855 0.583 -50.865 1.00 55.53 C \nANISOU 839 CG LEU A 105 5511 5964 9626 -313 -113 -620 C \nATOM 840 CD1 LEU A 105 20.246 1.981 -51.199 1.00 56.67 C \nANISOU 840 CD1 LEU A 105 5665 6133 9733 -361 -60 -627 C \nATOM 841 CD2 LEU A 105 20.792 -0.402 -51.550 1.00 56.80 C \nANISOU 841 CD2 LEU A 105 5610 6154 9819 -272 -139 -659 C \nATOM 842 N SER A 106 18.515 -1.446 -46.668 1.00 55.02 N \nANISOU 842 N SER A 106 5522 5796 9589 -305 -270 -521 N \nATOM 843 CA SER A 106 18.383 -1.230 -45.254 1.00 56.99 C \nANISOU 843 CA SER A 106 5795 6033 9826 -333 -292 -492 C \nATOM 844 C SER A 106 18.650 -2.552 -44.645 1.00 54.76 C \nANISOU 844 C SER A 106 5502 5732 9572 -303 -357 -488 C \nATOM 845 O SER A 106 18.577 -2.709 -43.439 1.00 48.73 O \nANISOU 845 O SER A 106 4756 4955 8805 -319 -391 -463 O \nATOM 846 CB SER A 106 16.973 -0.770 -44.930 1.00 56.32 C \nANISOU 846 CB SER A 106 5764 5922 9711 -352 -271 -456 C \nATOM 847 OG SER A 106 16.052 -1.481 -45.716 1.00 60.13 O \nANISOU 847 OG SER A 106 6257 6388 10199 -325 -271 -452 O \nATOM 848 N ARG A 107 18.903 -3.521 -45.518 1.00 53.75 N \nANISOU 848 N ARG A 107 5353 5599 9472 -258 -375 -512 N \nATOM 849 CA ARG A 107 19.206 -4.846 -45.063 1.00 65.00 C \nANISOU 849 CA ARG A 107 6776 6998 10922 -219 -437 -511 C \nATOM 850 C ARG A 107 20.508 -5.231 -45.755 1.00 58.91 C \nANISOU 850 C ARG A 107 5948 6261 10173 -175 -446 -554 C \nATOM 851 O ARG A 107 21.011 -6.322 -45.629 1.00 56.89 O \nANISOU 851 O ARG A 107 5684 5992 9939 -127 -494 -564 O \nATOM 852 CB ARG A 107 18.023 -5.795 -45.418 1.00 73.17 C \nANISOU 852 CB ARG A 107 7857 7984 11960 -205 -453 -496 C \nATOM 853 CG ARG A 107 17.400 -6.522 -44.180 1.00 82.78 C \nANISOU 853 CG ARG A 107 9120 9160 13174 -219 -504 -457 C \nATOM 854 CD ARG A 107 18.498 -6.883 -43.131 1.00 90.52 C \nANISOU 854 CD ARG A 107 10080 10144 14168 -203 -553 -457 C \nATOM 855 NE ARG A 107 19.015 -8.260 -42.968 1.00 88.76 N \nANISOU 855 NE ARG A 107 9866 9889 13970 -151 -614 -464 N \nATOM 856 CZ ARG A 107 19.058 -9.218 -43.899 1.00 97.36 C \nANISOU 856 CZ ARG A 107 10964 10951 15075 -104 -627 -487 C \nATOM 857 NH1 ARG A 107 18.576 -9.044 -45.128 1.00 93.23 N \nANISOU 857 NH1 ARG A 107 10440 10434 14551 -104 -585 -506 N \nATOM 858 NH2 ARG A 107 19.582 -10.407 -43.580 1.00107.09 N \nANISOU 858 NH2 ARG A 107 12214 12150 16324 -54 -684 -491 N \nATOM 859 N ILE A 108 21.055 -4.259 -46.453 1.00 53.21 N \nANISOU 859 N ILE A 108 5189 5587 9440 -193 -398 -578 N \nATOM 860 CA ILE A 108 22.277 -4.422 -47.173 1.00 50.85 C \nANISOU 860 CA ILE A 108 4829 5339 9154 -159 -397 -621 C \nATOM 861 C ILE A 108 23.324 -3.572 -46.510 1.00 53.56 C \nANISOU 861 C ILE A 108 5131 5741 9480 -195 -391 -627 C \nATOM 862 O ILE A 108 23.000 -2.549 -45.922 1.00 52.39 O \nANISOU 862 O ILE A 108 5009 5593 9306 -254 -365 -605 O \nATOM 863 CB ILE A 108 22.189 -3.942 -48.595 1.00 45.27 C \nANISOU 863 CB ILE A 108 4106 4653 8441 -161 -345 -648 C \nATOM 864 CG1 ILE A 108 21.206 -4.821 -49.360 1.00 41.89 C \nANISOU 864 CG1 ILE A 108 3713 4175 8027 -127 -350 -646 C \nATOM 865 CG2 ILE A 108 23.579 -3.989 -49.234 1.00 47.31 C \nANISOU 865 CG2 ILE A 108 4292 4979 8706 -134 -342 -693 C \nATOM 866 CD1 ILE A 108 21.098 -4.496 -50.850 1.00 41.63 C \nANISOU 866 CD1 ILE A 108 3663 4162 7990 -122 -301 -674 C \nATOM 867 N ASN A 109 24.561 -4.048 -46.594 1.00 52.11 N \nANISOU 867 N ASN A 109 4886 5608 9307 -156 -417 -656 N \nATOM 868 CA ASN A 109 25.657 -3.511 -45.850 1.00 54.08 C \nANISOU 868 CA ASN A 109 5087 5922 9537 -184 -425 -662 C \nATOM 869 C ASN A 109 26.848 -3.153 -46.710 1.00 55.86 C \nANISOU 869 C ASN A 109 5238 6235 9753 -180 -401 -707 C \nATOM 870 O ASN A 109 27.674 -2.304 -46.311 1.00 63.78 O \nANISOU 870 O ASN A 109 6202 7304 10726 -232 -386 -714 O \nATOM 871 CB ASN A 109 26.135 -4.554 -44.879 1.00 60.08 C \nANISOU 871 CB ASN A 109 5835 6678 10314 -134 -492 -652 C \nATOM 872 CG ASN A 109 25.484 -4.453 -43.521 1.00 63.67 C \nANISOU 872 CG ASN A 109 6341 7087 10762 -171 -517 -608 C \nATOM 873 OD1 ASN A 109 25.327 -5.467 -42.806 1.00 71.56 O \nANISOU 873 OD1 ASN A 109 7364 8048 11778 -131 -572 -588 O \nATOM 874 ND2 ASN A 109 25.138 -3.247 -43.128 1.00 57.63 N \nANISOU 874 ND2 ASN A 109 5599 6328 9969 -247 -478 -591 N \nATOM 875 N HIS A 110 26.938 -3.825 -47.864 1.00 51.91 N \nANISOU 875 N HIS A 110 4715 5736 9271 -122 -397 -737 N \nATOM 876 CA HIS A 110 28.047 -3.661 -48.790 1.00 58.65 C \nANISOU 876 CA HIS A 110 5492 6675 10115 -108 -377 -782 C \nATOM 877 C HIS A 110 27.769 -4.185 -50.212 1.00 54.24 C \nANISOU 877 C HIS A 110 4932 6103 9575 -59 -357 -811 C \nATOM 878 O HIS A 110 27.101 -5.190 -50.398 1.00 47.31 O \nANISOU 878 O HIS A 110 4095 5158 8725 -4 -383 -805 O \nATOM 879 CB HIS A 110 29.317 -4.263 -48.208 1.00 66.69 C \nANISOU 879 CB HIS A 110 6442 7766 11134 -61 -423 -799 C \nATOM 880 CG HIS A 110 30.535 -4.042 -49.050 1.00 71.38 C \nANISOU 880 CG HIS A 110 6946 8468 11709 -50 -403 -847 C \nATOM 881 ND1 HIS A 110 31.508 -5.015 -49.212 1.00 75.44 N \nANISOU 881 ND1 HIS A 110 7393 9038 12231 38 -442 -877 N \nATOM 882 CD2 HIS A 110 30.951 -2.964 -49.757 1.00 69.97 C \nANISOU 882 CD2 HIS A 110 6732 8354 11499 -116 -350 -868 C \nATOM 883 CE1 HIS A 110 32.465 -4.546 -49.988 1.00 76.01 C \nANISOU 883 CE1 HIS A 110 7387 9215 12279 26 -412 -916 C \nATOM 884 NE2 HIS A 110 32.154 -3.305 -50.330 1.00 77.29 N \nANISOU 884 NE2 HIS A 110 7567 9382 12416 -72 -356 -912 N \nATOM 885 N PHE A 111 28.250 -3.433 -51.198 1.00 55.28 N \nANISOU 885 N PHE A 111 5022 6296 9687 -90 -309 -841 N \nATOM 886 CA PHE A 111 28.089 -3.727 -52.591 1.00 61.01 C \nANISOU 886 CA PHE A 111 5737 7020 10421 -57 -283 -871 C \nATOM 887 C PHE A 111 29.389 -4.134 -53.242 1.00 73.40 C \nANISOU 887 C PHE A 111 7218 8682 11988 -8 -290 -920 C \nATOM 888 O PHE A 111 30.465 -3.987 -52.666 1.00 89.25 O \nANISOU 888 O PHE A 111 9164 10769 13978 -12 -307 -932 O \nATOM 889 CB PHE A 111 27.679 -2.455 -53.306 1.00 69.28 C \nANISOU 889 CB PHE A 111 6805 8077 11443 -133 -218 -869 C \nATOM 890 CG PHE A 111 26.189 -2.201 -53.317 1.00 64.47 C \nANISOU 890 CG PHE A 111 6282 7378 10837 -157 -198 -832 C \nATOM 891 CD1 PHE A 111 25.299 -3.245 -53.228 1.00 65.93 C \nANISOU 891 CD1 PHE A 111 6509 7489 11050 -106 -230 -816 C \nATOM 892 CD2 PHE A 111 25.708 -0.915 -53.447 1.00 60.48 C \nANISOU 892 CD2 PHE A 111 5813 6866 10300 -229 -147 -815 C \nATOM 893 CE1 PHE A 111 23.953 -3.007 -53.248 1.00 68.32 C \nANISOU 893 CE1 PHE A 111 6881 7727 11350 -129 -212 -783 C \nATOM 894 CE2 PHE A 111 24.358 -0.663 -53.439 1.00 62.20 C \nANISOU 894 CE2 PHE A 111 6104 7014 10517 -243 -130 -781 C \nATOM 895 CZ PHE A 111 23.468 -1.710 -53.369 1.00 64.41 C \nANISOU 895 CZ PHE A 111 6416 7233 10825 -193 -161 -765 C \nATOM 896 N GLU A 112 29.293 -4.650 -54.461 1.00 73.60 N \nANISOU 896 N GLU A 112 7234 8705 12026 39 -275 -951 N \nATOM 897 CA GLU A 112 30.470 -4.796 -55.323 1.00 71.37 C \nANISOU 897 CA GLU A 112 6864 8523 11733 74 -266 -1002 C \nATOM 898 C GLU A 112 30.106 -4.504 -56.787 1.00 65.48 C \nANISOU 898 C GLU A 112 6120 7778 10983 60 -215 -1026 C \nATOM 899 O GLU A 112 29.545 -5.326 -57.494 1.00 63.54 O \nANISOU 899 O GLU A 112 5902 7478 10760 115 -221 -1037 O \nATOM 900 CB GLU A 112 31.144 -6.162 -55.155 1.00 72.80 C \nANISOU 900 CB GLU A 112 7010 8717 11934 185 -321 -1025 C \nATOM 901 CG GLU A 112 32.539 -6.217 -55.785 1.00 85.59 C \nANISOU 901 CG GLU A 112 8524 10464 13532 222 -315 -1077 C \nATOM 902 CD GLU A 112 33.235 -7.574 -55.653 1.00 87.10 C \nANISOU 902 CD GLU A 112 8682 10672 13739 347 -370 -1102 C \nATOM 903 OE1 GLU A 112 32.845 -8.359 -54.776 1.00 98.71 O \nANISOU 903 OE1 GLU A 112 10206 12066 15232 394 -418 -1075 O \nATOM 904 OE2 GLU A 112 34.173 -7.845 -56.426 1.00 81.47 O \nANISOU 904 OE2 GLU A 112 7892 10051 13013 400 -364 -1150 O \nATOM 905 N LYS A 113 30.373 -3.275 -57.184 1.00 62.54 N \nANISOU 905 N LYS A 113 5725 7461 10575 -22 -165 -1032 N \nATOM 906 CA LYS A 113 30.124 -2.787 -58.532 1.00 61.71 C \nANISOU 906 CA LYS A 113 5620 7370 10459 -49 -113 -1052 C \nATOM 907 C LYS A 113 30.845 -3.656 -59.566 1.00 64.66 C \nANISOU 907 C LYS A 113 5927 7800 10841 27 -119 -1104 C \nATOM 908 O LYS A 113 32.038 -3.788 -59.536 1.00 66.74 O \nANISOU 908 O LYS A 113 6109 8160 11088 50 -131 -1136 O \nATOM 909 CB LYS A 113 30.605 -1.361 -58.599 1.00 59.59 C \nANISOU 909 CB LYS A 113 5331 7166 10143 -150 -67 -1052 C \nATOM 910 CG LYS A 113 30.293 -0.591 -59.854 1.00 62.14 C \nANISOU 910 CG LYS A 113 5667 7497 10444 -198 -9 -1063 C \nATOM 911 CD LYS A 113 31.175 0.665 -59.791 1.00 71.61 C \nANISOU 911 CD LYS A 113 6834 8784 11591 -294 26 -1072 C \nATOM 912 CE LYS A 113 30.803 1.756 -60.765 1.00 71.75 C \nANISOU 912 CE LYS A 113 6888 8798 11575 -367 87 -1070 C \nATOM 913 NZ LYS A 113 29.745 2.542 -60.116 1.00 75.41 N \nANISOU 913 NZ LYS A 113 7451 9170 12033 -415 102 -1021 N \nATOM 914 N ILE A 114 30.071 -4.284 -60.440 1.00 73.59 N \nANISOU 914 N ILE A 114 7095 8870 11995 70 -113 -1111 N \nATOM 915 CA ILE A 114 30.581 -5.203 -61.452 1.00 73.58 C \nANISOU 915 CA ILE A 114 7048 8905 12004 149 -119 -1160 C \nATOM 916 C ILE A 114 30.246 -4.701 -62.833 1.00 76.16 C \nANISOU 916 C ILE A 114 7374 9246 12318 114 -65 -1179 C \nATOM 917 O ILE A 114 29.067 -4.314 -63.098 1.00 77.02 O \nANISOU 917 O ILE A 114 7554 9280 12430 72 -39 -1148 O \nATOM 918 CB ILE A 114 29.886 -6.589 -61.377 1.00 85.37 C \nANISOU 918 CB ILE A 114 8599 10303 13537 235 -161 -1156 C \nATOM 919 CG1 ILE A 114 30.383 -7.370 -60.176 1.00 90.48 C \nANISOU 919 CG1 ILE A 114 9241 10941 14198 296 -221 -1147 C \nATOM 920 CG2 ILE A 114 30.177 -7.403 -62.639 1.00 86.45 C \nANISOU 920 CG2 ILE A 114 8707 10460 13679 306 -155 -1206 C \nATOM 921 CD1 ILE A 114 29.729 -8.729 -60.066 1.00 88.91 C \nANISOU 921 CD1 ILE A 114 9110 10641 14030 375 -265 -1142 C \nATOM 922 N GLN A 115 31.212 -4.796 -63.744 1.00 70.34 N \nANISOU 922 N GLN A 115 6559 8603 11564 138 -48 -1229 N \nATOM 923 CA GLN A 115 30.886 -4.549 -65.155 1.00 69.84 C \nANISOU 923 CA GLN A 115 6495 8549 11492 119 -2 -1252 C \nATOM 924 C GLN A 115 30.113 -5.732 -65.751 1.00 70.34 C \nANISOU 924 C GLN A 115 6605 8532 11588 195 -19 -1262 C \nATOM 925 O GLN A 115 30.576 -6.863 -65.715 1.00 69.79 O \nANISOU 925 O GLN A 115 6516 8465 11537 286 -57 -1290 O \nATOM 926 CB GLN A 115 32.105 -4.290 -65.961 1.00 67.21 C \nANISOU 926 CB GLN A 115 6066 8343 11128 117 22 -1302 C \nATOM 927 CG GLN A 115 31.797 -3.596 -67.264 1.00 69.55 C \nANISOU 927 CG GLN A 115 6365 8660 11403 62 78 -1315 C \nATOM 928 CD GLN A 115 33.028 -3.424 -68.126 1.00 67.72 C \nANISOU 928 CD GLN A 115 6033 8562 11137 61 101 -1369 C \nATOM 929 OE1 GLN A 115 33.846 -4.336 -68.205 1.00 75.43 O \nANISOU 929 OE1 GLN A 115 6946 9595 12120 146 72 -1410 O \nATOM 930 NE2 GLN A 115 33.175 -2.251 -68.744 1.00 61.37 N \nANISOU 930 NE2 GLN A 115 5215 7809 10292 -35 152 -1370 N \nATOM 931 N ILE A 116 28.921 -5.458 -66.275 1.00 72.32 N \nANISOU 931 N ILE A 116 6923 8714 11844 157 8 -1237 N \nATOM 932 CA ILE A 116 27.945 -6.493 -66.592 1.00 67.44 C \nANISOU 932 CA ILE A 116 6366 8004 11252 208 -11 -1232 C \nATOM 933 C ILE A 116 27.811 -6.675 -68.094 1.00 65.60 C \nANISOU 933 C ILE A 116 6121 7793 11013 218 24 -1269 C \nATOM 934 O ILE A 116 27.598 -7.794 -68.587 1.00 65.52 O \nANISOU 934 O ILE A 116 6130 7744 11021 284 5 -1293 O \nATOM 935 CB ILE A 116 26.594 -6.183 -65.879 1.00 70.09 C \nANISOU 935 CB ILE A 116 6790 8247 11596 160 -14 -1172 C \nATOM 936 CG1 ILE A 116 25.973 -7.452 -65.354 1.00 72.44 C \nANISOU 936 CG1 ILE A 116 7146 8457 11922 219 -63 -1160 C \nATOM 937 CG2 ILE A 116 25.615 -5.336 -66.699 1.00 67.51 C \nANISOU 937 CG2 ILE A 116 6497 7904 11250 97 37 -1152 C \nATOM 938 CD1 ILE A 116 26.731 -7.969 -64.158 1.00 71.30 C \nANISOU 938 CD1 ILE A 116 6985 8314 11790 264 -114 -1158 C \nATOM 939 N ILE A 117 27.899 -5.566 -68.819 1.00 62.30 N \nANISOU 939 N ILE A 117 5675 7430 10566 150 75 -1271 N \nATOM 940 CA ILE A 117 28.041 -5.562 -70.279 1.00 66.78 C \nANISOU 940 CA ILE A 117 6210 8043 11119 153 113 -1310 C \nATOM 941 C ILE A 117 28.838 -4.307 -70.665 1.00 78.62 C \nANISOU 941 C ILE A 117 7651 9641 12580 82 157 -1322 C \nATOM 942 O ILE A 117 28.317 -3.176 -70.598 1.00 85.19 O \nANISOU 942 O ILE A 117 8518 10459 13390 2 189 -1285 O \nATOM 943 CB ILE A 117 26.696 -5.625 -71.061 1.00 61.46 C \nANISOU 943 CB ILE A 117 5602 7300 10448 133 136 -1291 C \nATOM 944 CG1 ILE A 117 25.601 -4.835 -70.378 1.00 62.49 C \nANISOU 944 CG1 ILE A 117 5801 7369 10573 72 145 -1228 C \nATOM 945 CG2 ILE A 117 26.235 -7.068 -71.186 1.00 61.72 C \nANISOU 945 CG2 ILE A 117 5673 7266 10510 208 99 -1306 C \nATOM 946 CD1 ILE A 117 24.262 -4.834 -71.086 1.00 60.78 C \nANISOU 946 CD1 ILE A 117 5642 7100 10353 52 168 -1205 C \nATOM 947 N PRO A 118 30.107 -4.511 -71.074 1.00 85.28 N \nANISOU 947 N PRO A 118 8407 10584 13410 111 157 -1373 N \nATOM 948 CA PRO A 118 31.057 -3.439 -71.346 1.00 80.21 C \nANISOU 948 CA PRO A 118 7699 10050 12725 43 192 -1389 C \nATOM 949 C PRO A 118 30.577 -2.422 -72.369 1.00 78.19 C \nANISOU 949 C PRO A 118 7466 9804 12439 -37 249 -1380 C \nATOM 950 O PRO A 118 29.857 -2.763 -73.311 1.00 90.78 O \nANISOU 950 O PRO A 118 9089 11361 14043 -19 265 -1386 O \nATOM 951 CB PRO A 118 32.280 -4.184 -71.888 1.00 82.27 C \nANISOU 951 CB PRO A 118 7866 10413 12979 112 181 -1453 C \nATOM 952 CG PRO A 118 32.171 -5.561 -71.342 1.00 80.41 C \nANISOU 952 CG PRO A 118 7650 10118 12785 221 127 -1460 C \nATOM 953 CD PRO A 118 30.705 -5.845 -71.318 1.00 82.31 C \nANISOU 953 CD PRO A 118 7993 10226 13054 217 123 -1421 C \nATOM 954 N LYS A 119 31.014 -1.188 -72.173 1.00 73.71 N \nANISOU 954 N LYS A 119 6886 9288 11832 -127 278 -1366 N \nATOM 955 CA LYS A 119 30.609 -0.027 -72.954 1.00 72.76 C \nANISOU 955 CA LYS A 119 6799 9172 11675 -214 332 -1349 C \nATOM 956 C LYS A 119 31.208 -0.088 -74.337 1.00 74.88 C \nANISOU 956 C LYS A 119 7004 9527 11920 -215 362 -1399 C \nATOM 957 O LYS A 119 30.698 0.521 -75.291 1.00 83.96 O \nANISOU 957 O LYS A 119 8184 10669 13048 -262 404 -1391 O \nATOM 958 CB LYS A 119 31.063 1.259 -72.234 1.00 72.11 C \nANISOU 958 CB LYS A 119 6727 9121 11552 -310 349 -1323 C \nATOM 959 CG LYS A 119 30.596 2.565 -72.854 1.00 76.56 C \nANISOU 959 CG LYS A 119 7347 9670 12071 -403 403 -1298 C \nATOM 960 CD LYS A 119 31.347 3.761 -72.252 1.00 79.50 C \nANISOU 960 CD LYS A 119 7719 10093 12392 -503 420 -1286 C \nATOM 961 CE LYS A 119 30.898 5.086 -72.868 1.00 81.55 C \nANISOU 961 CE LYS A 119 8050 10331 12604 -595 474 -1260 C \nATOM 962 NZ LYS A 119 29.695 5.606 -72.168 1.00 93.01 N \nANISOU 962 NZ LYS A 119 9612 11665 14063 -603 476 -1200 N \nATOM 963 N SER A 120 32.303 -0.825 -74.451 1.00 78.87 N \nANISOU 963 N SER A 120 7420 10121 12427 -161 342 -1450 N \nATOM 964 CA SER A 120 33.018 -0.967 -75.724 1.00 73.77 C \nANISOU 964 CA SER A 120 6699 9574 11756 -154 369 -1504 C \nATOM 965 C SER A 120 32.458 -2.145 -76.567 1.00 70.95 C \nANISOU 965 C SER A 120 6353 9171 11435 -63 359 -1531 C \nATOM 966 O SER A 120 32.848 -2.329 -77.711 1.00 79.61 O \nANISOU 966 O SER A 120 7400 10333 12514 -53 383 -1574 O \nATOM 967 CB SER A 120 34.504 -1.110 -75.439 1.00 69.62 C \nANISOU 967 CB SER A 120 6068 9180 11206 -141 354 -1548 C \nATOM 968 OG SER A 120 34.705 -1.907 -74.281 1.00 73.20 O \nANISOU 968 OG SER A 120 6514 9607 11692 -66 301 -1543 O \nATOM 969 N SER A 121 31.494 -2.888 -76.036 1.00 62.73 N \nANISOU 969 N SER A 121 5381 8015 10438 -8 327 -1503 N \nATOM 970 CA SER A 121 30.831 -3.941 -76.807 1.00 65.36 C \nANISOU 970 CA SER A 121 5742 8293 10799 62 320 -1523 C \nATOM 971 C SER A 121 29.854 -3.399 -77.844 1.00 61.08 C \nANISOU 971 C SER A 121 5247 7717 10243 8 364 -1505 C \nATOM 972 O SER A 121 29.595 -4.044 -78.835 1.00 70.96 O \nANISOU 972 O SER A 121 6496 8965 11500 45 372 -1534 O \nATOM 973 CB SER A 121 30.073 -4.865 -75.877 1.00 66.20 C \nANISOU 973 CB SER A 121 5914 8290 10950 124 272 -1496 C \nATOM 974 OG SER A 121 28.855 -4.242 -75.528 1.00 77.55 O \nANISOU 974 OG SER A 121 7434 9641 12391 66 283 -1436 O \nATOM 975 N TRP A 122 29.306 -2.217 -77.610 1.00 63.73 N \nANISOU 975 N TRP A 122 5629 8027 10557 -77 390 -1456 N \nATOM 976 CA TRP A 122 28.284 -1.609 -78.495 1.00 66.18 C \nANISOU 976 CA TRP A 122 5993 8301 10850 -125 430 -1429 C \nATOM 977 C TRP A 122 28.974 -1.130 -79.768 1.00 70.67 C \nANISOU 977 C TRP A 122 6504 8967 11380 -164 473 -1468 C \nATOM 978 O TRP A 122 29.221 0.067 -79.979 1.00 80.89 O \nANISOU 978 O TRP A 122 7800 10302 12633 -247 510 -1453 O \nATOM 979 CB TRP A 122 27.521 -0.447 -77.784 1.00 65.17 C \nANISOU 979 CB TRP A 122 5938 8116 10706 -195 445 -1364 C \nATOM 980 CG TRP A 122 26.915 -0.830 -76.443 1.00 57.49 C \nANISOU 980 CG TRP A 122 5017 7058 9767 -164 404 -1325 C \nATOM 981 CD1 TRP A 122 27.310 -0.415 -75.238 1.00 57.99 C \nANISOU 981 CD1 TRP A 122 5086 7118 9831 -185 385 -1303 C \nATOM 982 CD2 TRP A 122 25.865 -1.762 -76.224 1.00 54.09 C \nANISOU 982 CD2 TRP A 122 4636 6544 9372 -110 376 -1307 C \nATOM 983 NE1 TRP A 122 26.583 -1.031 -74.257 1.00 57.28 N \nANISOU 983 NE1 TRP A 122 5044 6946 9776 -144 346 -1273 N \nATOM 984 CE2 TRP A 122 25.692 -1.879 -74.848 1.00 52.15 C \nANISOU 984 CE2 TRP A 122 4422 6246 9147 -99 339 -1274 C \nATOM 985 CE3 TRP A 122 25.085 -2.547 -77.070 1.00 56.64 C \nANISOU 985 CE3 TRP A 122 4980 6835 9708 -75 377 -1317 C \nATOM 986 CZ2 TRP A 122 24.727 -2.707 -74.275 1.00 53.09 C \nANISOU 986 CZ2 TRP A 122 4594 6282 9297 -58 305 -1249 C \nATOM 987 CZ3 TRP A 122 24.118 -3.383 -76.497 1.00 56.12 C \nANISOU 987 CZ3 TRP A 122 4967 6685 9670 -36 342 -1292 C \nATOM 988 CH2 TRP A 122 23.949 -3.435 -75.109 1.00 55.26 C \nANISOU 988 CH2 TRP A 122 4890 6525 9579 -29 307 -1258 C \nATOM 989 N SER A 123 29.259 -2.088 -80.634 1.00 72.74 N \nANISOU 989 N SER A 123 6722 9263 11653 -104 470 -1519 N \nATOM 990 CA SER A 123 29.950 -1.843 -81.905 1.00 80.01 C \nANISOU 990 CA SER A 123 7579 10281 12538 -129 507 -1565 C \nATOM 991 C SER A 123 29.095 -1.161 -82.965 1.00 88.82 C \nANISOU 991 C SER A 123 8739 11380 13629 -186 552 -1543 C \nATOM 992 O SER A 123 29.625 -0.433 -83.803 1.00 99.52 O \nANISOU 992 O SER A 123 10058 12813 14942 -244 590 -1560 O \nATOM 993 CB SER A 123 30.439 -3.167 -82.467 1.00 81.84 C \nANISOU 993 CB SER A 123 7759 10547 12791 -36 487 -1627 C \nATOM 994 OG SER A 123 30.833 -3.996 -81.397 1.00 92.97 O \nANISOU 994 OG SER A 123 9158 11934 14233 37 438 -1635 O \nATOM 995 N ASP A 124 27.781 -1.401 -82.940 1.00 93.21 N \nANISOU 995 N ASP A 124 9371 11838 14207 -171 546 -1504 N \nATOM 996 CA ASP A 124 26.894 -0.933 -84.013 1.00 90.10 C \nANISOU 996 CA ASP A 124 9015 11430 13789 -210 585 -1485 C \nATOM 997 C ASP A 124 26.054 0.267 -83.586 1.00 86.91 C \nANISOU 997 C ASP A 124 8685 10973 13363 -273 604 -1417 C \nATOM 998 O ASP A 124 25.223 0.778 -84.364 1.00 83.48 O \nANISOU 998 O ASP A 124 8291 10523 12905 -304 636 -1391 O \nATOM 999 CB ASP A 124 25.999 -2.085 -84.484 1.00 90.61 C \nANISOU 999 CB ASP A 124 9106 11439 13883 -149 568 -1494 C \nATOM 1000 CG ASP A 124 26.796 -3.356 -84.772 1.00 97.37 C \nANISOU 1000 CG ASP A 124 9905 12330 14762 -73 544 -1561 C \nATOM 1001 OD1 ASP A 124 27.818 -3.264 -85.485 1.00102.63 O \nANISOU 1001 OD1 ASP A 124 10500 13090 15406 -78 563 -1610 O \nATOM 1002 OD2 ASP A 124 26.424 -4.434 -84.270 1.00 95.48 O \nANISOU 1002 OD2 ASP A 124 9693 12026 14558 -9 505 -1565 O \nATOM 1003 N HIS A 125 26.263 0.719 -82.353 1.00 75.71 N \nANISOU 1003 N HIS A 125 7288 9530 11950 -290 586 -1388 N \nATOM 1004 CA HIS A 125 25.539 1.869 -81.863 1.00 73.12 C \nANISOU 1004 CA HIS A 125 7033 9150 11597 -344 605 -1326 C \nATOM 1005 C HIS A 125 26.543 2.862 -81.311 1.00 73.17 C \nANISOU 1005 C HIS A 125 7025 9203 11572 -409 616 -1325 C \nATOM 1006 O HIS A 125 27.646 2.506 -80.885 1.00 69.97 O \nANISOU 1006 O HIS A 125 6555 8855 11175 -399 596 -1362 O \nATOM 1007 CB HIS A 125 24.565 1.483 -80.754 1.00 71.18 C \nANISOU 1007 CB HIS A 125 6847 8812 11386 -306 570 -1283 C \nATOM 1008 CG HIS A 125 23.606 0.398 -81.126 1.00 67.26 C \nANISOU 1008 CG HIS A 125 6367 8271 10919 -248 552 -1284 C \nATOM 1009 ND1 HIS A 125 23.968 -0.935 -81.163 1.00 61.50 N \nANISOU 1009 ND1 HIS A 125 5596 7546 10226 -185 519 -1329 N \nATOM 1010 CD2 HIS A 125 22.279 0.446 -81.411 1.00 69.94 C \nANISOU 1010 CD2 HIS A 125 6762 8560 11251 -245 562 -1245 C \nATOM 1011 CE1 HIS A 125 22.914 -1.651 -81.521 1.00 69.89 C \nANISOU 1011 CE1 HIS A 125 6694 8560 11301 -154 510 -1319 C \nATOM 1012 NE2 HIS A 125 21.871 -0.843 -81.662 1.00 70.44 N \nANISOU 1012 NE2 HIS A 125 6818 8602 11346 -191 535 -1268 N \nATOM 1013 N GLU A 126 26.148 4.120 -81.322 1.00 71.70 N \nANISOU 1013 N GLU A 126 6904 8994 11345 -475 649 -1282 N \nATOM 1014 CA GLU A 126 27.001 5.173 -80.832 1.00 70.90 C \nANISOU 1014 CA GLU A 126 6806 8929 11205 -551 664 -1276 C \nATOM 1015 C GLU A 126 26.782 5.375 -79.329 1.00 74.15 C \nANISOU 1015 C GLU A 126 7264 9277 11633 -548 636 -1238 C \nATOM 1016 O GLU A 126 25.880 6.091 -78.922 1.00 78.04 O \nANISOU 1016 O GLU A 126 7842 9696 12111 -564 647 -1186 O \nATOM 1017 CB GLU A 126 26.732 6.472 -81.591 1.00 68.36 C \nANISOU 1017 CB GLU A 126 6543 8606 10823 -627 715 -1249 C \nATOM 1018 CG GLU A 126 27.807 7.513 -81.379 1.00 74.35 C \nANISOU 1018 CG GLU A 126 7299 9422 11530 -721 736 -1256 C \nATOM 1019 CD GLU A 126 29.164 6.972 -81.770 1.00 76.82 C \nANISOU 1019 CD GLU A 126 7497 9850 11839 -729 729 -1320 C \nATOM 1020 OE1 GLU A 126 29.968 6.817 -80.832 1.00 87.42 O \nANISOU 1020 OE1 GLU A 126 8800 11226 13190 -735 704 -1335 O \nATOM 1021 OE2 GLU A 126 29.399 6.668 -82.981 1.00 73.42 O \nANISOU 1021 OE2 GLU A 126 7017 9482 11399 -725 748 -1356 O \nATOM 1022 N ALA A 127 27.660 4.778 -78.523 1.00 82.80 N \nANISOU 1022 N ALA A 127 8300 10407 12753 -526 601 -1266 N \nATOM 1023 CA ALA A 127 27.585 4.853 -77.060 1.00 86.86 C \nANISOU 1023 CA ALA A 127 8846 10872 13285 -522 571 -1237 C \nATOM 1024 C ALA A 127 28.043 6.203 -76.501 1.00 89.41 C \nANISOU 1024 C ALA A 127 9210 11204 13557 -615 594 -1213 C \nATOM 1025 O ALA A 127 27.348 6.834 -75.705 1.00 81.18 O \nANISOU 1025 O ALA A 127 8251 10087 12508 -632 595 -1164 O \nATOM 1026 CB ALA A 127 28.392 3.714 -76.429 1.00 80.60 C \nANISOU 1026 CB ALA A 127 7973 10117 12532 -462 524 -1275 C \nATOM 1027 N SER A 128 29.213 6.645 -76.951 1.00110.04 N \nANISOU 1027 N SER A 128 11768 13913 16129 -678 614 -1248 N \nATOM 1028 CA SER A 128 29.898 7.814 -76.369 1.00116.37 C \nANISOU 1028 CA SER A 128 12597 14741 16878 -777 631 -1235 C \nATOM 1029 C SER A 128 29.135 9.145 -76.476 1.00110.26 C \nANISOU 1029 C SER A 128 11943 13894 16056 -844 671 -1185 C \nATOM 1030 O SER A 128 29.442 10.093 -75.727 1.00100.42 O \nANISOU 1030 O SER A 128 10749 12634 14770 -917 681 -1163 O \nATOM 1031 CB SER A 128 31.269 7.973 -77.023 1.00119.22 C \nANISOU 1031 CB SER A 128 12869 15233 17197 -836 648 -1286 C \nATOM 1032 OG SER A 128 31.124 8.283 -78.399 1.00120.95 O \nANISOU 1032 OG SER A 128 13092 15478 17386 -862 687 -1298 O \nATOM 1033 N SER A 129 28.154 9.208 -77.385 1.00 98.09 N \nANISOU 1033 N SER A 129 10448 12306 14515 -816 694 -1166 N \nATOM 1034 CA SER A 129 27.306 10.398 -77.521 1.00 97.01 C \nANISOU 1034 CA SER A 129 10431 12095 14335 -858 730 -1115 C \nATOM 1035 C SER A 129 26.138 10.360 -76.535 1.00 91.46 C \nANISOU 1035 C SER A 129 9803 11286 13660 -802 711 -1065 C \nATOM 1036 O SER A 129 25.219 11.175 -76.598 1.00 73.18 O \nANISOU 1036 O SER A 129 7588 8902 11316 -808 736 -1020 O \nATOM 1037 CB SER A 129 26.786 10.548 -78.939 1.00104.37 C \nANISOU 1037 CB SER A 129 11377 13032 15247 -853 764 -1115 C \nATOM 1038 OG SER A 129 25.595 11.314 -78.945 1.00113.76 O \nANISOU 1038 OG SER A 129 12679 14131 16413 -845 786 -1059 O \nATOM 1039 N GLY A 130 26.180 9.397 -75.628 1.00 91.36 N \nANISOU 1039 N GLY A 130 9744 11267 13703 -745 666 -1074 N \nATOM 1040 CA GLY A 130 25.214 9.337 -74.568 1.00 87.03 C \nANISOU 1040 CA GLY A 130 9257 10631 13178 -702 644 -1030 C \nATOM 1041 C GLY A 130 25.418 10.444 -73.569 1.00 78.69 C \nANISOU 1041 C GLY A 130 8275 9540 12082 -767 654 -1001 C \nATOM 1042 O GLY A 130 25.703 10.165 -72.405 1.00 75.64 O \nANISOU 1042 O GLY A 130 7876 9144 11719 -761 622 -999 O \nATOM 1043 N VAL A 131 25.235 11.690 -74.023 1.00 71.60 N \nANISOU 1043 N VAL A 131 7463 8618 11123 -827 698 -977 N \nATOM 1044 CA VAL A 131 25.625 12.874 -73.244 1.00 65.95 C \nANISOU 1044 CA VAL A 131 6828 7877 10355 -909 715 -956 C \nATOM 1045 C VAL A 131 24.596 13.997 -73.399 1.00 61.88 C \nANISOU 1045 C VAL A 131 6446 7274 9791 -915 752 -905 C \nATOM 1046 O VAL A 131 23.927 14.099 -74.427 1.00 56.66 O \nANISOU 1046 O VAL A 131 5808 6602 9119 -886 776 -894 O \nATOM 1047 CB VAL A 131 27.025 13.349 -73.695 1.00 66.10 C \nANISOU 1047 CB VAL A 131 6803 7985 10328 -1009 734 -995 C \nATOM 1048 CG1 VAL A 131 27.271 14.824 -73.347 1.00 73.34 C \nANISOU 1048 CG1 VAL A 131 7832 8866 11168 -1111 769 -970 C \nATOM 1049 CG2 VAL A 131 28.096 12.467 -73.079 1.00 61.14 C \nANISOU 1049 CG2 VAL A 131 6060 7437 9735 -1007 695 -1037 C \nATOM 1050 N SER A 132 24.473 14.844 -72.390 1.00 62.28 N \nANISOU 1050 N SER A 132 6587 7265 9810 -949 758 -875 N \nATOM 1051 CA SER A 132 23.545 15.978 -72.468 1.00 77.03 C \nANISOU 1051 CA SER A 132 8594 9048 11626 -950 793 -827 C \nATOM 1052 C SER A 132 23.908 17.117 -71.511 1.00 77.12 C \nANISOU 1052 C SER A 132 8707 9012 11581 -1027 808 -808 C \nATOM 1053 O SER A 132 24.558 16.915 -70.493 1.00 62.42 O \nANISOU 1053 O SER A 132 6813 7167 9735 -1058 782 -822 O \nATOM 1054 CB SER A 132 22.101 15.496 -72.191 1.00 87.12 C \nANISOU 1054 CB SER A 132 9894 10266 12940 -840 778 -790 C \nATOM 1055 OG SER A 132 21.168 16.575 -72.188 1.00 93.84 O \nANISOU 1055 OG SER A 132 10878 11040 13738 -826 811 -742 O \nATOM 1056 N SER A 133 23.428 18.307 -71.851 1.00 93.04 N \nANISOU 1056 N SER A 133 10855 10965 13532 -1052 849 -775 N \nATOM 1057 CA SER A 133 23.672 19.538 -71.066 1.00 93.25 C \nANISOU 1057 CA SER A 133 11008 10931 13493 -1127 870 -754 C \nATOM 1058 C SER A 133 22.888 19.525 -69.757 1.00 89.94 C \nANISOU 1058 C SER A 133 10640 10440 13094 -1068 850 -722 C \nATOM 1059 O SER A 133 23.273 20.183 -68.793 1.00 79.48 O \nANISOU 1059 O SER A 133 9383 9080 11735 -1127 852 -716 O \nATOM 1060 CB SER A 133 23.257 20.781 -71.865 1.00 93.82 C \nANISOU 1060 CB SER A 133 11218 10943 13485 -1155 920 -725 C \nATOM 1061 OG SER A 133 23.451 20.591 -73.257 1.00106.53 O \nANISOU 1061 OG SER A 133 12778 12609 15090 -1164 938 -743 O \nATOM 1062 N ALA A 134 21.769 18.792 -69.737 1.00 95.63 N \nANISOU 1062 N ALA A 134 11331 11140 13864 -954 831 -702 N \nATOM 1063 CA ALA A 134 20.951 18.643 -68.518 1.00 86.44 C \nANISOU 1063 CA ALA A 134 10201 9919 12723 -890 809 -672 C \nATOM 1064 C ALA A 134 21.764 17.998 -67.389 1.00 77.21 C \nANISOU 1064 C ALA A 134 8955 8785 11597 -923 768 -697 C \nATOM 1065 O ALA A 134 21.497 18.219 -66.203 1.00 70.52 O \nANISOU 1065 O ALA A 134 8157 7891 10748 -916 755 -678 O \nATOM 1066 CB ALA A 134 19.710 17.831 -68.814 1.00 75.39 C \nANISOU 1066 CB ALA A 134 8761 8515 11368 -774 794 -652 C \nATOM 1067 N CYS A 135 22.763 17.213 -67.782 1.00 79.24 N \nANISOU 1067 N CYS A 135 9091 9128 11889 -956 748 -741 N \nATOM 1068 CA CYS A 135 23.657 16.537 -66.848 1.00 88.59 C \nANISOU 1068 CA CYS A 135 10189 10361 13111 -985 708 -769 C \nATOM 1069 C CYS A 135 25.095 17.069 -66.961 1.00 92.71 C \nANISOU 1069 C CYS A 135 10691 10945 13588 -1104 721 -802 C \nATOM 1070 O CYS A 135 25.922 16.517 -67.681 1.00 90.21 O \nANISOU 1070 O CYS A 135 10273 10715 13287 -1126 715 -841 O \nATOM 1071 CB CYS A 135 23.643 15.017 -67.110 1.00 85.79 C \nANISOU 1071 CB CYS A 135 9698 10064 12836 -910 667 -794 C \nATOM 1072 SG CYS A 135 24.005 13.959 -65.694 1.00103.82 S \nANISOU 1072 SG CYS A 135 11900 12367 15181 -882 607 -805 S \nATOM 1073 N PRO A 136 25.404 18.132 -66.220 1.00102.37 N \nANISOU 1073 N PRO A 136 12014 12130 14754 -1184 739 -789 N \nATOM 1074 CA PRO A 136 26.760 18.632 -66.186 1.00109.90 C \nANISOU 1074 CA PRO A 136 12949 13148 15659 -1307 749 -819 C \nATOM 1075 C PRO A 136 27.689 17.732 -65.376 1.00109.56 C \nANISOU 1075 C PRO A 136 12781 13188 15660 -1319 703 -851 C \nATOM 1076 O PRO A 136 27.234 16.896 -64.601 1.00123.73 O \nANISOU 1076 O PRO A 136 14531 14966 17515 -1240 665 -842 O \nATOM 1077 CB PRO A 136 26.609 20.010 -65.517 1.00116.42 C \nANISOU 1077 CB PRO A 136 13936 13890 16410 -1379 780 -789 C \nATOM 1078 CG PRO A 136 25.147 20.326 -65.574 1.00117.29 C \nANISOU 1078 CG PRO A 136 14150 13893 16521 -1285 796 -744 C \nATOM 1079 CD PRO A 136 24.493 18.992 -65.450 1.00115.07 C \nANISOU 1079 CD PRO A 136 13761 13631 16328 -1166 755 -744 C \nATOM 1080 N TYR A 137 28.984 17.926 -65.567 1.00110.05 N \nANISOU 1080 N TYR A 137 12787 13343 15685 -1420 708 -886 N \nATOM 1081 CA TYR A 137 30.025 17.215 -64.834 1.00110.16 C \nANISOU 1081 CA TYR A 137 12682 13452 15723 -1442 668 -918 C \nATOM 1082 C TYR A 137 30.984 18.229 -64.233 1.00116.15 C \nANISOU 1082 C TYR A 137 13489 14240 16404 -1583 685 -925 C \nATOM 1083 O TYR A 137 30.966 18.521 -63.031 1.00121.73 O \nANISOU 1083 O TYR A 137 14242 14909 17100 -1608 671 -908 O \nATOM 1084 CB TYR A 137 30.799 16.270 -65.769 1.00103.23 C \nANISOU 1084 CB TYR A 137 11655 12693 14876 -1421 654 -964 C \nATOM 1085 CG TYR A 137 32.186 15.851 -65.283 1.00 93.84 C \nANISOU 1085 CG TYR A 137 10345 11630 13680 -1476 626 -1003 C \nATOM 1086 CD1 TYR A 137 32.458 15.662 -63.930 1.00 95.50 C \nANISOU 1086 CD1 TYR A 137 10541 11844 13903 -1481 592 -997 C \nATOM 1087 CD2 TYR A 137 33.218 15.633 -66.190 1.00 95.91 C \nANISOU 1087 CD2 TYR A 137 10506 12017 13920 -1519 634 -1047 C \nATOM 1088 CE1 TYR A 137 33.718 15.279 -63.498 1.00 93.12 C \nANISOU 1088 CE1 TYR A 137 10125 11666 13590 -1526 566 -1032 C \nATOM 1089 CE2 TYR A 137 34.482 15.245 -65.769 1.00 94.89 C \nANISOU 1089 CE2 TYR A 137 10259 12016 13778 -1562 609 -1084 C \nATOM 1090 CZ TYR A 137 34.721 15.066 -64.422 1.00 93.61 C \nANISOU 1090 CZ TYR A 137 10084 11855 13628 -1564 574 -1075 C \nATOM 1091 OH TYR A 137 35.959 14.676 -64.000 1.00 95.91 O \nANISOU 1091 OH TYR A 137 10255 12281 13903 -1601 548 -1109 O \nATOM 1092 N GLN A 138 31.850 18.739 -65.089 1.00105.69 N \nANISOU 1092 N GLN A 138 12148 12990 15020 -1681 713 -951 N \nATOM 1093 CA GLN A 138 32.786 19.743 -64.693 1.00100.73 C \nANISOU 1093 CA GLN A 138 11569 12398 14305 -1830 734 -959 C \nATOM 1094 C GLN A 138 32.524 20.886 -65.664 1.00 97.92 C \nANISOU 1094 C GLN A 138 11342 11987 13877 -1900 788 -945 C \nATOM 1095 O GLN A 138 33.443 21.388 -66.332 1.00 87.06 O \nANISOU 1095 O GLN A 138 9952 10692 12437 -2013 813 -970 O \nATOM 1096 CB GLN A 138 34.191 19.170 -64.805 1.00 97.01 C \nANISOU 1096 CB GLN A 138 10940 12094 13827 -1886 712 -1008 C \nATOM 1097 CG GLN A 138 35.209 19.901 -63.979 1.00 97.74 C \nANISOU 1097 CG GLN A 138 11049 12244 13845 -2029 715 -1018 C \nATOM 1098 CD GLN A 138 35.174 19.563 -62.502 1.00 88.57 C \nANISOU 1098 CD GLN A 138 9874 11064 12715 -2001 676 -1006 C \nATOM 1099 OE1 GLN A 138 35.311 18.407 -62.108 1.00 85.11 O \nANISOU 1099 OE1 GLN A 138 9311 10680 12347 -1909 631 -1019 O \nATOM 1100 NE2 GLN A 138 35.057 20.583 -61.674 1.00 90.71 N \nANISOU 1100 NE2 GLN A 138 10276 11262 12928 -2088 694 -981 N \nATOM 1101 N GLY A 139 31.252 21.296 -65.728 1.00 92.23 N \nANISOU 1101 N GLY A 139 10747 11131 13164 -1830 806 -904 N \nATOM 1102 CA GLY A 139 30.779 22.279 -66.696 1.00 95.76 C \nANISOU 1102 CA GLY A 139 11324 11509 13552 -1862 855 -884 C \nATOM 1103 C GLY A 139 30.401 21.616 -68.012 1.00104.82 C \nANISOU 1103 C GLY A 139 12398 12687 14742 -1780 860 -893 C \nATOM 1104 O GLY A 139 29.336 21.878 -68.582 1.00114.48 O \nANISOU 1104 O GLY A 139 13705 13823 15968 -1710 881 -862 O \nATOM 1105 N THR A 140 31.291 20.756 -68.496 1.00105.65 N \nANISOU 1105 N THR A 140 12344 12922 14876 -1788 840 -937 N \nATOM 1106 CA THR A 140 31.088 20.024 -69.734 1.00111.10 C \nANISOU 1106 CA THR A 140 12949 13658 15607 -1716 841 -954 C \nATOM 1107 C THR A 140 29.787 19.225 -69.666 1.00108.80 C \nANISOU 1107 C THR A 140 12652 13289 15397 -1561 820 -929 C \nATOM 1108 O THR A 140 29.395 18.770 -68.592 1.00111.94 O \nANISOU 1108 O THR A 140 13042 13649 15841 -1501 788 -915 O \nATOM 1109 CB THR A 140 32.239 19.026 -69.994 1.00113.46 C \nANISOU 1109 CB THR A 140 13064 14110 15936 -1725 814 -1008 C \nATOM 1110 OG1 THR A 140 32.250 18.038 -68.957 1.00124.97 O \nANISOU 1110 OG1 THR A 140 14436 15583 17463 -1648 764 -1014 O \nATOM 1111 CG2 THR A 140 33.598 19.721 -70.034 1.00115.31 C \nANISOU 1111 CG2 THR A 140 13280 14447 16086 -1883 831 -1037 C \nATOM 1112 N PRO A 141 29.117 19.052 -70.815 1.00105.42 N \nANISOU 1112 N PRO A 141 12228 12844 14983 -1500 838 -922 N \nATOM 1113 CA PRO A 141 27.968 18.168 -70.838 1.00108.41 C \nANISOU 1113 CA PRO A 141 12582 13173 15438 -1360 816 -904 C \nATOM 1114 C PRO A 141 28.379 16.712 -70.632 1.00109.79 C \nANISOU 1114 C PRO A 141 12597 13428 15691 -1294 768 -940 C \nATOM 1115 O PRO A 141 29.203 16.192 -71.377 1.00119.55 O \nANISOU 1115 O PRO A 141 13726 14764 16933 -1312 765 -982 O \nATOM 1116 CB PRO A 141 27.393 18.366 -72.246 1.00104.30 C \nANISOU 1116 CB PRO A 141 12090 12639 14900 -1334 848 -896 C \nATOM 1117 CG PRO A 141 28.527 18.843 -73.070 1.00100.54 C \nANISOU 1117 CG PRO A 141 11587 12247 14365 -1447 874 -929 C \nATOM 1118 CD PRO A 141 29.367 19.664 -72.134 1.00106.28 C \nANISOU 1118 CD PRO A 141 12367 12980 15036 -1562 879 -931 C \nATOM 1119 N SER A 142 27.831 16.079 -69.602 1.00110.56 N \nANISOU 1119 N SER A 142 12682 13482 15843 -1218 732 -923 N \nATOM 1120 CA SER A 142 28.116 14.668 -69.314 1.00 98.64 C \nANISOU 1120 CA SER A 142 11040 12032 14409 -1145 684 -952 C \nATOM 1121 C SER A 142 26.797 13.917 -69.086 1.00 85.82 C \nANISOU 1121 C SER A 142 9429 10332 12846 -1026 661 -923 C \nATOM 1122 O SER A 142 25.731 14.342 -69.556 1.00 80.42 O \nANISOU 1122 O SER A 142 8827 9580 12149 -992 686 -891 O \nATOM 1123 CB SER A 142 29.087 14.558 -68.136 1.00 99.38 C \nANISOU 1123 CB SER A 142 11086 12174 14501 -1194 654 -968 C \nATOM 1124 OG SER A 142 28.437 15.012 -66.969 1.00105.97 O \nANISOU 1124 OG SER A 142 12014 12918 15333 -1188 648 -929 O \nATOM 1125 N PHE A 143 26.880 12.811 -68.360 1.00 77.68 N \nANISOU 1125 N PHE A 143 8319 9319 11877 -965 614 -935 N \nATOM 1126 CA PHE A 143 25.773 11.885 -68.186 1.00 69.93 C \nANISOU 1126 CA PHE A 143 7330 8286 10955 -858 587 -916 C \nATOM 1127 C PHE A 143 26.157 10.813 -67.184 1.00 61.66 C \nANISOU 1127 C PHE A 143 6205 7261 9963 -816 533 -931 C \nATOM 1128 O PHE A 143 27.302 10.650 -66.879 1.00 59.83 O \nANISOU 1128 O PHE A 143 5906 7100 9727 -855 518 -962 O \nATOM 1129 CB PHE A 143 25.434 11.237 -69.508 1.00 63.84 C \nANISOU 1129 CB PHE A 143 6510 7539 10206 -806 595 -934 C \nATOM 1130 CG PHE A 143 24.190 10.417 -69.470 1.00 61.83 C \nANISOU 1130 CG PHE A 143 6263 7231 10000 -710 574 -911 C \nATOM 1131 CD1 PHE A 143 22.933 11.029 -69.499 1.00 61.68 C \nANISOU 1131 CD1 PHE A 143 6339 7136 9959 -686 597 -864 C \nATOM 1132 CD2 PHE A 143 24.256 9.035 -69.424 1.00 60.18 C \nANISOU 1132 CD2 PHE A 143 5967 7047 9852 -643 532 -935 C \nATOM 1133 CE1 PHE A 143 21.765 10.265 -69.502 1.00 51.67 C \nANISOU 1133 CE1 PHE A 143 5071 5832 8729 -603 578 -843 C \nATOM 1134 CE2 PHE A 143 23.096 8.276 -69.416 1.00 52.19 C \nANISOU 1134 CE2 PHE A 143 4965 5987 8877 -566 514 -914 C \nATOM 1135 CZ PHE A 143 21.859 8.887 -69.445 1.00 48.32 C \nANISOU 1135 CZ PHE A 143 4562 5434 8364 -550 536 -868 C \nATOM 1136 N PHE A 144 25.180 10.114 -66.653 1.00 55.82 N \nANISOU 1136 N PHE A 144 5478 6463 9268 -738 505 -906 N \nATOM 1137 CA PHE A 144 25.428 9.032 -65.705 1.00 57.88 C \nANISOU 1137 CA PHE A 144 5675 6735 9581 -691 451 -916 C \nATOM 1138 C PHE A 144 26.582 8.155 -66.176 1.00 57.64 C \nANISOU 1138 C PHE A 144 5529 6798 9574 -680 430 -968 C \nATOM 1139 O PHE A 144 26.738 7.899 -67.373 1.00 58.92 O \nANISOU 1139 O PHE A 144 5652 7001 9737 -668 447 -995 O \nATOM 1140 CB PHE A 144 24.172 8.147 -65.544 1.00 58.15 C \nANISOU 1140 CB PHE A 144 5724 6708 9663 -602 426 -891 C \nATOM 1141 CG PHE A 144 22.946 8.883 -65.044 1.00 49.70 C \nANISOU 1141 CG PHE A 144 4757 5556 8571 -596 444 -840 C \nATOM 1142 CD1 PHE A 144 21.826 9.084 -65.879 1.00 44.33 C \nANISOU 1142 CD1 PHE A 144 4123 4841 7879 -562 471 -817 C \nATOM 1143 CD2 PHE A 144 22.937 9.383 -63.774 1.00 44.60 C \nANISOU 1143 CD2 PHE A 144 4159 4875 7912 -623 433 -816 C \nATOM 1144 CE1 PHE A 144 20.714 9.778 -65.409 1.00 52.12 C \nANISOU 1144 CE1 PHE A 144 5201 5762 8839 -549 487 -771 C \nATOM 1145 CE2 PHE A 144 21.839 10.052 -63.278 1.00 48.27 C \nANISOU 1145 CE2 PHE A 144 4718 5269 8354 -612 449 -771 C \nATOM 1146 CZ PHE A 144 20.724 10.263 -64.083 1.00 54.92 C \nANISOU 1146 CZ PHE A 144 5605 6080 9183 -572 476 -748 C \nATOM 1147 N ARG A 145 27.385 7.701 -65.228 1.00 53.10 N \nANISOU 1147 N ARG A 145 4901 6260 9016 -681 393 -983 N \nATOM 1148 CA ARG A 145 28.561 6.896 -65.539 1.00 53.25 C \nANISOU 1148 CA ARG A 145 4807 6376 9050 -664 370 -1032 C \nATOM 1149 C ARG A 145 28.300 5.413 -65.570 1.00 49.47 C \nANISOU 1149 C ARG A 145 4275 5887 8633 -560 326 -1046 C \nATOM 1150 O ARG A 145 29.068 4.680 -66.183 1.00 53.55 O \nANISOU 1150 O ARG A 145 4708 6476 9164 -527 314 -1090 O \nATOM 1151 CB ARG A 145 29.653 7.195 -64.524 1.00 57.78 C \nANISOU 1151 CB ARG A 145 5345 7008 9600 -719 352 -1041 C \nATOM 1152 CG ARG A 145 30.111 8.652 -64.567 1.00 68.12 C \nANISOU 1152 CG ARG A 145 6705 8340 10839 -837 396 -1035 C \nATOM 1153 CD ARG A 145 31.417 8.852 -63.836 1.00 79.87 C \nANISOU 1153 CD ARG A 145 8131 9919 12296 -900 381 -1057 C \nATOM 1154 NE ARG A 145 31.750 10.266 -63.695 1.00 92.62 N \nANISOU 1154 NE ARG A 145 9813 11540 13838 -1021 421 -1045 N \nATOM 1155 CZ ARG A 145 32.324 11.025 -64.632 1.00 98.78 C \nANISOU 1155 CZ ARG A 145 10592 12378 14563 -1102 462 -1065 C \nATOM 1156 NH1 ARG A 145 32.634 10.531 -65.839 1.00101.66 N \nANISOU 1156 NH1 ARG A 145 10884 12806 14936 -1072 472 -1100 N \nATOM 1157 NH2 ARG A 145 32.590 12.298 -64.361 1.00 93.39 N \nANISOU 1157 NH2 ARG A 145 9984 11688 13810 -1217 495 -1052 N \nATOM 1158 N ASN A 146 27.228 4.966 -64.895 1.00 44.55 N \nANISOU 1158 N ASN A 146 3705 5177 8045 -510 302 -1011 N \nATOM 1159 CA ASN A 146 27.001 3.538 -64.697 1.00 42.09 C \nANISOU 1159 CA ASN A 146 3356 4847 7789 -420 254 -1021 C \nATOM 1160 C ASN A 146 26.037 2.950 -65.719 1.00 42.18 C \nANISOU 1160 C ASN A 146 3386 4819 7822 -368 263 -1021 C \nATOM 1161 O ASN A 146 25.577 1.799 -65.617 1.00 35.93 O \nANISOU 1161 O ASN A 146 2586 3993 7071 -299 228 -1023 O \nATOM 1162 CB ASN A 146 26.464 3.267 -63.332 1.00 43.14 C \nANISOU 1162 CB ASN A 146 3530 4917 7944 -401 217 -985 C \nATOM 1163 CG ASN A 146 27.496 3.288 -62.285 1.00 42.23 C \nANISOU 1163 CG ASN A 146 3374 4848 7823 -422 189 -993 C \nATOM 1164 OD1 ASN A 146 28.633 2.960 -62.549 1.00 50.07 O \nANISOU 1164 OD1 ASN A 146 4286 5924 8813 -417 179 -1033 O \nATOM 1165 ND2 ASN A 146 27.115 3.760 -61.072 1.00 47.67 N \nANISOU 1165 ND2 ASN A 146 4118 5489 8505 -451 178 -955 N \nATOM 1166 N VAL A 147 25.727 3.759 -66.716 1.00 42.98 N \nANISOU 1166 N VAL A 147 3514 4925 7890 -407 312 -1018 N \nATOM 1167 CA VAL A 147 24.621 3.511 -67.592 1.00 42.38 C \nANISOU 1167 CA VAL A 147 3472 4807 7823 -374 328 -1006 C \nATOM 1168 C VAL A 147 24.863 4.244 -68.906 1.00 46.55 C \nANISOU 1168 C VAL A 147 3994 5380 8314 -415 378 -1024 C \nATOM 1169 O VAL A 147 25.329 5.372 -68.929 1.00 60.91 O \nANISOU 1169 O VAL A 147 5833 7222 10088 -484 411 -1019 O \nATOM 1170 CB VAL A 147 23.351 3.985 -66.849 1.00 44.27 C \nANISOU 1170 CB VAL A 147 3799 4965 8056 -376 331 -950 C \nATOM 1171 CG1 VAL A 147 22.651 5.144 -67.536 1.00 42.60 C \nANISOU 1171 CG1 VAL A 147 3653 4734 7800 -414 383 -924 C \nATOM 1172 CG2 VAL A 147 22.407 2.808 -66.613 1.00 44.14 C \nANISOU 1172 CG2 VAL A 147 3791 4899 8081 -309 294 -937 C \nATOM 1173 N VAL A 148 24.594 3.562 -70.008 1.00 50.00 N \nANISOU 1173 N VAL A 148 4403 5830 8766 -374 384 -1047 N \nATOM 1174 CA VAL A 148 24.889 4.064 -71.327 1.00 46.31 C \nANISOU 1174 CA VAL A 148 3917 5411 8267 -406 427 -1069 C \nATOM 1175 C VAL A 148 23.635 4.505 -72.089 1.00 45.32 C \nANISOU 1175 C VAL A 148 3856 5240 8123 -405 460 -1037 C \nATOM 1176 O VAL A 148 22.697 3.729 -72.255 1.00 41.59 O \nANISOU 1176 O VAL A 148 3395 4728 7677 -352 444 -1026 O \nATOM 1177 CB VAL A 148 25.603 2.993 -72.156 1.00 41.66 C \nANISOU 1177 CB VAL A 148 3242 4884 7702 -361 413 -1125 C \nATOM 1178 CG1 VAL A 148 26.143 3.619 -73.422 1.00 43.15 C \nANISOU 1178 CG1 VAL A 148 3403 5140 7852 -407 458 -1152 C \nATOM 1179 CG2 VAL A 148 26.696 2.371 -71.327 1.00 43.40 C \nANISOU 1179 CG2 VAL A 148 3399 5147 7944 -339 373 -1154 C \nATOM 1180 N TRP A 149 23.692 5.702 -72.640 1.00 42.57 N \nANISOU 1180 N TRP A 149 3545 4905 7726 -465 506 -1025 N \nATOM 1181 CA TRP A 149 22.626 6.231 -73.486 1.00 42.92 C \nANISOU 1181 CA TRP A 149 3647 4918 7744 -464 541 -996 C \nATOM 1182 C TRP A 149 22.935 6.021 -74.925 1.00 48.44 C \nANISOU 1182 C TRP A 149 4299 5672 8433 -467 565 -1032 C \nATOM 1183 O TRP A 149 23.627 6.832 -75.553 1.00 57.95 O \nANISOU 1183 O TRP A 149 5499 6921 9597 -525 599 -1046 O \nATOM 1184 CB TRP A 149 22.488 7.735 -73.246 1.00 40.77 C \nANISOU 1184 CB TRP A 149 3457 4618 7416 -526 579 -960 C \nATOM 1185 CG TRP A 149 21.393 8.386 -73.975 1.00 42.16 C \nANISOU 1185 CG TRP A 149 3701 4760 7558 -518 614 -924 C \nATOM 1186 CD1 TRP A 149 20.630 7.843 -74.928 1.00 43.79 C \nANISOU 1186 CD1 TRP A 149 3893 4971 7774 -475 620 -924 C \nATOM 1187 CD2 TRP A 149 20.959 9.754 -73.842 1.00 43.35 C \nANISOU 1187 CD2 TRP A 149 3949 4868 7653 -556 651 -882 C \nATOM 1188 NE1 TRP A 149 19.726 8.770 -75.391 1.00 44.14 N \nANISOU 1188 NE1 TRP A 149 4013 4986 7773 -479 656 -884 N \nATOM 1189 CE2 TRP A 149 19.922 9.951 -74.738 1.00 44.23 C \nANISOU 1189 CE2 TRP A 149 4097 4965 7744 -524 676 -858 C \nATOM 1190 CE3 TRP A 149 21.361 10.824 -73.048 1.00 47.20 C \nANISOU 1190 CE3 TRP A 149 4502 5330 8103 -612 664 -864 C \nATOM 1191 CZ2 TRP A 149 19.234 11.152 -74.830 1.00 48.25 C \nANISOU 1191 CZ2 TRP A 149 4705 5430 8197 -535 712 -814 C \nATOM 1192 CZ3 TRP A 149 20.707 12.023 -73.168 1.00 47.45 C \nANISOU 1192 CZ3 TRP A 149 4637 5312 8079 -629 701 -823 C \nATOM 1193 CH2 TRP A 149 19.658 12.178 -74.043 1.00 49.34 C \nANISOU 1193 CH2 TRP A 149 4911 5535 8300 -586 724 -798 C \nATOM 1194 N LEU A 150 22.475 4.900 -75.468 1.00 47.86 N \nANISOU 1194 N LEU A 150 4190 5599 8394 -408 547 -1049 N \nATOM 1195 CA LEU A 150 22.878 4.479 -76.826 1.00 44.09 C \nANISOU 1195 CA LEU A 150 3656 5181 7915 -403 564 -1092 C \nATOM 1196 C LEU A 150 22.155 5.312 -77.835 1.00 48.92 C \nANISOU 1196 C LEU A 150 4316 5789 8484 -429 609 -1067 C \nATOM 1197 O LEU A 150 21.015 5.713 -77.602 1.00 67.14 O \nANISOU 1197 O LEU A 150 6690 8041 10779 -417 617 -1019 O \nATOM 1198 CB LEU A 150 22.620 3.001 -77.025 1.00 46.03 C \nANISOU 1198 CB LEU A 150 3859 5421 8208 -333 529 -1119 C \nATOM 1199 CG LEU A 150 23.386 2.060 -76.106 1.00 50.59 C \nANISOU 1199 CG LEU A 150 4390 6005 8827 -296 482 -1147 C \nATOM 1200 CD1 LEU A 150 22.931 0.627 -76.331 1.00 57.50 C \nANISOU 1200 CD1 LEU A 150 5249 6856 9743 -227 449 -1167 C \nATOM 1201 CD2 LEU A 150 24.882 2.152 -76.352 1.00 58.25 C \nANISOU 1201 CD2 LEU A 150 5287 7059 9787 -319 487 -1196 C \nATOM 1202 N ILE A 151 22.807 5.585 -78.956 1.00 49.54 N \nANISOU 1202 N ILE A 151 4358 5929 8536 -462 639 -1099 N \nATOM 1203 CA ILE A 151 22.182 6.238 -80.096 1.00 52.16 C \nANISOU 1203 CA ILE A 151 4726 6265 8828 -482 681 -1082 C \nATOM 1204 C ILE A 151 22.633 5.580 -81.386 1.00 51.48 C \nANISOU 1204 C ILE A 151 4569 6244 8746 -474 691 -1132 C \nATOM 1205 O ILE A 151 23.497 4.729 -81.369 1.00 49.78 O \nANISOU 1205 O ILE A 151 4281 6073 8561 -454 668 -1181 O \nATOM 1206 CB ILE A 151 22.408 7.755 -80.152 1.00 58.08 C \nANISOU 1206 CB ILE A 151 5540 7011 9518 -554 721 -1054 C \nATOM 1207 CG1 ILE A 151 23.875 8.111 -80.380 1.00 68.44 C \nANISOU 1207 CG1 ILE A 151 6801 8396 10807 -620 733 -1097 C \nATOM 1208 CG2 ILE A 151 21.889 8.401 -78.890 1.00 56.04 C \nANISOU 1208 CG2 ILE A 151 5359 6682 9252 -557 713 -1005 C \nATOM 1209 CD1 ILE A 151 24.085 9.467 -81.030 1.00 76.96 C \nANISOU 1209 CD1 ILE A 151 7937 9487 11817 -699 781 -1081 C \nATOM 1210 N LYS A 152 21.989 5.962 -82.487 1.00 55.38 N \nANISOU 1210 N LYS A 152 5088 6744 9208 -483 724 -1118 N \nATOM 1211 CA LYS A 152 22.240 5.347 -83.776 1.00 56.67 C \nANISOU 1211 CA LYS A 152 5192 6966 9373 -474 736 -1162 C \nATOM 1212 C LYS A 152 23.618 5.622 -84.333 1.00 69.78 C \nANISOU 1212 C LYS A 152 6793 8708 11012 -524 754 -1210 C \nATOM 1213 O LYS A 152 24.171 6.722 -84.171 1.00 73.36 O \nANISOU 1213 O LYS A 152 7274 9176 11424 -591 778 -1197 O \nATOM 1214 CB LYS A 152 21.184 5.817 -84.785 1.00 50.98 C \nANISOU 1214 CB LYS A 152 4517 6236 8618 -477 769 -1129 C \nATOM 1215 CG LYS A 152 21.231 7.260 -85.149 1.00 49.04 C \nANISOU 1215 CG LYS A 152 4330 5991 8311 -538 812 -1098 C \nATOM 1216 CD LYS A 152 20.103 7.604 -86.111 1.00 54.03 C \nANISOU 1216 CD LYS A 152 5005 6613 8909 -525 839 -1064 C \nATOM 1217 CE LYS A 152 20.139 9.052 -86.592 1.00 53.46 C \nANISOU 1217 CE LYS A 152 5003 6539 8770 -582 883 -1032 C \nATOM 1218 NZ LYS A 152 19.459 9.182 -87.919 1.00 58.12 N \nANISOU 1218 NZ LYS A 152 5601 7155 9328 -576 912 -1021 N \nATOM 1219 N LYS A 153 24.156 4.617 -85.017 1.00 82.99 N \nANISOU 1219 N LYS A 153 8387 10436 12708 -494 744 -1266 N \nATOM 1220 CA LYS A 153 25.414 4.736 -85.744 1.00 83.60 C \nANISOU 1220 CA LYS A 153 8394 10609 12762 -534 763 -1318 C \nATOM 1221 C LYS A 153 25.084 4.712 -87.230 1.00 83.52 C \nANISOU 1221 C LYS A 153 8372 10633 12726 -542 795 -1332 C \nATOM 1222 O LYS A 153 24.293 3.889 -87.674 1.00 79.91 O \nANISOU 1222 O LYS A 153 7916 10152 12295 -489 786 -1335 O \nATOM 1223 CB LYS A 153 26.325 3.580 -85.382 1.00 87.87 C \nANISOU 1223 CB LYS A 153 8850 11192 13343 -483 727 -1374 C \nATOM 1224 CG LYS A 153 27.790 3.858 -85.632 1.00 91.94 C \nANISOU 1224 CG LYS A 153 9291 11812 13830 -528 739 -1421 C \nATOM 1225 CD LYS A 153 28.603 2.596 -85.368 1.00100.23 C \nANISOU 1225 CD LYS A 153 10255 12908 14920 -457 703 -1478 C \nATOM 1226 CE LYS A 153 29.984 2.908 -84.818 1.00 98.34 C \nANISOU 1226 CE LYS A 153 9952 12755 14660 -492 697 -1507 C \nATOM 1227 NZ LYS A 153 30.486 1.801 -83.956 1.00101.96 N \nANISOU 1227 NZ LYS A 153 10360 13218 15164 -410 649 -1535 N \nATOM 1228 N ASN A 154 25.697 5.612 -87.995 1.00 87.02 N \nANISOU 1228 N ASN A 154 8808 11137 13117 -613 834 -1341 N \nATOM 1229 CA ASN A 154 25.185 5.969 -89.315 1.00 82.84 C \nANISOU 1229 CA ASN A 154 8297 10626 12553 -636 870 -1334 C \nATOM 1230 C ASN A 154 23.752 6.404 -89.104 1.00 80.70 C \nANISOU 1230 C ASN A 154 8119 10267 12276 -617 875 -1267 C \nATOM 1231 O ASN A 154 23.455 7.024 -88.079 1.00 83.62 O \nANISOU 1231 O ASN A 154 8552 10578 12644 -626 867 -1224 O \nATOM 1232 CB ASN A 154 25.297 4.806 -90.303 1.00 84.47 C \nANISOU 1232 CB ASN A 154 8430 10882 12782 -589 865 -1389 C \nATOM 1233 CG ASN A 154 26.688 4.682 -90.884 1.00 88.00 C \nANISOU 1233 CG ASN A 154 8788 11437 13210 -620 877 -1453 C \nATOM 1234 OD1 ASN A 154 26.897 4.808 -92.101 1.00 82.64 O \nANISOU 1234 OD1 ASN A 154 8080 10820 12500 -649 907 -1477 O \nATOM 1235 ND2 ASN A 154 27.653 4.413 -90.015 1.00 87.90 N \nANISOU 1235 ND2 ASN A 154 8728 11455 13216 -612 852 -1480 N \nATOM 1236 N ASN A 155 22.867 6.111 -90.044 1.00 72.98 N \nANISOU 1236 N ASN A 155 7151 9285 11294 -592 887 -1259 N \nATOM 1237 CA ASN A 155 21.451 6.225 -89.757 1.00 79.64 C \nANISOU 1237 CA ASN A 155 8064 10056 12139 -555 882 -1201 C \nATOM 1238 C ASN A 155 20.837 4.844 -89.506 1.00 73.88 C \nANISOU 1238 C ASN A 155 7305 9302 11464 -483 845 -1216 C \nATOM 1239 O ASN A 155 20.063 4.313 -90.306 1.00 71.20 O \nANISOU 1239 O ASN A 155 6960 8969 11123 -458 850 -1217 O \nATOM 1240 CB ASN A 155 20.770 6.986 -90.874 1.00 86.10 C \nANISOU 1240 CB ASN A 155 8925 10886 12905 -580 922 -1170 C \nATOM 1241 CG ASN A 155 21.286 8.399 -90.979 1.00 89.12 C \nANISOU 1241 CG ASN A 155 9359 11274 13229 -652 956 -1148 C \nATOM 1242 OD1 ASN A 155 22.135 8.818 -90.187 1.00 81.04 O \nANISOU 1242 OD1 ASN A 155 8339 10248 12204 -689 950 -1155 O \nATOM 1243 ND2 ASN A 155 20.789 9.138 -91.958 1.00 97.75 N \nANISOU 1243 ND2 ASN A 155 10495 12375 14270 -676 991 -1120 N \nATOM 1244 N THR A 156 21.255 4.245 -88.403 1.00 63.08 N \nANISOU 1244 N THR A 156 5919 7910 10140 -455 808 -1231 N \nATOM 1245 CA THR A 156 20.867 2.885 -88.088 1.00 70.55 C \nANISOU 1245 CA THR A 156 6839 8830 11135 -393 770 -1251 C \nATOM 1246 C THR A 156 20.963 2.546 -86.583 1.00 72.45 C \nANISOU 1246 C THR A 156 7094 9018 11415 -364 729 -1239 C \nATOM 1247 O THR A 156 22.035 2.606 -85.985 1.00 67.73 O \nANISOU 1247 O THR A 156 6465 8441 10830 -375 718 -1263 O \nATOM 1248 CB THR A 156 21.714 1.880 -88.859 1.00 70.27 C \nANISOU 1248 CB THR A 156 6727 8853 11119 -373 764 -1323 C \nATOM 1249 OG1 THR A 156 21.784 2.291 -90.223 1.00 83.70 O \nANISOU 1249 OG1 THR A 156 8410 10611 12780 -408 804 -1337 O \nATOM 1250 CG2 THR A 156 21.088 0.478 -88.778 1.00 75.58 C \nANISOU 1250 CG2 THR A 156 7395 9491 11833 -311 730 -1340 C \nATOM 1251 N TYR A 157 19.821 2.179 -86.003 1.00 69.12 N \nANISOU 1251 N TYR A 157 6716 8535 11009 -331 708 -1200 N \nATOM 1252 CA TYR A 157 19.767 1.633 -84.652 1.00 57.87 C \nANISOU 1252 CA TYR A 157 5304 7059 9625 -298 665 -1190 C \nATOM 1253 C TYR A 157 19.286 0.168 -84.812 1.00 60.10 C \nANISOU 1253 C TYR A 157 5570 7323 9942 -248 634 -1215 C \nATOM 1254 O TYR A 157 18.104 -0.127 -84.740 1.00 56.32 O \nANISOU 1254 O TYR A 157 5128 6809 9461 -234 625 -1182 O \nATOM 1255 CB TYR A 157 18.826 2.471 -83.781 1.00 51.99 C \nANISOU 1255 CB TYR A 157 4631 6260 8863 -306 667 -1122 C \nATOM 1256 CG TYR A 157 18.882 2.151 -82.269 1.00 43.14 C \nANISOU 1256 CG TYR A 157 3526 5088 7777 -285 627 -1107 C \nATOM 1257 CD1 TYR A 157 19.263 3.092 -81.371 1.00 40.66 C \nANISOU 1257 CD1 TYR A 157 3241 4756 7451 -313 631 -1082 C \nATOM 1258 CD2 TYR A 157 18.523 0.901 -81.773 1.00 37.98 C \nANISOU 1258 CD2 TYR A 157 2863 4403 7164 -240 585 -1118 C \nATOM 1259 CE1 TYR A 157 19.344 2.816 -80.025 1.00 39.26 C \nANISOU 1259 CE1 TYR A 157 3077 4538 7304 -296 595 -1069 C \nATOM 1260 CE2 TYR A 157 18.552 0.621 -80.416 1.00 35.86 C \nANISOU 1260 CE2 TYR A 157 2612 4088 6924 -223 548 -1102 C \nATOM 1261 CZ TYR A 157 18.977 1.565 -79.558 1.00 36.45 C \nANISOU 1261 CZ TYR A 157 2708 4152 6989 -249 553 -1079 C \nATOM 1262 OH TYR A 157 19.035 1.310 -78.200 1.00 35.95 O \nANISOU 1262 OH TYR A 157 2660 4048 6953 -234 517 -1063 O \nATOM 1263 N PRO A 158 20.218 -0.747 -85.066 1.00 62.35 N \nANISOU 1263 N PRO A 158 5801 7636 10254 -222 617 -1275 N \nATOM 1264 CA PRO A 158 19.805 -2.128 -85.200 1.00 58.68 C \nANISOU 1264 CA PRO A 158 5333 7144 9817 -176 587 -1300 C \nATOM 1265 C PRO A 158 19.242 -2.647 -83.906 1.00 54.77 C \nANISOU 1265 C PRO A 158 4880 6579 9352 -150 545 -1270 C \nATOM 1266 O PRO A 158 19.515 -2.086 -82.838 1.00 57.90 O \nANISOU 1266 O PRO A 158 5289 6955 9755 -157 534 -1244 O \nATOM 1267 CB PRO A 158 21.144 -2.871 -85.556 1.00 63.23 C \nANISOU 1267 CB PRO A 158 5846 7765 10415 -146 577 -1373 C \nATOM 1268 CG PRO A 158 22.246 -1.985 -85.083 1.00 59.38 C \nANISOU 1268 CG PRO A 158 5325 7317 9918 -172 587 -1377 C \nATOM 1269 CD PRO A 158 21.698 -0.590 -85.190 1.00 65.97 C \nANISOU 1269 CD PRO A 158 6199 8153 10714 -232 623 -1323 C \nATOM 1270 N THR A 159 18.527 -3.760 -83.978 1.00 52.84 N \nANISOU 1270 N THR A 159 4656 6298 9122 -122 520 -1276 N \nATOM 1271 CA THR A 159 17.849 -4.263 -82.803 1.00 48.72 C \nANISOU 1271 CA THR A 159 4180 5712 8621 -105 480 -1243 C \nATOM 1272 C THR A 159 18.803 -4.943 -81.849 1.00 54.89 C \nANISOU 1272 C THR A 159 4946 6466 9442 -66 440 -1271 C \nATOM 1273 O THR A 159 19.504 -5.842 -82.237 1.00 67.55 O \nANISOU 1273 O THR A 159 6524 8080 11064 -29 426 -1325 O \nATOM 1274 CB THR A 159 16.666 -5.144 -83.182 1.00 39.32 C \nANISOU 1274 CB THR A 159 3023 4493 7422 -102 469 -1234 C \nATOM 1275 OG1 THR A 159 15.700 -4.296 -83.820 1.00 37.96 O \nANISOU 1275 OG1 THR A 159 2864 4350 7208 -138 505 -1193 O \nATOM 1276 CG2 THR A 159 16.021 -5.728 -81.967 1.00 36.71 C \nANISOU 1276 CG2 THR A 159 2739 4100 7111 -90 426 -1203 C \nATOM 1277 N ILE A 160 18.822 -4.460 -80.600 1.00 59.82 N \nANISOU 1277 N ILE A 160 5592 7062 10077 -71 422 -1234 N \nATOM 1278 CA ILE A 160 19.709 -4.936 -79.568 1.00 51.68 C \nANISOU 1278 CA ILE A 160 4547 6010 9079 -37 384 -1252 C \nATOM 1279 C ILE A 160 19.134 -6.159 -78.923 1.00 60.84 C \nANISOU 1279 C ILE A 160 5750 7103 10264 -3 338 -1248 C \nATOM 1280 O ILE A 160 17.946 -6.193 -78.600 1.00 68.12 O \nANISOU 1280 O ILE A 160 6720 7986 11176 -23 331 -1205 O \nATOM 1281 CB ILE A 160 19.909 -3.866 -78.501 1.00 46.27 C \nANISOU 1281 CB ILE A 160 3870 5320 8389 -65 386 -1212 C \nATOM 1282 CG1 ILE A 160 20.746 -2.698 -79.095 1.00 43.67 C \nANISOU 1282 CG1 ILE A 160 3501 5059 8033 -104 429 -1224 C \nATOM 1283 CG2 ILE A 160 20.666 -4.409 -77.280 1.00 47.93 C \nANISOU 1283 CG2 ILE A 160 4072 5505 8633 -31 341 -1223 C \nATOM 1284 CD1 ILE A 160 20.740 -1.430 -78.241 1.00 42.86 C \nANISOU 1284 CD1 ILE A 160 3423 4949 7912 -146 442 -1179 C \nATOM 1285 N LYS A 161 19.991 -7.159 -78.718 1.00 59.70 N \nANISOU 1285 N LYS A 161 5589 6948 10148 49 305 -1294 N \nATOM 1286 CA LYS A 161 19.603 -8.410 -78.109 1.00 64.07 C \nANISOU 1286 CA LYS A 161 6190 7431 10723 85 258 -1295 C \nATOM 1287 C LYS A 161 20.816 -8.898 -77.342 1.00 60.12 C \nANISOU 1287 C LYS A 161 5664 6928 10252 139 223 -1326 C \nATOM 1288 O LYS A 161 21.772 -9.391 -77.903 1.00 76.59 O \nANISOU 1288 O LYS A 161 7710 9046 12344 184 222 -1380 O \nATOM 1289 CB LYS A 161 19.159 -9.407 -79.175 1.00 72.61 C \nANISOU 1289 CB LYS A 161 7291 8499 11796 98 260 -1329 C \nATOM 1290 CG LYS A 161 17.780 -9.990 -78.929 1.00 78.94 C \nANISOU 1290 CG LYS A 161 8164 9242 12589 73 241 -1293 C \nATOM 1291 CD LYS A 161 17.326 -10.805 -80.132 1.00 81.26 C \nANISOU 1291 CD LYS A 161 8476 9536 12866 72 252 -1326 C \nATOM 1292 CE LYS A 161 15.940 -11.403 -79.891 1.00 88.49 C \nANISOU 1292 CE LYS A 161 9459 10401 13763 36 233 -1290 C \nATOM 1293 NZ LYS A 161 15.973 -12.480 -78.859 1.00 91.04 N \nANISOU 1293 NZ LYS A 161 9838 10645 14107 65 179 -1290 N \nATOM 1294 N ARG A 162 20.773 -8.696 -76.043 1.00 58.57 N \nANISOU 1294 N ARG A 162 5488 6698 10069 136 196 -1289 N \nATOM 1295 CA ARG A 162 21.872 -8.992 -75.142 1.00 56.09 C \nANISOU 1295 CA ARG A 162 5147 6386 9777 183 162 -1307 C \nATOM 1296 C ARG A 162 21.276 -9.650 -73.915 1.00 52.39 C \nANISOU 1296 C ARG A 162 4742 5836 9327 195 113 -1272 C \nATOM 1297 O ARG A 162 20.181 -9.264 -73.473 1.00 55.95 O \nANISOU 1297 O ARG A 162 5238 6254 9768 148 116 -1221 O \nATOM 1298 CB ARG A 162 22.618 -7.686 -74.708 1.00 53.98 C \nANISOU 1298 CB ARG A 162 4828 6180 9501 148 184 -1293 C \nATOM 1299 CG ARG A 162 23.112 -6.840 -75.860 1.00 58.85 C \nANISOU 1299 CG ARG A 162 5390 6878 10092 117 235 -1319 C \nATOM 1300 CD ARG A 162 24.382 -7.423 -76.500 1.00 64.55 C \nANISOU 1300 CD ARG A 162 6046 7661 10818 171 233 -1386 C \nATOM 1301 NE ARG A 162 25.461 -7.339 -75.527 1.00 67.61 N \nANISOU 1301 NE ARG A 162 6393 8080 11216 195 207 -1394 N \nATOM 1302 CZ ARG A 162 26.429 -6.447 -75.537 1.00 62.70 C \nANISOU 1302 CZ ARG A 162 5707 7542 10575 166 229 -1406 C \nATOM 1303 NH1 ARG A 162 26.509 -5.556 -76.504 1.00 62.02 N \nANISOU 1303 NH1 ARG A 162 5592 7513 10458 111 278 -1413 N \nATOM 1304 NH2 ARG A 162 27.324 -6.483 -74.573 1.00 63.82 N \nANISOU 1304 NH2 ARG A 162 5814 7710 10724 189 201 -1411 N \nATOM 1305 N SER A 163 22.045 -10.539 -73.300 1.00 46.57 N \nANISOU 1305 N SER A 163 4006 5076 8612 258 70 -1297 N \nATOM 1306 CA SER A 163 21.590 -11.174 -72.082 1.00 50.94 C \nANISOU 1306 CA SER A 163 4620 5554 9182 270 22 -1264 C \nATOM 1307 C SER A 163 22.735 -11.527 -71.178 1.00 46.18 C \nANISOU 1307 C SER A 163 3991 4956 8598 329 -16 -1281 C \nATOM 1308 O SER A 163 23.834 -11.700 -71.634 1.00 58.49 O \nANISOU 1308 O SER A 163 5494 6568 10160 380 -13 -1329 O \nATOM 1309 CB SER A 163 20.740 -12.426 -72.410 1.00 59.30 C \nANISOU 1309 CB SER A 163 5754 6537 10239 285 -2 -1271 C \nATOM 1310 OG SER A 163 21.530 -13.599 -72.453 1.00 64.41 O \nANISOU 1310 OG SER A 163 6414 7157 10901 365 -36 -1317 O \nATOM 1311 N TYR A 164 22.460 -11.616 -69.886 1.00 42.60 N \nANISOU 1311 N TYR A 164 3576 4455 8157 323 -52 -1241 N \nATOM 1312 CA TYR A 164 23.471 -11.791 -68.856 1.00 44.65 C \nANISOU 1312 CA TYR A 164 3809 4724 8432 371 -89 -1246 C \nATOM 1313 C TYR A 164 23.048 -12.841 -67.884 1.00 51.85 C \nANISOU 1313 C TYR A 164 4797 5546 9358 401 -145 -1224 C \nATOM 1314 O TYR A 164 21.968 -12.743 -67.288 1.00 54.46 O \nANISOU 1314 O TYR A 164 5184 5823 9684 349 -153 -1176 O \nATOM 1315 CB TYR A 164 23.734 -10.495 -68.098 1.00 41.38 C \nANISOU 1315 CB TYR A 164 3353 4359 8012 318 -72 -1212 C \nATOM 1316 CG TYR A 164 24.736 -10.663 -66.966 1.00 44.08 C \nANISOU 1316 CG TYR A 164 3666 4715 8365 360 -112 -1214 C \nATOM 1317 CD1 TYR A 164 26.103 -10.771 -67.239 1.00 43.32 C \nANISOU 1317 CD1 TYR A 164 3495 4696 8269 415 -114 -1262 C \nATOM 1318 CD2 TYR A 164 24.315 -10.752 -65.614 1.00 38.07 C \nANISOU 1318 CD2 TYR A 164 2952 3899 7614 346 -149 -1168 C \nATOM 1319 CE1 TYR A 164 27.028 -10.935 -66.210 1.00 43.91 C \nANISOU 1319 CE1 TYR A 164 3538 4795 8350 456 -151 -1262 C \nATOM 1320 CE2 TYR A 164 25.216 -10.934 -64.621 1.00 40.67 C \nANISOU 1320 CE2 TYR A 164 3254 4244 7952 385 -186 -1169 C \nATOM 1321 CZ TYR A 164 26.590 -11.039 -64.926 1.00 45.72 C \nANISOU 1321 CZ TYR A 164 3816 4965 8590 443 -188 -1217 C \nATOM 1322 OH TYR A 164 27.557 -11.228 -63.923 1.00 54.81 O \nANISOU 1322 OH TYR A 164 4932 6146 9746 487 -226 -1218 O \nATOM 1323 N ASN A 165 23.902 -13.844 -67.726 1.00 58.16 N \nANISOU 1323 N ASN A 165 5599 6331 10170 487 -183 -1260 N \nATOM 1324 CA ASN A 165 23.649 -14.909 -66.799 1.00 68.71 C \nANISOU 1324 CA ASN A 165 7012 7579 11517 525 -239 -1243 C \nATOM 1325 C ASN A 165 24.486 -14.629 -65.556 1.00 64.12 C \nANISOU 1325 C ASN A 165 6394 7024 10946 550 -270 -1227 C \nATOM 1326 O ASN A 165 25.689 -14.752 -65.584 1.00 71.22 O \nANISOU 1326 O ASN A 165 7233 7980 11848 617 -279 -1263 O \nATOM 1327 CB ASN A 165 23.989 -16.262 -67.456 1.00 77.89 C \nANISOU 1327 CB ASN A 165 8216 8697 12680 610 -263 -1292 C \nATOM 1328 CG ASN A 165 23.503 -17.458 -66.661 1.00 84.11 C \nANISOU 1328 CG ASN A 165 9110 9375 13472 638 -319 -1273 C \nATOM 1329 OD1 ASN A 165 23.202 -17.330 -65.475 1.00 88.32 O \nANISOU 1329 OD1 ASN A 165 9670 9875 14011 611 -348 -1227 O \nATOM 1330 ND2 ASN A 165 23.442 -18.632 -67.311 1.00 91.58 N \nANISOU 1330 ND2 ASN A 165 10123 10261 14413 691 -335 -1309 N \nATOM 1331 N ASN A 166 23.825 -14.242 -64.471 1.00 55.69 N \nANISOU 1331 N ASN A 166 5360 5921 9880 495 -285 -1172 N \nATOM 1332 CA ASN A 166 24.487 -14.094 -63.194 1.00 57.53 C \nANISOU 1332 CA ASN A 166 5572 6165 10122 515 -319 -1152 C \nATOM 1333 C ASN A 166 25.238 -15.404 -62.826 1.00 64.29 C \nANISOU 1333 C ASN A 166 6457 6983 10988 620 -375 -1178 C \nATOM 1334 O ASN A 166 24.661 -16.376 -62.363 1.00 60.67 O \nANISOU 1334 O ASN A 166 6088 6431 10533 637 -416 -1161 O \nATOM 1335 CB ASN A 166 23.478 -13.708 -62.114 1.00 54.10 C \nANISOU 1335 CB ASN A 166 5189 5681 9685 443 -332 -1089 C \nATOM 1336 CG ASN A 166 24.118 -13.359 -60.769 1.00 51.96 C \nANISOU 1336 CG ASN A 166 4891 5430 9420 448 -362 -1065 C \nATOM 1337 OD1 ASN A 166 25.327 -13.362 -60.626 1.00 60.18 O \nANISOU 1337 OD1 ASN A 166 5870 6530 10465 503 -373 -1093 O \nATOM 1338 ND2 ASN A 166 23.286 -13.161 -59.752 1.00 46.96 N \nANISOU 1338 ND2 ASN A 166 4307 4750 8786 395 -378 -1013 N \nATOM 1339 N THR A 167 26.550 -15.388 -63.024 1.00 67.26 N \nANISOU 1339 N THR A 167 6754 7437 11364 689 -376 -1219 N \nATOM 1340 CA THR A 167 27.391 -16.525 -62.698 1.00 64.52 C \nANISOU 1340 CA THR A 167 6423 7070 11022 802 -426 -1246 C \nATOM 1341 C THR A 167 27.816 -16.556 -61.226 1.00 70.27 C \nANISOU 1341 C THR A 167 7150 7794 11756 821 -472 -1213 C \nATOM 1342 O THR A 167 28.593 -17.423 -60.843 1.00 76.53 O \nANISOU 1342 O THR A 167 7949 8579 12550 921 -516 -1231 O \nATOM 1343 CB THR A 167 28.643 -16.533 -63.566 1.00 57.89 C \nANISOU 1343 CB THR A 167 5492 6330 10175 877 -407 -1308 C \nATOM 1344 OG1 THR A 167 29.416 -15.342 -63.361 1.00 61.48 O \nANISOU 1344 OG1 THR A 167 5838 6903 10620 838 -380 -1307 O \nATOM 1345 CG2 THR A 167 28.298 -16.608 -65.007 1.00 56.47 C \nANISOU 1345 CG2 THR A 167 5315 6153 9988 867 -365 -1344 C \nATOM 1346 N ASN A 168 27.313 -15.623 -60.415 1.00 67.87 N \nANISOU 1346 N ASN A 168 6840 7497 11453 730 -463 -1164 N \nATOM 1347 CA ASN A 168 27.772 -15.468 -59.029 1.00 66.08 C \nANISOU 1347 CA ASN A 168 6598 7282 11228 737 -501 -1132 C \nATOM 1348 C ASN A 168 26.796 -16.072 -58.065 1.00 67.43 C \nANISOU 1348 C ASN A 168 6874 7341 11406 714 -543 -1084 C \nATOM 1349 O ASN A 168 25.758 -16.552 -58.495 1.00 74.47 O \nANISOU 1349 O ASN A 168 7846 8153 12298 686 -540 -1075 O \nATOM 1350 CB ASN A 168 27.948 -13.996 -58.708 1.00 68.60 C \nANISOU 1350 CB ASN A 168 6841 7686 11538 650 -464 -1112 C \nATOM 1351 CG ASN A 168 28.862 -13.290 -59.695 1.00 74.53 C \nANISOU 1351 CG ASN A 168 7490 8553 12276 653 -418 -1158 C \nATOM 1352 OD1 ASN A 168 30.085 -13.420 -59.624 1.00 99.43 O \nANISOU 1352 OD1 ASN A 168 10570 11788 15421 717 -432 -1189 O \nATOM 1353 ND2 ASN A 168 28.279 -12.515 -60.606 1.00 65.83 N \nANISOU 1353 ND2 ASN A 168 6380 7465 11167 582 -363 -1160 N \nATOM 1354 N GLN A 169 27.141 -16.070 -56.783 1.00 71.45 N \nANISOU 1354 N GLN A 169 7382 7850 11917 723 -583 -1053 N \nATOM 1355 CA GLN A 169 26.297 -16.672 -55.740 1.00 80.00 C \nANISOU 1355 CA GLN A 169 8563 8831 13003 702 -627 -1006 C \nATOM 1356 C GLN A 169 25.569 -15.612 -54.957 1.00 77.17 C \nANISOU 1356 C GLN A 169 8199 8481 12641 594 -609 -956 C \nATOM 1357 O GLN A 169 24.947 -15.902 -53.928 1.00 76.03 O \nANISOU 1357 O GLN A 169 8119 8272 12496 566 -644 -912 O \nATOM 1358 CB GLN A 169 27.109 -17.561 -54.768 1.00 84.06 C \nANISOU 1358 CB GLN A 169 9095 9324 13519 793 -692 -1002 C \nATOM 1359 CG GLN A 169 27.397 -18.963 -55.267 1.00 87.69 C \nANISOU 1359 CG GLN A 169 9619 9721 13979 902 -727 -1036 C \nATOM 1360 CD GLN A 169 28.580 -18.999 -56.197 1.00 90.56 C \nANISOU 1360 CD GLN A 169 9897 10173 14339 991 -708 -1096 C \nATOM 1361 OE1 GLN A 169 29.733 -18.935 -55.752 1.00 91.86 O \nANISOU 1361 OE1 GLN A 169 9989 10416 14499 1059 -728 -1110 O \nATOM 1362 NE2 GLN A 169 28.309 -19.122 -57.494 1.00 85.41 N \nANISOU 1362 NE2 GLN A 169 9251 9516 13686 992 -671 -1133 N \nATOM 1363 N GLU A 170 25.634 -14.385 -55.454 1.00 73.73 N \nANISOU 1363 N GLU A 170 7692 8122 12199 534 -554 -962 N \nATOM 1364 CA GLU A 170 24.940 -13.286 -54.810 1.00 71.37 C \nANISOU 1364 CA GLU A 170 7392 7832 11892 436 -530 -918 C \nATOM 1365 C GLU A 170 23.920 -12.675 -55.724 1.00 65.72 C \nANISOU 1365 C GLU A 170 6691 7109 11169 368 -477 -914 C \nATOM 1366 O GLU A 170 24.129 -12.547 -56.922 1.00 73.81 O \nANISOU 1366 O GLU A 170 7683 8169 12191 381 -441 -951 O \nATOM 1367 CB GLU A 170 25.925 -12.203 -54.374 1.00 76.45 C \nANISOU 1367 CB GLU A 170 7946 8575 12528 416 -512 -922 C \nATOM 1368 CG GLU A 170 27.064 -12.704 -53.486 1.00 79.79 C \nANISOU 1368 CG GLU A 170 8334 9028 12953 484 -562 -928 C \nATOM 1369 CD GLU A 170 28.278 -13.101 -54.275 1.00 80.74 C \nANISOU 1369 CD GLU A 170 8386 9219 13072 571 -562 -983 C \nATOM 1370 OE1 GLU A 170 28.120 -13.400 -55.470 1.00 85.57 O \nANISOU 1370 OE1 GLU A 170 9003 9824 13687 594 -537 -1016 O \nATOM 1371 OE2 GLU A 170 29.383 -13.123 -53.699 1.00 90.42 O \nANISOU 1371 OE2 GLU A 170 9551 10514 14292 616 -588 -993 O \nATOM 1372 N ASP A 171 22.803 -12.282 -55.140 1.00 58.88 N \nANISOU 1372 N ASP A 171 5875 6203 10295 297 -472 -868 N \nATOM 1373 CA ASP A 171 21.844 -11.449 -55.835 1.00 55.83 C \nANISOU 1373 CA ASP A 171 5493 5827 9894 229 -419 -856 C \nATOM 1374 C ASP A 171 22.576 -10.256 -56.368 1.00 55.95 C \nANISOU 1374 C ASP A 171 5429 5929 9902 209 -369 -877 C \nATOM 1375 O ASP A 171 23.401 -9.675 -55.661 1.00 51.57 O \nANISOU 1375 O ASP A 171 4828 5421 9345 204 -374 -875 O \nATOM 1376 CB ASP A 171 20.749 -10.979 -54.871 1.00 55.63 C \nANISOU 1376 CB ASP A 171 5513 5768 9856 160 -421 -801 C \nATOM 1377 CG ASP A 171 19.968 -12.147 -54.250 1.00 62.06 C \nANISOU 1377 CG ASP A 171 6410 6499 10671 165 -471 -775 C \nATOM 1378 OD1 ASP A 171 19.966 -13.259 -54.821 1.00 78.24 O \nANISOU 1378 OD1 ASP A 171 8496 8505 12726 209 -493 -798 O \nATOM 1379 OD2 ASP A 171 19.343 -11.958 -53.198 1.00 62.22 O \nANISOU 1379 OD2 ASP A 171 6463 6496 10681 122 -488 -732 O \nATOM 1380 N LEU A 172 22.309 -9.857 -57.609 1.00 59.69 N \nANISOU 1380 N LEU A 172 5885 6427 10367 193 -322 -899 N \nATOM 1381 CA LEU A 172 22.854 -8.572 -58.051 1.00 57.72 C \nANISOU 1381 CA LEU A 172 5573 6255 10104 157 -272 -911 C \nATOM 1382 C LEU A 172 21.816 -7.567 -58.570 1.00 54.67 C \nANISOU 1382 C LEU A 172 5207 5869 9696 90 -219 -887 C \nATOM 1383 O LEU A 172 20.815 -7.922 -59.178 1.00 48.71 O \nANISOU 1383 O LEU A 172 4493 5078 8938 83 -209 -880 O \nATOM 1384 CB LEU A 172 24.028 -8.742 -58.998 1.00 59.51 C \nANISOU 1384 CB LEU A 172 5732 6546 10334 205 -260 -966 C \nATOM 1385 CG LEU A 172 23.919 -9.467 -60.306 1.00 62.51 C \nANISOU 1385 CG LEU A 172 6114 6917 10720 246 -248 -1004 C \nATOM 1386 CD1 LEU A 172 23.638 -8.518 -61.435 1.00 69.36 C \nANISOU 1386 CD1 LEU A 172 6957 7828 11569 198 -187 -1014 C \nATOM 1387 CD2 LEU A 172 25.243 -10.159 -60.588 1.00 66.19 C \nANISOU 1387 CD2 LEU A 172 6526 7430 11196 326 -271 -1053 C \nATOM 1388 N LEU A 173 22.082 -6.293 -58.276 1.00 50.63 N \nANISOU 1388 N LEU A 173 4670 5402 9167 40 -186 -875 N \nATOM 1389 CA LEU A 173 21.140 -5.239 -58.547 1.00 45.02 C \nANISOU 1389 CA LEU A 173 3987 4688 8431 -17 -140 -846 C \nATOM 1390 C LEU A 173 21.504 -4.597 -59.847 1.00 45.13 C \nANISOU 1390 C LEU A 173 3963 4754 8431 -28 -89 -877 C \nATOM 1391 O LEU A 173 22.558 -4.007 -59.944 1.00 34.78 O \nANISOU 1391 O LEU A 173 2602 3500 7112 -39 -74 -900 O \nATOM 1392 CB LEU A 173 21.146 -4.232 -57.405 1.00 43.40 C \nANISOU 1392 CB LEU A 173 3794 4488 8209 -65 -134 -812 C \nATOM 1393 CG LEU A 173 20.595 -2.825 -57.701 1.00 43.76 C \nANISOU 1393 CG LEU A 173 3859 4548 8221 -122 -77 -792 C \nATOM 1394 CD1 LEU A 173 19.044 -2.868 -57.847 1.00 40.19 C \nANISOU 1394 CD1 LEU A 173 3464 4052 7756 -130 -66 -756 C \nATOM 1395 CD2 LEU A 173 21.026 -1.879 -56.617 1.00 39.27 C \nANISOU 1395 CD2 LEU A 173 3293 3992 7635 -164 -74 -772 C \nATOM 1396 N ILE A 174 20.575 -4.698 -60.841 1.00 46.52 N \nANISOU 1396 N ILE A 174 4163 4914 8599 -31 -63 -876 N \nATOM 1397 CA ILE A 174 20.777 -4.117 -62.184 1.00 36.24 C \nANISOU 1397 CA ILE A 174 2831 3657 7281 -43 -13 -903 C \nATOM 1398 C ILE A 174 19.783 -2.965 -62.386 1.00 39.09 C \nANISOU 1398 C ILE A 174 3229 4014 7610 -93 33 -866 C \nATOM 1399 O ILE A 174 18.696 -2.991 -61.894 1.00 45.82 O \nANISOU 1399 O ILE A 174 4129 4827 8454 -103 26 -828 O \nATOM 1400 CB ILE A 174 20.571 -5.154 -63.272 1.00 33.26 C \nANISOU 1400 CB ILE A 174 2449 3270 6916 -2 -19 -933 C \nATOM 1401 CG1 ILE A 174 21.295 -6.491 -62.882 1.00 32.31 C \nANISOU 1401 CG1 ILE A 174 2317 3132 6828 60 -74 -961 C \nATOM 1402 CG2 ILE A 174 21.039 -4.654 -64.613 1.00 30.96 C \nANISOU 1402 CG2 ILE A 174 2116 3036 6612 -9 27 -968 C \nATOM 1403 CD1 ILE A 174 21.121 -7.571 -63.929 1.00 31.16 C \nANISOU 1403 CD1 ILE A 174 2179 2969 6692 103 -80 -994 C \nATOM 1404 N LEU A 175 20.208 -1.916 -63.077 1.00 44.03 N \nANISOU 1404 N LEU A 175 3833 4684 8211 -123 79 -878 N \nATOM 1405 CA LEU A 175 19.411 -0.746 -63.316 1.00 42.29 C \nANISOU 1405 CA LEU A 175 3653 4461 7956 -163 125 -846 C \nATOM 1406 C LEU A 175 19.520 -0.323 -64.781 1.00 45.93 C \nANISOU 1406 C LEU A 175 4093 4961 8399 -172 171 -870 C \nATOM 1407 O LEU A 175 20.598 -0.362 -65.368 1.00 53.78 O \nANISOU 1407 O LEU A 175 5036 6001 9397 -171 178 -911 O \nATOM 1408 CB LEU A 175 19.867 0.402 -62.460 1.00 44.51 C \nANISOU 1408 CB LEU A 175 3947 4750 8214 -207 139 -828 C \nATOM 1409 CG LEU A 175 19.782 0.181 -60.949 1.00 51.03 C \nANISOU 1409 CG LEU A 175 4794 5541 9052 -207 99 -801 C \nATOM 1410 CD1 LEU A 175 21.112 -0.228 -60.364 1.00 49.90 C \nANISOU 1410 CD1 LEU A 175 4601 5429 8931 -200 66 -830 C \nATOM 1411 CD2 LEU A 175 19.310 1.444 -60.244 1.00 49.41 C \nANISOU 1411 CD2 LEU A 175 4642 5320 8812 -250 126 -763 C \nATOM 1412 N TRP A 176 18.386 0.067 -65.361 1.00 43.47 N \nANISOU 1412 N TRP A 176 3819 4636 8063 -179 201 -844 N \nATOM 1413 CA TRP A 176 18.320 0.510 -66.752 1.00 35.11 C \nANISOU 1413 CA TRP A 176 2749 3611 6982 -188 245 -860 C \nATOM 1414 C TRP A 176 17.269 1.559 -66.853 1.00 33.09 C \nANISOU 1414 C TRP A 176 2546 3341 6684 -208 283 -817 C \nATOM 1415 O TRP A 176 16.575 1.868 -65.874 1.00 31.26 O \nANISOU 1415 O TRP A 176 2358 3077 6442 -211 274 -778 O \nATOM 1416 CB TRP A 176 18.010 -0.664 -67.693 1.00 33.33 C \nANISOU 1416 CB TRP A 176 2500 3388 6775 -152 232 -886 C \nATOM 1417 CG TRP A 176 16.679 -1.300 -67.470 1.00 33.58 C \nANISOU 1417 CG TRP A 176 2570 3383 6807 -137 214 -855 C \nATOM 1418 CD1 TRP A 176 15.535 -1.030 -68.119 1.00 31.68 C \nANISOU 1418 CD1 TRP A 176 2354 3146 6537 -142 240 -830 C \nATOM 1419 CD2 TRP A 176 16.374 -2.278 -66.504 1.00 34.36 C \nANISOU 1419 CD2 TRP A 176 2685 3441 6931 -118 164 -844 C \nATOM 1420 NE1 TRP A 176 14.540 -1.769 -67.622 1.00 32.22 N \nANISOU 1420 NE1 TRP A 176 2449 3186 6608 -132 212 -806 N \nATOM 1421 CE2 TRP A 176 15.015 -2.548 -66.614 1.00 32.15 C \nANISOU 1421 CE2 TRP A 176 2439 3145 6631 -120 164 -813 C \nATOM 1422 CE3 TRP A 176 17.134 -2.950 -65.522 1.00 38.50 C \nANISOU 1422 CE3 TRP A 176 3199 3944 7487 -101 118 -856 C \nATOM 1423 CZ2 TRP A 176 14.374 -3.472 -65.834 1.00 35.57 C \nANISOU 1423 CZ2 TRP A 176 2900 3541 7076 -113 122 -795 C \nATOM 1424 CZ3 TRP A 176 16.470 -3.877 -64.687 1.00 39.40 C \nANISOU 1424 CZ3 TRP A 176 3345 4011 7614 -88 74 -835 C \nATOM 1425 CH2 TRP A 176 15.115 -4.139 -64.873 1.00 40.41 C \nANISOU 1425 CH2 TRP A 176 3509 4123 7721 -98 77 -806 C \nATOM 1426 N GLY A 177 17.126 2.118 -68.028 1.00 29.88 N \nANISOU 1426 N GLY A 177 2139 2961 6251 -218 325 -823 N \nATOM 1427 CA GLY A 177 16.294 3.289 -68.197 1.00 33.12 C \nANISOU 1427 CA GLY A 177 2605 3365 6616 -233 366 -784 C \nATOM 1428 C GLY A 177 15.701 3.405 -69.589 1.00 34.66 C \nANISOU 1428 C GLY A 177 2797 3585 6787 -225 400 -786 C \nATOM 1429 O GLY A 177 16.070 2.655 -70.461 1.00 32.05 O \nANISOU 1429 O GLY A 177 2421 3282 6476 -216 396 -822 O \nATOM 1430 N ILE A 178 14.817 4.407 -69.760 1.00 35.06 N \nANISOU 1430 N ILE A 178 2900 3629 6791 -227 436 -746 N \nATOM 1431 CA ILE A 178 14.152 4.651 -71.019 1.00 35.84 C \nANISOU 1431 CA ILE A 178 3003 3754 6859 -217 470 -740 C \nATOM 1432 C ILE A 178 14.123 6.164 -71.248 1.00 41.55 C \nANISOU 1432 C ILE A 178 3783 4474 7531 -237 517 -715 C \nATOM 1433 O ILE A 178 14.005 6.928 -70.273 1.00 39.85 O \nANISOU 1433 O ILE A 178 3620 4225 7296 -243 521 -686 O \nATOM 1434 CB ILE A 178 12.705 4.095 -71.053 1.00 37.25 C \nANISOU 1434 CB ILE A 178 3191 3935 7027 -183 459 -709 C \nATOM 1435 CG1 ILE A 178 12.057 4.379 -72.390 1.00 38.42 C \nANISOU 1435 CG1 ILE A 178 3339 4119 7139 -174 495 -702 C \nATOM 1436 CG2 ILE A 178 11.822 4.772 -70.043 1.00 37.21 C \nANISOU 1436 CG2 ILE A 178 3241 3904 6992 -170 462 -659 C \nATOM 1437 CD1 ILE A 178 10.707 3.738 -72.581 1.00 40.10 C \nANISOU 1437 CD1 ILE A 178 3548 4351 7337 -147 485 -678 C \nATOM 1438 N HIS A 179 14.299 6.589 -72.517 1.00 38.98 N \nANISOU 1438 N HIS A 179 3452 4178 7180 -249 553 -728 N \nATOM 1439 CA HIS A 179 14.297 7.997 -72.822 1.00 37.50 C \nANISOU 1439 CA HIS A 179 3328 3982 6939 -269 598 -705 C \nATOM 1440 C HIS A 179 13.055 8.355 -73.548 1.00 32.82 C \nANISOU 1440 C HIS A 179 2766 3399 6304 -233 625 -670 C \nATOM 1441 O HIS A 179 12.891 7.991 -74.700 1.00 30.12 O \nANISOU 1441 O HIS A 179 2390 3094 5958 -226 636 -685 O \nATOM 1442 CB HIS A 179 15.536 8.447 -73.671 1.00 37.13 C \nANISOU 1442 CB HIS A 179 3262 3963 6884 -319 624 -743 C \nATOM 1443 CG HIS A 179 15.441 9.870 -74.166 1.00 32.78 C \nANISOU 1443 CG HIS A 179 2785 3399 6269 -343 672 -718 C \nATOM 1444 ND1 HIS A 179 15.527 10.206 -75.501 1.00 38.18 N \nANISOU 1444 ND1 HIS A 179 3466 4116 6925 -356 706 -728 N \nATOM 1445 CD2 HIS A 179 15.245 11.020 -73.503 1.00 30.68 C \nANISOU 1445 CD2 HIS A 179 2607 3089 5961 -353 692 -683 C \nATOM 1446 CE1 HIS A 179 15.368 11.514 -75.634 1.00 33.37 C \nANISOU 1446 CE1 HIS A 179 2943 3480 6258 -373 744 -697 C \nATOM 1447 NE2 HIS A 179 15.228 12.027 -74.431 1.00 37.02 N \nANISOU 1447 NE2 HIS A 179 3463 3893 6710 -372 737 -671 N \nATOM 1448 N HIS A 180 12.241 9.175 -72.908 1.00 31.51 N \nANISOU 1448 N HIS A 180 2669 3203 6099 -209 638 -624 N \nATOM 1449 CA HIS A 180 11.077 9.729 -73.551 1.00 29.63 C \nANISOU 1449 CA HIS A 180 2470 2980 5809 -168 667 -585 C \nATOM 1450 C HIS A 180 11.539 10.969 -74.290 1.00 30.64 C \nANISOU 1450 C HIS A 180 2656 3098 5889 -193 713 -581 C \nATOM 1451 O HIS A 180 11.823 11.986 -73.652 1.00 32.81 O \nANISOU 1451 O HIS A 180 3004 3328 6135 -209 730 -564 O \nATOM 1452 CB HIS A 180 9.992 10.050 -72.506 1.00 30.56 C \nANISOU 1452 CB HIS A 180 2636 3075 5901 -124 661 -538 C \nATOM 1453 CG HIS A 180 9.574 8.890 -71.648 1.00 27.12 C \nANISOU 1453 CG HIS A 180 2153 2645 5507 -110 615 -539 C \nATOM 1454 ND1 HIS A 180 8.955 7.782 -72.155 1.00 27.17 N \nANISOU 1454 ND1 HIS A 180 2099 2693 5530 -94 594 -547 N \nATOM 1455 CD2 HIS A 180 9.718 8.649 -70.339 1.00 27.36 C \nANISOU 1455 CD2 HIS A 180 2189 2644 5562 -116 584 -535 C \nATOM 1456 CE1 HIS A 180 8.700 6.899 -71.204 1.00 25.89 C \nANISOU 1456 CE1 HIS A 180 1913 2524 5401 -91 553 -546 C \nATOM 1457 NE2 HIS A 180 9.124 7.410 -70.074 1.00 29.56 N \nANISOU 1457 NE2 HIS A 180 2416 2946 5872 -101 546 -538 N \nATOM 1458 N SER A 181 11.583 10.897 -75.614 1.00 30.78 N \nANISOU 1458 N SER A 181 2646 3154 5894 -198 734 -595 N \nATOM 1459 CA SER A 181 11.844 12.018 -76.459 1.00 38.45 C \nANISOU 1459 CA SER A 181 3675 4121 6814 -218 778 -587 C \nATOM 1460 C SER A 181 10.693 12.973 -76.581 1.00 42.55 C \nANISOU 1460 C SER A 181 4274 4625 7266 -165 807 -532 C \nATOM 1461 O SER A 181 9.586 12.694 -76.078 1.00 53.02 O \nANISOU 1461 O SER A 181 5600 5959 8587 -107 793 -501 O \nATOM 1462 CB SER A 181 12.244 11.508 -77.866 1.00 45.61 C \nANISOU 1462 CB SER A 181 4517 5081 7730 -240 788 -622 C \nATOM 1463 OG SER A 181 11.425 10.384 -78.285 1.00 41.07 O \nANISOU 1463 OG SER A 181 3876 4549 7179 -200 767 -625 O \nATOM 1464 N ASN A 182 10.907 14.088 -77.285 1.00 47.04 N \nANISOU 1464 N ASN A 182 4913 5179 7781 -180 848 -520 N \nATOM 1465 CA ASN A 182 9.919 15.231 -77.312 1.00 53.62 C \nANISOU 1465 CA ASN A 182 5848 5985 8541 -123 880 -465 C \nATOM 1466 C ASN A 182 9.002 15.276 -78.521 1.00 55.86 C \nANISOU 1466 C ASN A 182 6122 6317 8784 -75 901 -442 C \nATOM 1467 O ASN A 182 7.828 15.628 -78.394 1.00 62.84 O \nANISOU 1467 O ASN A 182 7044 7208 9624 -1 909 -397 O \nATOM 1468 CB ASN A 182 10.628 16.542 -77.201 1.00 55.20 C \nANISOU 1468 CB ASN A 182 6155 6125 8695 -166 912 -458 C \nATOM 1469 CG ASN A 182 11.186 16.749 -75.838 1.00 63.34 C \nANISOU 1469 CG ASN A 182 7219 7102 9743 -197 895 -463 C \nATOM 1470 OD1 ASN A 182 10.516 16.432 -74.822 1.00 64.88 O \nANISOU 1470 OD1 ASN A 182 7410 7287 9954 -150 872 -445 O \nATOM 1471 ND2 ASN A 182 12.383 17.314 -75.772 1.00 62.11 N \nANISOU 1471 ND2 ASN A 182 7100 6917 9581 -278 908 -488 N \nATOM 1472 N ASP A 183 9.503 14.805 -79.649 1.00 56.74 N \nANISOU 1472 N ASP A 183 6172 6472 8912 -112 905 -474 N \nATOM 1473 CA ASP A 183 8.748 14.805 -80.889 1.00 54.82 C \nANISOU 1473 CA ASP A 183 5915 6282 8633 -76 925 -457 C \nATOM 1474 C ASP A 183 9.311 13.811 -81.892 1.00 56.47 C \nANISOU 1474 C ASP A 183 6024 6546 8884 -120 916 -505 C \nATOM 1475 O ASP A 183 10.421 13.268 -81.712 1.00 51.94 O \nANISOU 1475 O ASP A 183 5403 5969 8363 -179 899 -553 O \nATOM 1476 CB ASP A 183 8.761 16.219 -81.522 1.00 59.41 C \nANISOU 1476 CB ASP A 183 6604 6832 9139 -72 970 -427 C \nATOM 1477 CG ASP A 183 10.168 16.869 -81.549 1.00 59.81 C \nANISOU 1477 CG ASP A 183 6700 6835 9188 -160 986 -456 C \nATOM 1478 OD1 ASP A 183 10.409 17.833 -80.824 1.00 64.21 O \nANISOU 1478 OD1 ASP A 183 7357 7327 9714 -171 999 -437 O \nATOM 1479 OD2 ASP A 183 11.002 16.462 -82.321 1.00 64.51 O \nANISOU 1479 OD2 ASP A 183 7238 7465 9809 -220 987 -496 O \nATOM 1480 N ALA A 184 8.564 13.610 -82.985 1.00 53.83 N \nANISOU 1480 N ALA A 184 5661 6269 8522 -89 928 -493 N \nATOM 1481 CA ALA A 184 8.949 12.626 -83.992 1.00 54.24 C \nANISOU 1481 CA ALA A 184 5621 6377 8609 -123 921 -537 C \nATOM 1482 C ALA A 184 10.351 12.921 -84.542 1.00 59.65 C \nANISOU 1482 C ALA A 184 6305 7052 9305 -198 937 -579 C \nATOM 1483 O ALA A 184 11.119 12.013 -84.814 1.00 66.33 O \nANISOU 1483 O ALA A 184 7074 7927 10203 -238 919 -630 O \nATOM 1484 CB ALA A 184 7.934 12.561 -85.118 1.00 45.80 C \nANISOU 1484 CB ALA A 184 4534 5371 7497 -83 937 -513 C \nATOM 1485 N ALA A 185 10.664 14.198 -84.704 1.00 62.86 N \nANISOU 1485 N ALA A 185 6803 7422 9659 -216 970 -557 N \nATOM 1486 CA ALA A 185 11.952 14.621 -85.275 1.00 62.59 C \nANISOU 1486 CA ALA A 185 6776 7385 9620 -296 989 -592 C \nATOM 1487 C ALA A 185 13.126 14.179 -84.394 1.00 60.44 C \nANISOU 1487 C ALA A 185 6465 7095 9404 -350 964 -636 C \nATOM 1488 O ALA A 185 14.065 13.523 -84.887 1.00 64.47 O \nANISOU 1488 O ALA A 185 6899 7648 9950 -399 957 -689 O \nATOM 1489 CB ALA A 185 11.964 16.135 -85.499 1.00 63.16 C \nANISOU 1489 CB ALA A 185 6972 7411 9617 -307 1029 -553 C \nATOM 1490 N GLU A 186 13.076 14.536 -83.109 1.00 54.32 N \nANISOU 1490 N GLU A 186 5741 6264 8633 -340 952 -617 N \nATOM 1491 CA GLU A 186 14.103 14.111 -82.145 1.00 55.67 C \nANISOU 1491 CA GLU A 186 5875 6421 8855 -385 925 -654 C \nATOM 1492 C GLU A 186 14.220 12.637 -82.118 1.00 56.18 C \nANISOU 1492 C GLU A 186 5827 6529 8989 -371 888 -694 C \nATOM 1493 O GLU A 186 15.316 12.085 -82.044 1.00 62.03 O \nANISOU 1493 O GLU A 186 6506 7293 9770 -416 872 -742 O \nATOM 1494 CB GLU A 186 13.822 14.582 -80.732 1.00 55.90 C \nANISOU 1494 CB GLU A 186 5972 6387 8880 -365 914 -623 C \nATOM 1495 CG GLU A 186 14.949 14.315 -79.743 1.00 62.12 C \nANISOU 1495 CG GLU A 186 6732 7161 9711 -419 889 -658 C \nATOM 1496 CD GLU A 186 14.596 14.633 -78.285 1.00 67.56 C \nANISOU 1496 CD GLU A 186 7478 7791 10401 -396 874 -629 C \nATOM 1497 OE1 GLU A 186 13.435 15.020 -77.999 1.00 76.17 O \nANISOU 1497 OE1 GLU A 186 8628 8852 11462 -332 880 -582 O \nATOM 1498 OE2 GLU A 186 15.513 14.523 -77.430 1.00 63.52 O \nANISOU 1498 OE2 GLU A 186 6951 7267 9917 -442 855 -653 O \nATOM 1499 N GLN A 187 13.079 11.976 -82.193 1.00 59.45 N \nANISOU 1499 N GLN A 187 6216 6960 9414 -309 873 -674 N \nATOM 1500 CA GLN A 187 13.095 10.517 -82.123 1.00 50.88 C \nANISOU 1500 CA GLN A 187 5035 5906 8391 -295 836 -710 C \nATOM 1501 C GLN A 187 13.940 9.974 -83.249 1.00 49.53 C \nANISOU 1501 C GLN A 187 4795 5788 8237 -333 842 -762 C \nATOM 1502 O GLN A 187 14.890 9.226 -83.005 1.00 62.90 O \nANISOU 1502 O GLN A 187 6428 7493 9978 -357 819 -809 O \nATOM 1503 CB GLN A 187 11.685 9.946 -82.157 1.00 43.64 C \nANISOU 1503 CB GLN A 187 4105 5006 7469 -233 823 -679 C \nATOM 1504 CG GLN A 187 11.651 8.402 -82.221 1.00 37.98 C \nANISOU 1504 CG GLN A 187 3301 4320 6809 -226 786 -716 C \nATOM 1505 CD GLN A 187 12.138 7.735 -80.929 1.00 38.17 C \nANISOU 1505 CD GLN A 187 3305 4309 6887 -230 746 -735 C \nATOM 1506 OE1 GLN A 187 12.138 8.326 -79.865 1.00 34.37 O \nANISOU 1506 OE1 GLN A 187 2873 3785 6401 -226 741 -709 O \nATOM 1507 NE2 GLN A 187 12.508 6.466 -81.026 1.00 42.58 N \nANISOU 1507 NE2 GLN A 187 3797 4886 7497 -233 715 -778 N \nATOM 1508 N THR A 188 13.616 10.373 -84.480 1.00 45.70 N \nANISOU 1508 N THR A 188 4320 5336 7710 -335 874 -753 N \nATOM 1509 CA THR A 188 14.345 9.926 -85.681 1.00 44.14 C \nANISOU 1509 CA THR A 188 4058 5193 7520 -371 885 -801 C \nATOM 1510 C THR A 188 15.816 10.274 -85.654 1.00 49.01 C \nANISOU 1510 C THR A 188 4662 5817 8143 -436 893 -841 C \nATOM 1511 O THR A 188 16.647 9.480 -86.065 1.00 54.16 O \nANISOU 1511 O THR A 188 5237 6512 8829 -457 882 -895 O \nATOM 1512 CB THR A 188 13.710 10.466 -86.979 1.00 48.63 C \nANISOU 1512 CB THR A 188 4650 5794 8033 -365 921 -778 C \nATOM 1513 OG1 THR A 188 12.686 11.431 -86.699 1.00 52.50 O \nANISOU 1513 OG1 THR A 188 5226 6250 8471 -326 938 -714 O \nATOM 1514 CG2 THR A 188 13.050 9.329 -87.770 1.00 52.58 C \nANISOU 1514 CG2 THR A 188 5080 6345 8553 -335 909 -795 C \nATOM 1515 N LYS A 189 16.142 11.488 -85.206 1.00 62.38 N \nANISOU 1515 N LYS A 189 6434 7471 9795 -470 914 -815 N \nATOM 1516 CA LYS A 189 17.550 11.952 -85.182 1.00 61.22 C \nANISOU 1516 CA LYS A 189 6281 7339 9641 -547 925 -849 C \nATOM 1517 C LYS A 189 18.387 11.195 -84.186 1.00 62.87 C \nANISOU 1517 C LYS A 189 6430 7551 9906 -555 888 -887 C \nATOM 1518 O LYS A 189 19.567 10.947 -84.429 1.00 59.86 O \nANISOU 1518 O LYS A 189 5989 7217 9537 -602 887 -936 O \nATOM 1519 CB LYS A 189 17.694 13.450 -84.943 1.00 67.89 C \nANISOU 1519 CB LYS A 189 7236 8138 10422 -590 957 -812 C \nATOM 1520 CG LYS A 189 17.176 14.004 -83.637 1.00 74.70 C \nANISOU 1520 CG LYS A 189 8178 8926 11277 -565 947 -769 C \nATOM 1521 CD LYS A 189 17.878 15.334 -83.284 1.00 91.91 C \nANISOU 1521 CD LYS A 189 10453 11067 13402 -636 974 -756 C \nATOM 1522 CE LYS A 189 16.902 16.460 -82.864 1.00 97.36 C \nANISOU 1522 CE LYS A 189 11277 11681 14036 -601 995 -692 C \nATOM 1523 NZ LYS A 189 17.551 17.790 -82.628 1.00 92.15 N \nANISOU 1523 NZ LYS A 189 10726 10974 13313 -674 1024 -678 N \nATOM 1524 N LEU A 190 17.789 10.829 -83.052 1.00 56.26 N \nANISOU 1524 N LEU A 190 5607 6668 9100 -509 858 -865 N \nATOM 1525 CA LEU A 190 18.529 10.082 -82.068 1.00 53.11 C \nANISOU 1525 CA LEU A 190 5155 6270 8754 -511 821 -897 C \nATOM 1526 C LEU A 190 18.620 8.628 -82.412 1.00 58.08 C \nANISOU 1526 C LEU A 190 5690 6939 9438 -475 791 -940 C \nATOM 1527 O LEU A 190 19.675 7.997 -82.223 1.00 60.61 O \nANISOU 1527 O LEU A 190 5943 7292 9792 -489 771 -988 O \nATOM 1528 CB LEU A 190 17.889 10.211 -80.697 1.00 48.52 C \nANISOU 1528 CB LEU A 190 4625 5626 8185 -479 799 -857 C \nATOM 1529 CG LEU A 190 18.156 11.562 -80.052 1.00 50.96 C \nANISOU 1529 CG LEU A 190 5025 5891 8447 -523 821 -827 C \nATOM 1530 CD1 LEU A 190 17.445 11.679 -78.706 1.00 46.91 C \nANISOU 1530 CD1 LEU A 190 4564 5317 7944 -486 800 -788 C \nATOM 1531 CD2 LEU A 190 19.656 11.775 -79.841 1.00 50.50 C \nANISOU 1531 CD2 LEU A 190 4935 5863 8388 -598 821 -868 C \nATOM 1532 N TYR A 191 17.499 8.089 -82.885 1.00 61.65 N \nANISOU 1532 N TYR A 191 6140 7388 9896 -425 788 -922 N \nATOM 1533 CA TYR A 191 17.328 6.632 -82.871 1.00 58.40 C \nANISOU 1533 CA TYR A 191 5662 6990 9537 -383 751 -953 C \nATOM 1534 C TYR A 191 16.950 5.998 -84.128 1.00 65.60 C \nANISOU 1534 C TYR A 191 6534 7944 10447 -368 761 -973 C \nATOM 1535 O TYR A 191 17.049 4.790 -84.217 1.00 67.03 O \nANISOU 1535 O TYR A 191 6662 8138 10670 -343 734 -1009 O \nATOM 1536 CB TYR A 191 16.240 6.246 -81.921 1.00 51.05 C \nANISOU 1536 CB TYR A 191 4761 6013 8624 -337 724 -915 C \nATOM 1537 CG TYR A 191 16.372 6.811 -80.562 1.00 45.39 C \nANISOU 1537 CG TYR A 191 4090 5247 7910 -343 711 -888 C \nATOM 1538 CD1 TYR A 191 17.359 6.348 -79.708 1.00 45.35 C \nANISOU 1538 CD1 TYR A 191 4049 5237 7944 -354 681 -919 C \nATOM 1539 CD2 TYR A 191 15.530 7.787 -80.115 1.00 45.94 C \nANISOU 1539 CD2 TYR A 191 4236 5279 7939 -334 728 -832 C \nATOM 1540 CE1 TYR A 191 17.523 6.869 -78.427 1.00 42.81 C \nANISOU 1540 CE1 TYR A 191 3769 4874 7624 -365 669 -895 C \nATOM 1541 CE2 TYR A 191 15.695 8.323 -78.847 1.00 47.08 C \nANISOU 1541 CE2 TYR A 191 4427 5378 8085 -342 718 -810 C \nATOM 1542 CZ TYR A 191 16.688 7.849 -78.023 1.00 43.77 C \nANISOU 1542 CZ TYR A 191 3969 4955 7706 -361 688 -842 C \nATOM 1543 OH TYR A 191 16.823 8.382 -76.777 1.00 44.52 O \nANISOU 1543 OH TYR A 191 4109 5007 7798 -372 678 -820 O \nATOM 1544 N GLN A 192 16.481 6.787 -85.085 1.00 70.75 N \nANISOU 1544 N GLN A 192 7218 8614 11049 -382 799 -950 N \nATOM 1545 CA GLN A 192 16.167 6.246 -86.376 1.00 67.20 C \nANISOU 1545 CA GLN A 192 6730 8212 10592 -375 812 -970 C \nATOM 1546 C GLN A 192 14.736 5.728 -86.317 1.00 61.55 C \nANISOU 1546 C GLN A 192 6029 7483 9876 -328 798 -935 C \nATOM 1547 O GLN A 192 13.854 6.366 -86.873 1.00 57.70 O \nANISOU 1547 O GLN A 192 5577 7004 9340 -319 824 -895 O \nATOM 1548 CB GLN A 192 17.130 5.144 -86.767 1.00 79.78 C \nANISOU 1548 CB GLN A 192 8242 9843 12227 -378 794 -1039 C \nATOM 1549 CG GLN A 192 17.766 5.255 -88.166 1.00 93.15 C \nANISOU 1549 CG GLN A 192 9896 11601 13898 -411 825 -1077 C \nATOM 1550 CD GLN A 192 17.076 6.242 -89.124 1.00 87.75 C \nANISOU 1550 CD GLN A 192 9256 10931 13152 -430 866 -1038 C \nATOM 1551 OE1 GLN A 192 17.428 7.411 -89.157 1.00 92.08 O \nANISOU 1551 OE1 GLN A 192 9850 11476 13661 -469 894 -1017 O \nATOM 1552 NE2 GLN A 192 16.121 5.764 -89.918 1.00 76.39 N \nANISOU 1552 NE2 GLN A 192 7809 9512 11704 -404 871 -1029 N \nATOM 1553 N ASN A 193 14.480 4.631 -85.594 1.00 56.75 N \nANISOU 1553 N ASN A 193 5396 6853 9312 -298 758 -947 N \nATOM 1554 CA ASN A 193 13.173 4.001 -85.648 1.00 52.85 C \nANISOU 1554 CA ASN A 193 4908 6361 8814 -265 744 -921 C \nATOM 1555 C ASN A 193 12.124 4.849 -84.915 1.00 48.01 C \nANISOU 1555 C ASN A 193 4357 5720 8165 -244 750 -854 C \nATOM 1556 O ASN A 193 12.377 5.307 -83.820 1.00 49.53 O \nANISOU 1556 O ASN A 193 4582 5870 8367 -243 740 -836 O \nATOM 1557 CB ASN A 193 13.260 2.578 -85.065 1.00 60.58 C \nANISOU 1557 CB ASN A 193 5851 7321 9846 -247 699 -954 C \nATOM 1558 CG ASN A 193 14.645 1.925 -85.290 1.00 52.95 C \nANISOU 1558 CG ASN A 193 4833 6366 8920 -258 687 -1020 C \nATOM 1559 OD1 ASN A 193 15.120 1.931 -86.371 1.00 47.35 O \nANISOU 1559 OD1 ASN A 193 4092 5698 8199 -274 710 -1053 O \nATOM 1560 ND2 ASN A 193 15.283 1.414 -84.247 1.00 51.51 N \nANISOU 1560 ND2 ASN A 193 4641 6149 8781 -246 653 -1039 N \nATOM 1561 N PRO A 194 10.943 5.053 -85.520 1.00 42.76 N \nANISOU 1561 N PRO A 194 3707 5085 7456 -224 767 -816 N \nATOM 1562 CA PRO A 194 9.887 5.876 -85.009 1.00 42.04 C \nANISOU 1562 CA PRO A 194 3671 4982 7322 -194 777 -754 C \nATOM 1563 C PRO A 194 9.047 5.193 -83.936 1.00 47.42 C \nANISOU 1563 C PRO A 194 4352 5646 8020 -167 741 -732 C \nATOM 1564 O PRO A 194 8.533 5.841 -83.024 1.00 44.21 O \nANISOU 1564 O PRO A 194 3992 5214 7594 -143 740 -688 O \nATOM 1565 CB PRO A 194 9.003 6.120 -86.237 1.00 41.49 C \nANISOU 1565 CB PRO A 194 3597 4969 7198 -182 805 -731 C \nATOM 1566 CG PRO A 194 9.222 4.947 -87.080 1.00 41.72 C \nANISOU 1566 CG PRO A 194 3562 5034 7254 -202 793 -780 C \nATOM 1567 CD PRO A 194 10.650 4.595 -86.894 1.00 45.50 C \nANISOU 1567 CD PRO A 194 4016 5487 7784 -231 782 -836 C \nATOM 1568 N THR A 195 8.926 3.877 -84.047 1.00 51.61 N \nANISOU 1568 N THR A 195 4835 6190 8584 -172 711 -763 N \nATOM 1569 CA THR A 195 8.165 3.107 -83.051 1.00 51.68 C \nANISOU 1569 CA THR A 195 4845 6184 8608 -157 674 -746 C \nATOM 1570 C THR A 195 9.068 2.099 -82.394 1.00 53.12 C \nANISOU 1570 C THR A 195 5004 6324 8854 -171 636 -792 C \nATOM 1571 O THR A 195 9.663 1.235 -83.063 1.00 56.18 O \nANISOU 1571 O THR A 195 5354 6721 9270 -185 628 -842 O \nATOM 1572 CB THR A 195 6.957 2.388 -83.706 1.00 47.16 C \nANISOU 1572 CB THR A 195 4248 5667 8004 -153 670 -733 C \nATOM 1573 OG1 THR A 195 6.263 3.316 -84.513 1.00 47.24 O \nANISOU 1573 OG1 THR A 195 4271 5726 7953 -137 707 -697 O \nATOM 1574 CG2 THR A 195 6.021 1.902 -82.630 1.00 44.97 C \nANISOU 1574 CG2 THR A 195 3981 5383 7723 -140 638 -702 C \nATOM 1575 N THR A 196 9.201 2.209 -81.091 1.00 54.65 N \nANISOU 1575 N THR A 196 5223 6473 9070 -162 613 -776 N \nATOM 1576 CA THR A 196 10.283 1.473 -80.388 1.00 57.96 C \nANISOU 1576 CA THR A 196 5624 6849 9549 -171 579 -818 C \nATOM 1577 C THR A 196 9.807 0.951 -79.036 1.00 51.18 C \nANISOU 1577 C THR A 196 4785 5953 8710 -160 540 -796 C \nATOM 1578 O THR A 196 8.722 1.294 -78.604 1.00 51.42 O \nANISOU 1578 O THR A 196 4840 5991 8705 -148 542 -749 O \nATOM 1579 CB THR A 196 11.547 2.370 -80.172 1.00 58.57 C \nANISOU 1579 CB THR A 196 5709 6908 9638 -185 596 -834 C \nATOM 1580 OG1 THR A 196 11.200 3.567 -79.464 1.00 55.29 O \nANISOU 1580 OG1 THR A 196 5344 6471 9191 -179 613 -785 O \nATOM 1581 CG2 THR A 196 12.130 2.774 -81.441 1.00 68.02 C \nANISOU 1581 CG2 THR A 196 6884 8142 10818 -203 631 -860 C \nATOM 1582 N TYR A 197 10.693 0.203 -78.353 1.00 42.85 N \nANISOU 1582 N TYR A 197 3717 4860 7706 -162 505 -830 N \nATOM 1583 CA TYR A 197 10.354 -0.518 -77.134 1.00 39.40 C \nANISOU 1583 CA TYR A 197 3295 4384 7293 -156 462 -817 C \nATOM 1584 C TYR A 197 11.598 -0.984 -76.434 1.00 36.71 C \nANISOU 1584 C TYR A 197 2941 4003 7003 -153 432 -854 C \nATOM 1585 O TYR A 197 12.601 -1.352 -77.105 1.00 35.07 O \nANISOU 1585 O TYR A 197 2701 3805 6820 -153 435 -903 O \nATOM 1586 CB TYR A 197 9.463 -1.777 -77.488 1.00 37.87 C \nANISOU 1586 CB TYR A 197 3093 4202 7094 -160 438 -823 C \nATOM 1587 CG TYR A 197 10.200 -2.762 -78.359 1.00 33.09 C \nANISOU 1587 CG TYR A 197 2459 3597 6517 -163 429 -881 C \nATOM 1588 CD1 TYR A 197 10.776 -3.858 -77.826 1.00 33.39 C \nANISOU 1588 CD1 TYR A 197 2497 3591 6598 -156 388 -914 C \nATOM 1589 CD2 TYR A 197 10.329 -2.574 -79.712 1.00 40.78 C \nANISOU 1589 CD2 TYR A 197 3409 4615 7473 -170 463 -904 C \nATOM 1590 CE1 TYR A 197 11.515 -4.740 -78.573 1.00 33.56 C \nANISOU 1590 CE1 TYR A 197 2498 3611 6644 -149 381 -970 C \nATOM 1591 CE2 TYR A 197 11.057 -3.473 -80.503 1.00 41.78 C \nANISOU 1591 CE2 TYR A 197 3508 4742 7623 -169 456 -961 C \nATOM 1592 CZ TYR A 197 11.660 -4.555 -79.890 1.00 40.43 C \nANISOU 1592 CZ TYR A 197 3341 4524 7496 -155 414 -995 C \nATOM 1593 OH TYR A 197 12.361 -5.488 -80.605 1.00 48.24 O \nANISOU 1593 OH TYR A 197 4310 5511 8508 -144 406 -1052 O \nATOM 1594 N ILE A 198 11.540 -1.053 -75.111 1.00 32.88 N \nANISOU 1594 N ILE A 198 2478 3479 6534 -148 403 -832 N \nATOM 1595 CA ILE A 198 12.553 -1.752 -74.367 1.00 34.73 C \nANISOU 1595 CA ILE A 198 2701 3677 6817 -141 365 -864 C \nATOM 1596 C ILE A 198 11.856 -2.959 -73.782 1.00 44.45 C \nANISOU 1596 C ILE A 198 3950 4879 8062 -135 322 -857 C \nATOM 1597 O ILE A 198 10.719 -2.852 -73.264 1.00 44.15 O \nANISOU 1597 O ILE A 198 3938 4840 7996 -143 317 -813 O \nATOM 1598 CB ILE A 198 13.105 -0.934 -73.196 1.00 40.86 C \nANISOU 1598 CB ILE A 198 3494 4430 7603 -145 361 -845 C \nATOM 1599 CG1 ILE A 198 13.940 0.214 -73.673 1.00 40.33 C \nANISOU 1599 CG1 ILE A 198 3417 4387 7521 -160 401 -855 C \nATOM 1600 CG2 ILE A 198 13.980 -1.810 -72.277 1.00 39.50 C \nANISOU 1600 CG2 ILE A 198 3310 4222 7478 -132 314 -872 C \nATOM 1601 CD1 ILE A 198 13.137 1.451 -74.022 1.00 45.52 C \nANISOU 1601 CD1 ILE A 198 4109 5060 8126 -169 444 -813 C \nATOM 1602 N SER A 199 12.528 -4.104 -73.812 1.00 48.47 N \nANISOU 1602 N SER A 199 4445 5364 8608 -122 289 -900 N \nATOM 1603 CA SER A 199 11.917 -5.369 -73.376 1.00 50.68 C \nANISOU 1603 CA SER A 199 4752 5609 8897 -121 246 -898 C \nATOM 1604 C SER A 199 12.913 -6.044 -72.468 1.00 53.02 C \nANISOU 1604 C SER A 199 5051 5858 9238 -98 204 -923 C \nATOM 1605 O SER A 199 14.016 -6.369 -72.874 1.00 56.47 O \nANISOU 1605 O SER A 199 5460 6296 9701 -74 201 -969 O \nATOM 1606 CB SER A 199 11.560 -6.230 -74.592 1.00 55.21 C \nANISOU 1606 CB SER A 199 5320 6198 9458 -127 251 -928 C \nATOM 1607 OG SER A 199 11.673 -7.605 -74.292 1.00 56.18 O \nANISOU 1607 OG SER A 199 5467 6273 9604 -118 207 -953 O \nATOM 1608 N VAL A 200 12.555 -6.199 -71.200 1.00 55.55 N \nANISOU 1608 N VAL A 200 5401 6141 9564 -102 172 -890 N \nATOM 1609 CA VAL A 200 13.484 -6.752 -70.200 1.00 49.38 C \nANISOU 1609 CA VAL A 200 4623 5317 8822 -78 129 -907 C \nATOM 1610 C VAL A 200 12.811 -7.933 -69.502 1.00 49.21 C \nANISOU 1610 C VAL A 200 4649 5246 8805 -83 82 -893 C \nATOM 1611 O VAL A 200 11.634 -7.831 -69.106 1.00 45.25 O \nANISOU 1611 O VAL A 200 4175 4745 8273 -114 80 -851 O \nATOM 1612 CB VAL A 200 13.811 -5.752 -69.126 1.00 44.48 C \nANISOU 1612 CB VAL A 200 4000 4695 8204 -84 132 -878 C \nATOM 1613 CG1 VAL A 200 14.947 -6.260 -68.269 1.00 36.19 C \nANISOU 1613 CG1 VAL A 200 2941 3615 7193 -57 93 -900 C \nATOM 1614 CG2 VAL A 200 14.140 -4.439 -69.729 1.00 51.91 C \nANISOU 1614 CG2 VAL A 200 4914 5683 9127 -96 183 -877 C \nATOM 1615 N GLY A 201 13.538 -9.041 -69.376 1.00 45.49 N \nANISOU 1615 N GLY A 201 4188 4733 8363 -52 44 -930 N \nATOM 1616 CA GLY A 201 12.999 -10.284 -68.834 1.00 49.12 C \nANISOU 1616 CA GLY A 201 4703 5136 8824 -57 -3 -923 C \nATOM 1617 C GLY A 201 13.951 -11.062 -67.956 1.00 51.06 C \nANISOU 1617 C GLY A 201 4966 5328 9106 -16 -51 -942 C \nATOM 1618 O GLY A 201 15.119 -11.257 -68.273 1.00 49.41 O \nANISOU 1618 O GLY A 201 4727 5122 8923 31 -54 -986 O \nATOM 1619 N THR A 202 13.445 -11.497 -66.812 1.00 51.17 N \nANISOU 1619 N THR A 202 5026 5299 9119 -32 -90 -909 N \nATOM 1620 CA THR A 202 14.131 -12.469 -65.981 1.00 47.44 C \nANISOU 1620 CA THR A 202 4587 4765 8674 5 -143 -922 C \nATOM 1621 C THR A 202 13.178 -13.676 -65.811 1.00 56.17 C \nANISOU 1621 C THR A 202 5770 5813 9759 -23 -179 -910 C \nATOM 1622 O THR A 202 12.254 -13.875 -66.594 1.00 67.41 O \nANISOU 1622 O THR A 202 7211 7251 11152 -63 -161 -907 O \nATOM 1623 CB THR A 202 14.515 -11.868 -64.644 1.00 45.05 C \nANISOU 1623 CB THR A 202 4272 4459 8386 8 -161 -892 C \nATOM 1624 OG1 THR A 202 13.366 -11.710 -63.796 1.00 40.77 O \nANISOU 1624 OG1 THR A 202 3766 3906 7819 -43 -171 -839 O \nATOM 1625 CG2 THR A 202 15.099 -10.539 -64.813 1.00 44.99 C \nANISOU 1625 CG2 THR A 202 4199 4511 8382 10 -119 -893 C \nATOM 1626 N SER A 203 13.392 -14.481 -64.784 1.00 59.89 N \nANISOU 1626 N SER A 203 6291 6221 10244 -8 -231 -902 N \nATOM 1627 CA SER A 203 12.435 -15.503 -64.424 1.00 57.40 C \nANISOU 1627 CA SER A 203 6056 5851 9902 -50 -266 -881 C \nATOM 1628 C SER A 203 11.173 -14.902 -63.801 1.00 55.27 C \nANISOU 1628 C SER A 203 5790 5612 9597 -121 -257 -824 C \nATOM 1629 O SER A 203 10.077 -15.489 -63.845 1.00 65.17 O \nANISOU 1629 O SER A 203 7093 6854 10813 -177 -268 -804 O \nATOM 1630 CB SER A 203 13.052 -16.485 -63.465 1.00 57.83 C \nANISOU 1630 CB SER A 203 6167 5828 9978 -11 -324 -886 C \nATOM 1631 OG SER A 203 13.279 -15.865 -62.235 1.00 61.19 O \nANISOU 1631 OG SER A 203 6571 6261 10417 -11 -339 -852 O \nATOM 1632 N THR A 204 11.328 -13.738 -63.220 1.00 48.74 N \nANISOU 1632 N THR A 204 4912 4828 8778 -119 -237 -799 N \nATOM 1633 CA THR A 204 10.262 -13.109 -62.423 1.00 46.28 C \nANISOU 1633 CA THR A 204 4604 4545 8436 -172 -232 -744 C \nATOM 1634 C THR A 204 9.717 -11.876 -63.102 1.00 48.55 C \nANISOU 1634 C THR A 204 4838 4910 8699 -190 -174 -730 C \nATOM 1635 O THR A 204 8.598 -11.494 -62.855 1.00 54.05 O \nANISOU 1635 O THR A 204 5539 5643 9357 -233 -162 -691 O \nATOM 1636 CB THR A 204 10.834 -12.737 -61.035 1.00 55.68 C \nANISOU 1636 CB THR A 204 5790 5716 9650 -155 -258 -722 C \nATOM 1637 OG1 THR A 204 9.967 -13.268 -60.003 1.00 60.65 O \nANISOU 1637 OG1 THR A 204 6472 6316 10255 -200 -295 -683 O \nATOM 1638 CG2 THR A 204 10.992 -11.182 -60.867 1.00 56.02 C \nANISOU 1638 CG2 THR A 204 5773 5819 9694 -153 -214 -705 C \nATOM 1639 N LEU A 205 10.506 -11.293 -64.013 1.00 47.42 N \nANISOU 1639 N LEU A 205 4646 4795 8574 -154 -138 -763 N \nATOM 1640 CA LEU A 205 10.221 -10.018 -64.601 1.00 43.75 C \nANISOU 1640 CA LEU A 205 4136 4397 8091 -162 -84 -751 C \nATOM 1641 C LEU A 205 9.917 -10.188 -66.092 1.00 44.08 C \nANISOU 1641 C LEU A 205 4163 4471 8114 -167 -53 -777 C \nATOM 1642 O LEU A 205 10.600 -10.932 -66.791 1.00 42.87 O \nANISOU 1642 O LEU A 205 4013 4294 7983 -142 -61 -822 O \nATOM 1643 CB LEU A 205 11.442 -9.078 -64.419 1.00 40.63 C \nANISOU 1643 CB LEU A 205 3697 4014 7728 -125 -66 -767 C \nATOM 1644 CG LEU A 205 11.235 -7.675 -64.999 1.00 40.01 C \nANISOU 1644 CG LEU A 205 3581 3995 7626 -133 -9 -754 C \nATOM 1645 CD1 LEU A 205 10.336 -6.837 -64.128 1.00 32.98 C \nANISOU 1645 CD1 LEU A 205 2703 3121 6705 -158 1 -701 C \nATOM 1646 CD2 LEU A 205 12.618 -7.016 -65.223 1.00 43.19 C \nANISOU 1646 CD2 LEU A 205 3942 4410 8058 -103 9 -786 C \nATOM 1647 N ASN A 206 8.973 -9.377 -66.560 1.00 44.53 N \nANISOU 1647 N ASN A 206 4201 4587 8131 -193 -13 -750 N \nATOM 1648 CA ASN A 206 8.464 -9.421 -67.894 1.00 47.04 C \nANISOU 1648 CA ASN A 206 4505 4947 8422 -206 19 -764 C \nATOM 1649 C ASN A 206 7.867 -8.046 -68.199 1.00 47.75 C \nANISOU 1649 C ASN A 206 4561 5104 8477 -211 68 -732 C \nATOM 1650 O ASN A 206 6.659 -7.857 -68.101 1.00 52.35 O \nANISOU 1650 O ASN A 206 5150 5727 9014 -240 76 -694 O \nATOM 1651 CB ASN A 206 7.399 -10.539 -68.035 1.00 42.22 C \nANISOU 1651 CB ASN A 206 3936 4329 7777 -251 -6 -755 C \nATOM 1652 CG ASN A 206 6.944 -10.751 -69.465 1.00 43.39 C \nANISOU 1652 CG ASN A 206 4071 4519 7896 -268 23 -776 C \nATOM 1653 OD1 ASN A 206 7.540 -10.245 -70.439 1.00 57.03 O \nANISOU 1653 OD1 ASN A 206 5762 6272 9637 -241 58 -804 O \nATOM 1654 ND2 ASN A 206 5.886 -11.481 -69.622 1.00 40.90 N \nANISOU 1654 ND2 ASN A 206 3785 4217 7539 -318 10 -762 N \nATOM 1655 N GLN A 207 8.724 -7.106 -68.604 1.00 41.08 N \nANISOU 1655 N GLN A 207 3683 4274 7650 -182 101 -748 N \nATOM 1656 CA GLN A 207 8.275 -5.784 -68.937 1.00 38.59 C \nANISOU 1656 CA GLN A 207 3349 4012 7303 -182 148 -720 C \nATOM 1657 C GLN A 207 8.458 -5.407 -70.428 1.00 40.12 C \nANISOU 1657 C GLN A 207 3512 4248 7485 -175 191 -745 C \nATOM 1658 O GLN A 207 9.198 -5.994 -71.166 1.00 37.12 O \nANISOU 1658 O GLN A 207 3118 3856 7129 -165 188 -790 O \nATOM 1659 CB GLN A 207 8.925 -4.744 -68.042 1.00 39.95 C \nANISOU 1659 CB GLN A 207 3520 4171 7490 -165 156 -705 C \nATOM 1660 CG GLN A 207 10.241 -4.244 -68.486 1.00 43.95 C \nANISOU 1660 CG GLN A 207 4000 4673 8027 -146 175 -741 C \nATOM 1661 CD GLN A 207 10.777 -3.050 -67.650 1.00 43.73 C \nANISOU 1661 CD GLN A 207 3975 4639 8001 -142 190 -722 C \nATOM 1662 OE1 GLN A 207 11.788 -2.422 -68.007 1.00 40.75 O \nANISOU 1662 OE1 GLN A 207 3578 4270 7637 -137 212 -746 O \nATOM 1663 NE2 GLN A 207 10.132 -2.764 -66.553 1.00 43.39 N \nANISOU 1663 NE2 GLN A 207 3960 4585 7943 -149 177 -682 N \nATOM 1664 N ARG A 208 7.687 -4.441 -70.874 1.00 40.86 N \nANISOU 1664 N ARG A 208 3598 4393 7534 -177 231 -714 N \nATOM 1665 CA ARG A 208 7.867 -3.903 -72.177 1.00 38.51 C \nANISOU 1665 CA ARG A 208 3275 4135 7222 -171 273 -732 C \nATOM 1666 C ARG A 208 7.521 -2.434 -72.091 1.00 46.07 C \nANISOU 1666 C ARG A 208 4237 5123 8144 -158 313 -693 C \nATOM 1667 O ARG A 208 6.397 -2.097 -71.755 1.00 45.66 O \nANISOU 1667 O ARG A 208 4198 5102 8050 -159 319 -650 O \nATOM 1668 CB ARG A 208 6.994 -4.558 -73.187 1.00 38.15 C \nANISOU 1668 CB ARG A 208 3221 4130 7144 -189 279 -736 C \nATOM 1669 CG ARG A 208 7.716 -4.754 -74.506 1.00 36.59 C \nANISOU 1669 CG ARG A 208 2999 3944 6961 -185 300 -783 C \nATOM 1670 CD ARG A 208 6.833 -5.309 -75.548 1.00 36.13 C \nANISOU 1670 CD ARG A 208 2933 3930 6865 -207 310 -786 C \nATOM 1671 NE ARG A 208 6.348 -4.262 -76.448 1.00 38.35 N \nANISOU 1671 NE ARG A 208 3193 4275 7103 -202 358 -765 N \nATOM 1672 CZ ARG A 208 6.587 -4.192 -77.755 1.00 39.50 C \nANISOU 1672 CZ ARG A 208 3315 4454 7240 -203 386 -792 C \nATOM 1673 NH1 ARG A 208 7.385 -5.098 -78.346 1.00 42.19 N \nANISOU 1673 NH1 ARG A 208 3647 4770 7615 -207 374 -847 N \nATOM 1674 NH2 ARG A 208 6.050 -3.191 -78.457 1.00 37.42 N \nANISOU 1674 NH2 ARG A 208 3040 4248 6932 -197 428 -765 N \nATOM 1675 N LEU A 209 8.513 -1.562 -72.361 1.00 49.78 N \nANISOU 1675 N LEU A 209 4700 5587 8629 -147 340 -710 N \nATOM 1676 CA LEU A 209 8.381 -0.106 -72.148 1.00 38.61 C \nANISOU 1676 CA LEU A 209 3304 4183 7182 -136 376 -676 C \nATOM 1677 C LEU A 209 8.330 0.554 -73.498 1.00 39.18 C \nANISOU 1677 C LEU A 209 3366 4298 7224 -133 422 -681 C \nATOM 1678 O LEU A 209 9.027 0.185 -74.404 1.00 39.00 O \nANISOU 1678 O LEU A 209 3315 4282 7221 -140 428 -722 O \nATOM 1679 CB LEU A 209 9.554 0.422 -71.411 1.00 42.78 C \nANISOU 1679 CB LEU A 209 3841 4671 7742 -138 372 -689 C \nATOM 1680 CG LEU A 209 9.850 -0.200 -70.045 1.00 45.17 C \nANISOU 1680 CG LEU A 209 4153 4929 8080 -140 326 -688 C \nATOM 1681 CD1 LEU A 209 11.208 0.194 -69.493 1.00 40.48 C \nANISOU 1681 CD1 LEU A 209 3556 4307 7520 -145 321 -711 C \nATOM 1682 CD2 LEU A 209 8.743 0.105 -69.084 1.00 46.37 C \nANISOU 1682 CD2 LEU A 209 4337 5081 8201 -136 319 -638 C \nATOM 1683 N VAL A 210 7.373 1.458 -73.656 1.00 48.54 N \nANISOU 1683 N VAL A 210 4571 5515 8355 -117 452 -638 N \nATOM 1684 CA VAL A 210 7.192 2.194 -74.920 1.00 47.03 C \nANISOU 1684 CA VAL A 210 4377 5367 8126 -110 497 -634 C \nATOM 1685 C VAL A 210 7.329 3.656 -74.583 1.00 42.95 C \nANISOU 1685 C VAL A 210 3905 4835 7580 -94 529 -605 C \nATOM 1686 O VAL A 210 6.728 4.108 -73.602 1.00 49.04 O \nANISOU 1686 O VAL A 210 4709 5594 8330 -75 525 -567 O \nATOM 1687 CB VAL A 210 5.803 1.949 -75.538 1.00 46.45 C \nANISOU 1687 CB VAL A 210 4292 5355 8002 -100 505 -606 C \nATOM 1688 CG1 VAL A 210 5.562 2.981 -76.623 1.00 56.48 C \nANISOU 1688 CG1 VAL A 210 5570 6665 9225 -82 553 -590 C \nATOM 1689 CG2 VAL A 210 5.749 0.581 -76.167 1.00 49.41 C \nANISOU 1689 CG2 VAL A 210 4630 5747 8399 -125 481 -641 C \nATOM 1690 N PRO A 211 8.170 4.377 -75.317 1.00 36.74 N \nANISOU 1690 N PRO A 211 3124 4043 6791 -104 561 -624 N \nATOM 1691 CA PRO A 211 8.457 5.786 -75.016 1.00 35.36 C \nANISOU 1691 CA PRO A 211 3005 3844 6587 -98 592 -600 C \nATOM 1692 C PRO A 211 7.259 6.627 -75.299 1.00 34.87 C \nANISOU 1692 C PRO A 211 2980 3810 6458 -60 623 -551 C \nATOM 1693 O PRO A 211 6.610 6.425 -76.357 1.00 35.01 O \nANISOU 1693 O PRO A 211 2973 3880 6448 -48 637 -546 O \nATOM 1694 CB PRO A 211 9.589 6.117 -75.987 1.00 32.38 C \nANISOU 1694 CB PRO A 211 2615 3469 6219 -128 617 -638 C \nATOM 1695 CG PRO A 211 9.501 5.119 -77.066 1.00 34.49 C \nANISOU 1695 CG PRO A 211 2825 3778 6500 -134 610 -669 C \nATOM 1696 CD PRO A 211 9.058 3.870 -76.355 1.00 35.37 C \nANISOU 1696 CD PRO A 211 2909 3883 6645 -127 565 -673 C \nATOM 1697 N LYS A 212 6.909 7.490 -74.378 1.00 34.95 N \nANISOU 1697 N LYS A 212 3046 3793 6441 -36 630 -514 N \nATOM 1698 CA LYS A 212 5.809 8.457 -74.535 1.00 37.25 C \nANISOU 1698 CA LYS A 212 3384 4108 6662 14 662 -464 C \nATOM 1699 C LYS A 212 6.272 9.732 -75.198 1.00 39.21 C \nANISOU 1699 C LYS A 212 3691 4336 6872 16 706 -457 C \nATOM 1700 O LYS A 212 6.876 10.593 -74.555 1.00 37.70 O \nANISOU 1700 O LYS A 212 3559 4089 6675 5 717 -453 O \nATOM 1701 CB LYS A 212 5.287 8.858 -73.130 1.00 38.00 C \nANISOU 1701 CB LYS A 212 3522 4175 6741 42 650 -429 C \nATOM 1702 CG LYS A 212 4.227 7.913 -72.569 1.00 39.49 C \nANISOU 1702 CG LYS A 212 3669 4407 6930 59 618 -412 C \nATOM 1703 CD LYS A 212 4.780 7.123 -71.422 1.00 38.10 C \nANISOU 1703 CD LYS A 212 3476 4190 6811 26 575 -433 C \nATOM 1704 CE LYS A 212 3.882 7.231 -70.217 1.00 41.59 C \nANISOU 1704 CE LYS A 212 3938 4636 7227 54 560 -395 C \nATOM 1705 NZ LYS A 212 4.589 6.807 -68.948 1.00 39.97 N \nANISOU 1705 NZ LYS A 212 3737 4376 7073 23 524 -411 N \nATOM 1706 N ILE A 213 6.024 9.842 -76.484 1.00 44.90 N \nANISOU 1706 N ILE A 213 4396 5099 7564 23 731 -457 N \nATOM 1707 CA ILE A 213 6.552 10.971 -77.271 1.00 53.75 C \nANISOU 1707 CA ILE A 213 5572 6200 8649 15 772 -455 C \nATOM 1708 C ILE A 213 5.546 12.124 -77.070 1.00 61.81 C \nANISOU 1708 C ILE A 213 6672 7218 9596 81 801 -398 C \nATOM 1709 O ILE A 213 4.459 12.095 -77.633 1.00 67.48 O \nANISOU 1709 O ILE A 213 7376 7994 10271 130 810 -369 O \nATOM 1710 CB ILE A 213 6.597 10.627 -78.784 1.00 49.61 C \nANISOU 1710 CB ILE A 213 5001 5729 8118 1 788 -474 C \nATOM 1711 CG1 ILE A 213 7.222 9.251 -79.045 1.00 52.72 C \nANISOU 1711 CG1 ILE A 213 5309 6144 8580 -43 756 -527 C \nATOM 1712 CG2 ILE A 213 7.265 11.740 -79.567 1.00 43.96 C \nANISOU 1712 CG2 ILE A 213 4342 4992 7368 -18 828 -475 C \nATOM 1713 CD1 ILE A 213 8.738 9.253 -79.049 1.00 55.12 C \nANISOU 1713 CD1 ILE A 213 5605 6412 8926 -100 754 -574 C \nATOM 1714 N ALA A 214 5.910 13.140 -76.318 1.00 64.24 N \nANISOU 1714 N ALA A 214 7063 7461 9884 83 815 -383 N \nATOM 1715 CA ALA A 214 5.042 14.300 -76.180 1.00 68.63 C \nANISOU 1715 CA ALA A 214 7706 8005 10364 151 845 -332 C \nATOM 1716 C ALA A 214 5.806 15.588 -75.845 1.00 65.60 C \nANISOU 1716 C ALA A 214 7434 7540 9953 131 873 -326 C \nATOM 1717 O ALA A 214 6.991 15.569 -75.548 1.00 62.37 O \nANISOU 1717 O ALA A 214 7027 7087 9582 60 866 -361 O \nATOM 1718 CB ALA A 214 4.019 14.017 -75.100 1.00 69.60 C \nANISOU 1718 CB ALA A 214 7820 8146 10478 205 824 -303 C \nATOM 1719 N THR A 215 5.086 16.695 -75.870 1.00 71.25 N \nANISOU 1719 N THR A 215 8242 8237 10594 197 904 -282 N \nATOM 1720 CA THR A 215 5.638 18.035 -75.541 1.00 75.21 C \nANISOU 1720 CA THR A 215 8872 8653 11052 186 935 -270 C \nATOM 1721 C THR A 215 5.554 18.270 -74.031 1.00 75.77 C \nANISOU 1721 C THR A 215 8988 8673 11127 199 920 -259 C \nATOM 1722 O THR A 215 4.541 17.971 -73.402 1.00 76.49 O \nANISOU 1722 O THR A 215 9057 8796 11209 265 906 -234 O \nATOM 1723 CB THR A 215 4.858 19.163 -76.290 1.00 72.94 C \nANISOU 1723 CB THR A 215 8678 8361 10675 260 976 -224 C \nATOM 1724 OG1 THR A 215 5.064 19.034 -77.709 1.00 71.24 O \nANISOU 1724 OG1 THR A 215 8428 8186 10453 237 991 -235 O \nATOM 1725 CG2 THR A 215 5.305 20.556 -75.844 1.00 74.93 C \nANISOU 1725 CG2 THR A 215 9081 8515 10874 255 1006 -208 C \nATOM 1726 N ARG A 216 6.620 18.778 -73.439 1.00 83.59 N \nANISOU 1726 N ARG A 216 10038 9591 12130 133 924 -279 N \nATOM 1727 CA ARG A 216 6.614 19.009 -71.994 1.00 92.17 C \nANISOU 1727 CA ARG A 216 11170 10629 13220 138 911 -272 C \nATOM 1728 C ARG A 216 7.191 20.351 -71.626 1.00 87.39 C \nANISOU 1728 C ARG A 216 10706 9933 12564 113 942 -263 C \nATOM 1729 O ARG A 216 7.838 21.009 -72.446 1.00 79.92 O \nANISOU 1729 O ARG A 216 9817 8960 11590 68 970 -270 O \nATOM 1730 CB ARG A 216 7.422 17.950 -71.263 1.00 97.66 C \nANISOU 1730 CB ARG A 216 11774 11333 13999 68 869 -312 C \nATOM 1731 CG ARG A 216 6.813 16.559 -71.272 1.00 96.93 C \nANISOU 1731 CG ARG A 216 11557 11315 13958 91 831 -320 C \nATOM 1732 CD ARG A 216 7.864 15.525 -70.897 1.00 83.52 C \nANISOU 1732 CD ARG A 216 9773 9620 12339 15 794 -366 C \nATOM 1733 NE ARG A 216 7.659 14.234 -71.515 1.00 74.63 N \nANISOU 1733 NE ARG A 216 8535 8561 11260 14 768 -387 N \nATOM 1734 CZ ARG A 216 8.359 13.770 -72.546 1.00 77.97 C \nANISOU 1734 CZ ARG A 216 8904 9010 11712 -30 769 -421 C \nATOM 1735 NH1 ARG A 216 9.322 14.487 -73.112 1.00 84.24 N \nANISOU 1735 NH1 ARG A 216 9737 9778 12491 -79 795 -439 N \nATOM 1736 NH2 ARG A 216 8.083 12.576 -73.027 1.00 78.28 N \nANISOU 1736 NH2 ARG A 216 8849 9104 11788 -26 744 -439 N \nATOM 1737 N SER A 217 6.925 20.725 -70.375 1.00 81.63 N \nANISOU 1737 N SER A 217 10035 9159 11820 138 937 -247 N \nATOM 1738 CA SER A 217 7.534 21.888 -69.739 1.00 81.49 C \nANISOU 1738 CA SER A 217 10153 9050 11761 102 960 -244 C \nATOM 1739 C SER A 217 8.981 21.568 -69.388 1.00 83.22 C \nANISOU 1739 C SER A 217 10336 9249 12033 -20 942 -289 C \nATOM 1740 O SER A 217 9.313 20.474 -68.948 1.00 81.85 O \nANISOU 1740 O SER A 217 10050 9117 11932 -52 904 -316 O \nATOM 1741 CB SER A 217 6.766 22.291 -68.471 1.00 81.21 C \nANISOU 1741 CB SER A 217 10182 8980 11695 170 958 -215 C \nATOM 1742 OG SER A 217 6.406 21.154 -67.668 1.00 77.25 O \nANISOU 1742 OG SER A 217 9566 8532 11254 182 915 -224 O \nATOM 1743 N LYS A 218 9.858 22.537 -69.595 1.00 91.05 N \nANISOU 1743 N LYS A 218 11429 10180 12985 -90 971 -298 N \nATOM 1744 CA LYS A 218 11.288 22.316 -69.419 1.00 87.34 C \nANISOU 1744 CA LYS A 218 10923 9706 12555 -211 958 -342 C \nATOM 1745 C LYS A 218 11.590 22.283 -67.935 1.00 84.18 C \nANISOU 1745 C LYS A 218 10537 9271 12175 -239 936 -348 C \nATOM 1746 O LYS A 218 11.330 23.249 -67.239 1.00 95.58 O \nANISOU 1746 O LYS A 218 12107 10646 13564 -221 956 -325 O \nATOM 1747 CB LYS A 218 12.105 23.394 -70.135 1.00 82.15 C \nANISOU 1747 CB LYS A 218 10370 9002 11839 -287 996 -347 C \nATOM 1748 CG LYS A 218 11.978 23.298 -71.646 1.00 90.82 C \nANISOU 1748 CG LYS A 218 11437 10145 12926 -275 1014 -347 C \nATOM 1749 CD LYS A 218 12.866 24.304 -72.372 1.00 97.53 C \nANISOU 1749 CD LYS A 218 12385 10954 13718 -363 1050 -355 C \nATOM 1750 CE LYS A 218 12.973 24.028 -73.866 1.00101.99 C \nANISOU 1750 CE LYS A 218 12891 11575 14284 -373 1062 -364 C \nATOM 1751 NZ LYS A 218 11.718 24.384 -74.569 1.00108.32 N \nANISOU 1751 NZ LYS A 218 13743 12375 15039 -262 1083 -321 N \nATOM 1752 N VAL A 219 12.118 21.153 -67.471 1.00 81.49 N \nANISOU 1752 N VAL A 219 10072 8980 11912 -277 895 -380 N \nATOM 1753 CA VAL A 219 12.707 20.995 -66.142 1.00 76.75 C \nANISOU 1753 CA VAL A 219 9465 8357 11339 -327 869 -395 C \nATOM 1754 C VAL A 219 14.235 20.943 -66.278 1.00 81.85 C \nANISOU 1754 C VAL A 219 10078 9017 12005 -447 864 -438 C \nATOM 1755 O VAL A 219 14.762 20.022 -66.897 1.00 81.97 O \nANISOU 1755 O VAL A 219 9975 9096 12073 -474 844 -468 O \nATOM 1756 CB VAL A 219 12.201 19.685 -65.489 1.00 72.57 C \nANISOU 1756 CB VAL A 219 8815 7879 10880 -280 822 -398 C \nATOM 1757 CG1 VAL A 219 12.731 19.524 -64.068 1.00 71.17 C \nANISOU 1757 CG1 VAL A 219 8633 7679 10728 -324 794 -410 C \nATOM 1758 CG2 VAL A 219 10.692 19.657 -65.496 1.00 68.85 C \nANISOU 1758 CG2 VAL A 219 8358 7416 10385 -167 827 -358 C \nATOM 1759 N ASN A 220 14.936 21.889 -65.641 1.00 98.59 N \nANISOU 1759 N ASN A 220 12298 11081 14081 -520 881 -441 N \nATOM 1760 CA ASN A 220 16.395 22.126 -65.837 1.00103.14 C \nANISOU 1760 CA ASN A 220 12865 11671 14652 -646 886 -478 C \nATOM 1761 C ASN A 220 16.733 22.486 -67.283 1.00100.26 C \nANISOU 1761 C ASN A 220 12512 11326 14255 -679 917 -486 C \nATOM 1762 O ASN A 220 17.722 22.022 -67.841 1.00 99.18 O \nANISOU 1762 O ASN A 220 12289 11250 14146 -750 908 -523 O \nATOM 1763 CB ASN A 220 17.235 20.918 -65.373 1.00112.72 C \nANISOU 1763 CB ASN A 220 13929 12954 15943 -688 839 -517 C \nATOM 1764 CG ASN A 220 17.151 20.686 -63.875 1.00119.36 C \nANISOU 1764 CG ASN A 220 14769 13774 16808 -681 810 -511 C \nATOM 1765 OD1 ASN A 220 16.783 21.591 -63.119 1.00124.55 O \nANISOU 1765 OD1 ASN A 220 15546 14363 17415 -677 828 -486 O \nATOM 1766 ND2 ASN A 220 17.489 19.469 -63.434 1.00117.49 N \nANISOU 1766 ND2 ASN A 220 14402 13594 16645 -679 764 -534 N \nATOM 1767 N GLY A 221 15.875 23.294 -67.891 1.00 98.07 N \nANISOU 1767 N GLY A 221 12342 11002 13920 -621 952 -452 N \nATOM 1768 CA GLY A 221 16.000 23.637 -69.302 1.00 95.97 C \nANISOU 1768 CA GLY A 221 12094 10751 13620 -637 982 -453 C \nATOM 1769 C GLY A 221 15.916 22.446 -70.239 1.00 93.61 C \nANISOU 1769 C GLY A 221 11641 10540 13385 -606 961 -473 C \nATOM 1770 O GLY A 221 16.405 22.515 -71.362 1.00106.84 O \nANISOU 1770 O GLY A 221 13297 12249 15047 -649 978 -489 O \nATOM 1771 N GLN A 222 15.262 21.370 -69.803 1.00 91.96 N \nANISOU 1771 N GLN A 222 11333 10369 13240 -531 925 -471 N \nATOM 1772 CA GLN A 222 15.137 20.140 -70.611 1.00 90.14 C \nANISOU 1772 CA GLN A 222 10959 10218 13071 -500 902 -492 C \nATOM 1773 C GLN A 222 13.700 19.562 -70.665 1.00 85.59 C \nANISOU 1773 C GLN A 222 10351 9658 12512 -383 890 -461 C \nATOM 1774 O GLN A 222 13.115 19.152 -69.659 1.00 80.28 O \nANISOU 1774 O GLN A 222 9661 8976 11863 -336 865 -447 O \nATOM 1775 CB GLN A 222 16.085 19.070 -70.094 1.00 86.34 C \nANISOU 1775 CB GLN A 222 10355 9788 12663 -551 861 -535 C \nATOM 1776 CG GLN A 222 15.988 17.748 -70.863 1.00 89.90 C \nANISOU 1776 CG GLN A 222 10667 10314 13177 -518 835 -560 C \nATOM 1777 CD GLN A 222 16.051 17.915 -72.388 1.00 89.03 C \nANISOU 1777 CD GLN A 222 10548 10238 13043 -527 864 -567 C \nATOM 1778 OE1 GLN A 222 15.174 17.461 -73.123 1.00 85.21 O \nANISOU 1778 OE1 GLN A 222 10030 9779 12566 -460 865 -554 O \nATOM 1779 NE2 GLN A 222 17.093 18.572 -72.859 1.00 93.89 N \nANISOU 1779 NE2 GLN A 222 11194 10857 13624 -615 888 -588 N \nATOM 1780 N SER A 223 13.148 19.534 -71.867 1.00 79.44 N \nANISOU 1780 N SER A 223 9561 8909 11716 -342 908 -450 N \nATOM 1781 CA SER A 223 11.767 19.125 -72.077 1.00 79.95 C \nANISOU 1781 CA SER A 223 9601 8998 11779 -237 903 -418 C \nATOM 1782 C SER A 223 11.603 17.597 -72.105 1.00 78.27 C \nANISOU 1782 C SER A 223 9242 8855 11644 -219 861 -442 C \nATOM 1783 O SER A 223 10.495 17.081 -72.015 1.00 86.57 O \nANISOU 1783 O SER A 223 10259 9932 12700 -144 848 -419 O \nATOM 1784 CB SER A 223 11.248 19.759 -73.381 1.00 78.27 C \nANISOU 1784 CB SER A 223 9438 8793 11509 -203 941 -395 C \nATOM 1785 OG SER A 223 10.438 20.896 -73.119 1.00 75.15 O \nANISOU 1785 OG SER A 223 9175 8340 11040 -141 970 -349 O \nATOM 1786 N GLY A 224 12.711 16.882 -72.229 1.00 68.91 N \nANISOU 1786 N GLY A 224 7973 7699 10511 -288 840 -488 N \nATOM 1787 CA GLY A 224 12.701 15.418 -72.277 1.00 53.20 C \nANISOU 1787 CA GLY A 224 5855 5765 8592 -276 800 -515 C \nATOM 1788 C GLY A 224 12.594 14.843 -70.917 1.00 46.52 C \nANISOU 1788 C GLY A 224 4985 4905 7787 -264 762 -513 C \nATOM 1789 O GLY A 224 12.633 15.579 -69.924 1.00 42.72 O \nANISOU 1789 O GLY A 224 4579 4373 7281 -272 767 -496 O \nATOM 1790 N ARG A 225 12.455 13.519 -70.861 1.00 44.29 N \nANISOU 1790 N ARG A 225 4602 4664 7564 -246 724 -533 N \nATOM 1791 CA ARG A 225 12.341 12.783 -69.594 1.00 41.24 C \nANISOU 1791 CA ARG A 225 4183 4268 7220 -236 682 -532 C \nATOM 1792 C ARG A 225 13.069 11.506 -69.703 1.00 36.75 C \nANISOU 1792 C ARG A 225 3513 3735 6718 -260 645 -576 C \nATOM 1793 O ARG A 225 13.314 10.985 -70.789 1.00 40.05 O \nANISOU 1793 O ARG A 225 3875 4193 7151 -266 648 -601 O \nATOM 1794 CB ARG A 225 10.860 12.491 -69.217 1.00 49.95 C \nANISOU 1794 CB ARG A 225 5292 5378 8310 -162 672 -493 C \nATOM 1795 CG ARG A 225 10.380 13.342 -68.081 1.00 67.45 C \nANISOU 1795 CG ARG A 225 7592 7548 10489 -139 680 -458 C \nATOM 1796 CD ARG A 225 9.510 14.468 -68.536 1.00 77.28 C \nANISOU 1796 CD ARG A 225 8924 8779 11661 -89 723 -418 C \nATOM 1797 NE ARG A 225 9.090 15.348 -67.432 1.00 82.06 N \nANISOU 1797 NE ARG A 225 9620 9334 12225 -63 733 -387 N \nATOM 1798 CZ ARG A 225 9.212 16.674 -67.441 1.00 75.68 C \nANISOU 1798 CZ ARG A 225 8924 8474 11357 -64 771 -369 C \nATOM 1799 NH1 ARG A 225 9.741 17.328 -68.471 1.00 66.84 N \nANISOU 1799 NH1 ARG A 225 7844 7344 10209 -95 804 -378 N \nATOM 1800 NH2 ARG A 225 8.782 17.358 -66.424 1.00 80.53 N \nANISOU 1800 NH2 ARG A 225 9617 9044 11936 -35 778 -343 N \nATOM 1801 N MET A 226 13.378 10.928 -68.561 1.00 40.22 N \nANISOU 1801 N MET A 226 3926 4160 7196 -269 607 -584 N \nATOM 1802 CA MET A 226 14.155 9.681 -68.523 1.00 43.79 C \nANISOU 1802 CA MET A 226 4286 4640 7710 -286 567 -625 C \nATOM 1803 C MET A 226 13.740 8.886 -67.304 1.00 45.61 C \nANISOU 1803 C MET A 226 4499 4854 7975 -262 523 -613 C \nATOM 1804 O MET A 226 13.954 9.334 -66.186 1.00 54.95 O \nANISOU 1804 O MET A 226 5720 6005 9153 -278 515 -601 O \nATOM 1805 CB MET A 226 15.644 10.021 -68.492 1.00 46.12 C \nANISOU 1805 CB MET A 226 4568 4942 8012 -350 572 -661 C \nATOM 1806 CG MET A 226 16.541 8.860 -68.809 1.00 52.90 C \nANISOU 1806 CG MET A 226 5332 5842 8925 -360 541 -709 C \nATOM 1807 SD MET A 226 18.210 9.431 -69.180 1.00 57.12 S \nANISOU 1807 SD MET A 226 5844 6411 9448 -435 559 -751 S \nATOM 1808 CE MET A 226 18.016 9.985 -70.865 1.00 44.87 C \nANISOU 1808 CE MET A 226 4306 4887 7857 -443 607 -756 C \nATOM 1809 N ASP A 227 13.126 7.721 -67.497 1.00 46.53 N \nANISOU 1809 N ASP A 227 4564 4991 8122 -229 495 -617 N \nATOM 1810 CA ASP A 227 12.693 6.901 -66.379 1.00 47.22 C \nANISOU 1810 CA ASP A 227 4637 5064 8239 -211 451 -605 C \nATOM 1811 C ASP A 227 13.675 5.748 -66.157 1.00 46.52 C \nANISOU 1811 C ASP A 227 4483 4982 8209 -226 408 -646 C \nATOM 1812 O ASP A 227 14.257 5.174 -67.102 1.00 46.09 O \nANISOU 1812 O ASP A 227 4380 4955 8177 -230 407 -682 O \nATOM 1813 CB ASP A 227 11.298 6.345 -66.630 1.00 55.85 C \nANISOU 1813 CB ASP A 227 5724 6175 9319 -169 445 -578 C \nATOM 1814 CG ASP A 227 10.218 7.450 -66.756 1.00 61.74 C \nANISOU 1814 CG ASP A 227 6534 6924 10002 -139 484 -533 C \nATOM 1815 OD1 ASP A 227 10.493 8.649 -66.379 1.00 66.58 O \nANISOU 1815 OD1 ASP A 227 7209 7507 10582 -148 512 -519 O \nATOM 1816 OD2 ASP A 227 9.099 7.093 -67.209 1.00 55.01 O \nANISOU 1816 OD2 ASP A 227 5668 6104 9128 -106 486 -513 O \nATOM 1817 N PHE A 228 13.863 5.392 -64.880 1.00 35.82 N \nANISOU 1817 N PHE A 228 3130 3602 6878 -230 372 -640 N \nATOM 1818 CA PHE A 228 14.728 4.318 -64.580 1.00 33.89 C \nANISOU 1818 CA PHE A 228 2831 3362 6685 -234 330 -674 C \nATOM 1819 C PHE A 228 14.051 3.170 -63.902 1.00 34.46 C \nANISOU 1819 C PHE A 228 2892 3418 6783 -209 284 -662 C \nATOM 1820 O PHE A 228 13.030 3.353 -63.284 1.00 46.57 O \nANISOU 1820 O PHE A 228 4462 4937 8295 -199 282 -624 O \nATOM 1821 CB PHE A 228 15.900 4.835 -63.747 1.00 33.96 C \nANISOU 1821 CB PHE A 228 2842 3363 6700 -270 324 -687 C \nATOM 1822 CG PHE A 228 16.835 5.669 -64.521 1.00 33.58 C \nANISOU 1822 CG PHE A 228 2789 3340 6631 -306 361 -711 C \nATOM 1823 CD1 PHE A 228 17.810 5.105 -65.293 1.00 34.04 C \nANISOU 1823 CD1 PHE A 228 2783 3437 6712 -312 355 -756 C \nATOM 1824 CD2 PHE A 228 16.679 7.031 -64.500 1.00 34.44 C \nANISOU 1824 CD2 PHE A 228 2962 3434 6690 -333 402 -688 C \nATOM 1825 CE1 PHE A 228 18.622 5.907 -66.070 1.00 38.03 C \nANISOU 1825 CE1 PHE A 228 3284 3975 7193 -351 391 -778 C \nATOM 1826 CE2 PHE A 228 17.478 7.839 -65.282 1.00 39.50 C \nANISOU 1826 CE2 PHE A 228 3607 4097 7304 -374 439 -708 C \nATOM 1827 CZ PHE A 228 18.464 7.281 -66.064 1.00 38.48 C \nANISOU 1827 CZ PHE A 228 3408 4015 7198 -387 433 -753 C \nATOM 1828 N PHE A 229 14.704 2.001 -63.922 1.00 34.85 N \nANISOU 1828 N PHE A 229 2896 3470 6878 -201 245 -695 N \nATOM 1829 CA PHE A 229 14.075 0.792 -63.412 1.00 38.39 C \nANISOU 1829 CA PHE A 229 3340 3898 7349 -181 201 -686 C \nATOM 1830 C PHE A 229 15.162 -0.085 -62.817 1.00 36.13 C \nANISOU 1830 C PHE A 229 3021 3599 7107 -175 155 -716 C \nATOM 1831 O PHE A 229 16.300 0.070 -63.143 1.00 32.60 O \nANISOU 1831 O PHE A 229 2540 3172 6672 -180 162 -750 O \nATOM 1832 CB PHE A 229 13.386 0.047 -64.561 1.00 37.74 C \nANISOU 1832 CB PHE A 229 3242 3833 7263 -164 205 -696 C \nATOM 1833 CG PHE A 229 12.232 0.762 -65.114 1.00 38.94 C \nANISOU 1833 CG PHE A 229 3420 4005 7369 -162 244 -664 C \nATOM 1834 CD1 PHE A 229 12.374 1.635 -66.167 1.00 42.78 C \nANISOU 1834 CD1 PHE A 229 3906 4518 7830 -166 291 -671 C \nATOM 1835 CD2 PHE A 229 10.979 0.551 -64.584 1.00 41.12 C \nANISOU 1835 CD2 PHE A 229 3722 4278 7623 -156 232 -626 C \nATOM 1836 CE1 PHE A 229 11.257 2.275 -66.715 1.00 42.91 C \nANISOU 1836 CE1 PHE A 229 3948 4556 7799 -156 326 -639 C \nATOM 1837 CE2 PHE A 229 9.847 1.178 -65.104 1.00 36.75 C \nANISOU 1837 CE2 PHE A 229 3187 3755 7020 -147 267 -594 C \nATOM 1838 CZ PHE A 229 9.992 2.032 -66.174 1.00 39.67 C \nANISOU 1838 CZ PHE A 229 3557 4149 7366 -143 313 -601 C \nATOM 1839 N TRP A 230 14.764 -1.038 -61.991 1.00 35.27 N \nANISOU 1839 N TRP A 230 2922 3461 7017 -163 110 -704 N \nATOM 1840 CA TRP A 230 15.712 -1.889 -61.343 1.00 37.34 C \nANISOU 1840 CA TRP A 230 3162 3707 7317 -150 64 -727 C \nATOM 1841 C TRP A 230 15.075 -3.239 -61.037 1.00 40.87 C \nANISOU 1841 C TRP A 230 3625 4121 7782 -131 18 -721 C \nATOM 1842 O TRP A 230 13.803 -3.317 -60.865 1.00 37.01 O \nANISOU 1842 O TRP A 230 3170 3621 7269 -142 18 -686 O \nATOM 1843 CB TRP A 230 16.169 -1.255 -60.070 1.00 34.42 C \nANISOU 1843 CB TRP A 230 2804 3328 6946 -169 53 -709 C \nATOM 1844 CG TRP A 230 15.119 -1.066 -59.018 1.00 35.22 C \nANISOU 1844 CG TRP A 230 2951 3402 7029 -181 42 -662 C \nATOM 1845 CD1 TRP A 230 14.203 -0.041 -58.945 1.00 35.60 C \nANISOU 1845 CD1 TRP A 230 3035 3453 7036 -196 79 -627 C \nATOM 1846 CD2 TRP A 230 14.866 -1.924 -57.868 1.00 34.97 C \nANISOU 1846 CD2 TRP A 230 2936 3338 7015 -176 -9 -644 C \nATOM 1847 NE1 TRP A 230 13.397 -0.208 -57.785 1.00 40.51 N \nANISOU 1847 NE1 TRP A 230 3690 4053 7650 -201 54 -590 N \nATOM 1848 CE2 TRP A 230 13.787 -1.346 -57.123 1.00 34.46 C \nANISOU 1848 CE2 TRP A 230 2911 3263 6918 -194 0 -599 C \nATOM 1849 CE3 TRP A 230 15.392 -3.175 -57.450 1.00 33.72 C \nANISOU 1849 CE3 TRP A 230 2764 3155 6892 -155 -63 -661 C \nATOM 1850 CZ2 TRP A 230 13.264 -1.934 -56.014 1.00 30.11 C \nANISOU 1850 CZ2 TRP A 230 2384 2688 6370 -199 -40 -573 C \nATOM 1851 CZ3 TRP A 230 14.939 -3.753 -56.263 1.00 29.67 C \nANISOU 1851 CZ3 TRP A 230 2281 2609 6384 -160 -106 -633 C \nATOM 1852 CH2 TRP A 230 13.856 -3.140 -55.572 1.00 31.67 C \nANISOU 1852 CH2 TRP A 230 2570 2858 6604 -186 -94 -589 C \nATOM 1853 N THR A 231 15.933 -4.269 -60.942 1.00 33.64 N \nANISOU 1853 N THR A 231 2689 3191 6901 -104 -22 -753 N \nATOM 1854 CA THR A 231 15.496 -5.569 -60.453 1.00 37.51 C \nANISOU 1854 CA THR A 231 3207 3637 7406 -89 -72 -747 C \nATOM 1855 C THR A 231 16.628 -6.265 -59.767 1.00 40.20 C \nANISOU 1855 C THR A 231 3533 3961 7781 -58 -117 -769 C \nATOM 1856 O THR A 231 17.802 -5.887 -59.912 1.00 43.98 O \nANISOU 1856 O THR A 231 3968 4473 8272 -44 -108 -798 O \nATOM 1857 CB THR A 231 14.932 -6.458 -61.563 1.00 38.54 C \nANISOU 1857 CB THR A 231 3347 3762 7535 -77 -71 -765 C \nATOM 1858 OG1 THR A 231 14.488 -7.695 -61.023 1.00 52.41 O \nANISOU 1858 OG1 THR A 231 5143 5470 9300 -71 -120 -757 O \nATOM 1859 CG2 THR A 231 15.973 -6.750 -62.593 1.00 38.26 C \nANISOU 1859 CG2 THR A 231 3271 3748 7519 -45 -61 -817 C \nATOM 1860 N ILE A 232 16.294 -7.268 -58.977 1.00 41.75 N \nANISOU 1860 N ILE A 232 3765 4110 7988 -49 -166 -754 N \nATOM 1861 CA ILE A 232 17.327 -8.154 -58.367 1.00 38.35 C \nANISOU 1861 CA ILE A 232 3328 3656 7588 -7 -216 -776 C \nATOM 1862 C ILE A 232 17.440 -9.389 -59.237 1.00 39.17 C \nANISOU 1862 C ILE A 232 3443 3734 7704 34 -235 -811 C \nATOM 1863 O ILE A 232 16.419 -9.985 -59.623 1.00 37.10 O \nANISOU 1863 O ILE A 232 3225 3442 7429 17 -238 -800 O \nATOM 1864 CB ILE A 232 16.944 -8.534 -56.950 1.00 32.72 C \nANISOU 1864 CB ILE A 232 2656 2900 6876 -20 -261 -738 C \nATOM 1865 CG1 ILE A 232 16.743 -7.262 -56.090 1.00 30.43 C \nANISOU 1865 CG1 ILE A 232 2360 2634 6568 -62 -238 -703 C \nATOM 1866 CG2 ILE A 232 17.945 -9.401 -56.322 1.00 30.69 C \nANISOU 1866 CG2 ILE A 232 2396 2620 6645 27 -311 -755 C \nATOM 1867 CD1 ILE A 232 17.835 -6.265 -56.129 1.00 30.00 C \nANISOU 1867 CD1 ILE A 232 2256 2628 6517 -63 -211 -722 C \nATOM 1868 N LEU A 233 18.659 -9.756 -59.589 1.00 41.02 N \nANISOU 1868 N LEU A 233 3640 3986 7960 85 -245 -854 N \nATOM 1869 CA LEU A 233 18.880 -10.935 -60.404 1.00 46.24 C \nANISOU 1869 CA LEU A 233 4316 4621 8633 133 -263 -892 C \nATOM 1870 C LEU A 233 19.456 -12.014 -59.568 1.00 47.91 C \nANISOU 1870 C LEU A 233 4555 4785 8863 185 -323 -898 C \nATOM 1871 O LEU A 233 20.593 -11.895 -59.125 1.00 58.04 O \nANISOU 1871 O LEU A 233 5794 6099 10160 223 -338 -914 O \nATOM 1872 CB LEU A 233 19.780 -10.629 -61.548 1.00 51.00 C \nANISOU 1872 CB LEU A 233 4857 5282 9241 163 -229 -940 C \nATOM 1873 CG LEU A 233 19.961 -11.731 -62.570 1.00 54.23 C \nANISOU 1873 CG LEU A 233 5279 5670 9656 213 -238 -984 C \nATOM 1874 CD1 LEU A 233 18.642 -12.045 -63.262 1.00 58.68 C \nANISOU 1874 CD1 LEU A 233 5895 6200 10201 173 -223 -970 C \nATOM 1875 CD2 LEU A 233 21.012 -11.322 -63.592 1.00 52.06 C \nANISOU 1875 CD2 LEU A 233 4930 5466 9384 243 -204 -1033 C \nATOM 1876 N LYS A 234 18.666 -13.064 -59.322 1.00 50.07 N \nANISOU 1876 N LYS A 234 4904 4988 9132 182 -359 -882 N \nATOM 1877 CA LYS A 234 19.071 -14.172 -58.434 1.00 51.88 C \nANISOU 1877 CA LYS A 234 5181 5156 9374 228 -421 -880 C \nATOM 1878 C LYS A 234 20.260 -14.951 -59.033 1.00 52.72 C \nANISOU 1878 C LYS A 234 5267 5265 9497 318 -437 -934 C \nATOM 1879 O LYS A 234 20.480 -14.927 -60.256 1.00 41.80 O \nANISOU 1879 O LYS A 234 3855 3912 8114 337 -404 -974 O \nATOM 1880 CB LYS A 234 17.925 -15.143 -58.268 1.00 56.93 C \nANISOU 1880 CB LYS A 234 5914 5719 9998 198 -449 -857 C \nATOM 1881 CG LYS A 234 16.618 -14.591 -57.739 1.00 57.51 C \nANISOU 1881 CG LYS A 234 6012 5793 10047 113 -437 -805 C \nATOM 1882 CD LYS A 234 16.608 -14.525 -56.225 1.00 64.40 C \nANISOU 1882 CD LYS A 234 6905 6644 10922 99 -475 -764 C \nATOM 1883 CE LYS A 234 15.196 -14.229 -55.719 1.00 71.43 C \nANISOU 1883 CE LYS A 234 7831 7528 11781 18 -469 -715 C \nATOM 1884 NZ LYS A 234 15.182 -13.814 -54.281 1.00 86.13 N \nANISOU 1884 NZ LYS A 234 9695 9389 13642 -4 -492 -675 N \nATOM 1885 N PRO A 235 21.047 -15.639 -58.169 1.00 65.80 N \nANISOU 1885 N PRO A 235 6939 6894 11168 379 -488 -937 N \nATOM 1886 CA PRO A 235 22.251 -16.385 -58.534 1.00 62.23 C \nANISOU 1886 CA PRO A 235 6467 6450 10728 479 -510 -985 C \nATOM 1887 C PRO A 235 22.243 -16.994 -59.916 1.00 65.71 C \nANISOU 1887 C PRO A 235 6921 6879 11165 514 -491 -1032 C \nATOM 1888 O PRO A 235 22.896 -16.434 -60.791 1.00 66.57 O \nANISOU 1888 O PRO A 235 6954 7064 11277 532 -452 -1068 O \nATOM 1889 CB PRO A 235 22.314 -17.404 -57.451 1.00 66.64 C \nANISOU 1889 CB PRO A 235 7098 6932 11290 518 -575 -965 C \nATOM 1890 CG PRO A 235 21.923 -16.595 -56.228 1.00 68.25 C \nANISOU 1890 CG PRO A 235 7292 7149 11492 450 -580 -912 C \nATOM 1891 CD PRO A 235 20.931 -15.570 -56.697 1.00 68.27 C \nANISOU 1891 CD PRO A 235 7275 7182 11481 358 -526 -892 C \nATOM 1892 N ASN A 236 21.500 -18.065 -60.178 1.00 66.24 N \nANISOU 1892 N ASN A 236 7085 6860 11223 515 -513 -1032 N \nATOM 1893 CA ASN A 236 21.591 -18.666 -61.533 1.00 70.64 C \nANISOU 1893 CA ASN A 236 7656 7408 11775 553 -494 -1082 C \nATOM 1894 C ASN A 236 20.518 -18.271 -62.536 1.00 66.68 C \nANISOU 1894 C ASN A 236 7162 6918 11258 474 -447 -1079 C \nATOM 1895 O ASN A 236 20.194 -19.037 -63.450 1.00 81.00 O \nANISOU 1895 O ASN A 236 9025 8692 13059 484 -442 -1108 O \nATOM 1896 CB ASN A 236 21.736 -20.201 -61.451 1.00 78.46 C \nANISOU 1896 CB ASN A 236 8748 8302 12762 624 -546 -1102 C \nATOM 1897 CG ASN A 236 23.169 -20.620 -61.196 1.00 79.28 C \nANISOU 1897 CG ASN A 236 8817 8428 12880 743 -575 -1136 C \nATOM 1898 OD1 ASN A 236 23.466 -21.253 -60.189 1.00 86.90 O \nANISOU 1898 OD1 ASN A 236 9830 9341 13846 789 -627 -1118 O \nATOM 1899 ND2 ASN A 236 24.075 -20.212 -62.078 1.00 76.88 N \nANISOU 1899 ND2 ASN A 236 8422 8209 12581 793 -541 -1183 N \nATOM 1900 N ASP A 237 20.000 -17.067 -62.409 1.00 61.70 N \nANISOU 1900 N ASP A 237 6480 6342 10622 398 -410 -1047 N \nATOM 1901 CA ASP A 237 18.993 -16.572 -63.356 1.00 55.44 C \nANISOU 1901 CA ASP A 237 5684 5572 9810 328 -362 -1041 C \nATOM 1902 C ASP A 237 19.713 -15.712 -64.375 1.00 55.60 C \nANISOU 1902 C ASP A 237 5612 5680 9835 344 -312 -1077 C \nATOM 1903 O ASP A 237 20.762 -15.147 -64.094 1.00 68.74 O \nANISOU 1903 O ASP A 237 7206 7398 11513 379 -307 -1090 O \nATOM 1904 CB ASP A 237 17.930 -15.781 -62.594 1.00 55.39 C \nANISOU 1904 CB ASP A 237 5685 5572 9788 242 -353 -982 C \nATOM 1905 CG ASP A 237 16.641 -15.552 -63.398 1.00 53.65 C \nANISOU 1905 CG ASP A 237 5485 5361 9539 171 -317 -966 C \nATOM 1906 OD1 ASP A 237 16.617 -15.683 -64.633 1.00 51.68 O \nANISOU 1906 OD1 ASP A 237 5223 5131 9283 178 -288 -1001 O \nATOM 1907 OD2 ASP A 237 15.652 -15.118 -62.757 1.00 51.65 O \nANISOU 1907 OD2 ASP A 237 5250 5107 9267 107 -315 -918 O \nATOM 1908 N ALA A 238 19.150 -15.615 -65.561 1.00 54.10 N \nANISOU 1908 N ALA A 238 5420 5506 9629 315 -273 -1094 N \nATOM 1909 CA ALA A 238 19.640 -14.710 -66.601 1.00 49.75 C \nANISOU 1909 CA ALA A 238 4786 5039 9077 313 -220 -1122 C \nATOM 1910 C ALA A 238 18.649 -13.575 -66.885 1.00 51.02 C \nANISOU 1910 C ALA A 238 4929 5240 9217 230 -174 -1085 C \nATOM 1911 O ALA A 238 17.418 -13.756 -66.714 1.00 45.36 O \nANISOU 1911 O ALA A 238 4267 4487 8481 178 -178 -1050 O \nATOM 1912 CB ALA A 238 19.859 -15.481 -67.864 1.00 51.14 C \nANISOU 1912 CB ALA A 238 4972 5211 9249 353 -209 -1175 C \nATOM 1913 N ILE A 239 19.180 -12.401 -67.296 1.00 45.63 N \nANISOU 1913 N ILE A 239 4171 4634 8534 218 -130 -1093 N \nATOM 1914 CA ILE A 239 18.340 -11.259 -67.641 1.00 39.85 C \nANISOU 1914 CA ILE A 239 3423 3939 7777 151 -84 -1060 C \nATOM 1915 C ILE A 239 18.495 -10.972 -69.089 1.00 43.78 C \nANISOU 1915 C ILE A 239 3882 4488 8264 150 -39 -1096 C \nATOM 1916 O ILE A 239 19.615 -10.983 -69.550 1.00 46.63 O \nANISOU 1916 O ILE A 239 4193 4887 8637 192 -32 -1139 O \nATOM 1917 CB ILE A 239 18.622 -10.027 -66.795 1.00 43.12 C \nANISOU 1917 CB ILE A 239 3803 4389 8192 124 -70 -1029 C \nATOM 1918 CG1 ILE A 239 17.780 -8.823 -67.317 1.00 46.00 C \nANISOU 1918 CG1 ILE A 239 4158 4792 8527 65 -18 -999 C \nATOM 1919 CG2 ILE A 239 20.074 -9.673 -66.830 1.00 44.21 C \nANISOU 1919 CG2 ILE A 239 3874 4579 8344 160 -65 -1065 C \nATOM 1920 CD1 ILE A 239 17.718 -7.675 -66.367 1.00 44.54 C \nANISOU 1920 CD1 ILE A 239 3967 4622 8334 31 -6 -959 C \nATOM 1921 N ASN A 240 17.362 -10.743 -69.819 1.00 45.25 N \nANISOU 1921 N ASN A 240 4089 4680 8424 103 -9 -1077 N \nATOM 1922 CA ASN A 240 17.395 -10.521 -71.278 1.00 49.64 C \nANISOU 1922 CA ASN A 240 4613 5283 8966 99 34 -1109 C \nATOM 1923 C ASN A 240 16.912 -9.103 -71.643 1.00 48.70 C \nANISOU 1923 C ASN A 240 4465 5219 8821 48 85 -1078 C \nATOM 1924 O ASN A 240 15.906 -8.637 -71.161 1.00 50.16 O \nANISOU 1924 O ASN A 240 4678 5395 8987 10 90 -1030 O \nATOM 1925 CB ASN A 240 16.510 -11.526 -72.008 1.00 58.76 C \nANISOU 1925 CB ASN A 240 5818 6404 10106 89 28 -1119 C \nATOM 1926 CG ASN A 240 16.804 -12.978 -71.635 1.00 62.31 C \nANISOU 1926 CG ASN A 240 6319 6784 10573 134 -24 -1145 C \nATOM 1927 OD1 ASN A 240 17.596 -13.665 -72.301 1.00 61.47 O \nANISOU 1927 OD1 ASN A 240 6204 6675 10477 186 -29 -1198 O \nATOM 1928 ND2 ASN A 240 16.169 -13.443 -70.565 1.00 65.22 N \nANISOU 1928 ND2 ASN A 240 6746 7095 10941 117 -63 -1108 N \nATOM 1929 N PHE A 241 17.653 -8.409 -72.475 1.00 46.56 N \nANISOU 1929 N PHE A 241 4140 5006 8546 51 123 -1106 N \nATOM 1930 CA PHE A 241 17.267 -7.087 -72.916 1.00 38.07 C \nANISOU 1930 CA PHE A 241 3046 3977 7443 7 172 -1080 C \nATOM 1931 C PHE A 241 17.042 -7.146 -74.400 1.00 41.17 C \nANISOU 1931 C PHE A 241 3421 4405 7816 0 207 -1106 C \nATOM 1932 O PHE A 241 17.846 -7.761 -75.121 1.00 44.17 O \nANISOU 1932 O PHE A 241 3773 4801 8209 33 205 -1159 O \nATOM 1933 CB PHE A 241 18.387 -6.057 -72.633 1.00 37.59 C \nANISOU 1933 CB PHE A 241 2939 3959 7385 3 190 -1087 C \nATOM 1934 CG PHE A 241 18.633 -5.777 -71.167 1.00 37.37 C \nANISOU 1934 CG PHE A 241 2923 3905 7370 1 162 -1058 C \nATOM 1935 CD1 PHE A 241 17.820 -4.876 -70.493 1.00 36.71 C \nANISOU 1935 CD1 PHE A 241 2873 3808 7267 -37 174 -1005 C \nATOM 1936 CD2 PHE A 241 19.641 -6.369 -70.489 1.00 36.04 C \nANISOU 1936 CD2 PHE A 241 2735 3729 7229 39 125 -1083 C \nATOM 1937 CE1 PHE A 241 17.968 -4.660 -69.165 1.00 35.93 C \nANISOU 1937 CE1 PHE A 241 2789 3684 7178 -41 149 -978 C \nATOM 1938 CE2 PHE A 241 19.860 -6.094 -69.130 1.00 36.46 C \nANISOU 1938 CE2 PHE A 241 2799 3762 7293 33 99 -1055 C \nATOM 1939 CZ PHE A 241 19.015 -5.266 -68.465 1.00 36.15 C \nANISOU 1939 CZ PHE A 241 2794 3704 7235 -9 110 -1003 C \nATOM 1940 N GLU A 242 16.027 -6.421 -74.866 1.00 39.06 N \nANISOU 1940 N GLU A 242 3168 4158 7516 -38 240 -1071 N \nATOM 1941 CA GLU A 242 15.815 -6.246 -76.259 1.00 42.07 C \nANISOU 1941 CA GLU A 242 3529 4582 7873 -51 279 -1090 C \nATOM 1942 C GLU A 242 15.242 -4.848 -76.518 1.00 46.74 C \nANISOU 1942 C GLU A 242 4120 5210 8428 -87 323 -1048 C \nATOM 1943 O GLU A 242 14.266 -4.424 -75.908 1.00 59.79 O \nANISOU 1943 O GLU A 242 5806 6849 10062 -104 323 -998 O \nATOM 1944 CB GLU A 242 14.842 -7.337 -76.785 1.00 44.99 C \nANISOU 1944 CB GLU A 242 3932 4930 8232 -54 264 -1095 C \nATOM 1945 CG GLU A 242 14.858 -7.464 -78.316 1.00 46.39 C \nANISOU 1945 CG GLU A 242 4085 5151 8392 -59 298 -1130 C \nATOM 1946 CD GLU A 242 13.673 -8.165 -78.911 1.00 49.27 C \nANISOU 1946 CD GLU A 242 4482 5509 8730 -82 296 -1122 C \nATOM 1947 OE1 GLU A 242 13.356 -7.836 -80.046 1.00 49.46 O \nANISOU 1947 OE1 GLU A 242 4486 5580 8726 -100 332 -1128 O \nATOM 1948 OE2 GLU A 242 13.076 -9.032 -78.247 1.00 61.52 O \nANISOU 1948 OE2 GLU A 242 6078 7013 10285 -85 259 -1108 O \nATOM 1949 N SER A 243 15.795 -4.148 -77.486 1.00 42.13 N \nANISOU 1949 N SER A 243 3502 4676 7830 -97 363 -1069 N \nATOM 1950 CA SER A 243 15.302 -2.832 -77.807 1.00 38.21 C \nANISOU 1950 CA SER A 243 3014 4209 7295 -127 406 -1031 C \nATOM 1951 C SER A 243 15.821 -2.365 -79.121 1.00 43.25 C \nANISOU 1951 C SER A 243 3617 4901 7915 -140 447 -1061 C \nATOM 1952 O SER A 243 16.949 -2.784 -79.571 1.00 51.24 O \nANISOU 1952 O SER A 243 4587 5936 8947 -127 444 -1115 O \nATOM 1953 CB SER A 243 15.747 -1.832 -76.769 1.00 35.93 C \nANISOU 1953 CB SER A 243 2737 3908 7007 -139 408 -1004 C \nATOM 1954 OG SER A 243 15.325 -0.499 -77.110 1.00 32.44 O \nANISOU 1954 OG SER A 243 2315 3488 6522 -165 452 -969 O \nATOM 1955 N ASN A 244 15.024 -1.456 -79.714 1.00 35.25 N \nANISOU 1955 N ASN A 244 2622 3911 6859 -162 484 -1026 N \nATOM 1956 CA ASN A 244 15.378 -0.862 -80.976 1.00 38.02 C \nANISOU 1956 CA ASN A 244 2949 4313 7184 -180 527 -1045 C \nATOM 1957 C ASN A 244 15.324 0.610 -80.887 1.00 38.19 C \nANISOU 1957 C ASN A 244 2996 4344 7169 -206 562 -1006 C \nATOM 1958 O ASN A 244 15.188 1.335 -81.879 1.00 35.10 O \nANISOU 1958 O ASN A 244 2605 3988 6741 -224 601 -1000 O \nATOM 1959 CB ASN A 244 14.476 -1.391 -82.064 1.00 38.34 C \nANISOU 1959 CB ASN A 244 2987 4378 7204 -180 538 -1048 C \nATOM 1960 CG ASN A 244 13.103 -0.897 -81.932 1.00 32.83 C \nANISOU 1960 CG ASN A 244 2327 3678 6468 -185 549 -989 C \nATOM 1961 OD1 ASN A 244 12.616 -0.641 -80.861 1.00 36.73 O \nANISOU 1961 OD1 ASN A 244 2853 4141 6962 -179 533 -949 O \nATOM 1962 ND2 ASN A 244 12.472 -0.716 -83.050 1.00 33.11 N \nANISOU 1962 ND2 ASN A 244 2357 3755 6467 -195 578 -982 N \nATOM 1963 N GLY A 245 15.443 1.071 -79.660 1.00 41.56 N \nANISOU 1963 N GLY A 245 3451 4736 7605 -207 547 -980 N \nATOM 1964 CA GLY A 245 15.446 2.496 -79.450 1.00 53.88 C \nANISOU 1964 CA GLY A 245 5049 6295 9129 -231 580 -943 C \nATOM 1965 C GLY A 245 15.104 2.897 -78.032 1.00 53.82 C \nANISOU 1965 C GLY A 245 5086 6240 9124 -226 561 -902 C \nATOM 1966 O GLY A 245 14.464 2.187 -77.245 1.00 65.22 O \nANISOU 1966 O GLY A 245 6539 7655 10588 -203 527 -886 O \nATOM 1967 N ASN A 246 15.543 4.098 -77.752 1.00 50.95 N \nANISOU 1967 N ASN A 246 4754 5871 8735 -253 586 -886 N \nATOM 1968 CA ASN A 246 15.427 4.749 -76.467 1.00 43.44 C \nANISOU 1968 CA ASN A 246 3850 4877 7777 -257 578 -850 C \nATOM 1969 C ASN A 246 15.833 4.006 -75.260 1.00 38.67 C \nANISOU 1969 C ASN A 246 3229 4245 7218 -247 533 -861 C \nATOM 1970 O ASN A 246 15.357 4.302 -74.186 1.00 42.74 O \nANISOU 1970 O ASN A 246 3785 4724 7730 -240 520 -825 O \nATOM 1971 CB ASN A 246 14.038 5.359 -76.240 1.00 45.22 C \nANISOU 1971 CB ASN A 246 4136 5082 7964 -235 592 -792 C \nATOM 1972 CG ASN A 246 13.448 5.906 -77.490 1.00 47.18 C \nANISOU 1972 CG ASN A 246 4397 5361 8167 -232 632 -778 C \nATOM 1973 OD1 ASN A 246 13.648 5.345 -78.534 1.00 46.91 O \nANISOU 1973 OD1 ASN A 246 4319 5364 8141 -236 637 -809 O \nATOM 1974 ND2 ASN A 246 12.823 7.070 -77.403 1.00 49.47 N \nANISOU 1974 ND2 ASN A 246 4753 5637 8407 -226 662 -732 N \nATOM 1975 N PHE A 247 16.772 3.093 -75.399 1.00 42.85 N \nANISOU 1975 N PHE A 247 3701 4794 7787 -243 509 -910 N \nATOM 1976 CA PHE A 247 17.227 2.240 -74.322 1.00 44.25 C \nANISOU 1976 CA PHE A 247 3858 4947 8007 -226 462 -924 C \nATOM 1977 C PHE A 247 18.432 2.877 -73.626 1.00 49.11 C \nANISOU 1977 C PHE A 247 4464 5570 8624 -257 461 -937 C \nATOM 1978 O PHE A 247 19.381 3.363 -74.269 1.00 59.38 O \nANISOU 1978 O PHE A 247 5737 6915 9911 -288 486 -966 O \nATOM 1979 CB PHE A 247 17.684 0.941 -74.911 1.00 48.32 C \nANISOU 1979 CB PHE A 247 4320 5482 8558 -199 438 -974 C \nATOM 1980 CG PHE A 247 18.127 -0.083 -73.882 1.00 52.93 C \nANISOU 1980 CG PHE A 247 4887 6038 9185 -171 386 -990 C \nATOM 1981 CD1 PHE A 247 17.610 -0.080 -72.610 1.00 52.39 C \nANISOU 1981 CD1 PHE A 247 4857 5924 9126 -167 359 -952 C \nATOM 1982 CD2 PHE A 247 19.049 -1.053 -74.208 1.00 49.30 C \nANISOU 1982 CD2 PHE A 247 4376 5600 8756 -144 364 -1042 C \nATOM 1983 CE1 PHE A 247 17.981 -1.042 -71.705 1.00 53.39 C \nANISOU 1983 CE1 PHE A 247 4972 6024 9289 -140 311 -964 C \nATOM 1984 CE2 PHE A 247 19.440 -1.982 -73.288 1.00 49.55 C \nANISOU 1984 CE2 PHE A 247 4399 5603 8823 -112 316 -1055 C \nATOM 1985 CZ PHE A 247 18.902 -1.988 -72.039 1.00 50.46 C \nANISOU 1985 CZ PHE A 247 4555 5670 8947 -112 289 -1015 C \nATOM 1986 N ILE A 248 18.380 2.899 -72.311 1.00 41.62 N \nANISOU 1986 N ILE A 248 3540 4585 7689 -254 434 -914 N \nATOM 1987 CA ILE A 248 19.445 3.402 -71.522 1.00 39.00 C \nANISOU 1987 CA ILE A 248 3199 4261 7358 -285 429 -924 C \nATOM 1988 C ILE A 248 19.989 2.134 -70.881 1.00 39.66 C \nANISOU 1988 C ILE A 248 3237 4343 7491 -249 377 -952 C \nATOM 1989 O ILE A 248 19.564 1.729 -69.804 1.00 34.43 O \nANISOU 1989 O ILE A 248 2597 3638 6848 -231 343 -928 O \nATOM 1990 CB ILE A 248 18.989 4.398 -70.457 1.00 41.97 C \nANISOU 1990 CB ILE A 248 3642 4595 7709 -308 436 -876 C \nATOM 1991 CG1 ILE A 248 18.093 5.494 -71.016 1.00 48.08 C \nANISOU 1991 CG1 ILE A 248 4479 5355 8433 -321 482 -839 C \nATOM 1992 CG2 ILE A 248 20.178 5.060 -69.852 1.00 42.16 C \nANISOU 1992 CG2 ILE A 248 3658 4638 7724 -355 439 -890 C \nATOM 1993 CD1 ILE A 248 18.723 6.290 -72.144 1.00 52.08 C \nANISOU 1993 CD1 ILE A 248 4981 5901 8905 -361 525 -859 C \nATOM 1994 N ALA A 249 21.005 1.532 -71.549 1.00 41.78 N \nANISOU 1994 N ALA A 249 3439 4660 7776 -238 371 -1004 N \nATOM 1995 CA ALA A 249 21.548 0.237 -71.147 1.00 36.26 C \nANISOU 1995 CA ALA A 249 2697 3961 7120 -191 324 -1036 C \nATOM 1996 C ALA A 249 22.470 0.312 -69.948 1.00 41.65 C \nANISOU 1996 C ALA A 249 3361 4652 7814 -197 295 -1039 C \nATOM 1997 O ALA A 249 23.133 1.312 -69.725 1.00 42.35 O \nANISOU 1997 O ALA A 249 3444 4772 7875 -246 317 -1037 O \nATOM 1998 CB ALA A 249 22.312 -0.377 -72.300 1.00 42.13 C \nANISOU 1998 CB ALA A 249 3378 4758 7869 -169 330 -1091 C \nATOM 1999 N PRO A 250 22.530 -0.770 -69.174 1.00 39.14 N \nANISOU 1999 N PRO A 250 3035 4305 7532 -150 246 -1044 N \nATOM 2000 CA PRO A 250 23.442 -0.906 -68.080 1.00 42.07 C \nANISOU 2000 CA PRO A 250 3379 4688 7916 -145 213 -1051 C \nATOM 2001 C PRO A 250 24.829 -1.285 -68.522 1.00 49.15 C \nANISOU 2001 C PRO A 250 4197 5661 8818 -125 206 -1106 C \nATOM 2002 O PRO A 250 25.002 -1.804 -69.597 1.00 46.91 O \nANISOU 2002 O PRO A 250 3881 5405 8537 -97 216 -1142 O \nATOM 2003 CB PRO A 250 22.851 -2.055 -67.267 1.00 39.60 C \nANISOU 2003 CB PRO A 250 3095 4313 7639 -95 161 -1036 C \nATOM 2004 CG PRO A 250 22.022 -2.817 -68.180 1.00 36.69 C \nANISOU 2004 CG PRO A 250 2744 3918 7279 -65 164 -1043 C \nATOM 2005 CD PRO A 250 21.637 -1.920 -69.314 1.00 37.61 C \nANISOU 2005 CD PRO A 250 2865 4062 7364 -103 219 -1040 C \nATOM 2006 N GLU A 251 25.826 -0.896 -67.727 1.00 62.69 N \nANISOU 2006 N GLU A 251 5877 7418 10524 -146 195 -1112 N \nATOM 2007 CA GLU A 251 27.207 -1.318 -67.902 1.00 59.71 C \nANISOU 2007 CA GLU A 251 5415 7124 10148 -121 181 -1162 C \nATOM 2008 C GLU A 251 27.603 -1.962 -66.620 1.00 56.47 C \nANISOU 2008 C GLU A 251 4996 6700 9762 -82 129 -1155 C \nATOM 2009 O GLU A 251 28.177 -3.025 -66.627 1.00 60.79 O \nANISOU 2009 O GLU A 251 5500 7266 10330 -11 94 -1188 O \nATOM 2010 CB GLU A 251 28.122 -0.139 -68.173 1.00 68.00 C \nANISOU 2010 CB GLU A 251 6425 8258 11153 -195 220 -1175 C \nATOM 2011 CG GLU A 251 29.577 -0.559 -68.408 1.00 75.39 C \nANISOU 2011 CG GLU A 251 7261 9300 12082 -170 207 -1229 C \nATOM 2012 CD GLU A 251 30.484 0.558 -68.894 1.00 68.45 C \nANISOU 2012 CD GLU A 251 6338 8518 11151 -252 249 -1248 C \nATOM 2013 OE1 GLU A 251 30.020 1.706 -69.015 1.00 70.72 O \nANISOU 2013 OE1 GLU A 251 6682 8782 11408 -331 288 -1218 O \nATOM 2014 OE2 GLU A 251 31.648 0.262 -69.189 1.00 68.94 O \nANISOU 2014 OE2 GLU A 251 6313 8682 11201 -236 243 -1293 O \nATOM 2015 N TYR A 252 27.266 -1.324 -65.508 1.00 51.10 N \nANISOU 2015 N TYR A 252 4358 5983 9074 -125 122 -1113 N \nATOM 2016 CA TYR A 252 27.629 -1.796 -64.193 1.00 57.67 C \nANISOU 2016 CA TYR A 252 5185 6803 9924 -99 74 -1101 C \nATOM 2017 C TYR A 252 26.419 -2.213 -63.343 1.00 59.95 C \nANISOU 2017 C TYR A 252 5551 6989 10237 -82 46 -1055 C \nATOM 2018 O TYR A 252 25.373 -1.581 -63.379 1.00 66.96 O \nANISOU 2018 O TYR A 252 6501 7828 11115 -121 72 -1019 O \nATOM 2019 CB TYR A 252 28.366 -0.694 -63.436 1.00 57.87 C \nANISOU 2019 CB TYR A 252 5191 6880 9916 -171 86 -1090 C \nATOM 2020 CG TYR A 252 29.678 -0.337 -63.997 1.00 57.88 C \nANISOU 2020 CG TYR A 252 5110 6994 9887 -195 105 -1134 C \nATOM 2021 CD1 TYR A 252 30.781 -1.201 -63.868 1.00 65.71 C \nANISOU 2021 CD1 TYR A 252 6020 8059 10890 -134 69 -1173 C \nATOM 2022 CD2 TYR A 252 29.855 0.855 -64.666 1.00 60.00 C \nANISOU 2022 CD2 TYR A 252 5381 7305 10113 -277 157 -1137 C \nATOM 2023 CE1 TYR A 252 32.015 -0.876 -64.390 1.00 65.07 C \nANISOU 2023 CE1 TYR A 252 5851 8098 10774 -156 87 -1215 C \nATOM 2024 CE2 TYR A 252 31.085 1.180 -65.191 1.00 65.66 C \nANISOU 2024 CE2 TYR A 252 6018 8135 10796 -308 175 -1178 C \nATOM 2025 CZ TYR A 252 32.147 0.310 -65.051 1.00 68.28 C \nANISOU 2025 CZ TYR A 252 6259 8546 11137 -248 140 -1217 C \nATOM 2026 OH TYR A 252 33.347 0.684 -65.592 1.00 90.51 O \nANISOU 2026 OH TYR A 252 8990 11487 13912 -283 160 -1257 O \nATOM 2027 N ALA A 253 26.586 -3.291 -62.595 1.00 58.13 N \nANISOU 2027 N ALA A 253 5317 6734 10037 -21 -7 -1056 N \nATOM 2028 CA ALA A 253 25.551 -3.784 -61.712 1.00 57.79 C \nANISOU 2028 CA ALA A 253 5342 6601 10014 -7 -40 -1015 C \nATOM 2029 C ALA A 253 26.183 -3.859 -60.361 1.00 52.62 C \nANISOU 2029 C ALA A 253 4673 5956 9364 -4 -79 -1002 C \nATOM 2030 O ALA A 253 27.357 -3.685 -60.256 1.00 56.22 O \nANISOU 2030 O ALA A 253 5065 6487 9809 -2 -83 -1029 O \nATOM 2031 CB ALA A 253 25.060 -5.155 -62.176 1.00 59.01 C \nANISOU 2031 CB ALA A 253 5519 6705 10197 63 -69 -1029 C \nATOM 2032 N TYR A 254 25.411 -4.172 -59.352 1.00 51.59 N \nANISOU 2032 N TYR A 254 4600 5755 9247 -2 -110 -963 N \nATOM 2033 CA TYR A 254 25.876 -4.196 -57.991 1.00 56.12 C \nANISOU 2033 CA TYR A 254 5169 6332 9823 -4 -148 -944 C \nATOM 2034 C TYR A 254 25.610 -5.549 -57.354 1.00 62.18 C \nANISOU 2034 C TYR A 254 5965 7039 10621 62 -207 -935 C \nATOM 2035 O TYR A 254 24.465 -5.954 -57.202 1.00 65.79 O \nANISOU 2035 O TYR A 254 6488 7421 11088 62 -217 -907 O \nATOM 2036 CB TYR A 254 25.145 -3.125 -57.199 1.00 59.43 C \nANISOU 2036 CB TYR A 254 5639 6719 10222 -77 -127 -898 C \nATOM 2037 CG TYR A 254 25.498 -1.727 -57.621 1.00 61.71 C \nANISOU 2037 CG TYR A 254 5912 7061 10474 -147 -73 -903 C \nATOM 2038 CD1 TYR A 254 24.728 -1.048 -58.558 1.00 63.42 C \nANISOU 2038 CD1 TYR A 254 6163 7261 10674 -178 -23 -896 C \nATOM 2039 CD2 TYR A 254 26.600 -1.078 -57.081 1.00 62.98 C \nANISOU 2039 CD2 TYR A 254 6029 7288 10613 -186 -71 -914 C \nATOM 2040 CE1 TYR A 254 25.056 0.230 -58.964 1.00 65.59 C \nANISOU 2040 CE1 TYR A 254 6435 7576 10911 -242 26 -900 C \nATOM 2041 CE2 TYR A 254 26.935 0.198 -57.466 1.00 63.16 C \nANISOU 2041 CE2 TYR A 254 6047 7354 10596 -259 -22 -918 C \nATOM 2042 CZ TYR A 254 26.163 0.850 -58.403 1.00 65.72 C \nANISOU 2042 CZ TYR A 254 6413 7653 10904 -286 27 -911 C \nATOM 2043 OH TYR A 254 26.473 2.122 -58.791 1.00 62.16 O \nANISOU 2043 OH TYR A 254 5971 7237 10410 -359 76 -914 O \nATOM 2044 N LYS A 255 26.673 -6.235 -56.961 1.00 67.86 N \nANISOU 2044 N LYS A 255 6637 7795 11350 118 -247 -959 N \nATOM 2045 CA LYS A 255 26.570 -7.496 -56.268 1.00 63.46 C \nANISOU 2045 CA LYS A 255 6113 7182 10818 184 -306 -950 C \nATOM 2046 C LYS A 255 26.276 -7.243 -54.836 1.00 57.48 C \nANISOU 2046 C LYS A 255 5388 6393 10058 149 -333 -905 C \nATOM 2047 O LYS A 255 26.908 -6.415 -54.240 1.00 61.55 O \nANISOU 2047 O LYS A 255 5866 6965 10557 109 -325 -900 O \nATOM 2048 CB LYS A 255 27.916 -8.161 -56.297 1.00 68.69 C \nANISOU 2048 CB LYS A 255 6707 7908 11484 259 -337 -990 C \nATOM 2049 CG LYS A 255 27.935 -9.502 -56.980 1.00 75.70 C \nANISOU 2049 CG LYS A 255 7613 8758 12392 351 -363 -1021 C \nATOM 2050 CD LYS A 255 29.125 -10.341 -56.528 1.00 73.06 C \nANISOU 2050 CD LYS A 255 7233 8466 12062 442 -411 -1046 C \nATOM 2051 CE LYS A 255 30.365 -10.092 -57.361 1.00 69.76 C \nANISOU 2051 CE LYS A 255 6715 8165 11627 473 -388 -1098 C \nATOM 2052 NZ LYS A 255 31.521 -10.829 -56.789 1.00 67.71 N \nANISOU 2052 NZ LYS A 255 6405 7957 11364 564 -436 -1118 N \nATOM 2053 N ILE A 256 25.360 -7.975 -54.247 1.00 57.07 N \nANISOU 2053 N ILE A 256 5407 6256 10021 162 -367 -874 N \nATOM 2054 CA ILE A 256 25.111 -7.717 -52.850 1.00 61.63 C \nANISOU 2054 CA ILE A 256 6013 6809 10594 127 -393 -832 C \nATOM 2055 C ILE A 256 25.877 -8.631 -51.872 1.00 71.73 C \nANISOU 2055 C ILE A 256 7282 8087 11886 187 -456 -831 C \nATOM 2056 O ILE A 256 25.565 -9.805 -51.678 1.00 77.82 O \nANISOU 2056 O ILE A 256 8101 8794 12674 240 -500 -825 O \nATOM 2057 CB ILE A 256 23.619 -7.573 -52.512 1.00 57.40 C \nANISOU 2057 CB ILE A 256 5556 6199 10056 79 -386 -787 C \nATOM 2058 CG1 ILE A 256 23.202 -8.511 -51.404 1.00 57.83 C \nANISOU 2058 CG1 ILE A 256 5664 6189 10121 99 -444 -756 C \nATOM 2059 CG2 ILE A 256 22.770 -7.696 -53.749 1.00 57.15 C \nANISOU 2059 CG2 ILE A 256 5549 6142 10023 76 -352 -798 C \nATOM 2060 CD1 ILE A 256 23.422 -7.919 -50.044 1.00 57.48 C \nANISOU 2060 CD1 ILE A 256 5615 6158 10066 61 -460 -725 C \nATOM 2061 N VAL A 257 26.851 -8.021 -51.222 1.00 80.33 N \nANISOU 2061 N VAL A 257 8314 9248 12962 171 -459 -834 N \nATOM 2062 CA VAL A 257 27.579 -8.646 -50.130 1.00 83.26 C \nANISOU 2062 CA VAL A 257 8669 9629 13337 215 -516 -826 C \nATOM 2063 C VAL A 257 28.063 -7.530 -49.221 1.00 88.38 C \nANISOU 2063 C VAL A 257 9280 10339 13961 146 -505 -808 C \nATOM 2064 O VAL A 257 28.969 -6.787 -49.603 1.00104.19 O \nANISOU 2064 O VAL A 257 11211 12433 15944 123 -475 -836 O \nATOM 2065 CB VAL A 257 28.730 -9.536 -50.648 1.00 80.34 C \nANISOU 2065 CB VAL A 257 8242 9310 12974 314 -543 -870 C \nATOM 2066 CG1 VAL A 257 29.776 -8.759 -51.477 1.00 68.45 C \nANISOU 2066 CG1 VAL A 257 6641 7921 11448 303 -501 -913 C \nATOM 2067 CG2 VAL A 257 29.336 -10.305 -49.477 1.00 79.74 C \nANISOU 2067 CG2 VAL A 257 8164 9233 12901 372 -607 -856 C \nATOM 2068 N LYS A 258 27.476 -7.369 -48.038 1.00 87.02 N \nANISOU 2068 N LYS A 258 9156 10120 13786 106 -525 -765 N \nATOM 2069 CA LYS A 258 26.626 -8.350 -47.395 1.00 86.21 C \nANISOU 2069 CA LYS A 258 9129 9925 13702 134 -571 -733 C \nATOM 2070 C LYS A 258 25.254 -7.799 -47.013 1.00 81.73 C \nANISOU 2070 C LYS A 258 8632 9294 13129 61 -549 -691 C \nATOM 2071 O LYS A 258 24.976 -6.606 -47.171 1.00 71.80 O \nANISOU 2071 O LYS A 258 7369 8061 11852 -7 -499 -686 O \nATOM 2072 CB LYS A 258 27.309 -8.816 -46.127 1.00103.83 C \nANISOU 2072 CB LYS A 258 11347 12170 15933 163 -628 -716 C \nATOM 2073 CG LYS A 258 27.348 -7.737 -45.058 1.00117.47 C \nANISOU 2073 CG LYS A 258 13065 13930 17638 81 -617 -687 C \nATOM 2074 CD LYS A 258 28.287 -8.078 -43.920 1.00130.63 C \nANISOU 2074 CD LYS A 258 14696 15638 19298 109 -668 -678 C \nATOM 2075 CE LYS A 258 29.733 -7.830 -44.323 1.00136.65 C \nANISOU 2075 CE LYS A 258 15358 16517 20046 137 -661 -719 C \nATOM 2076 NZ LYS A 258 30.690 -8.098 -43.210 1.00137.33 N \nANISOU 2076 NZ LYS A 258 15400 16660 20119 163 -710 -710 N \nATOM 2077 N LYS A 259 24.395 -8.697 -46.523 1.00 82.94 N \nANISOU 2077 N LYS A 259 8854 9366 13293 77 -588 -663 N \nATOM 2078 CA LYS A 259 23.065 -8.337 -45.998 1.00 79.36 C \nANISOU 2078 CA LYS A 259 8466 8858 12829 14 -576 -620 C \nATOM 2079 C LYS A 259 23.024 -8.307 -44.461 1.00 82.10 C \nANISOU 2079 C LYS A 259 8835 9193 13168 -13 -615 -582 C \nATOM 2080 O LYS A 259 23.202 -9.341 -43.822 1.00 74.71 O \nANISOU 2080 O LYS A 259 7922 8222 12243 29 -672 -571 O \nATOM 2081 CB LYS A 259 21.983 -9.289 -46.500 1.00 73.13 C \nANISOU 2081 CB LYS A 259 7743 7995 12049 31 -589 -611 C \nATOM 2082 CG LYS A 259 21.471 -8.990 -47.880 1.00 75.57 C \nANISOU 2082 CG LYS A 259 8048 8308 12355 23 -538 -633 C \nATOM 2083 CD LYS A 259 19.977 -9.248 -48.020 1.00 77.04 C \nANISOU 2083 CD LYS A 259 8302 8438 12532 -11 -531 -605 C \nATOM 2084 CE LYS A 259 19.473 -9.016 -49.428 1.00 79.83 C \nANISOU 2084 CE LYS A 259 8650 8800 12880 -14 -483 -626 C \nATOM 2085 NZ LYS A 259 19.985 -10.057 -50.377 1.00 89.80 N \nANISOU 2085 NZ LYS A 259 9907 10049 14162 49 -500 -665 N \nATOM 2086 N GLY A 260 22.777 -7.124 -43.884 1.00 78.45 N \nANISOU 2086 N GLY A 260 8369 8754 12684 -83 -583 -562 N \nATOM 2087 CA GLY A 260 22.634 -6.977 -42.431 1.00 78.02 C \nANISOU 2087 CA GLY A 260 8337 8688 12618 -117 -613 -525 C \nATOM 2088 C GLY A 260 21.673 -5.868 -42.049 1.00 84.27 C \nANISOU 2088 C GLY A 260 9163 9471 13384 -192 -571 -497 C \nATOM 2089 O GLY A 260 20.662 -5.667 -42.699 1.00 98.23 O \nANISOU 2089 O GLY A 260 10965 11213 15146 -207 -538 -491 O \nATOM 2090 N ASP A 261 21.982 -5.149 -40.985 1.00 79.78 N \nANISOU 2090 N ASP A 261 8588 8928 12797 -235 -573 -480 N \nATOM 2091 CA ASP A 261 21.107 -4.106 -40.519 1.00 79.06 C \nANISOU 2091 CA ASP A 261 8535 8827 12678 -299 -536 -454 C \nATOM 2092 C ASP A 261 21.623 -2.793 -41.068 1.00 76.98 C \nANISOU 2092 C ASP A 261 8244 8612 12394 -336 -478 -477 C \nATOM 2093 O ASP A 261 22.825 -2.615 -41.257 1.00 80.79 O \nANISOU 2093 O ASP A 261 8670 9148 12877 -331 -478 -505 O \nATOM 2094 CB ASP A 261 21.045 -4.073 -38.981 1.00 83.16 C \nANISOU 2094 CB ASP A 261 9075 9338 13184 -331 -571 -420 C \nATOM 2095 CG ASP A 261 20.099 -5.135 -38.382 1.00 87.72 C \nANISOU 2095 CG ASP A 261 9703 9857 13769 -318 -617 -387 C \nATOM 2096 OD1 ASP A 261 19.062 -5.473 -39.013 1.00100.06 O \nANISOU 2096 OD1 ASP A 261 11302 11384 15333 -311 -605 -380 O \nATOM 2097 OD2 ASP A 261 20.375 -5.617 -37.260 1.00 78.78 O \nANISOU 2097 OD2 ASP A 261 8578 8718 12638 -319 -666 -367 O \nATOM 2098 N SER A 262 20.706 -1.872 -41.315 1.00 78.08 N \nANISOU 2098 N SER A 262 8423 8735 12509 -372 -428 -465 N \nATOM 2099 CA SER A 262 21.036 -0.536 -41.746 1.00 76.25 C \nANISOU 2099 CA SER A 262 8186 8537 12250 -415 -370 -480 C \nATOM 2100 C SER A 262 19.753 0.305 -41.717 1.00 86.09 C \nANISOU 2100 C SER A 262 9495 9749 13465 -443 -327 -455 C \nATOM 2101 O SER A 262 18.644 -0.214 -41.407 1.00 86.25 O \nANISOU 2101 O SER A 262 9551 9732 13487 -429 -343 -427 O \nATOM 2102 CB SER A 262 21.597 -0.585 -43.179 1.00 75.29 C \nANISOU 2102 CB SER A 262 8023 8444 12140 -388 -344 -519 C \nATOM 2103 OG SER A 262 21.520 0.693 -43.798 1.00 92.70 O \nANISOU 2103 OG SER A 262 10244 10664 14314 -428 -281 -528 O \nATOM 2104 N ALA A 263 19.897 1.598 -42.028 1.00 76.62 N \nANISOU 2104 N ALA A 263 8313 8566 12234 -482 -272 -464 N \nATOM 2105 CA ALA A 263 18.756 2.394 -42.462 1.00 74.92 C \nANISOU 2105 CA ALA A 263 8152 8324 11990 -489 -222 -448 C \nATOM 2106 C ALA A 263 19.271 3.560 -43.245 1.00 65.56 C \nANISOU 2106 C ALA A 263 6972 7160 10777 -519 -166 -471 C \nATOM 2107 O ALA A 263 20.416 3.595 -43.614 1.00 57.73 O \nANISOU 2107 O ALA A 263 5934 6206 9793 -531 -167 -500 O \nATOM 2108 CB ALA A 263 17.885 2.834 -41.283 1.00 83.95 C \nANISOU 2108 CB ALA A 263 9350 9442 13105 -513 -223 -412 C \nATOM 2109 N ILE A 264 18.405 4.519 -43.512 1.00 70.16 N \nANISOU 2109 N ILE A 264 7613 7720 11325 -528 -117 -457 N \nATOM 2110 CA ILE A 264 18.797 5.666 -44.271 1.00 60.51 C \nANISOU 2110 CA ILE A 264 6412 6508 10071 -558 -62 -475 C \nATOM 2111 C ILE A 264 18.376 6.903 -43.475 1.00 63.34 C \nANISOU 2111 C ILE A 264 6847 6840 10379 -597 -28 -455 C \nATOM 2112 O ILE A 264 17.209 7.287 -43.444 1.00 80.47 O \nANISOU 2112 O ILE A 264 9071 8979 12524 -575 -4 -430 O \nATOM 2113 CB ILE A 264 18.174 5.635 -45.672 1.00 59.50 C \nANISOU 2113 CB ILE A 264 6286 6375 9946 -520 -29 -482 C \nATOM 2114 CG1 ILE A 264 18.844 4.552 -46.500 1.00 60.08 C \nANISOU 2114 CG1 ILE A 264 6286 6477 10064 -489 -57 -511 C \nATOM 2115 CG2 ILE A 264 18.315 6.998 -46.337 1.00 63.29 C \nANISOU 2115 CG2 ILE A 264 6812 6853 10381 -552 33 -491 C \nATOM 2116 CD1 ILE A 264 18.152 4.249 -47.808 1.00 56.13 C \nANISOU 2116 CD1 ILE A 264 5782 5973 9573 -448 -36 -516 C \nATOM 2117 N VAL A 265 19.362 7.520 -42.844 1.00 62.30 N \nANISOU 2117 N VAL A 265 6719 6726 10227 -655 -26 -466 N \nATOM 2118 CA VAL A 265 19.167 8.685 -42.000 1.00 57.68 C \nANISOU 2118 CA VAL A 265 6210 6116 9591 -702 3 -451 C \nATOM 2119 C VAL A 265 19.156 9.941 -42.842 1.00 55.21 C \nANISOU 2119 C VAL A 265 5959 5787 9232 -726 67 -461 C \nATOM 2120 O VAL A 265 19.953 10.078 -43.751 1.00 61.26 O \nANISOU 2120 O VAL A 265 6695 6581 10001 -746 83 -488 O \nATOM 2121 CB VAL A 265 20.280 8.757 -40.960 1.00 61.76 C \nANISOU 2121 CB VAL A 265 6703 6661 10102 -761 -25 -460 C \nATOM 2122 CG1 VAL A 265 20.109 9.970 -40.049 1.00 78.71 C \nANISOU 2122 CG1 VAL A 265 8936 8779 12193 -815 6 -447 C \nATOM 2123 CG2 VAL A 265 20.290 7.491 -40.128 1.00 46.03 C \nANISOU 2123 CG2 VAL A 265 4655 4682 8154 -732 -90 -448 C \nATOM 2124 N LYS A 266 18.270 10.860 -42.501 1.00 58.51 N \nANISOU 2124 N LYS A 266 6466 6160 9605 -724 103 -440 N \nATOM 2125 CA LYS A 266 18.142 12.151 -43.166 1.00 62.41 C \nANISOU 2125 CA LYS A 266 7041 6626 10046 -743 165 -444 C \nATOM 2126 C LYS A 266 18.752 13.194 -42.282 1.00 67.29 C \nANISOU 2126 C LYS A 266 7725 7228 10615 -819 183 -447 C \nATOM 2127 O LYS A 266 18.043 14.067 -41.777 1.00 80.18 O \nANISOU 2127 O LYS A 266 9451 8814 12200 -816 213 -429 O \nATOM 2128 CB LYS A 266 16.658 12.512 -43.408 1.00 61.07 C \nANISOU 2128 CB LYS A 266 6937 6416 9851 -678 195 -416 C \nATOM 2129 CG LYS A 266 15.865 11.489 -44.234 1.00 59.69 C \nANISOU 2129 CG LYS A 266 6703 6259 9717 -605 179 -409 C \nATOM 2130 CD LYS A 266 16.493 11.274 -45.593 1.00 63.14 C \nANISOU 2130 CD LYS A 266 7094 6721 10176 -606 190 -435 C \nATOM 2131 CE LYS A 266 15.470 11.100 -46.703 1.00 64.12 C \nANISOU 2131 CE LYS A 266 7219 6843 10301 -541 212 -425 C \nATOM 2132 NZ LYS A 266 16.032 11.695 -47.983 1.00 72.18 N \nANISOU 2132 NZ LYS A 266 8249 7869 11306 -559 252 -448 N \nATOM 2133 N SER A 267 20.077 13.136 -42.135 1.00 68.18 N \nANISOU 2133 N SER A 267 7790 7383 10733 -886 166 -472 N \nATOM 2134 CA SER A 267 20.816 14.110 -41.307 1.00 70.62 C \nANISOU 2134 CA SER A 267 8156 7687 10990 -975 182 -480 C \nATOM 2135 C SER A 267 21.502 15.168 -42.134 1.00 64.09 C \nANISOU 2135 C SER A 267 7379 6860 10114 -1040 231 -502 C \nATOM 2136 O SER A 267 21.866 14.919 -43.259 1.00 62.87 O \nANISOU 2136 O SER A 267 7177 6735 9978 -1030 239 -519 O \nATOM 2137 CB SER A 267 21.852 13.385 -40.446 1.00 77.06 C \nANISOU 2137 CB SER A 267 8886 8562 11833 -1017 129 -490 C \nATOM 2138 OG SER A 267 22.594 14.314 -39.656 1.00 75.65 O \nANISOU 2138 OG SER A 267 8757 8387 11601 -1111 144 -498 O \nATOM 2139 N GLU A 268 21.679 16.346 -41.554 1.00 76.69 N \nANISOU 2139 N GLU A 268 9075 8420 11645 -1108 264 -501 N \nATOM 2140 CA GLU A 268 22.585 17.400 -42.102 1.00 78.90 C \nANISOU 2140 CA GLU A 268 9408 8704 11867 -1201 306 -524 C \nATOM 2141 C GLU A 268 23.910 17.461 -41.313 1.00 65.46 C \nANISOU 2141 C GLU A 268 7663 7062 10146 -1306 283 -544 C \nATOM 2142 O GLU A 268 24.858 18.095 -41.701 1.00 76.23 O \nANISOU 2142 O GLU A 268 9041 8457 11468 -1394 306 -567 O \nATOM 2143 CB GLU A 268 21.885 18.768 -42.077 1.00 80.32 C \nANISOU 2143 CB GLU A 268 9747 8796 11974 -1213 364 -510 C \nATOM 2144 CG GLU A 268 22.583 19.832 -42.923 1.00 93.52 C \nANISOU 2144 CG GLU A 268 11490 10458 13585 -1294 413 -530 C \nATOM 2145 CD GLU A 268 22.118 21.264 -42.666 1.00104.33 C \nANISOU 2145 CD GLU A 268 13034 11736 14871 -1325 467 -519 C \nATOM 2146 OE1 GLU A 268 21.177 21.712 -43.356 1.00115.65 O \nANISOU 2146 OE1 GLU A 268 14545 13110 16286 -1255 502 -503 O \nATOM 2147 OE2 GLU A 268 22.715 21.969 -41.814 1.00101.80 O \nANISOU 2147 OE2 GLU A 268 12777 11403 14497 -1419 475 -526 O \nATOM 2148 N VAL A 269 23.928 16.786 -40.188 1.00 58.68 N \nANISOU 2148 N VAL A 269 6754 6225 9317 -1295 237 -534 N \nATOM 2149 CA VAL A 269 25.038 16.768 -39.267 1.00 52.79 C \nANISOU 2149 CA VAL A 269 5966 5539 8555 -1382 210 -547 C \nATOM 2150 C VAL A 269 26.222 16.058 -39.906 1.00 58.31 C \nANISOU 2150 C VAL A 269 6536 6337 9282 -1404 183 -575 C \nATOM 2151 O VAL A 269 26.083 15.125 -40.733 1.00 54.87 O \nANISOU 2151 O VAL A 269 6018 5926 8904 -1327 163 -579 O \nATOM 2152 CB VAL A 269 24.636 16.022 -37.975 1.00 53.26 C \nANISOU 2152 CB VAL A 269 5991 5597 8648 -1344 161 -525 C \nATOM 2153 CG1 VAL A 269 25.815 15.776 -37.069 1.00 53.55 C \nANISOU 2153 CG1 VAL A 269 5960 5710 8677 -1421 123 -537 C \nATOM 2154 CG2 VAL A 269 23.542 16.806 -37.244 1.00 50.33 C \nANISOU 2154 CG2 VAL A 269 5747 5137 8238 -1330 189 -500 C \nATOM 2155 N GLU A 270 27.410 16.508 -39.525 1.00 63.12 N \nANISOU 2155 N GLU A 270 7128 7010 9846 -1511 182 -595 N \nATOM 2156 CA GLU A 270 28.637 15.962 -40.080 1.00 64.78 C \nANISOU 2156 CA GLU A 270 7215 7329 10069 -1541 160 -624 C \nATOM 2157 C GLU A 270 29.175 14.791 -39.248 1.00 59.43 C \nANISOU 2157 C GLU A 270 6415 6726 9438 -1510 94 -623 C \nATOM 2158 O GLU A 270 28.756 14.552 -38.147 1.00 52.61 O \nANISOU 2158 O GLU A 270 5568 5834 8586 -1492 66 -601 O \nATOM 2159 CB GLU A 270 29.676 17.054 -40.197 1.00 78.85 C \nANISOU 2159 CB GLU A 270 9034 9155 11770 -1678 196 -648 C \nATOM 2160 CG GLU A 270 29.991 17.760 -38.885 1.00 88.96 C \nANISOU 2160 CG GLU A 270 10377 10430 12993 -1774 196 -642 C \nATOM 2161 CD GLU A 270 31.107 18.785 -39.032 1.00 96.21 C \nANISOU 2161 CD GLU A 270 11326 11404 13825 -1923 229 -668 C \nATOM 2162 OE1 GLU A 270 31.713 18.850 -40.133 1.00 98.45 O \nANISOU 2162 OE1 GLU A 270 11566 11743 14097 -1950 246 -691 O \nATOM 2163 OE2 GLU A 270 31.376 19.508 -38.043 1.00 97.59 O \nANISOU 2163 OE2 GLU A 270 11569 11570 13941 -2017 236 -665 O \nATOM 2164 N TYR A 271 30.119 14.074 -39.823 1.00 59.73 N \nANISOU 2164 N TYR A 271 6332 6862 9500 -1501 68 -648 N \nATOM 2165 CA TYR A 271 30.759 12.950 -39.163 1.00 64.96 C \nANISOU 2165 CA TYR A 271 6876 7605 10202 -1465 5 -650 C \nATOM 2166 C TYR A 271 31.660 13.504 -38.077 1.00 69.85 C \nANISOU 2166 C TYR A 271 7492 8286 10764 -1573 -4 -654 C \nATOM 2167 O TYR A 271 32.022 14.678 -38.108 1.00 84.65 O \nANISOU 2167 O TYR A 271 9436 10161 12566 -1684 40 -665 O \nATOM 2168 CB TYR A 271 31.570 12.175 -40.201 1.00 66.52 C \nANISOU 2168 CB TYR A 271 6953 7894 10428 -1425 -12 -679 C \nATOM 2169 CG TYR A 271 32.208 10.917 -39.708 1.00 68.43 C \nANISOU 2169 CG TYR A 271 7071 8216 10713 -1365 -77 -682 C \nATOM 2170 CD1 TYR A 271 31.461 9.913 -39.168 1.00 66.17 C \nANISOU 2170 CD1 TYR A 271 6776 7878 10488 -1267 -121 -657 C \nATOM 2171 CD2 TYR A 271 33.593 10.733 -39.801 1.00 81.40 C \nANISOU 2171 CD2 TYR A 271 8605 9993 12331 -1406 -95 -711 C \nATOM 2172 CE1 TYR A 271 32.053 8.740 -38.731 1.00 72.58 C \nANISOU 2172 CE1 TYR A 271 7484 8757 11337 -1206 -183 -659 C \nATOM 2173 CE2 TYR A 271 34.205 9.563 -39.353 1.00 81.95 C \nANISOU 2173 CE2 TYR A 271 8562 10140 12436 -1338 -157 -714 C \nATOM 2174 CZ TYR A 271 33.429 8.565 -38.826 1.00 78.09 C \nANISOU 2174 CZ TYR A 271 8076 9585 12010 -1236 -201 -687 C \nATOM 2175 OH TYR A 271 34.048 7.420 -38.384 1.00 79.93 O \nANISOU 2175 OH TYR A 271 8208 9887 12273 -1167 -262 -689 O \nATOM 2176 N GLY A 272 32.020 12.676 -37.114 1.00 73.80 N \nANISOU 2176 N GLY A 272 7915 8836 11289 -1547 -61 -645 N \nATOM 2177 CA GLY A 272 32.757 13.136 -35.928 1.00 69.27 C \nANISOU 2177 CA GLY A 272 7339 8318 10662 -1645 -74 -644 C \nATOM 2178 C GLY A 272 33.816 12.188 -35.412 1.00 70.02 C \nANISOU 2178 C GLY A 272 7296 8536 10773 -1628 -134 -653 C \nATOM 2179 O GLY A 272 34.295 12.354 -34.299 1.00 74.35 O \nANISOU 2179 O GLY A 272 7834 9129 11287 -1690 -156 -646 O \nATOM 2180 N ASN A 273 34.141 11.157 -36.187 1.00 70.57 N \nANISOU 2180 N ASN A 273 7262 8659 10892 -1538 -163 -666 N \nATOM 2181 CA ASN A 273 35.059 10.092 -35.748 1.00 75.95 C \nANISOU 2181 CA ASN A 273 7811 9451 11594 -1491 -225 -672 C \nATOM 2182 C ASN A 273 34.774 9.504 -34.350 1.00 84.47 C \nANISOU 2182 C ASN A 273 8891 10509 12697 -1459 -277 -640 C \nATOM 2183 O ASN A 273 35.684 9.356 -33.554 1.00 94.16 O \nANISOU 2183 O ASN A 273 10048 11833 13894 -1497 -311 -643 O \nATOM 2184 CB ASN A 273 36.484 10.585 -35.818 1.00 65.80 C \nANISOU 2184 CB ASN A 273 6448 8312 10241 -1592 -218 -703 C \nATOM 2185 CG ASN A 273 36.817 11.148 -37.182 1.00 69.52 C \nANISOU 2185 CG ASN A 273 6916 8814 10685 -1631 -168 -734 C \nATOM 2186 OD1 ASN A 273 37.306 10.446 -38.055 1.00 63.25 O \nANISOU 2186 OD1 ASN A 273 6026 8089 9917 -1565 -181 -756 O \nATOM 2187 ND2 ASN A 273 36.550 12.444 -37.373 1.00 73.34 N \nANISOU 2187 ND2 ASN A 273 7511 9243 11113 -1739 -109 -736 N \nATOM 2188 N CYS A 274 33.522 9.133 -34.095 1.00 95.11 N \nANISOU 2188 N CYS A 274 10309 11736 14093 -1387 -285 -611 N \nATOM 2189 CA CYS A 274 33.108 8.609 -32.787 1.00101.08 C \nANISOU 2189 CA CYS A 274 11078 12458 14869 -1360 -331 -578 C \nATOM 2190 C CYS A 274 32.566 7.192 -32.936 1.00100.52 C \nANISOU 2190 C CYS A 274 10968 12349 14875 -1224 -381 -563 C \nATOM 2191 O CYS A 274 32.636 6.621 -34.021 1.00 99.77 O \nANISOU 2191 O CYS A 274 10830 12264 14815 -1155 -380 -580 O \nATOM 2192 CB CYS A 274 32.075 9.532 -32.135 1.00 97.78 C \nANISOU 2192 CB CYS A 274 10791 11934 14426 -1413 -296 -555 C \nATOM 2193 SG CYS A 274 31.191 10.587 -33.293 1.00106.16 S \nANISOU 2193 SG CYS A 274 11964 12900 15472 -1433 -218 -564 S \nATOM 2194 N ASN A 275 32.062 6.637 -31.835 1.00105.51 N \nANISOU 2194 N ASN A 275 11619 12940 15529 -1192 -423 -530 N \nATOM 2195 CA ASN A 275 31.401 5.341 -31.834 1.00106.99 C \nANISOU 2195 CA ASN A 275 11794 13075 15782 -1076 -470 -510 C \nATOM 2196 C ASN A 275 30.172 5.341 -30.963 1.00110.59 C \nANISOU 2196 C ASN A 275 12338 13429 16250 -1071 -476 -473 C \nATOM 2197 O ASN A 275 30.114 6.075 -29.983 1.00115.54 O \nANISOU 2197 O ASN A 275 13011 14053 16838 -1147 -467 -460 O \nATOM 2198 CB ASN A 275 32.361 4.286 -31.285 1.00106.75 C \nANISOU 2198 CB ASN A 275 11664 13131 15766 -1026 -538 -509 C \nATOM 2199 CG ASN A 275 33.313 3.769 -32.332 1.00106.72 C \nANISOU 2199 CG ASN A 275 11563 13212 15773 -974 -545 -543 C \nATOM 2200 OD1 ASN A 275 33.068 3.900 -33.517 1.00114.55 O \nANISOU 2200 OD1 ASN A 275 12565 14181 16779 -953 -509 -563 O \nATOM 2201 ND2 ASN A 275 34.413 3.185 -31.895 1.00111.26 N \nANISOU 2201 ND2 ASN A 275 12044 13893 16337 -951 -592 -550 N \nATOM 2202 N THR A 276 29.230 4.466 -31.301 1.00106.71 N \nANISOU 2202 N THR A 276 11869 12865 15812 -982 -495 -457 N \nATOM 2203 CA THR A 276 27.992 4.307 -30.554 1.00110.92 C \nANISOU 2203 CA THR A 276 12477 13309 16358 -968 -504 -421 C \nATOM 2204 C THR A 276 27.320 2.995 -30.965 1.00119.45 C \nANISOU 2204 C THR A 276 13549 14341 17497 -865 -542 -407 C \nATOM 2205 O THR A 276 27.663 2.424 -31.991 1.00132.29 O \nANISOU 2205 O THR A 276 15128 15985 19151 -809 -546 -429 O \nATOM 2206 CB THR A 276 27.042 5.494 -30.790 1.00118.49 C \nANISOU 2206 CB THR A 276 13533 14202 17288 -1017 -438 -418 C \nATOM 2207 OG1 THR A 276 25.813 5.288 -30.086 1.00119.36 O \nANISOU 2207 OG1 THR A 276 13707 14237 17408 -996 -448 -384 O \nATOM 2208 CG2 THR A 276 26.721 5.653 -32.239 1.00121.37 C \nANISOU 2208 CG2 THR A 276 13906 14542 17667 -984 -396 -438 C \nATOM 2209 N LYS A 277 26.399 2.504 -30.146 1.00116.22 N \nANISOU 2209 N LYS A 277 13185 13872 17102 -846 -571 -373 N \nATOM 2210 CA LYS A 277 25.504 1.428 -30.548 1.00120.38 C \nANISOU 2210 CA LYS A 277 13728 14337 17674 -767 -596 -357 C \nATOM 2211 C LYS A 277 24.139 2.038 -30.814 1.00122.37 C \nANISOU 2211 C LYS A 277 14061 14518 17916 -780 -549 -344 C \nATOM 2212 O LYS A 277 23.200 1.346 -31.269 1.00141.67 O \nANISOU 2212 O LYS A 277 16529 16911 20389 -728 -557 -332 O \nATOM 2213 CB LYS A 277 25.408 0.355 -29.459 1.00131.30 C \nANISOU 2213 CB LYS A 277 15107 15708 19075 -735 -666 -326 C \nATOM 2214 CG LYS A 277 24.687 -0.923 -29.894 1.00136.08 C \nANISOU 2214 CG LYS A 277 15725 16255 19723 -655 -701 -313 C \nATOM 2215 CD LYS A 277 24.602 -2.034 -28.853 1.00134.46 C \nANISOU 2215 CD LYS A 277 15525 16032 19533 -625 -771 -281 C \nATOM 2216 CE LYS A 277 23.787 -3.211 -29.362 1.00132.75 C \nANISOU 2216 CE LYS A 277 15339 15749 19350 -559 -799 -269 C \nATOM 2217 NZ LYS A 277 24.108 -3.644 -30.756 1.00129.72 N \nANISOU 2217 NZ LYS A 277 14924 15369 18995 -499 -787 -301 N \nATOM 2218 N CYS A 278 24.026 3.334 -30.526 1.00102.99 N \nANISOU 2218 N CYS A 278 11650 12063 15417 -851 -500 -347 N \nATOM 2219 CA CYS A 278 22.803 4.042 -30.763 1.00110.57 C \nANISOU 2219 CA CYS A 278 12687 12965 16360 -859 -451 -336 C \nATOM 2220 C CYS A 278 23.076 5.388 -31.419 1.00106.15 C \nANISOU 2220 C CYS A 278 12158 12414 15762 -909 -384 -361 C \nATOM 2221 O CYS A 278 23.780 6.214 -30.845 1.00 96.51 O \nANISOU 2221 O CYS A 278 10943 11224 14501 -979 -370 -370 O \nATOM 2222 CB CYS A 278 22.052 4.246 -29.451 1.00112.60 C \nANISOU 2222 CB CYS A 278 12996 13192 16593 -889 -462 -304 C \nATOM 2223 SG CYS A 278 20.486 5.076 -29.757 1.00128.76 S \nANISOU 2223 SG CYS A 278 15133 15177 18613 -884 -403 -290 S \nATOM 2224 N GLN A 279 22.459 5.606 -32.590 1.00 90.49 N \nANISOU 2224 N GLN A 279 10197 10399 13785 -877 -343 -370 N \nATOM 2225 CA GLN A 279 22.628 6.836 -33.345 1.00 70.16 C \nANISOU 2225 CA GLN A 279 7660 7824 11173 -917 -279 -392 C \nATOM 2226 C GLN A 279 21.286 7.444 -33.716 1.00 70.50 C \nANISOU 2226 C GLN A 279 7784 7805 11198 -896 -232 -377 C \nATOM 2227 O GLN A 279 20.337 6.716 -34.005 1.00 70.87 O \nANISOU 2227 O GLN A 279 7831 7824 11274 -836 -246 -361 O \nATOM 2228 CB GLN A 279 23.419 6.531 -34.588 1.00 61.06 C \nANISOU 2228 CB GLN A 279 6446 6712 10044 -895 -274 -423 C \nATOM 2229 CG GLN A 279 23.580 7.709 -35.520 1.00 66.10 C \nANISOU 2229 CG GLN A 279 7122 7348 10645 -935 -208 -445 C \nATOM 2230 CD GLN A 279 24.583 8.745 -35.020 1.00 67.46 C \nANISOU 2230 CD GLN A 279 7307 7559 10765 -1030 -187 -461 C \nATOM 2231 OE1 GLN A 279 25.788 8.454 -34.897 1.00 57.52 O \nANISOU 2231 OE1 GLN A 279 5974 6374 9507 -1057 -214 -479 O \nATOM 2232 NE2 GLN A 279 24.109 9.963 -34.774 1.00 63.36 N \nANISOU 2232 NE2 GLN A 279 6883 6997 10195 -1080 -138 -455 N \nATOM 2233 N THR A 280 21.213 8.777 -33.708 1.00 67.94 N \nANISOU 2233 N THR A 280 7530 7461 10821 -947 -177 -384 N \nATOM 2234 CA THR A 280 19.994 9.488 -34.148 1.00 66.21 C \nANISOU 2234 CA THR A 280 7393 7188 10576 -920 -127 -372 C \nATOM 2235 C THR A 280 20.426 10.444 -35.223 1.00 65.95 C \nANISOU 2235 C THR A 280 7390 7153 10516 -946 -72 -397 C \nATOM 2236 O THR A 280 21.629 10.643 -35.410 1.00 68.56 O \nANISOU 2236 O THR A 280 7684 7527 10840 -998 -72 -422 O \nATOM 2237 CB THR A 280 19.246 10.211 -33.005 1.00 68.45 C \nANISOU 2237 CB THR A 280 7757 7435 10815 -942 -111 -349 C \nATOM 2238 OG1 THR A 280 19.416 11.623 -33.103 1.00 78.64 O \nANISOU 2238 OG1 THR A 280 9130 8702 12047 -993 -54 -362 O \nATOM 2239 CG2 THR A 280 19.723 9.750 -31.644 1.00 67.25 C \nANISOU 2239 CG2 THR A 280 7575 7308 10668 -978 -162 -338 C \nATOM 2240 N PRO A 281 19.475 11.041 -35.946 1.00 67.43 N \nANISOU 2240 N PRO A 281 7641 7298 10682 -911 -24 -391 N \nATOM 2241 CA PRO A 281 19.839 12.012 -36.982 1.00 76.31 C \nANISOU 2241 CA PRO A 281 8805 8413 11774 -937 30 -413 C \nATOM 2242 C PRO A 281 20.573 13.262 -36.500 1.00 72.67 C \nANISOU 2242 C PRO A 281 8412 7946 11252 -1027 63 -426 C \nATOM 2243 O PRO A 281 21.413 13.800 -37.230 1.00 77.93 O \nANISOU 2243 O PRO A 281 9080 8632 11899 -1076 90 -450 O \nATOM 2244 CB PRO A 281 18.476 12.435 -37.555 1.00 79.36 C \nANISOU 2244 CB PRO A 281 9260 8750 12142 -875 71 -395 C \nATOM 2245 CG PRO A 281 17.595 11.267 -37.314 1.00 75.33 C \nANISOU 2245 CG PRO A 281 8702 8246 11676 -807 29 -372 C \nATOM 2246 CD PRO A 281 18.035 10.782 -35.953 1.00 72.37 C \nANISOU 2246 CD PRO A 281 8296 7888 11312 -843 -20 -364 C \nATOM 2247 N ILE A 282 20.251 13.705 -35.290 1.00 62.42 N \nANISOU 2247 N ILE A 282 7172 6623 9922 -1053 62 -410 N \nATOM 2248 CA ILE A 282 20.847 14.890 -34.740 1.00 59.39 C \nANISOU 2248 CA ILE A 282 6865 6225 9474 -1142 94 -421 C \nATOM 2249 C ILE A 282 22.063 14.631 -33.816 1.00 66.02 C \nANISOU 2249 C ILE A 282 7647 7124 10315 -1221 54 -432 C \nATOM 2250 O ILE A 282 22.676 15.582 -33.293 1.00 73.08 O \nANISOU 2250 O ILE A 282 8600 8016 11152 -1309 77 -443 O \nATOM 2251 CB ILE A 282 19.809 15.728 -34.008 1.00 54.62 C \nANISOU 2251 CB ILE A 282 6375 5556 8821 -1129 126 -400 C \nATOM 2252 CG1 ILE A 282 19.326 15.048 -32.753 1.00 58.19 C \nANISOU 2252 CG1 ILE A 282 6800 6016 9293 -1108 81 -378 C \nATOM 2253 CG2 ILE A 282 18.661 16.021 -34.928 1.00 47.31 C \nANISOU 2253 CG2 ILE A 282 5503 4585 7888 -1048 165 -389 C \nATOM 2254 CD1 ILE A 282 18.557 15.991 -31.842 1.00 59.57 C \nANISOU 2254 CD1 ILE A 282 7087 6138 9409 -1114 112 -363 C \nATOM 2255 N GLY A 283 22.403 13.362 -33.615 1.00 59.19 N \nANISOU 2255 N GLY A 283 6671 6311 9508 -1189 -5 -429 N \nATOM 2256 CA GLY A 283 23.591 13.012 -32.861 1.00 63.79 C \nANISOU 2256 CA GLY A 283 7184 6960 10093 -1250 -46 -439 C \nATOM 2257 C GLY A 283 23.560 11.621 -32.271 1.00 60.97 C \nANISOU 2257 C GLY A 283 6737 6635 9795 -1197 -114 -423 C \nATOM 2258 O GLY A 283 22.511 11.096 -31.994 1.00 58.10 O \nANISOU 2258 O GLY A 283 6387 6232 9456 -1134 -130 -398 O \nATOM 2259 N ALA A 284 24.741 11.059 -32.044 1.00 58.75 N \nANISOU 2259 N ALA A 284 6367 6429 9528 -1225 -155 -437 N \nATOM 2260 CA ALA A 284 24.892 9.805 -31.356 1.00 62.80 C \nANISOU 2260 CA ALA A 284 6801 6974 10087 -1183 -222 -421 C \nATOM 2261 C ALA A 284 24.619 9.914 -29.840 1.00 68.65 C \nANISOU 2261 C ALA A 284 7576 7701 10806 -1216 -245 -397 C \nATOM 2262 O ALA A 284 24.680 10.990 -29.249 1.00 75.20 O \nANISOU 2262 O ALA A 284 8475 8516 11579 -1290 -213 -399 O \nATOM 2263 CB ALA A 284 26.286 9.267 -31.562 1.00 62.75 C \nANISOU 2263 CB ALA A 284 6691 7059 10094 -1199 -256 -444 C \nATOM 2264 N ILE A 285 24.298 8.785 -29.224 1.00 68.08 N \nANISOU 2264 N ILE A 285 7461 7630 10776 -1163 -302 -374 N \nATOM 2265 CA ILE A 285 24.233 8.720 -27.784 1.00 63.19 C \nANISOU 2265 CA ILE A 285 6856 7015 10141 -1196 -334 -352 C \nATOM 2266 C ILE A 285 24.889 7.489 -27.195 1.00 70.26 C \nANISOU 2266 C ILE A 285 7661 7962 11073 -1169 -406 -342 C \nATOM 2267 O ILE A 285 24.391 6.393 -27.334 1.00 75.74 O \nANISOU 2267 O ILE A 285 8327 8636 11813 -1095 -444 -326 O \nATOM 2268 CB ILE A 285 22.791 8.945 -27.213 1.00 61.11 C \nANISOU 2268 CB ILE A 285 6675 6678 9865 -1173 -318 -324 C \nATOM 2269 CG1 ILE A 285 22.833 8.833 -25.692 1.00 67.84 C \nANISOU 2269 CG1 ILE A 285 7533 7542 10700 -1212 -354 -303 C \nATOM 2270 CG2 ILE A 285 21.731 8.028 -27.756 1.00 53.13 C \nANISOU 2270 CG2 ILE A 285 5655 5630 8901 -1084 -334 -307 C \nATOM 2271 CD1 ILE A 285 23.839 9.788 -25.041 1.00 61.94 C \nANISOU 2271 CD1 ILE A 285 6802 6835 9899 -1311 -338 -320 C \nATOM 2272 N ASN A 286 26.001 7.716 -26.491 1.00 86.29 N \nANISOU 2272 N ASN A 286 9654 10059 13075 -1234 -425 -351 N \nATOM 2273 CA ASN A 286 26.672 6.716 -25.627 1.00 85.04 C \nANISOU 2273 CA ASN A 286 9420 9956 12936 -1219 -495 -337 C \nATOM 2274 C ASN A 286 26.178 6.774 -24.176 1.00 87.73 C \nANISOU 2274 C ASN A 286 9803 10274 13256 -1251 -518 -307 C \nATOM 2275 O ASN A 286 26.799 7.399 -23.334 1.00 85.43 O \nANISOU 2275 O ASN A 286 9515 10023 12920 -1330 -516 -310 O \nATOM 2276 CB ASN A 286 28.184 6.935 -25.654 1.00 87.31 C \nANISOU 2276 CB ASN A 286 9632 10344 13197 -1272 -504 -363 C \nATOM 2277 CG ASN A 286 28.938 5.964 -24.765 1.00 91.48 C \nANISOU 2277 CG ASN A 286 10082 10939 13739 -1253 -575 -349 C \nATOM 2278 OD1 ASN A 286 28.408 4.935 -24.337 1.00 99.33 O \nANISOU 2278 OD1 ASN A 286 11069 11899 14772 -1185 -623 -322 O \nATOM 2279 ND2 ASN A 286 30.185 6.297 -24.472 1.00 92.66 N \nANISOU 2279 ND2 ASN A 286 10171 11185 13849 -1314 -583 -366 N \nATOM 2280 N SER A 287 25.052 6.118 -23.899 1.00 97.61 N \nANISOU 2280 N SER A 287 11085 11464 14537 -1195 -538 -279 N \nATOM 2281 CA SER A 287 24.493 6.066 -22.542 1.00 98.51 C \nANISOU 2281 CA SER A 287 11237 11558 14633 -1219 -563 -249 C \nATOM 2282 C SER A 287 24.030 4.684 -22.147 1.00 93.21 C \nANISOU 2282 C SER A 287 10537 10870 14007 -1152 -627 -218 C \nATOM 2283 O SER A 287 24.280 3.711 -22.866 1.00 97.32 O \nANISOU 2283 O SER A 287 11007 11399 14573 -1086 -657 -222 O \nATOM 2284 CB SER A 287 23.353 7.069 -22.395 1.00100.23 C \nANISOU 2284 CB SER A 287 11554 11712 14816 -1244 -506 -243 C \nATOM 2285 OG SER A 287 23.859 8.396 -22.489 1.00102.60 O \nANISOU 2285 OG SER A 287 11895 12023 15064 -1320 -452 -268 O \nATOM 2286 N SER A 288 23.414 4.597 -20.970 1.00 90.86 N \nANISOU 2286 N SER A 288 10276 10553 13694 -1173 -648 -189 N \nATOM 2287 CA SER A 288 22.855 3.339 -20.477 1.00 90.14 C \nANISOU 2287 CA SER A 288 10173 10439 13636 -1121 -708 -157 C \nATOM 2288 C SER A 288 21.675 3.613 -19.569 1.00 86.64 C \nANISOU 2288 C SER A 288 9798 9955 13168 -1146 -699 -130 C \nATOM 2289 O SER A 288 21.852 3.761 -18.358 1.00 78.42 O \nANISOU 2289 O SER A 288 8765 8934 12099 -1194 -721 -114 O \nATOM 2290 CB SER A 288 23.908 2.531 -19.730 1.00 86.88 C \nANISOU 2290 CB SER A 288 9696 10081 13234 -1120 -775 -146 C \nATOM 2291 OG SER A 288 23.383 1.269 -19.380 1.00 90.75 O \nANISOU 2291 OG SER A 288 10185 10541 13756 -1066 -833 -115 O \nATOM 2292 N MET A 289 20.489 3.675 -20.178 1.00 84.63 N \nANISOU 2292 N MET A 289 9587 9649 12918 -1111 -667 -125 N \nATOM 2293 CA MET A 289 19.272 4.055 -19.488 1.00 92.29 C \nANISOU 2293 CA MET A 289 10621 10588 13857 -1127 -648 -105 C \nATOM 2294 C MET A 289 18.035 3.568 -20.245 1.00 88.04 C \nANISOU 2294 C MET A 289 10103 10010 13338 -1069 -637 -94 C \nATOM 2295 O MET A 289 18.001 3.551 -21.460 1.00 93.71 O \nANISOU 2295 O MET A 289 10810 10716 14078 -1029 -612 -111 O \nATOM 2296 CB MET A 289 19.232 5.586 -19.323 1.00 97.16 C \nANISOU 2296 CB MET A 289 11295 11201 14421 -1181 -581 -124 C \nATOM 2297 CG MET A 289 19.976 6.145 -18.111 1.00104.53 C \nANISOU 2297 CG MET A 289 12234 12167 15315 -1257 -591 -124 C \nATOM 2298 SD MET A 289 19.594 7.891 -17.759 1.00118.37 S \nANISOU 2298 SD MET A 289 14083 13896 16996 -1317 -513 -141 S \nATOM 2299 CE MET A 289 20.891 8.252 -16.592 1.00 84.04 C \nANISOU 2299 CE MET A 289 9715 9603 12615 -1410 -538 -147 C \nATOM 2300 N PRO A 290 16.979 3.220 -19.531 1.00 99.58 N \nANISOU 2300 N PRO A 290 11593 11457 14785 -1068 -653 -64 N \nATOM 2301 CA PRO A 290 15.803 2.651 -20.202 1.00101.79 C \nANISOU 2301 CA PRO A 290 11886 11712 15079 -1020 -648 -52 C \nATOM 2302 C PRO A 290 15.051 3.625 -21.091 1.00 93.72 C \nANISOU 2302 C PRO A 290 10902 10675 14034 -999 -576 -69 C \nATOM 2303 O PRO A 290 14.237 3.192 -21.936 1.00 90.07 O \nANISOU 2303 O PRO A 290 10439 10200 13585 -954 -567 -65 O \nATOM 2304 CB PRO A 290 14.905 2.213 -19.036 1.00 97.35 C \nANISOU 2304 CB PRO A 290 11347 11151 14493 -1040 -680 -17 C \nATOM 2305 CG PRO A 290 15.300 3.087 -17.914 1.00101.27 C \nANISOU 2305 CG PRO A 290 11864 11664 14949 -1097 -669 -18 C \nATOM 2306 CD PRO A 290 16.772 3.368 -18.085 1.00105.64 C \nANISOU 2306 CD PRO A 290 12383 12236 15518 -1117 -673 -42 C \nATOM 2307 N PHE A 291 15.305 4.918 -20.925 1.00 83.82 N \nANISOU 2307 N PHE A 291 9684 9422 12741 -1031 -525 -87 N \nATOM 2308 CA PHE A 291 14.582 5.907 -21.727 1.00 92.82 C \nANISOU 2308 CA PHE A 291 10872 10543 13853 -1006 -456 -101 C \nATOM 2309 C PHE A 291 15.432 7.080 -22.224 1.00 86.76 C \nANISOU 2309 C PHE A 291 10129 9770 13068 -1032 -406 -134 C \nATOM 2310 O PHE A 291 16.522 7.342 -21.712 1.00 79.72 O \nANISOU 2310 O PHE A 291 9225 8895 12171 -1084 -418 -145 O \nATOM 2311 CB PHE A 291 13.384 6.424 -20.945 1.00 95.55 C \nANISOU 2311 CB PHE A 291 11271 10886 14148 -1009 -432 -83 C \nATOM 2312 CG PHE A 291 12.495 5.328 -20.410 1.00100.24 C \nANISOU 2312 CG PHE A 291 11844 11494 14750 -996 -479 -51 C \nATOM 2313 CD1 PHE A 291 12.650 4.857 -19.120 1.00102.24 C \nANISOU 2313 CD1 PHE A 291 12088 11761 14996 -1037 -527 -30 C \nATOM 2314 CD2 PHE A 291 11.527 4.763 -21.203 1.00 98.70 C \nANISOU 2314 CD2 PHE A 291 11638 11299 14564 -948 -476 -41 C \nATOM 2315 CE1 PHE A 291 11.837 3.863 -18.611 1.00 99.30 C \nANISOU 2315 CE1 PHE A 291 11703 11401 14625 -1033 -571 1 C \nATOM 2316 CE2 PHE A 291 10.706 3.765 -20.709 1.00104.21 C \nANISOU 2316 CE2 PHE A 291 12321 12013 15262 -947 -519 -11 C \nATOM 2317 CZ PHE A 291 10.859 3.313 -19.411 1.00103.12 C \nANISOU 2317 CZ PHE A 291 12180 11886 15117 -991 -566 11 C \nATOM 2318 N HIS A 292 14.925 7.739 -23.269 1.00 85.13 N \nANISOU 2318 N HIS A 292 9955 9541 12848 -997 -350 -148 N \nATOM 2319 CA HIS A 292 15.500 8.976 -23.794 1.00 74.70 C \nANISOU 2319 CA HIS A 292 8679 8206 11499 -1021 -293 -176 C \nATOM 2320 C HIS A 292 14.410 9.794 -24.458 1.00 74.99 C \nANISOU 2320 C HIS A 292 8779 8213 11499 -975 -232 -178 C \nATOM 2321 O HIS A 292 13.320 9.283 -24.731 1.00 92.07 O \nANISOU 2321 O HIS A 292 10933 10379 13669 -921 -235 -160 O \nATOM 2322 CB HIS A 292 16.657 8.693 -24.758 1.00 71.57 C \nANISOU 2322 CB HIS A 292 8227 7824 11141 -1026 -302 -200 C \nATOM 2323 CG HIS A 292 16.230 8.287 -26.137 1.00 80.33 C \nANISOU 2323 CG HIS A 292 9315 8925 12283 -963 -288 -206 C \nATOM 2324 ND1 HIS A 292 15.698 9.172 -27.049 1.00 88.30 N \nANISOU 2324 ND1 HIS A 292 10376 9908 13266 -937 -227 -217 N \nATOM 2325 CD2 HIS A 292 16.309 7.100 -26.778 1.00 78.67 C \nANISOU 2325 CD2 HIS A 292 9040 8726 12126 -922 -328 -203 C \nATOM 2326 CE1 HIS A 292 15.432 8.546 -28.178 1.00 86.13 C \nANISOU 2326 CE1 HIS A 292 10063 9634 13027 -886 -229 -220 C \nATOM 2327 NE2 HIS A 292 15.793 7.285 -28.038 1.00 84.23 N \nANISOU 2327 NE2 HIS A 292 9753 9415 12835 -877 -289 -213 N \nATOM 2328 N ASN A 293 14.716 11.055 -24.730 1.00 78.46 N \nANISOU 2328 N ASN A 293 9285 8629 11898 -999 -176 -199 N \nATOM 2329 CA ASN A 293 13.797 11.972 -25.425 1.00 73.95 C \nANISOU 2329 CA ASN A 293 8786 8026 11287 -951 -113 -202 C \nATOM 2330 C ASN A 293 14.486 12.790 -26.507 1.00 71.88 C \nANISOU 2330 C ASN A 293 8555 7741 11015 -963 -67 -230 C \nATOM 2331 O ASN A 293 14.103 13.920 -26.781 1.00 76.37 O \nANISOU 2331 O ASN A 293 9211 8273 11532 -952 -10 -238 O \nATOM 2332 CB ASN A 293 13.169 12.915 -24.431 1.00 78.74 C \nANISOU 2332 CB ASN A 293 9478 8613 11828 -961 -81 -196 C \nATOM 2333 CG ASN A 293 14.190 13.783 -23.731 1.00 78.89 C \nANISOU 2333 CG ASN A 293 9546 8617 11812 -1043 -68 -214 C \nATOM 2334 OD1 ASN A 293 15.383 13.461 -23.679 1.00 74.57 O \nANISOU 2334 OD1 ASN A 293 8950 8091 11293 -1101 -98 -226 O \nATOM 2335 ND2 ASN A 293 13.717 14.888 -23.184 1.00 78.67 N \nANISOU 2335 ND2 ASN A 293 9617 8556 11718 -1049 -23 -217 N \nATOM 2336 N ILE A 294 15.505 12.197 -27.115 1.00 66.79 N \nANISOU 2336 N ILE A 294 7841 7120 10418 -985 -94 -245 N \nATOM 2337 CA ILE A 294 16.366 12.867 -28.065 1.00 67.29 C \nANISOU 2337 CA ILE A 294 7921 7174 10474 -1013 -59 -272 C \nATOM 2338 C ILE A 294 15.672 13.099 -29.396 1.00 71.44 C \nANISOU 2338 C ILE A 294 8467 7678 11000 -948 -18 -275 C \nATOM 2339 O ILE A 294 15.498 14.229 -29.835 1.00 75.26 O \nANISOU 2339 O ILE A 294 9034 8124 11436 -948 39 -285 O \nATOM 2340 CB ILE A 294 17.634 12.041 -28.343 1.00 59.91 C \nANISOU 2340 CB ILE A 294 6890 6284 9589 -1045 -104 -287 C \nATOM 2341 CG1 ILE A 294 18.355 11.639 -27.051 1.00 63.39 C \nANISOU 2341 CG1 ILE A 294 7295 6758 10034 -1102 -153 -281 C \nATOM 2342 CG2 ILE A 294 18.566 12.843 -29.237 1.00 57.16 C \nANISOU 2342 CG2 ILE A 294 6560 5935 9222 -1088 -65 -317 C \nATOM 2343 CD1 ILE A 294 18.834 12.804 -26.198 1.00 67.08 C \nANISOU 2343 CD1 ILE A 294 7835 7215 10439 -1183 -124 -291 C \nATOM 2344 N HIS A 295 15.281 11.996 -30.023 1.00 75.43 N \nANISOU 2344 N HIS A 295 8899 8204 11557 -892 -49 -266 N \nATOM 2345 CA HIS A 295 14.687 12.020 -31.358 1.00 75.63 C \nANISOU 2345 CA HIS A 295 8926 8219 11590 -832 -18 -269 C \nATOM 2346 C HIS A 295 13.917 10.700 -31.618 1.00 65.51 C \nANISOU 2346 C HIS A 295 7573 6962 10355 -773 -59 -250 C \nATOM 2347 O HIS A 295 14.367 9.645 -31.206 1.00 68.56 O \nANISOU 2347 O HIS A 295 7892 7372 10785 -787 -115 -245 O \nATOM 2348 CB HIS A 295 15.805 12.214 -32.381 1.00 80.31 C \nANISOU 2348 CB HIS A 295 9495 8819 12200 -861 -4 -298 C \nATOM 2349 CG HIS A 295 15.317 12.569 -33.753 1.00 81.22 C \nANISOU 2349 CG HIS A 295 9632 8917 12309 -812 40 -304 C \nATOM 2350 ND1 HIS A 295 15.058 11.618 -34.715 1.00 79.21 N \nANISOU 2350 ND1 HIS A 295 9311 8684 12103 -761 21 -303 N \nATOM 2351 CD2 HIS A 295 15.018 13.765 -34.310 1.00 83.84 C \nANISOU 2351 CD2 HIS A 295 10052 9212 12590 -804 101 -310 C \nATOM 2352 CE1 HIS A 295 14.625 12.218 -35.808 1.00 85.33 C \nANISOU 2352 CE1 HIS A 295 10123 9440 12857 -726 69 -308 C \nATOM 2353 NE2 HIS A 295 14.586 13.522 -35.588 1.00 83.03 N \nANISOU 2353 NE2 HIS A 295 9927 9113 12506 -749 118 -312 N \nATOM 2354 N PRO A 296 12.752 10.771 -32.268 1.00 63.53 N \nANISOU 2354 N PRO A 296 7342 6706 10090 -710 -32 -237 N \nATOM 2355 CA PRO A 296 11.950 9.572 -32.544 1.00 59.63 C \nANISOU 2355 CA PRO A 296 6789 6238 9631 -663 -67 -219 C \nATOM 2356 C PRO A 296 12.665 8.603 -33.425 1.00 72.71 C \nANISOU 2356 C PRO A 296 8372 7907 11346 -661 -98 -234 C \nATOM 2357 O PRO A 296 12.799 7.435 -33.079 1.00 63.59 O \nANISOU 2357 O PRO A 296 7161 6769 10232 -663 -153 -226 O \nATOM 2358 CB PRO A 296 10.705 10.114 -33.263 1.00 59.87 C \nANISOU 2358 CB PRO A 296 6860 6267 9623 -600 -19 -209 C \nATOM 2359 CG PRO A 296 11.005 11.544 -33.640 1.00 68.13 C \nANISOU 2359 CG PRO A 296 7985 7278 10623 -606 42 -225 C \nATOM 2360 CD PRO A 296 12.051 12.025 -32.650 1.00 71.68 C \nANISOU 2360 CD PRO A 296 8462 7711 11064 -679 34 -237 C \nATOM 2361 N LEU A 297 13.109 9.103 -34.577 1.00 93.56 N \nANISOU 2361 N LEU A 297 11019 10540 13989 -653 -62 -256 N \nATOM 2362 CA LEU A 297 13.801 8.284 -35.584 1.00100.88 C \nANISOU 2362 CA LEU A 297 11880 11483 14969 -645 -83 -275 C \nATOM 2363 C LEU A 297 15.175 7.875 -35.115 1.00 95.42 C \nANISOU 2363 C LEU A 297 11142 10806 14308 -693 -123 -292 C \nATOM 2364 O LEU A 297 16.154 8.534 -35.391 1.00108.01 O \nANISOU 2364 O LEU A 297 12742 12404 15894 -730 -101 -315 O \nATOM 2365 CB LEU A 297 13.921 9.025 -36.921 1.00106.16 C \nANISOU 2365 CB LEU A 297 12570 12143 15625 -629 -30 -294 C \nATOM 2366 CG LEU A 297 12.608 9.491 -37.548 1.00104.81 C \nANISOU 2366 CG LEU A 297 12442 11962 15418 -573 12 -279 C \nATOM 2367 CD1 LEU A 297 12.832 10.517 -38.656 1.00105.53 C \nANISOU 2367 CD1 LEU A 297 12577 12037 15484 -567 70 -297 C \nATOM 2368 CD2 LEU A 297 11.847 8.289 -38.084 1.00105.71 C \nANISOU 2368 CD2 LEU A 297 12499 12100 15566 -527 -18 -267 C \nATOM 2369 N THR A 298 15.245 6.775 -34.399 1.00 88.42 N \nANISOU 2369 N THR A 298 10211 9932 13454 -692 -181 -279 N \nATOM 2370 CA THR A 298 16.497 6.333 -33.822 1.00 84.66 C \nANISOU 2370 CA THR A 298 9688 9476 13003 -729 -224 -291 C \nATOM 2371 C THR A 298 16.898 5.072 -34.520 1.00 76.19 C \nANISOU 2371 C THR A 298 8547 8418 11984 -694 -265 -300 C \nATOM 2372 O THR A 298 16.053 4.433 -35.129 1.00 92.79 O \nANISOU 2372 O THR A 298 10643 10509 14102 -649 -269 -291 O \nATOM 2373 CB THR A 298 16.278 6.096 -32.320 1.00 94.88 C \nANISOU 2373 CB THR A 298 10995 10770 14286 -755 -261 -266 C \nATOM 2374 OG1 THR A 298 15.656 7.268 -31.740 1.00 99.05 O \nANISOU 2374 OG1 THR A 298 11596 11280 14759 -776 -217 -256 O \nATOM 2375 CG2 THR A 298 17.575 5.810 -31.603 1.00 92.25 C \nANISOU 2375 CG2 THR A 298 10620 10463 13968 -796 -301 -275 C \nATOM 2376 N ILE A 299 18.173 4.704 -34.451 1.00 67.57 N \nANISOU 2376 N ILE A 299 7402 7354 10916 -711 -295 -319 N \nATOM 2377 CA ILE A 299 18.667 3.509 -35.125 1.00 67.16 C \nANISOU 2377 CA ILE A 299 7288 7316 10913 -670 -334 -332 C \nATOM 2378 C ILE A 299 19.698 2.772 -34.307 1.00 70.03 C \nANISOU 2378 C ILE A 299 7603 7708 11299 -679 -392 -334 C \nATOM 2379 O ILE A 299 20.625 3.366 -33.790 1.00 86.74 O \nANISOU 2379 O ILE A 299 9707 9856 13396 -724 -389 -345 O \nATOM 2380 CB ILE A 299 19.201 3.800 -36.571 1.00 79.67 C \nANISOU 2380 CB ILE A 299 8847 8918 12507 -655 -297 -366 C \nATOM 2381 CG1 ILE A 299 20.760 3.939 -36.656 1.00 80.81 C \nANISOU 2381 CG1 ILE A 299 8936 9111 12655 -683 -306 -396 C \nATOM 2382 CG2 ILE A 299 18.481 5.007 -37.209 1.00 80.12 C \nANISOU 2382 CG2 ILE A 299 8963 8954 12526 -665 -229 -367 C \nATOM 2383 CD1 ILE A 299 21.447 2.750 -37.288 1.00 79.81 C \nANISOU 2383 CD1 ILE A 299 8739 9011 12575 -634 -346 -415 C \nATOM 2384 N GLY A 300 19.546 1.466 -34.195 1.00 92.30 N \nANISOU 2384 N GLY A 300 10399 10518 14155 -636 -446 -322 N \nATOM 2385 CA GLY A 300 20.452 0.613 -33.409 1.00109.03 C \nANISOU 2385 CA GLY A 300 12474 12658 16293 -630 -508 -320 C \nATOM 2386 C GLY A 300 19.707 -0.026 -32.240 1.00120.05 C \nANISOU 2386 C GLY A 300 13901 14024 17687 -634 -552 -282 C \nATOM 2387 O GLY A 300 18.516 -0.339 -32.362 1.00112.54 O \nANISOU 2387 O GLY A 300 12986 13037 16735 -619 -548 -262 O \nATOM 2388 N GLU A 301 20.417 -0.235 -31.126 1.00128.77 N \nANISOU 2388 N GLU A 301 14987 15151 18788 -655 -594 -272 N \nATOM 2389 CA GLU A 301 19.788 -0.636 -29.854 1.00132.29 C \nANISOU 2389 CA GLU A 301 15466 15575 19224 -673 -632 -235 C \nATOM 2390 C GLU A 301 19.821 0.568 -28.911 1.00125.49 C \nANISOU 2390 C GLU A 301 14630 14731 18320 -739 -603 -229 C \nATOM 2391 O GLU A 301 20.849 0.945 -28.325 1.00 86.51 O \nANISOU 2391 O GLU A 301 9666 9834 13371 -773 -612 -237 O \nATOM 2392 CB GLU A 301 20.402 -1.885 -29.202 1.00138.67 C \nANISOU 2392 CB GLU A 301 16245 16387 20057 -644 -706 -222 C \nATOM 2393 CG GLU A 301 19.582 -3.158 -29.384 1.00129.17 C \nANISOU 2393 CG GLU A 301 15067 15135 18878 -601 -746 -202 C \nATOM 2394 CD GLU A 301 20.188 -4.366 -28.681 1.00128.17 C \nANISOU 2394 CD GLU A 301 14926 15002 18770 -571 -821 -187 C \nATOM 2395 OE1 GLU A 301 21.255 -4.242 -28.055 1.00126.39 O \nANISOU 2395 OE1 GLU A 301 14663 14818 18541 -578 -844 -192 O \nATOM 2396 OE2 GLU A 301 19.598 -5.458 -28.755 1.00129.33 O \nANISOU 2396 OE2 GLU A 301 15104 15105 18932 -541 -858 -170 O \nATOM 2397 N CYS A 302 18.645 1.154 -28.783 1.00131.49 N \nANISOU 2397 N CYS A 302 15445 15463 19053 -755 -567 -213 N \nATOM 2398 CA CYS A 302 18.478 2.438 -28.159 1.00128.08 C \nANISOU 2398 CA CYS A 302 15053 15036 18575 -808 -524 -211 C \nATOM 2399 C CYS A 302 17.338 2.402 -27.158 1.00126.63 C \nANISOU 2399 C CYS A 302 14916 14832 18367 -822 -533 -178 C \nATOM 2400 O CYS A 302 16.296 1.773 -27.387 1.00138.89 O \nANISOU 2400 O CYS A 302 16483 16364 19927 -791 -542 -160 O \nATOM 2401 CB CYS A 302 18.152 3.476 -29.229 1.00123.06 C \nANISOU 2401 CB CYS A 302 14446 14391 17920 -805 -454 -232 C \nATOM 2402 SG CYS A 302 19.411 3.516 -30.492 1.00111.20 S \nANISOU 2402 SG CYS A 302 12889 12919 16444 -792 -440 -272 S \nATOM 2403 N PRO A 303 17.526 3.094 -26.041 1.00111.50 N \nANISOU 2403 N PRO A 303 13022 12926 16415 -873 -529 -170 N \nATOM 2404 CA PRO A 303 16.452 3.337 -25.102 1.00103.03 C \nANISOU 2404 CA PRO A 303 11997 11840 15308 -892 -525 -143 C \nATOM 2405 C PRO A 303 15.131 3.711 -25.754 1.00 91.01 C \nANISOU 2405 C PRO A 303 10515 10298 13766 -861 -479 -138 C \nATOM 2406 O PRO A 303 15.096 4.271 -26.846 1.00100.17 O \nANISOU 2406 O PRO A 303 11683 11451 14925 -839 -432 -158 O \nATOM 2407 CB PRO A 303 16.982 4.532 -24.280 1.00107.86 C \nANISOU 2407 CB PRO A 303 12639 12465 15877 -952 -497 -152 C \nATOM 2408 CG PRO A 303 18.400 4.765 -24.705 1.00101.31 C \nANISOU 2408 CG PRO A 303 11770 11663 15061 -972 -496 -180 C \nATOM 2409 CD PRO A 303 18.813 3.606 -25.548 1.00102.14 C \nANISOU 2409 CD PRO A 303 11815 11775 15220 -920 -534 -187 C \nATOM 2410 N LYS A 304 14.049 3.452 -25.055 1.00 95.49 N \nANISOU 2410 N LYS A 304 11108 10863 14312 -861 -491 -110 N \nATOM 2411 CA LYS A 304 12.750 3.816 -25.572 1.00101.37 C \nANISOU 2411 CA LYS A 304 11884 11602 15029 -830 -448 -102 C \nATOM 2412 C LYS A 304 12.637 5.319 -25.657 1.00 92.08 C \nANISOU 2412 C LYS A 304 10759 10420 13807 -838 -380 -118 C \nATOM 2413 O LYS A 304 12.647 6.005 -24.651 1.00 98.42 O \nANISOU 2413 O LYS A 304 11597 11224 14573 -873 -370 -113 O \nATOM 2414 CB LYS A 304 11.644 3.294 -24.655 1.00112.03 C \nANISOU 2414 CB LYS A 304 13247 12963 16355 -838 -475 -69 C \nATOM 2415 CG LYS A 304 11.550 1.785 -24.547 1.00119.17 C \nANISOU 2415 CG LYS A 304 14119 13867 17295 -833 -541 -49 C \nATOM 2416 CD LYS A 304 10.139 1.383 -24.157 1.00111.34 C \nANISOU 2416 CD LYS A 304 13142 12891 16269 -834 -548 -20 C \nATOM 2417 CE LYS A 304 9.152 1.722 -25.242 1.00108.28 C \nANISOU 2417 CE LYS A 304 12762 12515 15863 -793 -499 -26 C \nATOM 2418 NZ LYS A 304 9.586 1.387 -26.631 1.00103.98 N \nANISOU 2418 NZ LYS A 304 12193 11954 15361 -758 -492 -47 N \nATOM 2419 N TYR A 305 12.516 5.826 -26.865 1.00 89.80 N \nANISOU 2419 N TYR A 305 10480 10122 13519 -805 -334 -136 N \nATOM 2420 CA TYR A 305 12.160 7.211 -27.036 1.00 90.75 C \nANISOU 2420 CA TYR A 305 10662 10229 13588 -801 -268 -146 C \nATOM 2421 C TYR A 305 10.830 7.510 -26.317 1.00 88.28 C \nANISOU 2421 C TYR A 305 10391 9927 13226 -784 -252 -123 C \nATOM 2422 O TYR A 305 9.815 6.821 -26.508 1.00 70.95 O \nANISOU 2422 O TYR A 305 8175 7751 11032 -751 -265 -103 O \nATOM 2423 CB TYR A 305 12.057 7.581 -28.514 1.00 83.42 C \nANISOU 2423 CB TYR A 305 9739 9291 12667 -759 -224 -165 C \nATOM 2424 CG TYR A 305 11.646 9.026 -28.743 1.00 94.26 C \nANISOU 2424 CG TYR A 305 11188 10644 13983 -747 -154 -173 C \nATOM 2425 CD1 TYR A 305 12.503 10.069 -28.461 1.00 94.59 C \nANISOU 2425 CD1 TYR A 305 11276 10665 13999 -793 -125 -193 C \nATOM 2426 CD2 TYR A 305 10.385 9.349 -29.221 1.00 93.00 C \nANISOU 2426 CD2 TYR A 305 11057 10488 13790 -691 -117 -162 C \nATOM 2427 CE1 TYR A 305 12.118 11.383 -28.657 1.00 95.03 C \nANISOU 2427 CE1 TYR A 305 11416 10693 13998 -780 -62 -200 C \nATOM 2428 CE2 TYR A 305 10.012 10.665 -29.424 1.00 93.58 C \nANISOU 2428 CE2 TYR A 305 11208 10540 13808 -670 -55 -169 C \nATOM 2429 CZ TYR A 305 10.885 11.678 -29.135 1.00 91.25 C \nANISOU 2429 CZ TYR A 305 10969 10213 13489 -715 -27 -188 C \nATOM 2430 OH TYR A 305 10.517 12.989 -29.328 1.00 98.63 O \nANISOU 2430 OH TYR A 305 11994 11116 14364 -693 35 -195 O \nATOM 2431 N VAL A 306 10.841 8.555 -25.502 1.00 83.77 N \nANISOU 2431 N VAL A 306 9876 9344 12606 -809 -222 -125 N \nATOM 2432 CA VAL A 306 9.612 9.011 -24.832 1.00 86.02 C \nANISOU 2432 CA VAL A 306 10205 9642 12835 -787 -199 -107 C \nATOM 2433 C VAL A 306 9.548 10.509 -24.898 1.00 78.09 C \nANISOU 2433 C VAL A 306 9284 8610 11776 -778 -132 -123 C \nATOM 2434 O VAL A 306 10.574 11.115 -25.029 1.00 70.10 O \nANISOU 2434 O VAL A 306 8298 7571 10767 -816 -117 -145 O \nATOM 2435 CB VAL A 306 9.572 8.552 -23.373 1.00 82.01 C \nANISOU 2435 CB VAL A 306 9688 9153 12319 -831 -244 -87 C \nATOM 2436 CG1 VAL A 306 8.734 7.292 -23.287 1.00 82.21 C \nANISOU 2436 CG1 VAL A 306 9661 9211 12362 -814 -290 -60 C \nATOM 2437 CG2 VAL A 306 10.982 8.304 -22.857 1.00 74.92 C \nANISOU 2437 CG2 VAL A 306 8766 8244 11455 -893 -282 -98 C \nATOM 2438 N LYS A 307 8.351 11.090 -24.826 1.00 85.48 N \nANISOU 2438 N LYS A 307 10265 9556 12658 -728 -94 -113 N \nATOM 2439 CA LYS A 307 8.222 12.548 -24.882 1.00109.72 C \nANISOU 2439 CA LYS A 307 13429 12591 15668 -709 -28 -127 C \nATOM 2440 C LYS A 307 8.031 13.245 -23.524 1.00115.46 C \nANISOU 2440 C LYS A 307 14217 13312 16339 -734 -17 -124 C \nATOM 2441 O LYS A 307 7.449 14.326 -23.450 1.00128.40 O \nANISOU 2441 O LYS A 307 15938 14932 17916 -696 36 -129 O \nATOM 2442 CB LYS A 307 7.144 12.953 -25.878 1.00119.75 C \nANISOU 2442 CB LYS A 307 14723 13870 16907 -624 18 -123 C \nATOM 2443 CG LYS A 307 5.707 12.653 -25.491 1.00125.41 C \nANISOU 2443 CG LYS A 307 15424 14641 17587 -570 17 -98 C \nATOM 2444 CD LYS A 307 4.765 13.122 -26.613 1.00128.83 C \nANISOU 2444 CD LYS A 307 15875 15087 17986 -483 65 -96 C \nATOM 2445 CE LYS A 307 5.439 13.136 -27.993 1.00128.34 C \nANISOU 2445 CE LYS A 307 15804 14994 17966 -477 79 -113 C \nATOM 2446 NZ LYS A 307 4.551 13.572 -29.097 1.00133.54 N \nANISOU 2446 NZ LYS A 307 16480 15667 18592 -393 124 -109 N \nATOM 2447 N SER A 308 8.550 12.628 -22.466 1.00119.82 N \nANISOU 2447 N SER A 308 14733 13879 16913 -797 -68 -117 N \nATOM 2448 CA SER A 308 8.594 13.241 -21.134 1.00118.98 C \nANISOU 2448 CA SER A 308 14681 13766 16760 -837 -63 -117 C \nATOM 2449 C SER A 308 9.842 14.095 -21.012 1.00114.54 C \nANISOU 2449 C SER A 308 14173 13159 16190 -901 -43 -143 C \nATOM 2450 O SER A 308 10.829 13.842 -21.699 1.00102.28 O \nANISOU 2450 O SER A 308 12584 11596 14681 -932 -56 -156 O \nATOM 2451 CB SER A 308 8.651 12.171 -20.032 1.00116.36 C \nANISOU 2451 CB SER A 308 14284 13473 16453 -883 -129 -95 C \nATOM 2452 OG SER A 308 7.492 11.349 -19.989 1.00113.72 O \nANISOU 2452 OG SER A 308 13905 13186 16119 -840 -151 -70 O \nATOM 2453 N ASN A 309 9.792 15.093 -20.132 1.00111.05 N \nANISOU 2453 N ASN A 309 13815 12693 15686 -925 -12 -151 N \nATOM 2454 CA ASN A 309 10.968 15.898 -19.804 1.00108.84 C \nANISOU 2454 CA ASN A 309 13591 12375 15387 -1004 4 -175 C \nATOM 2455 C ASN A 309 11.732 15.357 -18.609 1.00106.84 C \nANISOU 2455 C ASN A 309 13293 12149 15152 -1086 -50 -169 C \nATOM 2456 O ASN A 309 12.907 15.654 -18.442 1.00102.13 O \nANISOU 2456 O ASN A 309 12704 11542 14557 -1162 -55 -187 O \nATOM 2457 CB ASN A 309 10.575 17.346 -19.538 1.00112.47 C \nANISOU 2457 CB ASN A 309 14182 12786 15766 -990 70 -189 C \nATOM 2458 CG ASN A 309 10.182 18.076 -20.808 1.00117.97 C \nANISOU 2458 CG ASN A 309 14937 13444 16441 -922 126 -200 C \nATOM 2459 OD1 ASN A 309 10.770 17.857 -21.868 1.00114.97 O \nANISOU 2459 OD1 ASN A 309 14524 13059 16103 -928 125 -209 O \nATOM 2460 ND2 ASN A 309 9.185 18.942 -20.708 1.00119.27 N \nANISOU 2460 ND2 ASN A 309 15193 13585 16539 -854 176 -199 N \nATOM 2461 N LYS A 310 11.055 14.553 -17.792 1.00106.86 N \nANISOU 2461 N LYS A 310 13248 12192 15163 -1073 -90 -144 N \nATOM 2462 CA LYS A 310 11.608 14.083 -16.533 1.00 96.59 C \nANISOU 2462 CA LYS A 310 11914 10918 13868 -1144 -139 -135 C \nATOM 2463 C LYS A 310 11.126 12.667 -16.201 1.00 92.84 C \nANISOU 2463 C LYS A 310 11347 10491 13438 -1127 -203 -104 C \nATOM 2464 O LYS A 310 9.919 12.404 -16.123 1.00 99.10 O \nANISOU 2464 O LYS A 310 12136 11304 14214 -1073 -199 -86 O \nATOM 2465 CB LYS A 310 11.197 15.055 -15.425 1.00 92.66 C \nANISOU 2465 CB LYS A 310 11506 10406 13297 -1164 -107 -139 C \nATOM 2466 CG LYS A 310 11.802 14.754 -14.065 1.00 92.37 C \nANISOU 2466 CG LYS A 310 11447 10393 13255 -1246 -151 -132 C \nATOM 2467 CD LYS A 310 11.065 15.491 -12.964 1.00 90.73 C \nANISOU 2467 CD LYS A 310 11315 10180 12976 -1247 -123 -132 C \nATOM 2468 CE LYS A 310 11.628 15.132 -11.599 1.00 92.94 C \nANISOU 2468 CE LYS A 310 11569 10490 13252 -1330 -170 -122 C \nATOM 2469 NZ LYS A 310 11.200 16.125 -10.577 1.00 99.72 N \nANISOU 2469 NZ LYS A 310 12521 11333 14033 -1347 -132 -132 N \nATOM 2470 N LEU A 311 12.076 11.759 -16.008 1.00 82.10 N \nANISOU 2470 N LEU A 311 9914 9150 12129 -1174 -262 -98 N \nATOM 2471 CA LEU A 311 11.784 10.462 -15.394 1.00 89.21 C \nANISOU 2471 CA LEU A 311 10745 10089 13063 -1176 -328 -68 C \nATOM 2472 C LEU A 311 12.811 10.182 -14.318 1.00 83.57 C \nANISOU 2472 C LEU A 311 10006 9392 12356 -1253 -375 -64 C \nATOM 2473 O LEU A 311 13.914 9.689 -14.621 1.00 80.67 O \nANISOU 2473 O LEU A 311 9586 9031 12032 -1278 -408 -70 O \nATOM 2474 CB LEU A 311 11.791 9.308 -16.420 1.00 91.12 C \nANISOU 2474 CB LEU A 311 10913 10339 13369 -1134 -363 -58 C \nATOM 2475 CG LEU A 311 10.681 9.341 -17.487 1.00 97.61 C \nANISOU 2475 CG LEU A 311 11744 11157 14188 -1058 -327 -56 C \nATOM 2476 CD1 LEU A 311 10.852 8.192 -18.476 1.00 95.96 C \nANISOU 2476 CD1 LEU A 311 11466 10954 14043 -1029 -364 -50 C \nATOM 2477 CD2 LEU A 311 9.281 9.315 -16.883 1.00 98.30 C \nANISOU 2477 CD2 LEU A 311 11849 11271 14229 -1029 -319 -35 C \nATOM 2478 N VAL A 312 12.427 10.451 -13.066 1.00 77.68 N \nANISOU 2478 N VAL A 312 9291 8659 11565 -1286 -379 -53 N \nATOM 2479 CA VAL A 312 13.327 10.241 -11.906 1.00 74.76 C \nANISOU 2479 CA VAL A 312 8902 8310 11193 -1362 -423 -47 C \nATOM 2480 C VAL A 312 12.724 9.347 -10.799 1.00 73.97 C \nANISOU 2480 C VAL A 312 8771 8243 11090 -1374 -476 -13 C \nATOM 2481 O VAL A 312 11.685 9.653 -10.218 1.00 75.48 O \nANISOU 2481 O VAL A 312 9000 8443 11237 -1361 -455 -4 O \nATOM 2482 CB VAL A 312 13.758 11.583 -11.296 1.00 64.21 C \nANISOU 2482 CB VAL A 312 7644 6957 9796 -1418 -376 -71 C \nATOM 2483 CG1 VAL A 312 14.693 11.359 -10.130 1.00 58.70 C \nANISOU 2483 CG1 VAL A 312 6920 6289 9094 -1500 -422 -65 C \nATOM 2484 CG2 VAL A 312 14.444 12.428 -12.355 1.00 58.96 C \nANISOU 2484 CG2 VAL A 312 7013 6260 9130 -1420 -328 -104 C \nATOM 2485 N LEU A 313 13.410 8.258 -10.505 1.00 69.16 N \nANISOU 2485 N LEU A 313 8095 7657 10526 -1397 -544 6 N \nATOM 2486 CA LEU A 313 12.924 7.317 -9.512 1.00 75.20 C \nANISOU 2486 CA LEU A 313 8833 8450 11291 -1412 -600 40 C \nATOM 2487 C LEU A 313 13.510 7.670 -8.155 1.00 82.79 C \nANISOU 2487 C LEU A 313 9808 9431 12217 -1486 -617 43 C \nATOM 2488 O LEU A 313 14.735 7.745 -7.992 1.00 82.38 O \nANISOU 2488 O LEU A 313 9734 9387 12178 -1530 -636 33 O \nATOM 2489 CB LEU A 313 13.324 5.871 -9.866 1.00 67.87 C \nANISOU 2489 CB LEU A 313 7833 7527 10425 -1394 -669 62 C \nATOM 2490 CG LEU A 313 12.674 5.272 -11.108 1.00 68.02 C \nANISOU 2490 CG LEU A 313 7833 7530 10480 -1327 -664 65 C \nATOM 2491 CD1 LEU A 313 13.515 4.110 -11.626 1.00 61.81 C \nANISOU 2491 CD1 LEU A 313 6988 6740 9756 -1311 -722 72 C \nATOM 2492 CD2 LEU A 313 11.230 4.847 -10.811 1.00 69.84 C \nANISOU 2492 CD2 LEU A 313 8075 7775 10684 -1307 -667 90 C \nATOM 2493 N ALA A 314 12.645 7.854 -7.167 1.00 79.97 N \nANISOU 2493 N ALA A 314 9482 9088 11812 -1503 -613 57 N \nATOM 2494 CA ALA A 314 13.116 7.997 -5.805 1.00 80.29 C \nANISOU 2494 CA ALA A 314 9530 9153 11822 -1574 -639 65 C \nATOM 2495 C ALA A 314 13.679 6.660 -5.364 1.00 73.20 C \nANISOU 2495 C ALA A 314 8565 8280 10968 -1594 -722 97 C \nATOM 2496 O ALA A 314 13.055 5.626 -5.557 1.00 78.31 O \nANISOU 2496 O ALA A 314 9183 8930 11642 -1560 -760 123 O \nATOM 2497 CB ALA A 314 11.978 8.404 -4.898 1.00 87.59 C \nANISOU 2497 CB ALA A 314 10501 10093 12687 -1580 -616 74 C \nATOM 2498 N THR A 315 14.857 6.690 -4.767 1.00 65.04 N \nANISOU 2498 N THR A 315 7511 7266 9937 -1649 -752 94 N \nATOM 2499 CA THR A 315 15.454 5.510 -4.143 1.00 66.47 C \nANISOU 2499 CA THR A 315 7634 7473 10148 -1669 -833 126 C \nATOM 2500 C THR A 315 15.589 5.689 -2.617 1.00 75.21 C \nANISOU 2500 C THR A 315 8754 8613 11208 -1741 -857 141 C \nATOM 2501 O THR A 315 15.375 4.763 -1.844 1.00 81.53 O \nANISOU 2501 O THR A 315 9532 9432 12013 -1754 -915 176 O \nATOM 2502 CB THR A 315 16.844 5.221 -4.749 1.00 66.01 C \nANISOU 2502 CB THR A 315 7523 7424 10133 -1666 -859 114 C \nATOM 2503 OG1 THR A 315 17.732 6.365 -4.607 1.00 58.20 O \nANISOU 2503 OG1 THR A 315 6553 6449 9111 -1720 -819 82 O \nATOM 2504 CG2 THR A 315 16.684 4.870 -6.233 1.00 62.63 C \nANISOU 2504 CG2 THR A 315 7078 6965 9753 -1593 -844 103 C \nATOM 2505 N GLY A 316 15.952 6.888 -2.195 1.00 76.41 N \nANISOU 2505 N GLY A 316 8947 8770 11313 -1792 -810 114 N \nATOM 2506 CA GLY A 316 16.119 7.181 -0.792 1.00 75.02 C \nANISOU 2506 CA GLY A 316 8789 8626 11090 -1864 -826 123 C \nATOM 2507 C GLY A 316 14.856 7.723 -0.148 1.00 76.34 C \nANISOU 2507 C GLY A 316 9017 8788 11203 -1868 -788 124 C \nATOM 2508 O GLY A 316 13.742 7.474 -0.639 1.00 72.64 O \nANISOU 2508 O GLY A 316 8557 8302 10738 -1810 -772 132 O \nATOM 2509 N LEU A 317 15.058 8.523 0.909 1.00 71.69 N \nANISOU 2509 N LEU A 317 8467 8215 10556 -1935 -770 113 N \nATOM 2510 CA LEU A 317 14.003 8.969 1.809 1.00 77.13 C \nANISOU 2510 CA LEU A 317 9208 8912 11186 -1949 -745 117 C \nATOM 2511 C LEU A 317 13.583 10.423 1.629 1.00 73.94 C \nANISOU 2511 C LEU A 317 8891 8476 10726 -1943 -659 77 C \nATOM 2512 O LEU A 317 14.362 11.237 1.209 1.00 84.65 O \nANISOU 2512 O LEU A 317 10277 9810 12074 -1966 -623 47 O \nATOM 2513 CB LEU A 317 14.463 8.789 3.252 1.00 79.26 C \nANISOU 2513 CB LEU A 317 9466 9224 11425 -2030 -789 135 C \nATOM 2514 CG LEU A 317 15.098 7.430 3.554 1.00 86.56 C \nANISOU 2514 CG LEU A 317 10313 10180 12398 -2042 -878 175 C \nATOM 2515 CD1 LEU A 317 16.623 7.516 3.610 1.00 83.12 C \nANISOU 2515 CD1 LEU A 317 9841 9765 11976 -2089 -903 165 C \nATOM 2516 CD2 LEU A 317 14.542 6.868 4.853 1.00 87.19 C \nANISOU 2516 CD2 LEU A 317 10387 10294 12446 -2080 -922 209 C \nATOM 2517 N ARG A 318 12.349 10.736 1.986 1.00 69.22 N \nANISOU 2517 N ARG A 318 8335 7881 10084 -1914 -627 78 N \nATOM 2518 CA ARG A 318 11.912 12.117 2.092 1.00 72.83 C \nANISOU 2518 CA ARG A 318 8886 8310 10475 -1909 -549 43 C \nATOM 2519 C ARG A 318 12.936 12.910 2.889 1.00 81.37 C \nANISOU 2519 C ARG A 318 10009 9391 11518 -2000 -540 22 C \nATOM 2520 O ARG A 318 13.254 12.547 4.013 1.00 79.30 O \nANISOU 2520 O ARG A 318 9722 9168 11240 -2065 -584 40 O \nATOM 2521 CB ARG A 318 10.553 12.216 2.787 1.00 65.19 C \nANISOU 2521 CB ARG A 318 7947 7369 9455 -1881 -531 52 C \nATOM 2522 CG ARG A 318 9.380 11.820 1.915 1.00 62.76 C \nANISOU 2522 CG ARG A 318 7621 7064 9162 -1788 -516 63 C \nATOM 2523 CD ARG A 318 8.077 11.952 2.686 1.00 69.89 C \nANISOU 2523 CD ARG A 318 8544 8007 10002 -1766 -498 71 C \nATOM 2524 NE ARG A 318 6.935 11.331 2.031 1.00 74.20 N \nANISOU 2524 NE ARG A 318 9053 8581 10560 -1693 -499 89 N \nATOM 2525 CZ ARG A 318 6.105 11.942 1.199 1.00 78.41 C \nANISOU 2525 CZ ARG A 318 9620 9102 11069 -1610 -440 71 C \nATOM 2526 NH1 ARG A 318 6.253 13.220 0.909 1.00 86.92 N \nANISOU 2526 NH1 ARG A 318 10781 10134 12111 -1583 -372 34 N \nATOM 2527 NH2 ARG A 318 5.103 11.275 0.670 1.00 84.42 N \nANISOU 2527 NH2 ARG A 318 10336 9901 11838 -1554 -448 91 N \nATOM 2528 N ASN A 319 13.435 14.003 2.319 1.00 92.31 N \nANISOU 2528 N ASN A 319 11460 10732 12881 -2009 -482 -16 N \nATOM 2529 CA ASN A 319 14.503 14.785 2.963 1.00 94.55 C \nANISOU 2529 CA ASN A 319 11785 11015 13124 -2106 -471 -39 C \nATOM 2530 C ASN A 319 14.207 16.278 2.984 1.00 97.22 C \nANISOU 2530 C ASN A 319 12251 11301 13388 -2112 -388 -79 C \nATOM 2531 O ASN A 319 14.692 17.039 2.152 1.00 92.62 O \nANISOU 2531 O ASN A 319 11720 10673 12799 -2114 -344 -108 O \nATOM 2532 CB ASN A 319 15.818 14.518 2.248 1.00 92.53 C \nANISOU 2532 CB ASN A 319 11476 10765 12917 -2139 -497 -43 C \nATOM 2533 CG ASN A 319 16.953 15.341 2.794 1.00 85.87 C \nANISOU 2533 CG ASN A 319 10671 9930 12027 -2245 -484 -68 C \nATOM 2534 OD1 ASN A 319 17.024 15.608 3.987 1.00 96.72 O \nANISOU 2534 OD1 ASN A 319 12071 11328 13352 -2312 -491 -67 O \nATOM 2535 ND2 ASN A 319 17.839 15.773 1.910 1.00 80.13 N \nANISOU 2535 ND2 ASN A 319 9949 9185 11311 -2266 -462 -92 N \nATOM 2536 N SER A 320 13.352 16.680 3.914 1.00111.03 N \nANISOU 2536 N SER A 320 14055 13055 15077 -2109 -367 -81 N \nATOM 2537 CA SER A 320 13.143 18.101 4.189 1.00120.46 C \nANISOU 2537 CA SER A 320 15380 14200 16190 -2123 -292 -120 C \nATOM 2538 C SER A 320 13.942 18.499 5.439 1.00121.97 C \nANISOU 2538 C SER A 320 15600 14413 16331 -2242 -305 -130 C \nATOM 2539 O SER A 320 14.009 17.721 6.405 1.00113.15 O \nANISOU 2539 O SER A 320 14414 13355 15222 -2284 -362 -102 O \nATOM 2540 CB SER A 320 11.655 18.418 4.371 1.00119.85 C \nANISOU 2540 CB SER A 320 15355 14115 16067 -2034 -251 -122 C \nATOM 2541 OG SER A 320 11.483 19.710 4.931 1.00122.59 O \nANISOU 2541 OG SER A 320 15831 14421 16328 -2055 -188 -158 O \nATOM 2542 N PRO A 321 14.585 19.687 5.405 1.00123.58 N \nANISOU 2542 N PRO A 321 15906 14569 16480 -2302 -253 -168 N \nATOM 2543 CA PRO A 321 15.162 20.301 6.617 1.00129.03 C \nANISOU 2543 CA PRO A 321 16652 15272 17103 -2414 -249 -184 C \nATOM 2544 C PRO A 321 14.102 21.068 7.424 1.00120.80 C \nANISOU 2544 C PRO A 321 15713 14204 15981 -2386 -200 -201 C \nATOM 2545 O PRO A 321 14.319 22.210 7.823 1.00121.71 O \nANISOU 2545 O PRO A 321 15948 14274 16020 -2439 -149 -237 O \nATOM 2546 CB PRO A 321 16.262 21.237 6.065 1.00127.10 C \nANISOU 2546 CB PRO A 321 16476 14983 16831 -2489 -211 -220 C \nATOM 2547 CG PRO A 321 16.390 20.899 4.611 1.00132.97 C \nANISOU 2547 CG PRO A 321 17175 15706 17642 -2421 -210 -216 C \nATOM 2548 CD PRO A 321 15.048 20.375 4.191 1.00127.32 C \nANISOU 2548 CD PRO A 321 16434 14983 16960 -2289 -207 -196 C \nTER 2549 PRO A 321 \nATOM 2550 N ILE B 10 10.335 10.999 12.775 1.00 98.50 N \nANISOU 2550 N ILE B 10 12185 11944 13298 -1318 -779 -14 N \nATOM 2551 CA ILE B 10 8.929 11.517 12.661 1.00 96.54 C \nANISOU 2551 CA ILE B 10 11963 11743 12975 -1172 -805 -52 C \nATOM 2552 C ILE B 10 8.875 13.057 12.671 1.00109.89 C \nANISOU 2552 C ILE B 10 13864 13327 14561 -1085 -863 -78 C \nATOM 2553 O ILE B 10 8.087 13.668 11.945 1.00131.03 O \nANISOU 2553 O ILE B 10 16628 15995 17163 -964 -896 -111 O \nATOM 2554 CB ILE B 10 7.973 10.906 13.718 1.00 86.39 C \nANISOU 2554 CB ILE B 10 10547 10605 11672 -1118 -796 -66 C \nATOM 2555 CG1 ILE B 10 7.021 11.966 14.305 1.00 81.91 C \nANISOU 2555 CG1 ILE B 10 10043 10096 10984 -945 -840 -116 C \nATOM 2556 CG2 ILE B 10 8.762 10.211 14.809 1.00 85.96 C \nANISOU 2556 CG2 ILE B 10 10433 10548 11681 -1221 -777 -37 C \nATOM 2557 CD1 ILE B 10 5.836 11.407 15.069 1.00 79.19 C \nANISOU 2557 CD1 ILE B 10 9534 9975 10580 -884 -831 -139 C \nATOM 2558 N GLU B 11 9.721 13.681 13.476 1.00107.55 N \nANISOU 2558 N GLU B 11 13676 12945 14246 -1145 -886 -66 N \nATOM 2559 CA GLU B 11 9.855 15.135 13.460 1.00105.55 C \nANISOU 2559 CA GLU B 11 13687 12545 13872 -1103 -959 -81 C \nATOM 2560 C GLU B 11 10.726 15.593 12.287 1.00101.41 C \nANISOU 2560 C GLU B 11 13298 11908 13326 -1248 -973 -50 C \nATOM 2561 O GLU B 11 10.928 16.796 12.091 1.00110.87 O \nANISOU 2561 O GLU B 11 14765 12958 14403 -1261 -1046 -53 O \nATOM 2562 CB GLU B 11 10.437 15.614 14.793 1.00112.40 C \nANISOU 2562 CB GLU B 11 14632 13365 14709 -1143 -984 -74 C \nATOM 2563 CG GLU B 11 9.608 15.254 16.020 1.00119.89 C \nANISOU 2563 CG GLU B 11 15457 14435 15661 -1007 -975 -105 C \nATOM 2564 CD GLU B 11 8.176 15.776 15.979 1.00121.49 C \nANISOU 2564 CD GLU B 11 15705 14707 15749 -756 -1022 -170 C \nATOM 2565 OE1 GLU B 11 7.963 16.954 16.363 1.00120.68 O \nANISOU 2565 OE1 GLU B 11 15834 14507 15512 -621 -1103 -207 O \nATOM 2566 OE2 GLU B 11 7.257 15.005 15.595 1.00120.50 O \nANISOU 2566 OE2 GLU B 11 15391 14749 15644 -689 -985 -187 O \nATOM 2567 N GLY B 12 11.217 14.633 11.500 1.00 97.18 N \nANISOU 2567 N GLY B 12 12595 11444 12886 -1357 -912 -23 N \nATOM 2568 CA GLY B 12 12.164 14.882 10.420 1.00 99.41 C \nANISOU 2568 CA GLY B 12 12943 11679 13147 -1518 -912 9 C \nATOM 2569 C GLY B 12 13.309 13.884 10.483 1.00103.90 C \nANISOU 2569 C GLY B 12 13316 12364 13799 -1663 -851 39 C \nATOM 2570 O GLY B 12 13.395 13.085 11.421 1.00 99.47 O \nANISOU 2570 O GLY B 12 12609 11878 13306 -1637 -820 38 O \nATOM 2571 N GLY B 13 14.188 13.936 9.483 1.00102.21 N \nANISOU 2571 N GLY B 13 13101 12177 13557 -1803 -842 62 N \nATOM 2572 CA GLY B 13 15.341 13.027 9.397 1.00100.43 C \nANISOU 2572 CA GLY B 13 12684 12103 13371 -1906 -793 78 C \nATOM 2573 C GLY B 13 16.567 13.479 10.187 1.00 94.76 C \nANISOU 2573 C GLY B 13 11978 11448 12580 -2069 -802 100 C \nATOM 2574 O GLY B 13 16.677 14.638 10.572 1.00 90.46 O \nANISOU 2574 O GLY B 13 11632 10804 11936 -2161 -852 116 O \nATOM 2575 N TRP B 14 17.483 12.546 10.437 1.00 97.22 N \nANISOU 2575 N TRP B 14 12091 11928 12921 -2096 -762 99 N \nATOM 2576 CA TRP B 14 18.706 12.819 11.225 1.00 87.73 C \nANISOU 2576 CA TRP B 14 10848 10846 11641 -2243 -763 115 C \nATOM 2577 C TRP B 14 19.831 13.235 10.289 1.00 87.49 C \nANISOU 2577 C TRP B 14 10791 10971 11479 -2447 -763 135 C \nATOM 2578 O TRP B 14 20.543 12.376 9.735 1.00 80.42 O \nANISOU 2578 O TRP B 14 9697 10281 10577 -2430 -728 118 O \nATOM 2579 CB TRP B 14 19.233 11.585 11.988 1.00 81.86 C \nANISOU 2579 CB TRP B 14 9895 10246 10961 -2150 -727 93 C \nATOM 2580 CG TRP B 14 18.445 10.912 13.070 1.00 79.70 C \nANISOU 2580 CG TRP B 14 9600 9887 10794 -1993 -724 78 C \nATOM 2581 CD1 TRP B 14 18.558 9.572 13.474 1.00 78.23 C \nANISOU 2581 CD1 TRP B 14 9278 9772 10674 -1870 -706 56 C \nATOM 2582 CD2 TRP B 14 17.461 11.498 13.919 1.00 81.77 C \nANISOU 2582 CD2 TRP B 14 9989 9994 11085 -1943 -746 81 C \nATOM 2583 NE1 TRP B 14 17.697 9.324 14.511 1.00 80.69 N \nANISOU 2583 NE1 TRP B 14 9625 9981 11055 -1787 -713 54 N \nATOM 2584 CE2 TRP B 14 16.998 10.473 14.792 1.00 85.22 C \nANISOU 2584 CE2 TRP B 14 10334 10436 11608 -1820 -732 66 C \nATOM 2585 CE3 TRP B 14 16.890 12.776 14.010 1.00 79.31 C \nANISOU 2585 CE3 TRP B 14 9877 9541 10714 -1975 -787 89 C \nATOM 2586 CZ2 TRP B 14 16.000 10.700 15.739 1.00 83.85 C \nANISOU 2586 CZ2 TRP B 14 10221 10173 11464 -1746 -746 61 C \nATOM 2587 CZ3 TRP B 14 15.897 12.993 14.949 1.00 81.65 C \nANISOU 2587 CZ3 TRP B 14 10241 9743 11038 -1857 -807 75 C \nATOM 2588 CH2 TRP B 14 15.466 11.969 15.809 1.00 82.52 C \nANISOU 2588 CH2 TRP B 14 10216 9902 11237 -1753 -781 62 C \nATOM 2589 N GLN B 15 20.023 14.540 10.134 1.00 88.03 N \nANISOU 2589 N GLN B 15 11071 10959 11417 -2642 -811 168 N \nATOM 2590 CA GLN B 15 21.163 15.044 9.387 1.00 90.13 C \nANISOU 2590 CA GLN B 15 11323 11404 11517 -2903 -818 197 C \nATOM 2591 C GLN B 15 22.458 14.357 9.849 1.00 89.56 C \nANISOU 2591 C GLN B 15 10983 11654 11393 -2968 -777 187 C \nATOM 2592 O GLN B 15 23.414 14.208 9.069 1.00 83.33 O \nANISOU 2592 O GLN B 15 10044 11131 10485 -3100 -758 189 O \nATOM 2593 CB GLN B 15 21.274 16.552 9.556 1.00 98.24 C \nANISOU 2593 CB GLN B 15 12663 12281 12381 -3140 -894 242 C \nATOM 2594 CG GLN B 15 22.294 17.200 8.617 1.00101.74 C \nANISOU 2594 CG GLN B 15 13147 12892 12620 -3465 -915 284 C \nATOM 2595 CD GLN B 15 21.963 17.092 7.119 1.00108.69 C \nANISOU 2595 CD GLN B 15 14031 13764 13501 -3450 -908 281 C \nATOM 2596 OE1 GLN B 15 20.810 16.900 6.701 1.00100.38 O \nANISOU 2596 OE1 GLN B 15 13057 12505 12577 -3225 -910 256 O \nATOM 2597 NE2 GLN B 15 23.001 17.207 6.298 1.00115.48 N \nANISOU 2597 NE2 GLN B 15 14788 14886 14201 -3699 -898 305 N \nATOM 2598 N GLY B 16 22.469 13.940 11.118 1.00 86.77 N \nANISOU 2598 N GLY B 16 10563 11294 11110 -2860 -766 172 N \nATOM 2599 CA GLY B 16 23.629 13.354 11.746 1.00 85.33 C \nANISOU 2599 CA GLY B 16 10153 11398 10869 -2889 -737 155 C \nATOM 2600 C GLY B 16 23.828 11.867 11.534 1.00 93.01 C \nANISOU 2600 C GLY B 16 10879 12538 11923 -2648 -696 102 C \nATOM 2601 O GLY B 16 24.868 11.346 11.924 1.00 94.95 O \nANISOU 2601 O GLY B 16 10929 13059 12089 -2638 -681 76 O \nATOM 2602 N MET B 17 22.866 11.164 10.931 1.00 96.92 N \nANISOU 2602 N MET B 17 11393 12880 12553 -2447 -688 81 N \nATOM 2603 CA MET B 17 23.039 9.730 10.731 1.00 91.64 C \nANISOU 2603 CA MET B 17 10551 12332 11938 -2218 -669 30 C \nATOM 2604 C MET B 17 23.583 9.424 9.353 1.00 89.71 C \nANISOU 2604 C MET B 17 10190 12290 11608 -2222 -657 10 C \nATOM 2605 O MET B 17 22.848 9.360 8.374 1.00 95.64 O \nANISOU 2605 O MET B 17 11010 12910 12418 -2179 -656 14 O \nATOM 2606 CB MET B 17 21.766 8.933 10.959 1.00 94.86 C \nANISOU 2606 CB MET B 17 11038 12489 12515 -2008 -673 18 C \nATOM 2607 CG MET B 17 22.051 7.434 10.827 1.00 94.43 C \nANISOU 2607 CG MET B 17 10862 12537 12479 -1789 -676 -31 C \nATOM 2608 SD MET B 17 20.830 6.371 11.545 1.00 83.59 S \nANISOU 2608 SD MET B 17 9588 10917 11254 -1601 -696 -39 S \nATOM 2609 CE MET B 17 19.406 6.949 10.611 1.00 93.12 C \nANISOU 2609 CE MET B 17 10926 11911 12545 -1650 -688 -7 C \nATOM 2610 N VAL B 18 24.882 9.216 9.302 1.00 97.10 N \nANISOU 2610 N VAL B 18 10932 13572 12390 -2262 -649 -16 N \nATOM 2611 CA VAL B 18 25.612 8.977 8.063 1.00106.11 C \nANISOU 2611 CA VAL B 18 11920 14997 13402 -2276 -639 -43 C \nATOM 2612 C VAL B 18 25.819 7.474 7.841 1.00111.64 C \nANISOU 2612 C VAL B 18 12485 15813 14118 -1952 -645 -117 C \nATOM 2613 O VAL B 18 26.220 7.048 6.761 1.00127.41 O \nANISOU 2613 O VAL B 18 14372 18007 16033 -1879 -643 -152 O \nATOM 2614 CB VAL B 18 26.997 9.691 8.102 1.00108.80 C \nANISOU 2614 CB VAL B 18 12103 15731 13505 -2530 -632 -34 C \nATOM 2615 CG1 VAL B 18 26.825 11.168 8.462 1.00106.16 C \nANISOU 2615 CG1 VAL B 18 11966 15242 13126 -2865 -647 43 C \nATOM 2616 CG2 VAL B 18 27.957 9.016 9.085 1.00105.72 C \nANISOU 2616 CG2 VAL B 18 11517 15620 13030 -2402 -632 -85 C \nATOM 2617 N ASP B 19 25.550 6.686 8.874 1.00110.47 N \nANISOU 2617 N ASP B 19 12373 15538 14062 -1757 -663 -141 N \nATOM 2618 CA ASP B 19 25.852 5.250 8.898 1.00114.42 C \nANISOU 2618 CA ASP B 19 12803 16131 14542 -1443 -693 -215 C \nATOM 2619 C ASP B 19 24.864 4.378 8.078 1.00119.32 C \nANISOU 2619 C ASP B 19 13552 16509 15276 -1263 -715 -227 C \nATOM 2620 O ASP B 19 25.169 3.232 7.719 1.00110.14 O \nANISOU 2620 O ASP B 19 12363 15431 14057 -1011 -754 -290 O \nATOM 2621 CB ASP B 19 25.851 4.763 10.361 1.00121.88 C \nANISOU 2621 CB ASP B 19 13789 16984 15534 -1331 -716 -227 C \nATOM 2622 CG ASP B 19 26.915 5.447 11.213 1.00123.38 C \nANISOU 2622 CG ASP B 19 13839 17442 15596 -1476 -700 -225 C \nATOM 2623 OD1 ASP B 19 27.827 6.083 10.636 1.00130.80 O \nANISOU 2623 OD1 ASP B 19 14620 18708 16371 -1638 -679 -226 O \nATOM 2624 OD2 ASP B 19 26.835 5.337 12.458 1.00120.99 O \nANISOU 2624 OD2 ASP B 19 13585 17038 15346 -1445 -711 -220 O \nATOM 2625 N GLY B 20 23.673 4.906 7.799 1.00112.74 N \nANISOU 2625 N GLY B 20 12872 15379 14584 -1381 -699 -171 N \nATOM 2626 CA GLY B 20 22.632 4.121 7.132 1.00101.22 C \nANISOU 2626 CA GLY B 20 11538 13690 13230 -1246 -719 -174 C \nATOM 2627 C GLY B 20 21.363 4.893 6.824 1.00 94.23 C \nANISOU 2627 C GLY B 20 10789 12545 12471 -1390 -697 -116 C \nATOM 2628 O GLY B 20 21.327 6.122 6.932 1.00 93.10 O \nANISOU 2628 O GLY B 20 10665 12389 12322 -1586 -673 -75 O \nATOM 2629 N TRP B 21 20.311 4.160 6.469 1.00 85.18 N \nANISOU 2629 N TRP B 21 9754 11194 11418 -1287 -716 -114 N \nATOM 2630 CA TRP B 21 19.023 4.780 6.121 1.00 88.66 C \nANISOU 2630 CA TRP B 21 10304 11423 11959 -1383 -700 -70 C \nATOM 2631 C TRP B 21 18.104 4.923 7.309 1.00 77.47 C \nANISOU 2631 C TRP B 21 8977 9832 10625 -1408 -704 -44 C \nATOM 2632 O TRP B 21 17.440 5.937 7.458 1.00 69.48 O \nANISOU 2632 O TRP B 21 8023 8728 9648 -1510 -689 -14 O \nATOM 2633 CB TRP B 21 18.311 3.981 5.027 1.00100.63 C \nANISOU 2633 CB TRP B 21 11875 12850 13511 -1288 -714 -80 C \nATOM 2634 CG TRP B 21 18.773 4.299 3.627 1.00111.53 C \nANISOU 2634 CG TRP B 21 13189 14353 14832 -1316 -698 -90 C \nATOM 2635 CD1 TRP B 21 19.765 5.156 3.259 1.00116.05 C \nANISOU 2635 CD1 TRP B 21 13660 15126 15309 -1432 -674 -90 C \nATOM 2636 CD2 TRP B 21 18.270 3.732 2.421 1.00114.58 C \nANISOU 2636 CD2 TRP B 21 13612 14687 15237 -1244 -707 -100 C \nATOM 2637 NE1 TRP B 21 19.896 5.173 1.902 1.00118.04 N \nANISOU 2637 NE1 TRP B 21 13874 15456 15519 -1436 -666 -99 N \nATOM 2638 CE2 TRP B 21 18.993 4.300 1.361 1.00114.79 C \nANISOU 2638 CE2 TRP B 21 13546 14885 15185 -1307 -685 -108 C \nATOM 2639 CE3 TRP B 21 17.271 2.794 2.132 1.00119.86 C \nANISOU 2639 CE3 TRP B 21 14388 15188 15967 -1153 -735 -99 C \nATOM 2640 CZ2 TRP B 21 18.754 3.963 0.029 1.00123.21 C \nANISOU 2640 CZ2 TRP B 21 14616 15951 16247 -1257 -686 -119 C \nATOM 2641 CZ3 TRP B 21 17.030 2.460 0.801 1.00123.94 C \nANISOU 2641 CZ3 TRP B 21 14918 15698 16476 -1110 -739 -109 C \nATOM 2642 CH2 TRP B 21 17.768 3.047 -0.232 1.00120.36 C \nANISOU 2642 CH2 TRP B 21 14364 15408 15959 -1149 -713 -121 C \nATOM 2643 N TYR B 22 18.058 3.885 8.133 1.00 75.47 N \nANISOU 2643 N TYR B 22 8751 9539 10385 -1302 -735 -59 N \nATOM 2644 CA TYR B 22 17.300 3.938 9.368 1.00 74.67 C \nANISOU 2644 CA TYR B 22 8714 9315 10341 -1333 -740 -36 C \nATOM 2645 C TYR B 22 18.193 3.599 10.537 1.00 73.58 C \nANISOU 2645 C TYR B 22 8540 9254 10165 -1290 -757 -53 C \nATOM 2646 O TYR B 22 19.192 2.886 10.380 1.00 77.57 O \nANISOU 2646 O TYR B 22 8996 9882 10595 -1179 -781 -92 O \nATOM 2647 CB TYR B 22 16.160 2.939 9.346 1.00 80.65 C \nANISOU 2647 CB TYR B 22 9571 9932 11140 -1286 -771 -27 C \nATOM 2648 CG TYR B 22 15.540 2.714 7.993 1.00 78.65 C \nANISOU 2648 CG TYR B 22 9348 9639 10897 -1276 -770 -25 C \nATOM 2649 CD1 TYR B 22 15.668 1.493 7.348 1.00 72.31 C \nANISOU 2649 CD1 TYR B 22 8605 8812 10056 -1176 -814 -45 C \nATOM 2650 CD2 TYR B 22 14.792 3.719 7.378 1.00 72.99 C \nANISOU 2650 CD2 TYR B 22 8623 8896 10215 -1354 -736 -5 C \nATOM 2651 CE1 TYR B 22 15.077 1.277 6.122 1.00 71.02 C \nANISOU 2651 CE1 TYR B 22 8475 8607 9902 -1174 -815 -42 C \nATOM 2652 CE2 TYR B 22 14.186 3.507 6.157 1.00 69.17 C \nANISOU 2652 CE2 TYR B 22 8163 8378 9740 -1343 -736 -4 C \nATOM 2653 CZ TYR B 22 14.338 2.286 5.526 1.00 68.58 C \nANISOU 2653 CZ TYR B 22 8129 8288 9639 -1263 -770 -20 C \nATOM 2654 OH TYR B 22 13.764 2.098 4.287 1.00 58.31 O \nANISOU 2654 OH TYR B 22 6854 6956 8346 -1259 -770 -18 O \nATOM 2655 N GLY B 23 17.827 4.105 11.710 1.00 67.41 N \nANISOU 2655 N GLY B 23 7780 8411 9421 -1357 -749 -30 N \nATOM 2656 CA GLY B 23 18.586 3.811 12.916 1.00 67.35 C \nANISOU 2656 CA GLY B 23 7745 8463 9383 -1322 -764 -43 C \nATOM 2657 C GLY B 23 18.122 4.524 14.149 1.00 65.58 C \nANISOU 2657 C GLY B 23 7545 8172 9202 -1407 -751 -16 C \nATOM 2658 O GLY B 23 16.969 4.960 14.238 1.00 57.40 O \nANISOU 2658 O GLY B 23 6565 7026 8217 -1456 -742 8 O \nATOM 2659 N TYR B 24 19.039 4.688 15.095 1.00 72.70 N \nANISOU 2659 N TYR B 24 8394 9163 10065 -1413 -751 -25 N \nATOM 2660 CA TYR B 24 18.679 5.182 16.436 1.00 73.56 C \nANISOU 2660 CA TYR B 24 8533 9208 10209 -1471 -747 -5 C \nATOM 2661 C TYR B 24 19.477 6.398 16.846 1.00 71.66 C \nANISOU 2661 C TYR B 24 8249 9057 9923 -1583 -726 5 C \nATOM 2662 O TYR B 24 20.494 6.727 16.234 1.00 85.61 O \nANISOU 2662 O TYR B 24 9940 10976 11612 -1631 -717 -6 O \nATOM 2663 CB TYR B 24 18.910 4.091 17.464 1.00 73.51 C \nANISOU 2663 CB TYR B 24 8543 9190 10196 -1381 -781 -19 C \nATOM 2664 CG TYR B 24 18.343 2.738 17.077 1.00 78.55 C \nANISOU 2664 CG TYR B 24 9273 9737 10835 -1286 -825 -28 C \nATOM 2665 CD1 TYR B 24 19.108 1.822 16.349 1.00 77.93 C \nANISOU 2665 CD1 TYR B 24 9201 9721 10689 -1155 -860 -66 C \nATOM 2666 CD2 TYR B 24 17.045 2.371 17.443 1.00 78.26 C \nANISOU 2666 CD2 TYR B 24 9326 9569 10840 -1333 -839 1 C \nATOM 2667 CE1 TYR B 24 18.606 0.572 16.014 1.00 75.74 C \nANISOU 2667 CE1 TYR B 24 9061 9327 10389 -1072 -919 -73 C \nATOM 2668 CE2 TYR B 24 16.532 1.131 17.113 1.00 80.81 C \nANISOU 2668 CE2 TYR B 24 9765 9802 11136 -1292 -890 2 C \nATOM 2669 CZ TYR B 24 17.322 0.230 16.397 1.00 84.60 C \nANISOU 2669 CZ TYR B 24 10295 10298 11553 -1161 -935 -34 C \nATOM 2670 OH TYR B 24 16.842 -1.012 16.046 1.00 95.24 O \nANISOU 2670 OH TYR B 24 11810 11527 12851 -1121 -1004 -33 O \nATOM 2671 N HIS B 25 18.991 7.076 17.870 1.00 64.47 N \nANISOU 2671 N HIS B 25 7391 8063 9041 -1638 -725 25 N \nATOM 2672 CA HIS B 25 19.746 8.081 18.552 1.00 62.42 C \nANISOU 2672 CA HIS B 25 7125 7863 8727 -1747 -720 36 C \nATOM 2673 C HIS B 25 19.456 7.974 20.019 1.00 64.92 C \nANISOU 2673 C HIS B 25 7464 8121 9081 -1722 -728 40 C \nATOM 2674 O HIS B 25 18.317 8.182 20.446 1.00 67.87 O \nANISOU 2674 O HIS B 25 7910 8374 9504 -1700 -734 51 O \nATOM 2675 CB HIS B 25 19.414 9.492 18.103 1.00 66.88 C \nANISOU 2675 CB HIS B 25 7797 8357 9259 -1867 -722 60 C \nATOM 2676 CG HIS B 25 20.190 10.535 18.854 1.00 79.24 C \nANISOU 2676 CG HIS B 25 9403 9961 10744 -2008 -732 77 C \nATOM 2677 ND1 HIS B 25 21.570 10.592 18.851 1.00 89.42 N \nANISOU 2677 ND1 HIS B 25 10590 11448 11935 -2114 -724 76 N \nATOM 2678 CD2 HIS B 25 19.776 11.535 19.667 1.00 82.86 C \nANISOU 2678 CD2 HIS B 25 9997 10300 11186 -2060 -755 93 C \nATOM 2679 CE1 HIS B 25 21.969 11.599 19.605 1.00 93.90 C \nANISOU 2679 CE1 HIS B 25 11237 12008 12433 -2259 -741 100 C \nATOM 2680 NE2 HIS B 25 20.897 12.192 20.106 1.00 91.00 N \nANISOU 2680 NE2 HIS B 25 11031 11428 12116 -2220 -763 110 N \nATOM 2681 N HIS B 26 20.487 7.669 20.799 1.00 65.45 N \nANISOU 2681 N HIS B 26 7457 8302 9108 -1721 -731 29 N \nATOM 2682 CA HIS B 26 20.353 7.604 22.247 1.00 67.88 C \nANISOU 2682 CA HIS B 26 7783 8565 9444 -1708 -739 34 C \nATOM 2683 C HIS B 26 20.972 8.823 22.938 1.00 71.61 C \nANISOU 2683 C HIS B 26 8273 9077 9860 -1841 -736 51 C \nATOM 2684 O HIS B 26 21.858 9.490 22.421 1.00 72.38 O \nANISOU 2684 O HIS B 26 8344 9289 9869 -1957 -731 56 O \nATOM 2685 CB HIS B 26 20.978 6.302 22.777 1.00 71.12 C \nANISOU 2685 CB HIS B 26 8130 9049 9843 -1591 -757 6 C \nATOM 2686 CG HIS B 26 22.472 6.320 22.834 1.00 77.58 C \nANISOU 2686 CG HIS B 26 8833 10081 10562 -1597 -755 -19 C \nATOM 2687 ND1 HIS B 26 23.259 6.089 21.730 1.00 78.30 N \nANISOU 2687 ND1 HIS B 26 8836 10342 10574 -1567 -752 -45 N \nATOM 2688 CD2 HIS B 26 23.327 6.541 23.865 1.00 82.42 C \nANISOU 2688 CD2 HIS B 26 9386 10805 11124 -1628 -755 -24 C \nATOM 2689 CE1 HIS B 26 24.535 6.180 22.071 1.00 85.02 C \nANISOU 2689 CE1 HIS B 26 9563 11427 11315 -1581 -750 -69 C \nATOM 2690 NE2 HIS B 26 24.604 6.444 23.364 1.00 80.88 N \nANISOU 2690 NE2 HIS B 26 9056 10867 10809 -1621 -752 -56 N \nATOM 2691 N SER B 27 20.489 9.095 24.127 1.00 73.46 N \nANISOU 2691 N SER B 27 8561 9222 10128 -1837 -743 60 N \nATOM 2692 CA SER B 27 21.135 10.040 24.991 1.00 74.30 C \nANISOU 2692 CA SER B 27 8696 9359 10176 -1949 -749 74 C \nATOM 2693 C SER B 27 20.994 9.525 26.426 1.00 71.58 C \nANISOU 2693 C SER B 27 8329 8990 9878 -1882 -754 69 C \nATOM 2694 O SER B 27 19.908 9.134 26.849 1.00 68.20 O \nANISOU 2694 O SER B 27 7938 8458 9517 -1799 -759 68 O \nATOM 2695 CB SER B 27 20.547 11.441 24.815 1.00 71.04 C \nANISOU 2695 CB SER B 27 8449 8816 9727 -2036 -770 95 C \nATOM 2696 OG SER B 27 19.241 11.516 25.348 1.00 78.57 O \nANISOU 2696 OG SER B 27 9479 9633 10740 -1929 -782 89 O \nATOM 2697 N ASN B 28 22.111 9.510 27.151 1.00 70.71 N \nANISOU 2697 N ASN B 28 8148 9004 9715 -1928 -752 65 N \nATOM 2698 CA ASN B 28 22.140 9.052 28.539 1.00 69.33 C \nANISOU 2698 CA ASN B 28 7953 8817 9573 -1874 -759 60 C \nATOM 2699 C ASN B 28 23.273 9.726 29.317 1.00 67.05 C \nANISOU 2699 C ASN B 28 7628 8647 9202 -1989 -759 66 C \nATOM 2700 O ASN B 28 23.911 10.625 28.795 1.00 68.41 O \nANISOU 2700 O ASN B 28 7811 8898 9282 -2137 -758 81 O \nATOM 2701 CB ASN B 28 22.252 7.522 28.601 1.00 71.75 C \nANISOU 2701 CB ASN B 28 8192 9161 9907 -1726 -768 33 C \nATOM 2702 CG ASN B 28 23.530 6.997 27.966 1.00 72.41 C \nANISOU 2702 CG ASN B 28 8162 9447 9905 -1684 -770 1 C \nATOM 2703 OD1 ASN B 28 24.323 7.755 27.414 1.00 72.76 O \nANISOU 2703 OD1 ASN B 28 8144 9635 9865 -1794 -754 4 O \nATOM 2704 ND2 ASN B 28 23.724 5.688 28.028 1.00 67.60 N \nANISOU 2704 ND2 ASN B 28 7535 8860 9288 -1524 -797 -32 N \nATOM 2705 N GLU B 29 23.485 9.313 30.570 1.00 62.94 N \nANISOU 2705 N GLU B 29 7075 8139 8701 -1941 -764 59 N \nATOM 2706 CA GLU B 29 24.553 9.856 31.435 1.00 69.03 C \nANISOU 2706 CA GLU B 29 7800 9037 9392 -2046 -764 64 C \nATOM 2707 C GLU B 29 25.970 9.707 30.793 1.00 69.58 C \nANISOU 2707 C GLU B 29 7718 9385 9333 -2101 -755 44 C \nATOM 2708 O GLU B 29 26.795 10.591 30.936 1.00 70.89 O \nANISOU 2708 O GLU B 29 7863 9683 9388 -2281 -754 61 O \nATOM 2709 CB GLU B 29 24.489 9.245 32.862 1.00 67.89 C \nANISOU 2709 CB GLU B 29 7639 8861 9296 -1956 -772 54 C \nATOM 2710 CG GLU B 29 24.548 7.703 32.875 1.00 80.65 C \nANISOU 2710 CG GLU B 29 9193 10510 10942 -1773 -784 20 C \nATOM 2711 CD GLU B 29 23.196 6.947 32.601 1.00 84.08 C \nANISOU 2711 CD GLU B 29 9717 10759 11470 -1679 -796 25 C \nATOM 2712 OE1 GLU B 29 22.068 7.480 32.757 1.00 70.69 O \nANISOU 2712 OE1 GLU B 29 8101 8927 9831 -1720 -791 49 O \nATOM 2713 OE2 GLU B 29 23.257 5.763 32.220 1.00 90.59 O \nANISOU 2713 OE2 GLU B 29 10539 11592 12288 -1558 -819 2 O \nATOM 2714 N GLN B 30 26.187 8.636 30.030 1.00 70.60 N \nANISOU 2714 N GLN B 30 7755 9612 9459 -1954 -755 8 N \nATOM 2715 CA GLN B 30 27.435 8.407 29.304 1.00 71.80 C \nANISOU 2715 CA GLN B 30 7742 10069 9470 -1960 -749 -25 C \nATOM 2716 C GLN B 30 27.544 9.270 28.023 1.00 82.63 C \nANISOU 2716 C GLN B 30 9119 11506 10772 -2133 -736 -1 C \nATOM 2717 O GLN B 30 28.549 9.178 27.290 1.00 79.12 O \nANISOU 2717 O GLN B 30 8522 11352 10189 -2168 -728 -25 O \nATOM 2718 CB GLN B 30 27.621 6.921 28.952 1.00 74.22 C \nANISOU 2718 CB GLN B 30 7979 10448 9773 -1699 -770 -82 C \nATOM 2719 CG GLN B 30 27.780 5.999 30.154 1.00 88.27 C \nANISOU 2719 CG GLN B 30 9765 12205 11570 -1530 -800 -112 C \nATOM 2720 CD GLN B 30 26.457 5.469 30.704 1.00101.23 C \nANISOU 2720 CD GLN B 30 11579 13524 13360 -1460 -819 -90 C \nATOM 2721 OE1 GLN B 30 25.371 5.927 30.329 1.00113.12 O \nANISOU 2721 OE1 GLN B 30 13183 14838 14959 -1543 -804 -51 O \nATOM 2722 NE2 GLN B 30 26.544 4.497 31.599 1.00106.08 N \nANISOU 2722 NE2 GLN B 30 12232 14098 13974 -1310 -857 -115 N \nATOM 2723 N GLY B 31 26.564 10.147 27.774 1.00 88.84 N \nANISOU 2723 N GLY B 31 10080 12048 11627 -2241 -738 43 N \nATOM 2724 CA GLY B 31 26.548 10.982 26.557 1.00 88.40 C \nANISOU 2724 CA GLY B 31 10080 12004 11504 -2403 -737 68 C \nATOM 2725 C GLY B 31 25.512 10.516 25.534 1.00 85.79 C \nANISOU 2725 C GLY B 31 9810 11508 11278 -2272 -733 61 C \nATOM 2726 O GLY B 31 24.456 10.035 25.891 1.00 87.55 O \nANISOU 2726 O GLY B 31 10107 11527 11629 -2129 -738 57 O \nATOM 2727 N SER B 32 25.832 10.680 24.255 1.00 84.37 N \nANISOU 2727 N SER B 32 9591 11441 11026 -2342 -727 61 N \nATOM 2728 CA SER B 32 24.884 10.501 23.181 1.00 75.56 C \nANISOU 2728 CA SER B 32 8550 10170 9989 -2266 -725 62 C \nATOM 2729 C SER B 32 25.545 9.907 21.943 1.00 79.42 C \nANISOU 2729 C SER B 32 8895 10876 10404 -2228 -712 33 C \nATOM 2730 O SER B 32 26.767 9.747 21.893 1.00 73.28 O \nANISOU 2730 O SER B 32 7951 10400 9492 -2271 -706 11 O \nATOM 2731 CB SER B 32 24.231 11.836 22.833 1.00 70.82 C \nANISOU 2731 CB SER B 32 8154 9381 9372 -2427 -744 105 C \nATOM 2732 OG SER B 32 25.063 12.639 22.062 1.00 71.92 O \nANISOU 2732 OG SER B 32 8297 9670 9359 -2650 -751 127 O \nATOM 2733 N GLY B 33 24.720 9.541 20.962 1.00 81.60 N \nANISOU 2733 N GLY B 33 9224 11023 10759 -2134 -710 29 N \nATOM 2734 CA GLY B 33 25.226 8.971 19.716 1.00 82.94 C \nANISOU 2734 CA GLY B 33 9275 11376 10865 -2079 -702 -1 C \nATOM 2735 C GLY B 33 24.176 8.441 18.750 1.00 81.83 C \nANISOU 2735 C GLY B 33 9208 11055 10828 -1955 -703 -5 C \nATOM 2736 O GLY B 33 23.069 8.111 19.150 1.00 82.18 O \nANISOU 2736 O GLY B 33 9359 10869 10997 -1860 -711 2 O \nATOM 2737 N TYR B 34 24.537 8.377 17.468 1.00 83.49 N \nANISOU 2737 N TYR B 34 9352 11400 10971 -1972 -695 -17 N \nATOM 2738 CA TYR B 34 23.705 7.755 16.433 1.00 82.30 C \nANISOU 2738 CA TYR B 34 9248 11121 10900 -1847 -697 -28 C \nATOM 2739 C TYR B 34 24.138 6.317 16.168 1.00 82.13 C \nANISOU 2739 C TYR B 34 9130 11222 10855 -1617 -715 -85 C \nATOM 2740 O TYR B 34 25.256 5.929 16.462 1.00 80.65 O \nANISOU 2740 O TYR B 34 8806 11283 10553 -1552 -723 -125 O \nATOM 2741 CB TYR B 34 23.782 8.529 15.125 1.00 80.80 C \nANISOU 2741 CB TYR B 34 9068 10984 10647 -1992 -685 -8 C \nATOM 2742 CG TYR B 34 23.280 9.961 15.189 1.00 80.54 C \nANISOU 2742 CG TYR B 34 9202 10790 10611 -2200 -691 44 C \nATOM 2743 CD1 TYR B 34 24.166 11.024 15.395 1.00 71.48 C \nANISOU 2743 CD1 TYR B 34 8061 9777 9319 -2441 -697 73 C \nATOM 2744 CD2 TYR B 34 21.923 10.261 15.025 1.00 74.21 C \nANISOU 2744 CD2 TYR B 34 8567 9710 9918 -2155 -701 62 C \nATOM 2745 CE1 TYR B 34 23.708 12.331 15.465 1.00 71.56 C \nANISOU 2745 CE1 TYR B 34 8289 9602 9300 -2621 -725 119 C \nATOM 2746 CE2 TYR B 34 21.469 11.573 15.090 1.00 73.18 C \nANISOU 2746 CE2 TYR B 34 8624 9426 9756 -2297 -724 98 C \nATOM 2747 CZ TYR B 34 22.362 12.598 15.315 1.00 74.34 C \nANISOU 2747 CZ TYR B 34 8821 9662 9762 -2525 -742 126 C \nATOM 2748 OH TYR B 34 21.902 13.886 15.374 1.00 80.30 O \nANISOU 2748 OH TYR B 34 9823 10227 10461 -2654 -786 160 O \nATOM 2749 N ALA B 35 23.226 5.530 15.619 1.00 86.51 N \nANISOU 2749 N ALA B 35 9772 11600 11498 -1485 -730 -92 N \nATOM 2750 CA ALA B 35 23.480 4.122 15.350 1.00 91.39 C \nANISOU 2750 CA ALA B 35 10376 12266 12084 -1253 -768 -145 C \nATOM 2751 C ALA B 35 22.455 3.594 14.355 1.00 90.70 C \nANISOU 2751 C ALA B 35 10397 11995 12070 -1193 -781 -138 C \nATOM 2752 O ALA B 35 21.277 3.546 14.651 1.00 88.12 O \nANISOU 2752 O ALA B 35 10194 11438 11850 -1226 -783 -104 O \nATOM 2753 CB ALA B 35 23.423 3.324 16.643 1.00 93.20 C \nANISOU 2753 CB ALA B 35 10669 12408 12336 -1134 -805 -159 C \nATOM 2754 N ALA B 36 22.913 3.228 13.166 1.00100.81 N \nANISOU 2754 N ALA B 36 11617 13408 13277 -1112 -787 -171 N \nATOM 2755 CA ALA B 36 22.017 2.757 12.109 1.00104.68 C \nANISOU 2755 CA ALA B 36 12204 13743 13825 -1064 -799 -165 C \nATOM 2756 C ALA B 36 21.688 1.281 12.271 1.00104.40 C \nANISOU 2756 C ALA B 36 12305 13577 13787 -863 -867 -196 C \nATOM 2757 O ALA B 36 22.508 0.512 12.773 1.00106.63 O \nANISOU 2757 O ALA B 36 12581 13959 13973 -695 -914 -245 O \nATOM 2758 CB ALA B 36 22.638 3.009 10.744 1.00109.00 C \nANISOU 2758 CB ALA B 36 12640 14486 14288 -1069 -781 -187 C \nATOM 2759 N ASP B 37 20.489 0.888 11.850 1.00101.55 N \nANISOU 2759 N ASP B 37 12085 12995 13506 -884 -881 -167 N \nATOM 2760 CA ASP B 37 20.119 -0.515 11.858 1.00105.12 C \nANISOU 2760 CA ASP B 37 12714 13300 13925 -736 -960 -186 C \nATOM 2761 C ASP B 37 20.665 -1.181 10.594 1.00111.68 C \nANISOU 2761 C ASP B 37 13549 14222 14663 -567 -997 -238 C \nATOM 2762 O ASP B 37 20.353 -0.768 9.479 1.00120.49 O \nANISOU 2762 O ASP B 37 14617 15354 15809 -629 -961 -225 O \nATOM 2763 CB ASP B 37 18.612 -0.665 11.942 1.00104.54 C \nANISOU 2763 CB ASP B 37 12779 12995 13945 -863 -964 -130 C \nATOM 2764 CG ASP B 37 18.191 -2.046 12.347 1.00107.99 C \nANISOU 2764 CG ASP B 37 13439 13262 14330 -786 -1056 -134 C \nATOM 2765 OD1 ASP B 37 18.916 -3.020 12.056 1.00113.31 O \nANISOU 2765 OD1 ASP B 37 14211 13949 14894 -590 -1131 -186 O \nATOM 2766 OD2 ASP B 37 17.119 -2.157 12.959 1.00114.80 O \nANISOU 2766 OD2 ASP B 37 14393 13988 15238 -922 -1061 -86 O \nATOM 2767 N LYS B 38 21.470 -2.221 10.779 1.00104.59 N \nANISOU 2767 N LYS B 38 12720 13381 13637 -335 -1076 -302 N \nATOM 2768 CA LYS B 38 22.144 -2.879 9.671 1.00102.36 C \nANISOU 2768 CA LYS B 38 12436 13227 13230 -119 -1123 -369 C \nATOM 2769 C LYS B 38 21.180 -3.657 8.811 1.00100.41 C \nANISOU 2769 C LYS B 38 12400 12746 13003 -100 -1174 -352 C \nATOM 2770 O LYS B 38 21.211 -3.557 7.585 1.00 92.28 O \nANISOU 2770 O LYS B 38 11315 11788 11960 -74 -1157 -366 O \nATOM 2771 CB LYS B 38 23.210 -3.834 10.204 1.00108.44 C \nANISOU 2771 CB LYS B 38 13260 14113 13829 172 -1214 -453 C \nATOM 2772 CG LYS B 38 24.018 -4.547 9.133 1.00112.09 C \nANISOU 2772 CG LYS B 38 13716 14754 14121 457 -1277 -542 C \nATOM 2773 CD LYS B 38 25.187 -5.309 9.711 1.00110.79 C \nANISOU 2773 CD LYS B 38 13564 14775 13757 778 -1364 -640 C \nATOM 2774 CE LYS B 38 26.163 -5.692 8.629 1.00112.25 C \nANISOU 2774 CE LYS B 38 13636 15264 13748 1061 -1403 -740 C \nATOM 2775 NZ LYS B 38 27.281 -6.527 9.134 1.00115.45 N \nANISOU 2775 NZ LYS B 38 14070 15874 13922 1440 -1506 -853 N \nATOM 2776 N GLU B 39 20.338 -4.449 9.470 1.00100.43 N \nANISOU 2776 N GLU B 39 12654 12482 13025 -131 -1241 -321 N \nATOM 2777 CA GLU B 39 19.396 -5.315 8.775 1.00 97.99 C \nANISOU 2777 CA GLU B 39 12586 11941 12703 -142 -1308 -299 C \nATOM 2778 C GLU B 39 18.384 -4.473 8.009 1.00 98.02 C \nANISOU 2778 C GLU B 39 12485 11915 12843 -371 -1218 -237 C \nATOM 2779 O GLU B 39 18.181 -4.671 6.815 1.00 96.72 O \nANISOU 2779 O GLU B 39 12346 11738 12664 -337 -1225 -246 O \nATOM 2780 CB GLU B 39 18.675 -6.254 9.755 1.00 96.52 C \nANISOU 2780 CB GLU B 39 12692 11497 12484 -197 -1399 -266 C \nATOM 2781 CG GLU B 39 17.665 -7.176 9.079 1.00103.45 C \nANISOU 2781 CG GLU B 39 13848 12140 13319 -261 -1479 -234 C \nATOM 2782 CD GLU B 39 17.074 -8.238 9.993 1.00105.10 C \nANISOU 2782 CD GLU B 39 14394 12102 13438 -330 -1595 -202 C \nATOM 2783 OE1 GLU B 39 17.612 -8.455 11.099 1.00112.11 O \nANISOU 2783 OE1 GLU B 39 15335 12984 14276 -254 -1634 -221 O \nATOM 2784 OE2 GLU B 39 16.058 -8.863 9.602 1.00101.29 O \nANISOU 2784 OE2 GLU B 39 14132 11435 12919 -481 -1651 -153 O \nATOM 2785 N SER B 40 17.776 -3.519 8.706 1.00 96.83 N \nANISOU 2785 N SER B 40 12220 11760 12810 -583 -1139 -181 N \nATOM 2786 CA SER B 40 16.704 -2.711 8.148 1.00 93.02 C \nANISOU 2786 CA SER B 40 11664 11243 12438 -777 -1066 -127 C \nATOM 2787 C SER B 40 17.182 -1.903 6.932 1.00 87.78 C \nANISOU 2787 C SER B 40 10828 10733 11793 -758 -1004 -147 C \nATOM 2788 O SER B 40 16.535 -1.896 5.884 1.00 97.28 O \nANISOU 2788 O SER B 40 12054 11887 13022 -800 -993 -132 O \nATOM 2789 CB SER B 40 16.140 -1.779 9.230 1.00 91.12 C \nANISOU 2789 CB SER B 40 11333 11002 12285 -949 -1005 -82 C \nATOM 2790 OG SER B 40 14.725 -1.841 9.249 1.00 90.50 O \nANISOU 2790 OG SER B 40 11327 10810 12248 -1102 -1002 -32 O \nATOM 2791 N THR B 41 18.311 -1.227 7.075 1.00 90.53 N \nANISOU 2791 N THR B 41 11006 11280 12112 -714 -966 -177 N \nATOM 2792 CA THR B 41 18.905 -0.450 5.980 1.00 87.82 C \nANISOU 2792 CA THR B 41 10499 11118 11751 -727 -913 -194 C \nATOM 2793 C THR B 41 19.199 -1.363 4.785 1.00 93.01 C \nANISOU 2793 C THR B 41 11210 11804 12324 -555 -963 -240 C \nATOM 2794 O THR B 41 18.934 -1.004 3.640 1.00102.18 O \nANISOU 2794 O THR B 41 12327 12988 13509 -602 -931 -231 O \nATOM 2795 CB THR B 41 20.192 0.266 6.444 1.00 86.57 C \nANISOU 2795 CB THR B 41 10157 11211 11526 -728 -879 -220 C \nATOM 2796 OG1 THR B 41 19.872 1.227 7.459 1.00 85.62 O \nANISOU 2796 OG1 THR B 41 10007 11043 11481 -900 -835 -174 O \nATOM 2797 CG2 THR B 41 20.862 0.993 5.286 1.00 92.59 C \nANISOU 2797 CG2 THR B 41 10760 12191 12231 -774 -835 -234 C \nATOM 2798 N GLN B 42 19.734 -2.549 5.053 1.00 93.97 N \nANISOU 2798 N GLN B 42 11450 11917 12337 -340 -1050 -293 N \nATOM 2799 CA GLN B 42 20.038 -3.516 3.997 1.00 89.64 C \nANISOU 2799 CA GLN B 42 10996 11384 11681 -131 -1120 -348 C \nATOM 2800 C GLN B 42 18.800 -3.947 3.227 1.00 86.90 C \nANISOU 2800 C GLN B 42 10825 10798 11396 -213 -1141 -306 C \nATOM 2801 O GLN B 42 18.768 -3.873 2.001 1.00 92.46 O \nANISOU 2801 O GLN B 42 11486 11551 12092 -189 -1126 -317 O \nATOM 2802 CB GLN B 42 20.735 -4.753 4.571 1.00 85.13 C \nANISOU 2802 CB GLN B 42 10590 10799 10958 141 -1235 -416 C \nATOM 2803 CG GLN B 42 21.357 -5.644 3.515 1.00 86.34 C \nANISOU 2803 CG GLN B 42 10816 11036 10954 423 -1315 -496 C \nATOM 2804 CD GLN B 42 22.292 -4.864 2.597 1.00 87.32 C \nANISOU 2804 CD GLN B 42 10634 11520 11025 460 -1242 -538 C \nATOM 2805 OE1 GLN B 42 23.107 -4.059 3.058 1.00 88.50 O \nANISOU 2805 OE1 GLN B 42 10540 11936 11150 408 -1179 -549 O \nATOM 2806 NE2 GLN B 42 22.184 -5.105 1.292 1.00 88.52 N \nANISOU 2806 NE2 GLN B 42 10799 11691 11142 531 -1253 -559 N \nATOM 2807 N LYS B 43 17.795 -4.410 3.965 1.00 86.52 N \nANISOU 2807 N LYS B 43 10966 10513 11393 -322 -1178 -257 N \nATOM 2808 CA LYS B 43 16.507 -4.841 3.393 1.00 81.92 C \nANISOU 2808 CA LYS B 43 10550 9725 10850 -448 -1202 -208 C \nATOM 2809 C LYS B 43 15.906 -3.776 2.456 1.00 84.55 C \nANISOU 2809 C LYS B 43 10710 10121 11293 -601 -1103 -173 C \nATOM 2810 O LYS B 43 15.343 -4.091 1.417 1.00 89.98 O \nANISOU 2810 O LYS B 43 11468 10741 11979 -614 -1117 -165 O \nATOM 2811 CB LYS B 43 15.522 -5.158 4.510 1.00 85.23 C \nANISOU 2811 CB LYS B 43 11118 9970 11295 -615 -1230 -151 C \nATOM 2812 CG LYS B 43 15.550 -6.584 5.015 1.00102.70 C \nANISOU 2812 CG LYS B 43 13648 12000 13372 -521 -1366 -164 C \nATOM 2813 CD LYS B 43 16.939 -7.025 5.468 1.00114.88 C \nANISOU 2813 CD LYS B 43 15218 13626 14804 -248 -1428 -242 C \nATOM 2814 CE LYS B 43 16.990 -8.508 5.838 1.00124.34 C \nANISOU 2814 CE LYS B 43 16802 14608 15835 -112 -1591 -265 C \nATOM 2815 NZ LYS B 43 18.299 -9.016 6.355 1.00129.14 N \nANISOU 2815 NZ LYS B 43 17466 15298 16305 197 -1669 -351 N \nATOM 2816 N ALA B 44 16.063 -2.514 2.825 1.00 85.66 N \nANISOU 2816 N ALA B 44 10646 10385 11514 -709 -1012 -155 N \nATOM 2817 CA ALA B 44 15.540 -1.416 2.039 1.00 82.73 C \nANISOU 2817 CA ALA B 44 10148 10059 11228 -841 -932 -125 C \nATOM 2818 C ALA B 44 16.293 -1.221 0.746 1.00 82.88 C \nANISOU 2818 C ALA B 44 10070 10217 11204 -756 -915 -162 C \nATOM 2819 O ALA B 44 15.707 -0.865 -0.261 1.00 92.30 O \nANISOU 2819 O ALA B 44 11247 11385 12438 -821 -886 -143 O \nATOM 2820 CB ALA B 44 15.540 -0.134 2.852 1.00 75.78 C \nANISOU 2820 CB ALA B 44 9137 9243 10413 -970 -864 -99 C \nATOM 2821 N ILE B 45 17.593 -1.440 0.777 1.00 86.15 N \nANISOU 2821 N ILE B 45 10407 10805 11520 -608 -934 -216 N \nATOM 2822 CA ILE B 45 18.439 -1.268 -0.402 1.00 86.75 C \nANISOU 2822 CA ILE B 45 10359 11082 11522 -525 -919 -258 C \nATOM 2823 C ILE B 45 18.217 -2.429 -1.359 1.00 81.51 C \nANISOU 2823 C ILE B 45 9842 10328 10799 -362 -989 -290 C \nATOM 2824 O ILE B 45 18.089 -2.223 -2.558 1.00 83.89 O \nANISOU 2824 O ILE B 45 10098 10670 11105 -375 -966 -292 O \nATOM 2825 CB ILE B 45 19.944 -1.215 -0.001 1.00 92.42 C \nANISOU 2825 CB ILE B 45 10922 12084 12111 -402 -924 -317 C \nATOM 2826 CG1 ILE B 45 20.246 -0.016 0.898 1.00 93.92 C \nANISOU 2826 CG1 ILE B 45 10975 12371 12338 -589 -859 -282 C \nATOM 2827 CG2 ILE B 45 20.852 -1.165 -1.221 1.00 94.88 C \nANISOU 2827 CG2 ILE B 45 11085 12660 12303 -304 -916 -369 C \nATOM 2828 CD1 ILE B 45 21.498 -0.202 1.738 1.00100.16 C \nANISOU 2828 CD1 ILE B 45 11656 13393 13007 -474 -879 -333 C \nATOM 2829 N ASP B 46 18.221 -3.645 -0.828 1.00 84.25 N \nANISOU 2829 N ASP B 46 10387 10549 11075 -206 -1084 -318 N \nATOM 2830 CA ASP B 46 17.881 -4.837 -1.608 1.00 84.76 C \nANISOU 2830 CA ASP B 46 10672 10464 11067 -65 -1175 -342 C \nATOM 2831 C ASP B 46 16.540 -4.667 -2.308 1.00 90.05 C \nANISOU 2831 C ASP B 46 11414 10959 11844 -257 -1146 -277 C \nATOM 2832 O ASP B 46 16.424 -4.930 -3.510 1.00 95.59 O \nANISOU 2832 O ASP B 46 12144 11657 12520 -201 -1159 -292 O \nATOM 2833 CB ASP B 46 17.874 -6.075 -0.719 1.00 85.98 C \nANISOU 2833 CB ASP B 46 11100 10441 11125 69 -1295 -362 C \nATOM 2834 CG ASP B 46 19.288 -6.558 -0.394 1.00101.62 C \nANISOU 2834 CG ASP B 46 13054 12611 12944 367 -1357 -455 C \nATOM 2835 OD1 ASP B 46 20.252 -6.075 -1.033 1.00108.06 O \nANISOU 2835 OD1 ASP B 46 13634 13722 13701 477 -1312 -508 O \nATOM 2836 OD2 ASP B 46 19.456 -7.398 0.520 1.00108.95 O \nANISOU 2836 OD2 ASP B 46 14190 13421 13784 489 -1453 -477 O \nATOM 2837 N GLY B 47 15.542 -4.181 -1.572 1.00 85.08 N \nANISOU 2837 N GLY B 47 10791 10216 11321 -475 -1104 -210 N \nATOM 2838 CA GLY B 47 14.228 -3.956 -2.135 1.00 78.88 C \nANISOU 2838 CA GLY B 47 10040 9314 10615 -653 -1074 -155 C \nATOM 2839 C GLY B 47 14.228 -2.860 -3.186 1.00 80.48 C \nANISOU 2839 C GLY B 47 10052 9640 10887 -710 -987 -150 C \nATOM 2840 O GLY B 47 13.779 -3.058 -4.331 1.00 86.49 O \nANISOU 2840 O GLY B 47 10850 10362 11649 -711 -991 -147 O \nATOM 2841 N VAL B 48 14.718 -1.690 -2.810 1.00 77.15 N \nANISOU 2841 N VAL B 48 9448 9354 10510 -772 -915 -146 N \nATOM 2842 CA VAL B 48 14.635 -0.514 -3.695 1.00 83.17 C \nANISOU 2842 CA VAL B 48 10073 10204 11323 -867 -841 -132 C \nATOM 2843 C VAL B 48 15.448 -0.695 -4.973 1.00 86.50 C \nANISOU 2843 C VAL B 48 10433 10757 11676 -757 -845 -174 C \nATOM 2844 O VAL B 48 15.037 -0.262 -6.046 1.00 95.56 O \nANISOU 2844 O VAL B 48 11553 11902 12854 -814 -815 -160 O \nATOM 2845 CB VAL B 48 15.032 0.784 -2.947 1.00 80.95 C \nANISOU 2845 CB VAL B 48 9665 10019 11073 -977 -783 -115 C \nATOM 2846 CG1 VAL B 48 15.736 1.770 -3.860 1.00 81.04 C \nANISOU 2846 CG1 VAL B 48 9551 10188 11054 -1030 -737 -122 C \nATOM 2847 CG2 VAL B 48 13.791 1.424 -2.308 1.00 76.62 C \nANISOU 2847 CG2 VAL B 48 9157 9346 10608 -1109 -758 -69 C \nATOM 2848 N THR B 49 16.594 -1.349 -4.871 1.00 91.80 N \nANISOU 2848 N THR B 49 11080 11560 12239 -585 -888 -230 N \nATOM 2849 CA THR B 49 17.474 -1.480 -6.035 1.00 91.64 C \nANISOU 2849 CA THR B 49 10965 11731 12122 -463 -891 -280 C \nATOM 2850 C THR B 49 16.874 -2.408 -7.087 1.00 96.99 C \nANISOU 2850 C THR B 49 11791 12273 12787 -366 -942 -291 C \nATOM 2851 O THR B 49 16.917 -2.102 -8.274 1.00105.14 O \nANISOU 2851 O THR B 49 12752 13384 13813 -377 -914 -297 O \nATOM 2852 CB THR B 49 18.878 -1.991 -5.678 1.00 91.32 C \nANISOU 2852 CB THR B 49 10843 11924 11930 -258 -932 -354 C \nATOM 2853 OG1 THR B 49 18.760 -2.956 -4.637 1.00 99.60 O \nANISOU 2853 OG1 THR B 49 12064 12823 12955 -138 -1007 -368 O \nATOM 2854 CG2 THR B 49 19.780 -0.850 -5.205 1.00 94.73 C \nANISOU 2854 CG2 THR B 49 11051 12611 12329 -382 -866 -350 C \nATOM 2855 N ASN B 50 16.299 -3.529 -6.665 1.00 88.19 N \nANISOU 2855 N ASN B 50 10902 10950 11657 -291 -1023 -290 N \nATOM 2856 CA ASN B 50 15.707 -4.469 -7.620 1.00 84.54 C \nANISOU 2856 CA ASN B 50 10622 10337 11161 -220 -1086 -296 C \nATOM 2857 C ASN B 50 14.425 -3.919 -8.224 1.00 79.00 C \nANISOU 2857 C ASN B 50 9919 9519 10578 -431 -1031 -232 C \nATOM 2858 O ASN B 50 14.061 -4.269 -9.347 1.00 83.21 O \nANISOU 2858 O ASN B 50 10514 10005 11099 -405 -1048 -235 O \nATOM 2859 CB ASN B 50 15.406 -5.800 -6.936 1.00 87.27 C \nANISOU 2859 CB ASN B 50 11258 10472 11428 -128 -1203 -303 C \nATOM 2860 CG ASN B 50 16.552 -6.297 -6.082 1.00 90.02 C \nANISOU 2860 CG ASN B 50 11632 10915 11658 85 -1265 -366 C \nATOM 2861 OD1 ASN B 50 17.651 -5.741 -6.103 1.00 91.61 O \nANISOU 2861 OD1 ASN B 50 11610 11379 11817 185 -1221 -413 O \nATOM 2862 ND2 ASN B 50 16.299 -7.351 -5.317 1.00 89.21 N \nANISOU 2862 ND2 ASN B 50 11808 10608 11480 145 -1372 -367 N \nATOM 2863 N LYS B 51 13.758 -3.051 -7.482 1.00 72.37 N \nANISOU 2863 N LYS B 51 9008 8649 9839 -619 -970 -179 N \nATOM 2864 CA LYS B 51 12.665 -2.286 -8.035 1.00 71.25 C \nANISOU 2864 CA LYS B 51 8820 8461 9791 -786 -910 -132 C \nATOM 2865 C LYS B 51 13.124 -1.493 -9.236 1.00 80.68 C \nANISOU 2865 C LYS B 51 9874 9786 10995 -777 -857 -147 C \nATOM 2866 O LYS B 51 12.538 -1.591 -10.323 1.00 89.43 O \nANISOU 2866 O LYS B 51 11013 10848 12118 -794 -854 -139 O \nATOM 2867 CB LYS B 51 12.128 -1.325 -7.009 1.00 70.19 C \nANISOU 2867 CB LYS B 51 8612 8325 9732 -932 -858 -93 C \nATOM 2868 CG LYS B 51 10.931 -0.539 -7.486 1.00 69.38 C \nANISOU 2868 CG LYS B 51 8475 8189 9697 -1062 -810 -56 C \nATOM 2869 CD LYS B 51 10.553 0.575 -6.523 1.00 67.45 C \nANISOU 2869 CD LYS B 51 8156 7970 9502 -1157 -764 -33 C \nATOM 2870 CE LYS B 51 9.379 0.152 -5.684 1.00 68.71 C \nANISOU 2870 CE LYS B 51 8380 8066 9663 -1236 -785 -5 C \nATOM 2871 NZ LYS B 51 8.959 1.082 -4.619 1.00 76.38 N \nANISOU 2871 NZ LYS B 51 9288 9071 10660 -1296 -753 9 N \nATOM 2872 N VAL B 52 14.190 -0.727 -9.047 1.00 83.77 N \nANISOU 2872 N VAL B 52 10116 10352 11361 -768 -818 -168 N \nATOM 2873 CA VAL B 52 14.809 -0.002 -10.148 1.00 83.34 C \nANISOU 2873 CA VAL B 52 9932 10458 11277 -785 -776 -182 C \nATOM 2874 C VAL B 52 15.182 -0.939 -11.319 1.00 82.64 C \nANISOU 2874 C VAL B 52 9871 10418 11111 -623 -818 -227 C \nATOM 2875 O VAL B 52 14.923 -0.627 -12.485 1.00 93.75 O \nANISOU 2875 O VAL B 52 11250 11840 12532 -661 -793 -220 O \nATOM 2876 CB VAL B 52 16.074 0.759 -9.670 1.00 81.08 C \nANISOU 2876 CB VAL B 52 9487 10397 10922 -816 -745 -199 C \nATOM 2877 CG1 VAL B 52 16.912 1.238 -10.852 1.00 74.10 C \nANISOU 2877 CG1 VAL B 52 8467 9736 9953 -831 -718 -222 C \nATOM 2878 CG2 VAL B 52 15.673 1.942 -8.801 1.00 82.69 C \nANISOU 2878 CG2 VAL B 52 9680 10542 11195 -999 -702 -151 C \nATOM 2879 N ASN B 53 15.836 -2.053 -11.019 1.00 70.87 N \nANISOU 2879 N ASN B 53 8447 8958 9523 -426 -889 -278 N \nATOM 2880 CA ASN B 53 16.301 -2.937 -12.078 1.00 74.63 C \nANISOU 2880 CA ASN B 53 8964 9497 9895 -228 -943 -335 C \nATOM 2881 C ASN B 53 15.112 -3.574 -12.785 1.00 83.81 C \nANISOU 2881 C ASN B 53 10316 10420 11109 -253 -978 -306 C \nATOM 2882 O ASN B 53 15.072 -3.660 -14.008 1.00 85.93 O \nANISOU 2882 O ASN B 53 10571 10721 11357 -212 -976 -320 O \nATOM 2883 CB ASN B 53 17.269 -4.008 -11.548 1.00 75.56 C \nANISOU 2883 CB ASN B 53 9149 9695 9865 36 -1031 -408 C \nATOM 2884 CG ASN B 53 18.489 -3.410 -10.862 1.00 82.70 C \nANISOU 2884 CG ASN B 53 9840 10888 10695 63 -996 -442 C \nATOM 2885 OD1 ASN B 53 18.945 -2.318 -11.209 1.00 82.39 O \nANISOU 2885 OD1 ASN B 53 9585 11062 10659 -79 -916 -428 O \nATOM 2886 ND2 ASN B 53 19.012 -4.120 -9.869 1.00 84.10 N \nANISOU 2886 ND2 ASN B 53 10093 11074 10789 229 -1062 -484 N \nATOM 2887 N SER B 54 14.135 -4.030 -12.014 1.00 89.55 N \nANISOU 2887 N SER B 54 11215 10924 11887 -337 -1012 -264 N \nATOM 2888 CA SER B 54 12.958 -4.648 -12.609 1.00 89.20 C \nANISOU 2888 CA SER B 54 11347 10678 11865 -404 -1049 -230 C \nATOM 2889 C SER B 54 12.320 -3.713 -13.632 1.00 91.64 C \nANISOU 2889 C SER B 54 11531 11023 12265 -540 -968 -198 C \nATOM 2890 O SER B 54 11.972 -4.131 -14.731 1.00 99.67 O \nANISOU 2890 O SER B 54 12614 11991 13264 -510 -990 -203 O \nATOM 2891 CB SER B 54 11.957 -5.032 -11.524 1.00 93.46 C \nANISOU 2891 CB SER B 54 12038 11039 12433 -545 -1081 -179 C \nATOM 2892 OG SER B 54 12.461 -6.115 -10.742 1.00 86.50 O \nANISOU 2892 OG SER B 54 11349 10075 11443 -412 -1182 -209 O \nATOM 2893 N ILE B 55 12.182 -2.438 -13.277 1.00 92.37 N \nANISOU 2893 N ILE B 55 11463 11192 12442 -680 -885 -168 N \nATOM 2894 CA ILE B 55 11.671 -1.425 -14.212 1.00 86.80 C \nANISOU 2894 CA ILE B 55 10659 10518 11802 -789 -818 -143 C \nATOM 2895 C ILE B 55 12.549 -1.335 -15.451 1.00 95.11 C \nANISOU 2895 C ILE B 55 11627 11712 12800 -699 -808 -181 C \nATOM 2896 O ILE B 55 12.043 -1.332 -16.565 1.00108.47 O \nANISOU 2896 O ILE B 55 13336 13368 14509 -716 -799 -174 O \nATOM 2897 CB ILE B 55 11.609 -0.029 -13.538 1.00 82.84 C \nANISOU 2897 CB ILE B 55 10045 10070 11360 -922 -752 -115 C \nATOM 2898 CG1 ILE B 55 10.468 0.023 -12.511 1.00 82.60 C \nANISOU 2898 CG1 ILE B 55 10078 9923 11383 -1015 -754 -78 C \nATOM 2899 CG2 ILE B 55 11.457 1.114 -14.538 1.00 80.28 C \nANISOU 2899 CG2 ILE B 55 9646 9794 11062 -1006 -699 -102 C \nATOM 2900 CD1 ILE B 55 10.614 1.121 -11.481 1.00 75.84 C \nANISOU 2900 CD1 ILE B 55 9151 9108 10556 -1090 -716 -64 C \nATOM 2901 N ILE B 56 13.861 -1.266 -15.234 1.00100.49 N \nANISOU 2901 N ILE B 56 12202 12579 13400 -608 -808 -223 N \nATOM 2902 CA ILE B 56 14.838 -1.175 -16.321 1.00 99.19 C \nANISOU 2902 CA ILE B 56 11917 12624 13145 -524 -799 -266 C \nATOM 2903 C ILE B 56 14.935 -2.460 -17.151 1.00 97.85 C \nANISOU 2903 C ILE B 56 11857 12424 12896 -316 -871 -315 C \nATOM 2904 O ILE B 56 14.967 -2.391 -18.376 1.00102.20 O \nANISOU 2904 O ILE B 56 12368 13037 13427 -296 -859 -327 O \nATOM 2905 CB ILE B 56 16.255 -0.826 -15.791 1.00100.04 C \nANISOU 2905 CB ILE B 56 11858 13007 13146 -481 -786 -305 C \nATOM 2906 CG1 ILE B 56 16.271 0.588 -15.221 1.00 98.42 C \nANISOU 2906 CG1 ILE B 56 11559 12845 12992 -713 -719 -255 C \nATOM 2907 CG2 ILE B 56 17.308 -0.933 -16.897 1.00 95.87 C \nANISOU 2907 CG2 ILE B 56 11186 12759 12479 -371 -787 -361 C \nATOM 2908 CD1 ILE B 56 17.508 0.922 -14.419 1.00 99.84 C \nANISOU 2908 CD1 ILE B 56 11595 13270 13069 -718 -710 -280 C \nATOM 2909 N ASP B 57 15.033 -3.607 -16.488 1.00 98.22 N \nANISOU 2909 N ASP B 57 12062 12375 12883 -157 -955 -345 N \nATOM 2910 CA ASP B 57 15.272 -4.896 -17.170 1.00106.07 C \nANISOU 2910 CA ASP B 57 13215 13327 13759 81 -1051 -402 C \nATOM 2911 C ASP B 57 14.069 -5.411 -17.970 1.00101.96 C \nANISOU 2911 C ASP B 57 12882 12568 13291 15 -1081 -365 C \nATOM 2912 O ASP B 57 14.230 -5.912 -19.081 1.00104.31 O \nANISOU 2912 O ASP B 57 13225 12887 13520 144 -1117 -402 O \nATOM 2913 CB ASP B 57 15.716 -5.976 -16.170 1.00113.19 C \nANISOU 2913 CB ASP B 57 14293 14160 14553 275 -1154 -446 C \nATOM 2914 CG ASP B 57 17.006 -5.628 -15.466 1.00114.08 C \nANISOU 2914 CG ASP B 57 14216 14548 14579 386 -1136 -498 C \nATOM 2915 OD1 ASP B 57 17.865 -4.968 -16.088 1.00119.04 O \nANISOU 2915 OD1 ASP B 57 14601 15477 15152 408 -1080 -531 O \nATOM 2916 OD2 ASP B 57 17.140 -6.001 -14.282 1.00113.72 O \nANISOU 2916 OD2 ASP B 57 14264 14432 14511 430 -1180 -503 O \nATOM 2917 N LYS B 58 12.872 -5.295 -17.407 1.00100.64 N \nANISOU 2917 N LYS B 58 12812 12201 13227 -185 -1067 -296 N \nATOM 2918 CA LYS B 58 11.639 -5.658 -18.135 1.00102.71 C \nANISOU 2918 CA LYS B 58 13216 12282 13529 -296 -1085 -254 C \nATOM 2919 C LYS B 58 11.509 -4.947 -19.474 1.00111.24 C \nANISOU 2919 C LYS B 58 14153 13455 14659 -336 -1017 -251 C \nATOM 2920 O LYS B 58 10.844 -5.435 -20.387 1.00115.64 O \nANISOU 2920 O LYS B 58 14821 13908 15209 -348 -1046 -240 O \nATOM 2921 CB LYS B 58 10.404 -5.362 -17.295 1.00 99.74 C \nANISOU 2921 CB LYS B 58 12878 11779 13240 -527 -1058 -183 C \nATOM 2922 CG LYS B 58 10.248 -6.308 -16.121 1.00102.72 C \nANISOU 2922 CG LYS B 58 13462 12017 13550 -528 -1144 -174 C \nATOM 2923 CD LYS B 58 9.603 -7.623 -16.559 1.00108.12 C \nANISOU 2923 CD LYS B 58 14448 12501 14132 -532 -1256 -163 C \nATOM 2924 CE LYS B 58 10.006 -8.790 -15.663 1.00104.24 C \nANISOU 2924 CE LYS B 58 14232 11867 13505 -429 -1383 -183 C \nATOM 2925 NZ LYS B 58 11.283 -9.420 -16.112 1.00102.02 N \nANISOU 2925 NZ LYS B 58 14033 11625 13102 -106 -1459 -270 N \nATOM 2926 N MET B 59 12.189 -3.817 -19.600 1.00111.88 N \nANISOU 2926 N MET B 59 14005 13733 14773 -367 -936 -259 N \nATOM 2927 CA MET B 59 12.190 -3.079 -20.836 1.00117.65 C \nANISOU 2927 CA MET B 59 14610 14561 15532 -417 -877 -256 C \nATOM 2928 C MET B 59 12.933 -3.797 -21.971 1.00119.25 C \nANISOU 2928 C MET B 59 14821 14864 15624 -220 -922 -316 C \nATOM 2929 O MET B 59 12.908 -3.312 -23.095 1.00118.27 O \nANISOU 2929 O MET B 59 14608 14816 15513 -257 -881 -315 O \nATOM 2930 CB MET B 59 12.774 -1.676 -20.622 1.00126.47 C \nANISOU 2930 CB MET B 59 15522 15853 16676 -535 -795 -243 C \nATOM 2931 CG MET B 59 12.200 -0.642 -21.571 1.00134.19 C \nANISOU 2931 CG MET B 59 16440 16828 17718 -682 -734 -208 C \nATOM 2932 SD MET B 59 10.425 -0.417 -21.303 1.00148.53 S \nANISOU 2932 SD MET B 59 18371 18410 19652 -818 -723 -149 S \nATOM 2933 CE MET B 59 9.787 -1.400 -22.668 1.00152.07 C \nANISOU 2933 CE MET B 59 18924 18770 20087 -749 -761 -158 C \nATOM 2934 N ASN B 60 13.546 -4.953 -21.695 1.00124.29 N \nANISOU 2934 N ASN B 60 15585 15498 16142 1 -1014 -373 N \nATOM 2935 CA ASN B 60 14.276 -5.770 -22.708 1.00137.08 C \nANISOU 2935 CA ASN B 60 17243 17219 17622 250 -1078 -447 C \nATOM 2936 C ASN B 60 13.661 -5.875 -24.131 1.00141.67 C \nANISOU 2936 C ASN B 60 17867 17732 18227 226 -1073 -435 C \nATOM 2937 O ASN B 60 14.266 -6.479 -25.040 1.00133.99 O \nANISOU 2937 O ASN B 60 16914 16860 17135 438 -1124 -499 O \nATOM 2938 CB ASN B 60 14.446 -7.208 -22.162 1.00144.94 C \nANISOU 2938 CB ASN B 60 18516 18064 18490 478 -1214 -494 C \nATOM 2939 CG ASN B 60 15.768 -7.431 -21.449 1.00148.59 C \nANISOU 2939 CG ASN B 60 18898 18746 18814 708 -1252 -571 C \nATOM 2940 OD1 ASN B 60 16.801 -6.850 -21.802 1.00151.06 O \nANISOU 2940 OD1 ASN B 60 18948 19390 19058 784 -1200 -618 O \nATOM 2941 ND2 ASN B 60 15.752 -8.314 -20.456 1.00150.01 N \nANISOU 2941 ND2 ASN B 60 19312 18759 18927 817 -1349 -586 N \nATOM 2942 N THR B 61 12.475 -5.286 -24.312 1.00142.65 N \nANISOU 2942 N THR B 61 18000 17707 18492 -13 -1016 -361 N \nATOM 2943 CA THR B 61 11.678 -5.433 -25.537 1.00149.85 C \nANISOU 2943 CA THR B 61 18979 18520 19439 -60 -1015 -341 C \nATOM 2944 C THR B 61 12.335 -4.945 -26.842 1.00162.71 C \nANISOU 2944 C THR B 61 20436 20355 21032 1 -971 -375 C \nATOM 2945 O THR B 61 12.462 -5.724 -27.791 1.00175.62 O \nANISOU 2945 O THR B 61 22161 21978 22586 156 -1028 -415 O \nATOM 2946 CB THR B 61 10.300 -4.756 -25.384 1.00141.18 C \nANISOU 2946 CB THR B 61 17883 17281 18480 -317 -957 -262 C \nATOM 2947 OG1 THR B 61 10.467 -3.367 -25.083 1.00134.67 O \nANISOU 2947 OG1 THR B 61 16854 16582 17732 -448 -863 -238 O \nATOM 2948 CG2 THR B 61 9.495 -5.414 -24.282 1.00132.67 C \nANISOU 2948 CG2 THR B 61 16986 16015 17406 -396 -1010 -226 C \nATOM 2949 N GLN B 62 12.715 -3.665 -26.893 1.00166.71 N \nANISOU 2949 N GLN B 62 20718 21040 21583 -134 -879 -357 N \nATOM 2950 CA GLN B 62 13.312 -3.047 -28.101 1.00160.50 C \nANISOU 2950 CA GLN B 62 19762 20467 20752 -140 -832 -377 C \nATOM 2951 C GLN B 62 14.589 -3.748 -28.637 1.00149.69 C \nANISOU 2951 C GLN B 62 18317 19354 19205 116 -880 -465 C \nATOM 2952 O GLN B 62 15.460 -4.160 -27.859 1.00143.95 O \nANISOU 2952 O GLN B 62 17558 18762 18373 267 -919 -515 O \nATOM 2953 CB GLN B 62 13.562 -1.532 -27.900 1.00162.16 C \nANISOU 2953 CB GLN B 62 19794 20814 21005 -364 -743 -336 C \nATOM 2954 CG GLN B 62 14.714 -1.138 -26.981 1.00164.99 C \nANISOU 2954 CG GLN B 62 20009 21401 21277 -366 -729 -358 C \nATOM 2955 CD GLN B 62 14.457 -1.471 -25.523 1.00176.48 C \nANISOU 2955 CD GLN B 62 21559 22712 22781 -349 -756 -346 C \nATOM 2956 OE1 GLN B 62 13.387 -1.956 -25.163 1.00176.66 O \nANISOU 2956 OE1 GLN B 62 21753 22472 22896 -359 -784 -316 O \nATOM 2957 NE2 GLN B 62 15.445 -1.221 -24.674 1.00195.70 N \nANISOU 2957 NE2 GLN B 62 23876 25342 25138 -335 -750 -369 N \nATOM 2958 N PHE B 63 14.651 -3.916 -29.963 1.00141.25 N \nANISOU 2958 N PHE B 63 17223 18357 18090 183 -883 -489 N \nATOM 2959 CA PHE B 63 15.872 -4.347 -30.672 1.00148.24 C \nANISOU 2959 CA PHE B 63 17979 19559 18786 415 -915 -578 C \nATOM 2960 C PHE B 63 16.106 -3.603 -32.008 1.00140.16 C \nANISOU 2960 C PHE B 63 16778 18739 17736 311 -852 -573 C \nATOM 2961 O PHE B 63 17.130 -2.947 -32.201 1.00126.47 O \nANISOU 2961 O PHE B 63 14805 17363 15886 264 -808 -597 O \nATOM 2962 CB PHE B 63 15.837 -5.852 -30.986 1.00153.49 C \nANISOU 2962 CB PHE B 63 18871 20098 19349 728 -1034 -645 C \nATOM 2963 CG PHE B 63 15.568 -6.743 -29.800 1.00156.68 C \nANISOU 2963 CG PHE B 63 19517 20267 19748 835 -1121 -650 C \nATOM 2964 CD1 PHE B 63 16.595 -7.105 -28.925 1.00151.18 C \nANISOU 2964 CD1 PHE B 63 18777 19751 18912 1038 -1169 -717 C \nATOM 2965 CD2 PHE B 63 14.298 -7.261 -29.586 1.00156.27 C \nANISOU 2965 CD2 PHE B 63 19738 19833 19803 731 -1163 -591 C \nATOM 2966 CE1 PHE B 63 16.353 -7.939 -27.843 1.00147.02 C \nANISOU 2966 CE1 PHE B 63 18500 18992 18368 1135 -1258 -722 C \nATOM 2967 CE2 PHE B 63 14.050 -8.095 -28.503 1.00159.63 C \nANISOU 2967 CE2 PHE B 63 20406 20047 20200 795 -1250 -590 C \nATOM 2968 CZ PHE B 63 15.079 -8.433 -27.631 1.00151.50 C \nANISOU 2968 CZ PHE B 63 19355 19163 19043 1001 -1300 -655 C \nATOM 2969 N GLU B 64 15.139 -3.720 -32.921 1.00141.10 N \nANISOU 2969 N GLU B 64 17020 18642 17951 258 -851 -539 N \nATOM 2970 CA GLU B 64 15.245 -3.167 -34.281 1.00136.96 C \nANISOU 2970 CA GLU B 64 16371 18266 17403 180 -804 -536 C \nATOM 2971 C GLU B 64 14.833 -1.711 -34.256 1.00130.56 C \nANISOU 2971 C GLU B 64 15477 17428 16701 -151 -714 -454 C \nATOM 2972 O GLU B 64 14.141 -1.303 -33.334 1.00145.37 O \nANISOU 2972 O GLU B 64 17441 19097 18698 -287 -697 -400 O \nATOM 2973 CB GLU B 64 14.309 -3.899 -35.257 1.00136.37 C \nANISOU 2973 CB GLU B 64 16482 17947 17385 259 -845 -532 C \nATOM 2974 CG GLU B 64 14.751 -5.303 -35.659 1.00142.33 C \nANISOU 2974 CG GLU B 64 17358 18728 17993 600 -949 -619 C \nATOM 2975 CD GLU B 64 15.993 -5.334 -36.560 1.00143.58 C \nANISOU 2975 CD GLU B 64 17303 19295 17957 779 -951 -703 C \nATOM 2976 OE1 GLU B 64 15.923 -4.970 -37.765 1.00138.82 O \nANISOU 2976 OE1 GLU B 64 16611 18783 17350 715 -913 -696 O \nATOM 2977 OE2 GLU B 64 17.063 -5.744 -36.057 1.00146.01 O \nANISOU 2977 OE2 GLU B 64 17521 19860 18095 996 -994 -780 O \nATOM 2978 N ALA B 65 15.207 -0.946 -35.282 1.00112.18 N \nANISOU 2978 N ALA B 65 13009 15297 14317 -275 -667 -446 N \nATOM 2979 CA ALA B 65 14.779 0.449 -35.393 1.00102.36 C \nANISOU 2979 CA ALA B 65 11751 13991 13151 -583 -603 -369 C \nATOM 2980 C ALA B 65 14.625 0.849 -36.860 1.00 99.78 C \nANISOU 2980 C ALA B 65 11393 13716 12803 -664 -579 -358 C \nATOM 2981 O ALA B 65 15.355 0.334 -37.712 1.00105.79 O \nANISOU 2981 O ALA B 65 12038 14721 13434 -530 -593 -414 O \nATOM 2982 CB ALA B 65 15.755 1.363 -34.666 1.00 93.85 C \nANISOU 2982 CB ALA B 65 10526 13163 11972 -754 -572 -357 C \nATOM 2983 N VAL B 66 13.649 1.714 -37.172 1.00 91.56 N \nANISOU 2983 N VAL B 66 10462 12448 11878 -855 -550 -293 N \nATOM 2984 CA VAL B 66 13.402 2.130 -38.579 1.00 92.46 C \nANISOU 2984 CA VAL B 66 10573 12577 11980 -937 -531 -278 C \nATOM 2985 C VAL B 66 12.560 3.421 -38.626 1.00 90.61 C \nANISOU 2985 C VAL B 66 10464 12136 11828 -1174 -505 -207 C \nATOM 2986 O VAL B 66 11.826 3.708 -37.681 1.00 87.82 O \nANISOU 2986 O VAL B 66 10224 11567 11575 -1206 -509 -177 O \nATOM 2987 CB VAL B 66 12.828 0.954 -39.478 1.00 85.72 C \nANISOU 2987 CB VAL B 66 9787 11611 11171 -716 -563 -315 C \nATOM 2988 CG1 VAL B 66 12.185 -0.168 -38.635 1.00 81.17 C \nANISOU 2988 CG1 VAL B 66 9351 10812 10680 -536 -612 -331 C \nATOM 2989 CG2 VAL B 66 11.824 1.474 -40.508 1.00 82.59 C \nANISOU 2989 CG2 VAL B 66 9485 11032 10863 -824 -543 -273 C \nATOM 2990 N GLY B 67 12.749 4.214 -39.693 1.00 93.25 N \nANISOU 2990 N GLY B 67 10781 12558 12093 -1332 -487 -185 N \nATOM 2991 CA GLY B 67 11.853 5.324 -40.065 1.00 89.04 C \nANISOU 2991 CA GLY B 67 10414 11802 11617 -1503 -482 -129 C \nATOM 2992 C GLY B 67 10.801 4.832 -41.042 1.00 85.97 C \nANISOU 2992 C GLY B 67 10102 11234 11330 -1382 -486 -135 C \nATOM 2993 O GLY B 67 9.939 4.075 -40.627 1.00 85.11 O \nANISOU 2993 O GLY B 67 10053 10948 11337 -1231 -498 -146 O \nATOM 2994 N ARG B 68 10.882 5.279 -42.314 1.00 83.64 N \nANISOU 2994 N ARG B 68 9805 10997 10976 -1472 -478 -125 N \nATOM 2995 CA ARG B 68 10.175 4.710 -43.526 1.00 71.04 C \nANISOU 2995 CA ARG B 68 8236 9314 9441 -1357 -479 -140 C \nATOM 2996 C ARG B 68 9.808 5.788 -44.556 1.00 70.84 C \nANISOU 2996 C ARG B 68 8313 9219 9385 -1522 -475 -103 C \nATOM 2997 O ARG B 68 9.548 6.939 -44.195 1.00 80.30 O \nANISOU 2997 O ARG B 68 9648 10298 10562 -1681 -487 -63 O \nATOM 2998 CB ARG B 68 8.950 3.901 -43.183 1.00 73.05 C \nANISOU 2998 CB ARG B 68 8584 9329 9844 -1189 -493 -147 C \nATOM 2999 CG ARG B 68 8.480 2.946 -44.284 1.00 77.98 C \nANISOU 2999 CG ARG B 68 9208 9917 10504 -1047 -501 -173 C \nATOM 3000 CD ARG B 68 8.213 1.531 -43.754 1.00 74.19 C \nANISOU 3000 CD ARG B 68 8749 9371 10071 -856 -533 -204 C \nATOM 3001 NE ARG B 68 7.644 1.585 -42.416 1.00 80.30 N \nANISOU 3001 NE ARG B 68 9589 10008 10913 -873 -541 -184 N \nATOM 3002 CZ ARG B 68 8.042 0.833 -41.392 1.00 93.23 C \nANISOU 3002 CZ ARG B 68 11218 11666 12538 -784 -566 -205 C \nATOM 3003 NH1 ARG B 68 9.007 -0.066 -41.562 1.00102.62 N \nANISOU 3003 NH1 ARG B 68 12347 13004 13640 -640 -594 -253 N \nATOM 3004 NH2 ARG B 68 7.474 0.989 -40.207 1.00 84.68 N \nANISOU 3004 NH2 ARG B 68 10193 10466 11516 -823 -568 -182 N \nATOM 3005 N GLU B 69 9.797 5.420 -45.840 1.00 64.11 N \nANISOU 3005 N GLU B 69 7415 8430 8514 -1477 -469 -118 N \nATOM 3006 CA GLU B 69 9.760 6.397 -46.928 1.00 63.27 C \nANISOU 3006 CA GLU B 69 7382 8321 8337 -1652 -468 -87 C \nATOM 3007 C GLU B 69 8.646 6.139 -47.935 1.00 59.87 C \nANISOU 3007 C GLU B 69 7038 7706 8004 -1547 -471 -90 C \nATOM 3008 O GLU B 69 8.479 5.027 -48.397 1.00 62.48 O \nANISOU 3008 O GLU B 69 7290 8064 8387 -1372 -466 -125 O \nATOM 3009 CB GLU B 69 11.109 6.397 -47.633 1.00 72.77 C \nANISOU 3009 CB GLU B 69 8410 9874 9366 -1759 -455 -100 C \nATOM 3010 CG GLU B 69 11.473 7.678 -48.385 1.00 79.80 C \nANISOU 3010 CG GLU B 69 9382 10826 10113 -2054 -463 -52 C \nATOM 3011 CD GLU B 69 12.952 8.073 -48.241 1.00 85.01 C \nANISOU 3011 CD GLU B 69 9883 11863 10553 -2275 -456 -45 C \nATOM 3012 OE1 GLU B 69 13.728 7.359 -47.546 1.00 80.19 O \nANISOU 3012 OE1 GLU B 69 9078 11487 9902 -2168 -442 -86 O \nATOM 3013 OE2 GLU B 69 13.351 9.103 -48.842 1.00 93.98 O \nANISOU 3013 OE2 GLU B 69 11094 13080 11533 -2566 -470 2 O \nATOM 3014 N PHE B 70 7.927 7.194 -48.324 1.00 59.85 N \nANISOU 3014 N PHE B 70 7213 7524 8003 -1655 -487 -55 N \nATOM 3015 CA PHE B 70 6.715 7.098 -49.151 1.00 53.11 C \nANISOU 3015 CA PHE B 70 6455 6486 7237 -1553 -493 -58 C \nATOM 3016 C PHE B 70 6.644 8.196 -50.168 1.00 50.44 C \nANISOU 3016 C PHE B 70 6256 6098 6812 -1706 -512 -30 C \nATOM 3017 O PHE B 70 7.106 9.268 -49.911 1.00 64.43 O \nANISOU 3017 O PHE B 70 8144 7864 8473 -1894 -537 2 O \nATOM 3018 CB PHE B 70 5.475 7.206 -48.279 1.00 53.80 C \nANISOU 3018 CB PHE B 70 6659 6355 7427 -1447 -509 -58 C \nATOM 3019 CG PHE B 70 5.365 6.119 -47.229 1.00 50.17 C \nANISOU 3019 CG PHE B 70 6099 5911 7051 -1314 -498 -79 C \nATOM 3020 CD1 PHE B 70 5.665 6.385 -45.945 1.00 46.68 C \nANISOU 3020 CD1 PHE B 70 5665 5469 6602 -1348 -504 -72 C \nATOM 3021 CD2 PHE B 70 5.020 4.829 -47.589 1.00 45.99 C \nANISOU 3021 CD2 PHE B 70 5492 5394 6590 -1170 -492 -105 C \nATOM 3022 CE1 PHE B 70 5.581 5.395 -44.999 1.00 46.28 C \nANISOU 3022 CE1 PHE B 70 5540 5427 6616 -1237 -501 -90 C \nATOM 3023 CE2 PHE B 70 4.979 3.822 -46.685 1.00 43.67 C \nANISOU 3023 CE2 PHE B 70 5150 5101 6343 -1071 -498 -121 C \nATOM 3024 CZ PHE B 70 5.252 4.105 -45.363 1.00 45.50 C \nANISOU 3024 CZ PHE B 70 5384 5332 6573 -1103 -501 -113 C \nATOM 3025 N ASN B 71 6.025 7.944 -51.311 1.00 47.65 N \nANISOU 3025 N ASN B 71 5917 5690 6498 -1633 -507 -39 N \nATOM 3026 CA ASN B 71 5.936 8.930 -52.354 1.00 48.28 C \nANISOU 3026 CA ASN B 71 6142 5713 6489 -1769 -531 -14 C \nATOM 3027 C ASN B 71 4.694 9.834 -52.200 1.00 47.27 C \nANISOU 3027 C ASN B 71 6262 5316 6384 -1719 -576 -5 C \nATOM 3028 O ASN B 71 4.124 9.924 -51.144 1.00 54.32 O \nANISOU 3028 O ASN B 71 7207 6105 7327 -1628 -589 -13 O \nATOM 3029 CB ASN B 71 6.031 8.271 -53.745 1.00 49.15 C \nANISOU 3029 CB ASN B 71 6141 5929 6605 -1724 -506 -30 C \nATOM 3030 CG ASN B 71 4.756 7.632 -54.186 1.00 50.04 C \nANISOU 3030 CG ASN B 71 6274 5890 6851 -1523 -502 -53 C \nATOM 3031 OD1 ASN B 71 3.714 7.776 -53.557 1.00 66.48 O \nANISOU 3031 OD1 ASN B 71 8452 7804 9005 -1425 -518 -57 O \nATOM 3032 ND2 ASN B 71 4.827 6.896 -55.242 1.00 52.51 N \nANISOU 3032 ND2 ASN B 71 6486 6286 7180 -1461 -482 -71 N \nATOM 3033 N ASN B 72 4.342 10.560 -53.227 1.00 48.16 N \nANISOU 3033 N ASN B 72 6532 5334 6433 -1774 -606 7 N \nATOM 3034 CA ASN B 72 3.317 11.556 -53.126 1.00 51.60 C \nANISOU 3034 CA ASN B 72 7232 5536 6838 -1715 -667 7 C \nATOM 3035 C ASN B 72 1.916 10.948 -53.267 1.00 51.80 C \nANISOU 3035 C ASN B 72 7211 5482 6987 -1457 -655 -33 C \nATOM 3036 O ASN B 72 0.962 11.535 -52.785 1.00 53.02 O \nANISOU 3036 O ASN B 72 7518 5499 7127 -1334 -698 -51 O \nATOM 3037 CB ASN B 72 3.522 12.594 -54.210 1.00 55.67 C \nANISOU 3037 CB ASN B 72 7968 5975 7208 -1879 -718 35 C \nATOM 3038 CG ASN B 72 2.826 13.884 -53.909 1.00 60.21 C \nANISOU 3038 CG ASN B 72 8897 6302 7679 -1856 -811 37 C \nATOM 3039 OD1 ASN B 72 2.742 14.302 -52.742 1.00 68.46 O \nANISOU 3039 OD1 ASN B 72 10042 7269 8702 -1829 -844 35 O \nATOM 3040 ND2 ASN B 72 2.374 14.573 -54.955 1.00 59.49 N \nANISOU 3040 ND2 ASN B 72 9023 6079 7503 -1862 -865 40 N \nATOM 3041 N LEU B 73 1.794 9.817 -53.975 1.00 49.39 N \nANISOU 3041 N LEU B 73 6709 5280 6776 -1380 -604 -48 N \nATOM 3042 CA LEU B 73 0.562 9.092 -54.084 1.00 44.71 C \nANISOU 3042 CA LEU B 73 6048 4656 6285 -1185 -589 -79 C \nATOM 3043 C LEU B 73 0.438 7.958 -53.093 1.00 42.70 C \nANISOU 3043 C LEU B 73 5623 4475 6127 -1102 -556 -92 C \nATOM 3044 O LEU B 73 -0.359 7.052 -53.313 1.00 47.11 O \nANISOU 3044 O LEU B 73 6092 5053 6756 -995 -539 -108 O \nATOM 3045 CB LEU B 73 0.358 8.595 -55.499 1.00 42.88 C \nANISOU 3045 CB LEU B 73 5758 4457 6076 -1162 -570 -84 C \nATOM 3046 CG LEU B 73 0.157 9.719 -56.448 1.00 44.95 C \nANISOU 3046 CG LEU B 73 6219 4617 6243 -1213 -612 -75 C \nATOM 3047 CD1 LEU B 73 -0.026 9.179 -57.862 1.00 43.26 C \nANISOU 3047 CD1 LEU B 73 5933 4446 6060 -1190 -588 -81 C \nATOM 3048 CD2 LEU B 73 -1.025 10.636 -56.020 1.00 47.87 C \nANISOU 3048 CD2 LEU B 73 6786 4836 6566 -1077 -670 -98 C \nATOM 3049 N GLU B 74 1.179 8.068 -51.994 1.00 45.15 N \nANISOU 3049 N GLU B 74 5914 4818 6422 -1167 -556 -81 N \nATOM 3050 CA GLU B 74 1.090 7.117 -50.862 1.00 42.72 C \nANISOU 3050 CA GLU B 74 5483 4558 6190 -1097 -536 -91 C \nATOM 3051 C GLU B 74 0.923 7.867 -49.555 1.00 43.41 C \nANISOU 3051 C GLU B 74 5657 4586 6250 -1099 -560 -89 C \nATOM 3052 O GLU B 74 1.482 7.487 -48.550 1.00 42.94 O \nANISOU 3052 O GLU B 74 5526 4577 6212 -1123 -549 -85 O \nATOM 3053 CB GLU B 74 2.339 6.242 -50.800 1.00 42.75 C \nANISOU 3053 CB GLU B 74 5344 4698 6200 -1147 -510 -90 C \nATOM 3054 CG GLU B 74 2.561 5.389 -52.071 1.00 42.78 C \nANISOU 3054 CG GLU B 74 5263 4776 6217 -1112 -493 -102 C \nATOM 3055 CD GLU B 74 3.851 4.584 -51.982 1.00 44.59 C \nANISOU 3055 CD GLU B 74 5358 5172 6414 -1115 -480 -115 C \nATOM 3056 OE1 GLU B 74 4.896 5.200 -51.688 1.00 46.47 O \nANISOU 3056 OE1 GLU B 74 5568 5520 6569 -1230 -477 -106 O \nATOM 3057 OE2 GLU B 74 3.822 3.348 -52.241 1.00 40.17 O \nANISOU 3057 OE2 GLU B 74 4732 4643 5887 -999 -482 -139 O \nATOM 3058 N ARG B 75 0.060 8.878 -49.546 1.00 43.13 N \nANISOU 3058 N ARG B 75 5782 4443 6162 -1041 -601 -98 N \nATOM 3059 CA ARG B 75 -0.208 9.651 -48.346 1.00 42.90 C \nANISOU 3059 CA ARG B 75 5862 4349 6088 -1007 -636 -105 C \nATOM 3060 C ARG B 75 -1.066 8.900 -47.301 1.00 40.36 C \nANISOU 3060 C ARG B 75 5416 4086 5831 -884 -620 -126 C \nATOM 3061 O ARG B 75 -0.943 9.127 -46.104 1.00 39.02 O \nANISOU 3061 O ARG B 75 5262 3912 5653 -881 -630 -127 O \nATOM 3062 CB ARG B 75 -0.855 10.981 -48.737 1.00 46.85 C \nANISOU 3062 CB ARG B 75 6609 4715 6475 -946 -703 -119 C \nATOM 3063 CG ARG B 75 0.001 11.836 -49.654 1.00 48.10 C \nANISOU 3063 CG ARG B 75 6942 4798 6537 -1112 -735 -89 C \nATOM 3064 CD ARG B 75 1.350 12.005 -49.016 1.00 56.81 C \nANISOU 3064 CD ARG B 75 8037 5944 7604 -1315 -728 -52 C \nATOM 3065 NE ARG B 75 2.188 12.995 -49.664 1.00 69.04 N \nANISOU 3065 NE ARG B 75 9783 7437 9011 -1527 -773 -16 N \nATOM 3066 CZ ARG B 75 3.493 13.147 -49.394 1.00 80.78 C \nANISOU 3066 CZ ARG B 75 11241 9022 10431 -1760 -764 22 C \nATOM 3067 NH1 ARG B 75 4.093 12.349 -48.508 1.00 85.19 N \nANISOU 3067 NH1 ARG B 75 11578 9728 11063 -1769 -711 21 N \nATOM 3068 NH2 ARG B 75 4.212 14.082 -50.020 1.00 77.42 N \nANISOU 3068 NH2 ARG B 75 11008 8565 9843 -1996 -811 62 N \nATOM 3069 N ARG B 76 -1.921 7.994 -47.748 1.00 40.97 N \nANISOU 3069 N ARG B 76 5375 4230 5961 -805 -597 -141 N \nATOM 3070 CA ARG B 76 -2.731 7.194 -46.749 1.00 40.00 C \nANISOU 3070 CA ARG B 76 5132 4193 5873 -739 -585 -153 C \nATOM 3071 C ARG B 76 -1.869 6.282 -45.962 1.00 36.20 C \nANISOU 3071 C ARG B 76 4558 3744 5454 -821 -560 -132 C \nATOM 3072 O ARG B 76 -1.824 6.344 -44.737 1.00 32.64 O \nANISOU 3072 O ARG B 76 4094 3305 5001 -819 -565 -132 O \nATOM 3073 CB ARG B 76 -3.787 6.391 -47.470 1.00 37.81 C \nANISOU 3073 CB ARG B 76 4763 3995 5609 -688 -572 -164 C \nATOM 3074 CG ARG B 76 -4.860 7.237 -48.148 1.00 37.48 C \nANISOU 3074 CG ARG B 76 4791 3964 5488 -565 -600 -198 C \nATOM 3075 CD ARG B 76 -5.725 6.388 -49.032 1.00 36.11 C \nANISOU 3075 CD ARG B 76 4514 3883 5324 -550 -583 -203 C \nATOM 3076 NE ARG B 76 -4.910 5.835 -50.094 1.00 38.47 N \nANISOU 3076 NE ARG B 76 4813 4117 5687 -639 -562 -177 N \nATOM 3077 CZ ARG B 76 -5.228 4.728 -50.737 1.00 42.96 C \nANISOU 3077 CZ ARG B 76 5298 4735 6288 -676 -545 -167 C \nATOM 3078 NH1 ARG B 76 -6.331 4.032 -50.397 1.00 47.66 N \nANISOU 3078 NH1 ARG B 76 5805 5452 6853 -673 -546 -173 N \nATOM 3079 NH2 ARG B 76 -4.485 4.315 -51.708 1.00 43.40 N \nANISOU 3079 NH2 ARG B 76 5365 4737 6386 -725 -533 -153 N \nATOM 3080 N ILE B 77 -1.032 5.535 -46.689 1.00 37.08 N \nANISOU 3080 N ILE B 77 4618 3868 5604 -882 -540 -118 N \nATOM 3081 CA ILE B 77 -0.031 4.669 -46.031 1.00 39.07 C \nANISOU 3081 CA ILE B 77 4798 4157 5890 -928 -529 -108 C \nATOM 3082 C ILE B 77 0.907 5.449 -45.154 1.00 37.94 C \nANISOU 3082 C ILE B 77 4686 4010 5718 -987 -532 -100 C \nATOM 3083 O ILE B 77 1.261 5.018 -44.042 1.00 47.77 O \nANISOU 3083 O ILE B 77 5888 5281 6981 -992 -530 -98 O \nATOM 3084 CB ILE B 77 0.798 3.921 -47.104 1.00 46.75 C \nANISOU 3084 CB ILE B 77 5725 5167 6870 -943 -518 -109 C \nATOM 3085 CG1 ILE B 77 -0.066 2.991 -47.921 1.00 47.63 C \nANISOU 3085 CG1 ILE B 77 5822 5269 7006 -895 -522 -114 C \nATOM 3086 CG2 ILE B 77 1.850 3.037 -46.440 1.00 56.98 C \nANISOU 3086 CG2 ILE B 77 6959 6522 8171 -940 -519 -113 C \nATOM 3087 CD1 ILE B 77 -0.897 2.055 -47.054 1.00 48.16 C \nANISOU 3087 CD1 ILE B 77 5875 5334 7087 -882 -537 -110 C \nATOM 3088 N GLU B 78 1.366 6.591 -45.624 1.00 38.79 N \nANISOU 3088 N GLU B 78 4886 4087 5766 -1051 -542 -92 N \nATOM 3089 CA GLU B 78 2.335 7.384 -44.846 1.00 43.94 C \nANISOU 3089 CA GLU B 78 5588 4742 6363 -1151 -552 -77 C \nATOM 3090 C GLU B 78 1.744 7.861 -43.557 1.00 42.56 C \nANISOU 3090 C GLU B 78 5476 4508 6186 -1103 -573 -82 C \nATOM 3091 O GLU B 78 2.366 7.827 -42.521 1.00 55.79 O \nANISOU 3091 O GLU B 78 7123 6212 7862 -1146 -570 -75 O \nATOM 3092 CB GLU B 78 2.786 8.561 -45.714 1.00 53.36 C \nANISOU 3092 CB GLU B 78 6919 5895 7461 -1263 -575 -61 C \nATOM 3093 CG GLU B 78 3.810 9.477 -45.054 1.00 65.60 C \nANISOU 3093 CG GLU B 78 8554 7453 8916 -1422 -596 -36 C \nATOM 3094 CD GLU B 78 4.188 10.641 -45.952 1.00 76.54 C \nANISOU 3094 CD GLU B 78 10121 8785 10175 -1574 -634 -12 C \nATOM 3095 OE1 GLU B 78 5.398 10.870 -46.167 1.00 96.28 O \nANISOU 3095 OE1 GLU B 78 12591 11406 12586 -1766 -628 14 O \nATOM 3096 OE2 GLU B 78 3.277 11.332 -46.467 1.00 79.47 O \nANISOU 3096 OE2 GLU B 78 10670 9009 10514 -1507 -675 -20 O \nATOM 3097 N ASN B 79 0.502 8.273 -43.620 1.00 46.13 N \nANISOU 3097 N ASN B 79 6000 4900 6625 -996 -595 -101 N \nATOM 3098 CA ASN B 79 -0.208 8.779 -42.458 1.00 52.11 C \nANISOU 3098 CA ASN B 79 6813 5630 7355 -914 -621 -117 C \nATOM 3099 C ASN B 79 -0.435 7.615 -41.515 1.00 48.89 C \nANISOU 3099 C ASN B 79 6246 5310 7020 -890 -592 -118 C \nATOM 3100 O ASN B 79 -0.355 7.777 -40.292 1.00 41.92 O \nANISOU 3100 O ASN B 79 5364 4432 6132 -886 -599 -119 O \nATOM 3101 CB ASN B 79 -1.556 9.392 -42.876 1.00 55.19 C \nANISOU 3101 CB ASN B 79 7289 5994 7685 -764 -655 -151 C \nATOM 3102 CG ASN B 79 -2.201 10.173 -41.764 1.00 62.44 C \nANISOU 3102 CG ASN B 79 8297 6897 8531 -649 -698 -179 C \nATOM 3103 OD1 ASN B 79 -3.244 9.803 -41.292 1.00 63.10 O \nANISOU 3103 OD1 ASN B 79 8280 7086 8607 -532 -694 -208 O \nATOM 3104 ND2 ASN B 79 -1.568 11.271 -41.339 1.00 70.89 N \nANISOU 3104 ND2 ASN B 79 9562 7847 9525 -691 -744 -172 N \nATOM 3105 N LEU B 80 -0.772 6.457 -42.099 1.00 44.48 N \nANISOU 3105 N LEU B 80 5576 4809 6514 -881 -568 -117 N \nATOM 3106 CA LEU B 80 -0.932 5.217 -41.322 1.00 44.89 C \nANISOU 3106 CA LEU B 80 5521 4922 6613 -890 -555 -112 C \nATOM 3107 C LEU B 80 0.343 4.889 -40.576 1.00 42.77 C \nANISOU 3107 C LEU B 80 5230 4652 6369 -951 -548 -98 C \nATOM 3108 O LEU B 80 0.332 4.624 -39.370 1.00 40.42 O \nANISOU 3108 O LEU B 80 4907 4371 6081 -954 -552 -96 O \nATOM 3109 CB LEU B 80 -1.326 4.064 -42.271 1.00 46.13 C \nANISOU 3109 CB LEU B 80 5624 5107 6795 -894 -548 -108 C \nATOM 3110 CG LEU B 80 -1.407 2.661 -41.713 1.00 48.20 C \nANISOU 3110 CG LEU B 80 5841 5395 7077 -928 -555 -97 C \nATOM 3111 CD1 LEU B 80 -2.099 2.621 -40.383 1.00 56.08 C \nANISOU 3111 CD1 LEU B 80 6811 6445 8052 -939 -564 -95 C \nATOM 3112 CD2 LEU B 80 -2.146 1.769 -42.631 1.00 49.46 C \nANISOU 3112 CD2 LEU B 80 5995 5571 7227 -940 -564 -93 C \nATOM 3113 N ASN B 81 1.470 4.909 -41.297 1.00 44.52 N \nANISOU 3113 N ASN B 81 5449 4881 6587 -998 -539 -93 N \nATOM 3114 CA ASN B 81 2.778 4.769 -40.636 1.00 50.36 C \nANISOU 3114 CA ASN B 81 6149 5669 7317 -1048 -534 -88 C \nATOM 3115 C ASN B 81 2.988 5.829 -39.534 1.00 53.38 C \nANISOU 3115 C ASN B 81 6589 6024 7668 -1095 -543 -79 C \nATOM 3116 O ASN B 81 3.402 5.512 -38.435 1.00 51.79 O \nANISOU 3116 O ASN B 81 6349 5850 7479 -1101 -542 -78 O \nATOM 3117 CB ASN B 81 3.899 4.948 -41.651 1.00 55.20 C \nANISOU 3117 CB ASN B 81 6736 6352 7886 -1105 -524 -87 C \nATOM 3118 CG ASN B 81 5.239 4.489 -41.124 1.00 59.04 C \nANISOU 3118 CG ASN B 81 7134 6960 8340 -1126 -518 -95 C \nATOM 3119 OD1 ASN B 81 5.492 3.294 -41.027 1.00 61.43 O \nANISOU 3119 OD1 ASN B 81 7377 7305 8657 -1039 -525 -114 O \nATOM 3120 ND2 ASN B 81 6.068 5.421 -40.729 1.00 58.60 N \nANISOU 3120 ND2 ASN B 81 7085 6961 8218 -1237 -515 -82 N \nATOM 3121 N LYS B 82 2.740 7.096 -39.849 1.00 51.21 N \nANISOU 3121 N LYS B 82 6433 5684 7339 -1125 -561 -75 N \nATOM 3122 CA LYS B 82 2.924 8.134 -38.851 1.00 64.17 C \nANISOU 3122 CA LYS B 82 8177 7275 8929 -1166 -585 -68 C \nATOM 3123 C LYS B 82 2.092 7.869 -37.591 1.00 72.57 C \nANISOU 3123 C LYS B 82 9213 8332 10027 -1073 -590 -81 C \nATOM 3124 O LYS B 82 2.575 8.050 -36.474 1.00 73.38 O \nANISOU 3124 O LYS B 82 9318 8438 10123 -1107 -594 -75 O \nATOM 3125 CB LYS B 82 2.545 9.470 -39.431 1.00 75.20 C \nANISOU 3125 CB LYS B 82 9767 8566 10240 -1177 -626 -68 C \nATOM 3126 CG LYS B 82 2.595 10.614 -38.445 1.00 81.84 C \nANISOU 3126 CG LYS B 82 10777 9318 11001 -1198 -673 -65 C \nATOM 3127 CD LYS B 82 4.026 10.964 -38.076 1.00 93.67 C \nANISOU 3127 CD LYS B 82 12293 10853 12444 -1390 -673 -32 C \nATOM 3128 CE LYS B 82 4.088 12.317 -37.380 1.00100.12 C \nANISOU 3128 CE LYS B 82 13357 11539 13145 -1446 -739 -22 C \nATOM 3129 NZ LYS B 82 3.132 12.480 -36.240 1.00101.87 N \nANISOU 3129 NZ LYS B 82 13621 11699 13384 -1274 -763 -52 N \nATOM 3130 N LYS B 83 0.833 7.454 -37.756 1.00 76.67 N \nANISOU 3130 N LYS B 83 9697 8865 10568 -968 -590 -99 N \nATOM 3131 CA LYS B 83 -0.062 7.257 -36.602 1.00 71.27 C \nANISOU 3131 CA LYS B 83 8973 8222 9886 -896 -597 -113 C \nATOM 3132 C LYS B 83 0.274 6.046 -35.767 1.00 60.54 C \nANISOU 3132 C LYS B 83 7501 6918 8584 -939 -577 -100 C \nATOM 3133 O LYS B 83 0.120 6.061 -34.526 1.00 57.23 O \nANISOU 3133 O LYS B 83 7064 6520 8160 -930 -582 -101 O \nATOM 3134 CB LYS B 83 -1.506 7.158 -37.034 1.00 82.26 C \nANISOU 3134 CB LYS B 83 10335 9675 11246 -794 -604 -138 C \nATOM 3135 CG LYS B 83 -2.083 8.480 -37.564 1.00 94.74 C \nANISOU 3135 CG LYS B 83 12057 11204 12737 -688 -643 -167 C \nATOM 3136 CD LYS B 83 -1.308 9.737 -37.114 1.00 97.08 C \nANISOU 3136 CD LYS B 83 12536 11374 12974 -709 -682 -163 C \nATOM 3137 CE LYS B 83 -1.946 11.068 -37.518 1.00 95.45 C \nANISOU 3137 CE LYS B 83 12540 11083 12645 -579 -747 -198 C \nATOM 3138 NZ LYS B 83 -0.934 12.122 -37.811 1.00 91.38 N \nANISOU 3138 NZ LYS B 83 12253 10403 12064 -688 -791 -174 N \nATOM 3139 N MET B 84 0.776 5.014 -36.416 1.00 53.44 N \nANISOU 3139 N MET B 84 6547 6033 7726 -976 -562 -90 N \nATOM 3140 CA MET B 84 1.385 3.899 -35.680 1.00 50.19 C \nANISOU 3140 CA MET B 84 6081 5642 7345 -1004 -562 -81 C \nATOM 3141 C MET B 84 2.486 4.346 -34.747 1.00 51.61 C \nANISOU 3141 C MET B 84 6263 5825 7521 -1038 -559 -77 C \nATOM 3142 O MET B 84 2.544 3.930 -33.579 1.00 55.99 O \nANISOU 3142 O MET B 84 6797 6391 8087 -1040 -565 -74 O \nATOM 3143 CB MET B 84 1.973 2.859 -36.618 1.00 52.10 C \nANISOU 3143 CB MET B 84 6305 5890 7602 -1000 -563 -82 C \nATOM 3144 CG MET B 84 2.280 1.572 -35.880 1.00 54.89 C \nANISOU 3144 CG MET B 84 6656 6242 7959 -992 -586 -80 C \nATOM 3145 SD MET B 84 2.976 0.368 -36.917 1.00 68.56 S \nANISOU 3145 SD MET B 84 8410 7968 9673 -936 -610 -95 S \nATOM 3146 CE MET B 84 4.652 1.037 -37.023 1.00 49.19 C \nANISOU 3146 CE MET B 84 5884 5615 7192 -917 -588 -114 C \nATOM 3147 N GLU B 85 3.380 5.204 -35.229 1.00 56.11 N \nANISOU 3147 N GLU B 85 6862 6397 8059 -1085 -553 -74 N \nATOM 3148 CA GLU B 85 4.487 5.714 -34.358 1.00 58.78 C \nANISOU 3148 CA GLU B 85 7199 6767 8368 -1151 -553 -67 C \nATOM 3149 C GLU B 85 4.028 6.626 -33.264 1.00 56.66 C \nANISOU 3149 C GLU B 85 7006 6442 8082 -1155 -568 -63 C \nATOM 3150 O GLU B 85 4.405 6.440 -32.118 1.00 65.16 O \nANISOU 3150 O GLU B 85 8051 7539 9168 -1166 -568 -61 O \nATOM 3151 CB GLU B 85 5.577 6.401 -35.166 1.00 71.20 C \nANISOU 3151 CB GLU B 85 8784 8393 9874 -1250 -548 -59 C \nATOM 3152 CG GLU B 85 6.180 5.561 -36.297 1.00 78.95 C \nANISOU 3152 CG GLU B 85 9675 9471 10849 -1231 -534 -70 C \nATOM 3153 CD GLU B 85 6.701 4.193 -35.856 1.00 86.77 C \nANISOU 3153 CD GLU B 85 10568 10539 11860 -1143 -535 -92 C \nATOM 3154 OE1 GLU B 85 6.807 3.907 -34.635 1.00 91.61 O \nANISOU 3154 OE1 GLU B 85 11171 11146 12490 -1123 -543 -93 O \nATOM 3155 OE2 GLU B 85 7.026 3.393 -36.763 1.00 96.31 O \nANISOU 3155 OE2 GLU B 85 11728 11810 13054 -1080 -537 -111 O \nATOM 3156 N ASP B 86 3.194 7.593 -33.577 1.00 63.95 N \nANISOU 3156 N ASP B 86 8036 7293 8967 -1123 -589 -69 N \nATOM 3157 CA ASP B 86 2.571 8.422 -32.517 1.00 69.94 C \nANISOU 3157 CA ASP B 86 8882 8004 9690 -1073 -616 -78 C \nATOM 3158 C ASP B 86 1.776 7.537 -31.568 1.00 73.52 C \nANISOU 3158 C ASP B 86 9228 8519 10188 -1003 -605 -89 C \nATOM 3159 O ASP B 86 1.785 7.759 -30.373 1.00 80.98 O \nANISOU 3159 O ASP B 86 10178 9467 11123 -994 -614 -90 O \nATOM 3160 CB ASP B 86 1.620 9.474 -33.104 1.00 78.80 C \nANISOU 3160 CB ASP B 86 10148 9053 10738 -986 -655 -99 C \nATOM 3161 CG ASP B 86 2.329 10.469 -34.002 1.00 91.79 C \nANISOU 3161 CG ASP B 86 11955 10611 12310 -1080 -682 -83 C \nATOM 3162 OD1 ASP B 86 3.559 10.646 -33.853 1.00105.51 O \nANISOU 3162 OD1 ASP B 86 13704 12359 14026 -1232 -677 -55 O \nATOM 3163 OD2 ASP B 86 1.662 11.086 -34.867 1.00 99.79 O \nANISOU 3163 OD2 ASP B 86 13089 11560 13267 -1013 -714 -99 O \nATOM 3164 N GLY B 87 1.079 6.547 -32.120 1.00 71.49 N \nANISOU 3164 N GLY B 87 8885 8313 9964 -973 -591 -92 N \nATOM 3165 CA GLY B 87 0.279 5.625 -31.319 1.00 70.78 C \nANISOU 3165 CA GLY B 87 8708 8298 9888 -956 -588 -94 C \nATOM 3166 C GLY B 87 1.092 4.947 -30.229 1.00 64.61 C \nANISOU 3166 C GLY B 87 7890 7516 9141 -1011 -584 -78 C \nATOM 3167 O GLY B 87 0.738 5.057 -29.055 1.00 74.70 O \nANISOU 3167 O GLY B 87 9152 8827 10405 -1002 -591 -80 O \nATOM 3168 N PHE B 88 2.168 4.260 -30.607 1.00 46.50 N \nANISOU 3168 N PHE B 88 5584 5204 6880 -1050 -578 -68 N \nATOM 3169 CA PHE B 88 3.005 3.559 -29.638 1.00 49.54 C \nANISOU 3169 CA PHE B 88 5943 5597 7281 -1072 -583 -62 C \nATOM 3170 C PHE B 88 3.796 4.461 -28.733 1.00 55.89 C \nANISOU 3170 C PHE B 88 6759 6403 8074 -1098 -578 -61 C \nATOM 3171 O PHE B 88 4.046 4.141 -27.555 1.00 60.19 O \nANISOU 3171 O PHE B 88 7284 6958 8626 -1105 -583 -58 O \nATOM 3172 CB PHE B 88 3.970 2.608 -30.334 1.00 47.37 C \nANISOU 3172 CB PHE B 88 5655 5332 7010 -1058 -588 -68 C \nATOM 3173 CG PHE B 88 3.318 1.384 -30.876 1.00 40.60 C \nANISOU 3173 CG PHE B 88 4826 4450 6152 -1041 -612 -66 C \nATOM 3174 CD1 PHE B 88 2.626 0.516 -30.037 1.00 43.85 C \nANISOU 3174 CD1 PHE B 88 5270 4841 6549 -1071 -640 -53 C \nATOM 3175 CD2 PHE B 88 3.424 1.083 -32.161 1.00 40.44 C \nANISOU 3175 CD2 PHE B 88 4815 4425 6127 -1015 -613 -73 C \nATOM 3176 CE1 PHE B 88 2.024 -0.650 -30.513 1.00 44.49 C \nANISOU 3176 CE1 PHE B 88 5418 4887 6600 -1095 -676 -44 C \nATOM 3177 CE2 PHE B 88 2.832 -0.092 -32.660 1.00 44.54 C \nANISOU 3177 CE2 PHE B 88 5392 4903 6629 -1010 -646 -69 C \nATOM 3178 CZ PHE B 88 2.112 -0.934 -31.843 1.00 42.13 C \nANISOU 3178 CZ PHE B 88 5142 4568 6298 -1061 -680 -52 C \nATOM 3179 N LEU B 89 4.121 5.633 -29.245 1.00 68.36 N \nANISOU 3179 N LEU B 89 8390 7962 9621 -1125 -575 -61 N \nATOM 3180 CA LEU B 89 4.836 6.637 -28.456 1.00 76.68 C \nANISOU 3180 CA LEU B 89 9493 9004 10638 -1182 -581 -54 C \nATOM 3181 C LEU B 89 3.969 7.127 -27.308 1.00 77.95 C \nANISOU 3181 C LEU B 89 9697 9130 10790 -1133 -598 -60 C \nATOM 3182 O LEU B 89 4.432 7.230 -26.171 1.00 88.60 O \nANISOU 3182 O LEU B 89 11040 10487 12139 -1159 -600 -55 O \nATOM 3183 CB LEU B 89 5.223 7.798 -29.360 1.00 89.00 C \nANISOU 3183 CB LEU B 89 11154 10529 12133 -1250 -592 -46 C \nATOM 3184 CG LEU B 89 5.883 9.018 -28.717 1.00 99.12 C \nANISOU 3184 CG LEU B 89 12550 11773 13338 -1347 -616 -32 C \nATOM 3185 CD1 LEU B 89 6.778 9.757 -29.697 1.00 93.64 C \nANISOU 3185 CD1 LEU B 89 11928 11096 12557 -1491 -626 -12 C \nATOM 3186 CD2 LEU B 89 4.796 9.953 -28.218 1.00104.81 C \nANISOU 3186 CD2 LEU B 89 13420 12382 14022 -1263 -656 -45 C \nATOM 3187 N ASP B 90 2.710 7.438 -27.615 1.00 78.85 N \nANISOU 3187 N ASP B 90 9845 9230 10884 -1051 -610 -76 N \nATOM 3188 CA ASP B 90 1.738 7.874 -26.607 1.00 83.84 C \nANISOU 3188 CA ASP B 90 10495 9882 11479 -969 -629 -95 C \nATOM 3189 C ASP B 90 1.633 6.827 -25.500 1.00 79.05 C \nANISOU 3189 C ASP B 90 9777 9346 10913 -992 -615 -86 C \nATOM 3190 O ASP B 90 1.762 7.148 -24.332 1.00 85.98 O \nANISOU 3190 O ASP B 90 10664 10226 11777 -987 -623 -88 O \nATOM 3191 CB ASP B 90 0.365 8.123 -27.234 1.00 95.93 C \nANISOU 3191 CB ASP B 90 12030 11458 12959 -858 -644 -123 C \nATOM 3192 CG ASP B 90 0.295 9.439 -28.014 1.00111.70 C \nANISOU 3192 CG ASP B 90 14198 13363 14882 -796 -681 -141 C \nATOM 3193 OD1 ASP B 90 1.350 10.088 -28.258 1.00115.01 O \nANISOU 3193 OD1 ASP B 90 14736 13676 15287 -886 -694 -121 O \nATOM 3194 OD2 ASP B 90 -0.844 9.819 -28.390 1.00135.78 O \nANISOU 3194 OD2 ASP B 90 17269 16458 17862 -662 -704 -176 O \nATOM 3195 N VAL B 91 1.427 5.573 -25.888 1.00 71.83 N \nANISOU 3195 N VAL B 91 8784 8474 10035 -1024 -602 -76 N \nATOM 3196 CA VAL B 91 1.261 4.463 -24.957 1.00 64.95 C \nANISOU 3196 CA VAL B 91 7852 7649 9178 -1067 -604 -63 C \nATOM 3197 C VAL B 91 2.493 4.304 -24.099 1.00 69.51 C \nANISOU 3197 C VAL B 91 8439 8186 9788 -1102 -603 -53 C \nATOM 3198 O VAL B 91 2.399 4.286 -22.873 1.00 74.62 O \nANISOU 3198 O VAL B 91 9070 8855 10428 -1111 -609 -50 O \nATOM 3199 CB VAL B 91 1.026 3.173 -25.715 1.00 62.75 C \nANISOU 3199 CB VAL B 91 7557 7376 8909 -1110 -609 -50 C \nATOM 3200 CG1 VAL B 91 1.070 1.976 -24.783 1.00 67.71 C \nANISOU 3200 CG1 VAL B 91 8188 8009 9531 -1175 -631 -31 C \nATOM 3201 CG2 VAL B 91 -0.318 3.229 -26.414 1.00 64.07 C \nANISOU 3201 CG2 VAL B 91 7692 7624 9028 -1096 -610 -58 C \nATOM 3202 N TRP B 92 3.661 4.237 -24.732 1.00 69.44 N \nANISOU 3202 N TRP B 92 8442 8144 9798 -1117 -596 -51 N \nATOM 3203 CA TRP B 92 4.940 4.099 -23.978 1.00 69.01 C \nANISOU 3203 CA TRP B 92 8372 8098 9750 -1141 -596 -48 C \nATOM 3204 C TRP B 92 5.325 5.276 -23.109 1.00 74.33 C \nANISOU 3204 C TRP B 92 9074 8765 10404 -1170 -593 -46 C \nATOM 3205 O TRP B 92 5.873 5.105 -22.022 1.00 85.43 O \nANISOU 3205 O TRP B 92 10459 10188 11814 -1186 -596 -43 O \nATOM 3206 CB TRP B 92 6.109 3.782 -24.918 1.00 64.65 C \nANISOU 3206 CB TRP B 92 7795 7581 9186 -1141 -591 -56 C \nATOM 3207 CG TRP B 92 6.068 2.354 -25.370 1.00 60.85 C \nANISOU 3207 CG TRP B 92 7314 7095 8710 -1087 -612 -64 C \nATOM 3208 CD1 TRP B 92 5.881 1.887 -26.638 1.00 58.73 C \nANISOU 3208 CD1 TRP B 92 7058 6819 8438 -1058 -616 -70 C \nATOM 3209 CD2 TRP B 92 6.168 1.205 -24.531 1.00 53.48 C \nANISOU 3209 CD2 TRP B 92 6409 6142 7770 -1056 -644 -66 C \nATOM 3210 NE1 TRP B 92 5.884 0.506 -26.638 1.00 58.47 N \nANISOU 3210 NE1 TRP B 92 7074 6755 8388 -1008 -656 -77 N \nATOM 3211 CE2 TRP B 92 6.054 0.067 -25.352 1.00 57.97 C \nANISOU 3211 CE2 TRP B 92 7034 6676 8317 -1008 -678 -74 C \nATOM 3212 CE3 TRP B 92 6.357 1.031 -23.173 1.00 58.23 C \nANISOU 3212 CE3 TRP B 92 7016 6739 8371 -1066 -656 -62 C \nATOM 3213 CZ2 TRP B 92 6.125 -1.241 -24.850 1.00 64.52 C \nANISOU 3213 CZ2 TRP B 92 7959 7447 9107 -969 -735 -78 C \nATOM 3214 CZ3 TRP B 92 6.410 -0.281 -22.651 1.00 66.74 C \nANISOU 3214 CZ3 TRP B 92 8167 7771 9420 -1031 -706 -64 C \nATOM 3215 CH2 TRP B 92 6.303 -1.396 -23.496 1.00 66.79 C \nANISOU 3215 CH2 TRP B 92 8262 7725 9389 -984 -750 -73 C \nATOM 3216 N THR B 93 5.014 6.477 -23.562 1.00 80.46 N \nANISOU 3216 N THR B 93 9922 9504 11145 -1174 -598 -48 N \nATOM 3217 CA THR B 93 5.194 7.674 -22.720 1.00 78.03 C \nANISOU 3217 CA THR B 93 9699 9156 10791 -1197 -615 -46 C \nATOM 3218 C THR B 93 4.294 7.532 -21.496 1.00 72.93 C \nANISOU 3218 C THR B 93 9032 8524 10153 -1131 -623 -56 C \nATOM 3219 O THR B 93 4.748 7.609 -20.368 1.00 74.98 O \nANISOU 3219 O THR B 93 9285 8788 10414 -1156 -625 -51 O \nATOM 3220 CB THR B 93 4.860 8.980 -23.498 1.00 83.06 C \nANISOU 3220 CB THR B 93 10484 9716 11359 -1192 -642 -51 C \nATOM 3221 OG1 THR B 93 5.904 9.274 -24.428 1.00 76.17 O \nANISOU 3221 OG1 THR B 93 9641 8847 10455 -1303 -638 -34 O \nATOM 3222 CG2 THR B 93 4.673 10.171 -22.554 1.00 82.89 C \nANISOU 3222 CG2 THR B 93 10605 9623 11267 -1170 -682 -58 C \nATOM 3223 N TYR B 94 3.008 7.327 -21.740 1.00 73.71 N \nANISOU 3223 N TYR B 94 9107 8657 10241 -1054 -627 -72 N \nATOM 3224 CA TYR B 94 2.027 7.147 -20.679 1.00 72.02 C \nANISOU 3224 CA TYR B 94 8842 8517 10004 -1001 -634 -84 C \nATOM 3225 C TYR B 94 2.441 6.118 -19.640 1.00 68.40 C \nANISOU 3225 C TYR B 94 8310 8090 9588 -1067 -624 -65 C \nATOM 3226 O TYR B 94 2.295 6.360 -18.445 1.00 58.01 O \nANISOU 3226 O TYR B 94 6986 6802 8254 -1055 -631 -69 O \nATOM 3227 CB TYR B 94 0.699 6.720 -21.274 1.00 75.37 C \nANISOU 3227 CB TYR B 94 9202 9040 10394 -951 -634 -99 C \nATOM 3228 CG TYR B 94 -0.353 6.422 -20.243 1.00 82.19 C \nANISOU 3228 CG TYR B 94 9978 10048 11203 -925 -639 -111 C \nATOM 3229 CD1 TYR B 94 -1.251 7.407 -19.843 1.00 80.71 C \nANISOU 3229 CD1 TYR B 94 9799 9950 10919 -790 -662 -153 C \nATOM 3230 CD2 TYR B 94 -0.447 5.149 -19.674 1.00 76.99 C \nANISOU 3230 CD2 TYR B 94 9240 9448 10563 -1033 -632 -84 C \nATOM 3231 CE1 TYR B 94 -2.211 7.127 -18.912 1.00 86.45 C \nANISOU 3231 CE1 TYR B 94 10414 10863 11571 -768 -665 -168 C \nATOM 3232 CE2 TYR B 94 -1.404 4.867 -18.750 1.00 84.83 C \nANISOU 3232 CE2 TYR B 94 10147 10602 11483 -1048 -638 -90 C \nATOM 3233 CZ TYR B 94 -2.278 5.860 -18.381 1.00 90.36 C \nANISOU 3233 CZ TYR B 94 10812 11430 12089 -917 -649 -133 C \nATOM 3234 OH TYR B 94 -3.249 5.563 -17.463 1.00132.97 O \nANISOU 3234 OH TYR B 94 16091 17043 17389 -934 -654 -143 O \nATOM 3235 N ASN B 95 2.912 4.959 -20.089 1.00 66.19 N \nANISOU 3235 N ASN B 95 7997 7802 9352 -1122 -616 -48 N \nATOM 3236 CA ASN B 95 3.283 3.911 -19.151 1.00 63.99 C \nANISOU 3236 CA ASN B 95 7692 7530 9091 -1168 -624 -34 C \nATOM 3237 C ASN B 95 4.423 4.372 -18.268 1.00 69.69 C \nANISOU 3237 C ASN B 95 8426 8224 9829 -1176 -620 -33 C \nATOM 3238 O ASN B 95 4.300 4.391 -17.022 1.00 74.23 O \nANISOU 3238 O ASN B 95 8988 8817 10398 -1185 -626 -30 O \nATOM 3239 CB ASN B 95 3.684 2.621 -19.872 1.00 65.51 C \nANISOU 3239 CB ASN B 95 7900 7691 9298 -1190 -637 -25 C \nATOM 3240 CG ASN B 95 2.488 1.886 -20.481 1.00 66.87 C \nANISOU 3240 CG ASN B 95 8076 7895 9439 -1224 -650 -16 C \nATOM 3241 OD1 ASN B 95 1.334 1.997 -20.019 1.00 73.12 O \nANISOU 3241 OD1 ASN B 95 8825 8772 10184 -1255 -651 -13 O \nATOM 3242 ND2 ASN B 95 2.760 1.128 -21.511 1.00 67.53 N \nANISOU 3242 ND2 ASN B 95 8199 7932 9526 -1222 -663 -14 N \nATOM 3243 N ALA B 96 5.519 4.776 -18.890 1.00 64.41 N \nANISOU 3243 N ALA B 96 7771 7536 9165 -1187 -612 -35 N \nATOM 3244 CA ALA B 96 6.707 5.156 -18.119 1.00 75.22 C \nANISOU 3244 CA ALA B 96 9134 8918 10526 -1221 -609 -33 C \nATOM 3245 C ALA B 96 6.410 6.222 -17.036 1.00 84.92 C \nANISOU 3245 C ALA B 96 10407 10123 11734 -1230 -615 -32 C \nATOM 3246 O ALA B 96 6.863 6.116 -15.893 1.00 82.79 O \nANISOU 3246 O ALA B 96 10120 9867 11470 -1247 -617 -28 O \nATOM 3247 CB ALA B 96 7.777 5.655 -19.057 1.00 79.77 C \nANISOU 3247 CB ALA B 96 9710 9528 11073 -1264 -599 -34 C \nATOM 3248 N GLU B 97 5.610 7.228 -17.385 1.00 92.75 N \nANISOU 3248 N GLU B 97 11472 11077 12691 -1198 -626 -40 N \nATOM 3249 CA GLU B 97 5.256 8.281 -16.430 1.00 92.19 C \nANISOU 3249 CA GLU B 97 11479 10974 12574 -1168 -648 -48 C \nATOM 3250 C GLU B 97 4.396 7.782 -15.275 1.00 88.97 C \nANISOU 3250 C GLU B 97 11003 10626 12174 -1115 -649 -57 C \nATOM 3251 O GLU B 97 4.622 8.163 -14.136 1.00 79.21 O \nANISOU 3251 O GLU B 97 9787 9385 10924 -1117 -658 -58 O \nATOM 3252 CB GLU B 97 4.549 9.431 -17.123 1.00 97.24 C \nANISOU 3252 CB GLU B 97 12246 11556 13144 -1102 -678 -67 C \nATOM 3253 CG GLU B 97 5.372 10.069 -18.227 1.00 98.95 C \nANISOU 3253 CG GLU B 97 12562 11706 13327 -1186 -687 -52 C \nATOM 3254 CD GLU B 97 5.323 11.574 -18.180 1.00 98.95 C \nANISOU 3254 CD GLU B 97 12785 11592 13220 -1179 -743 -59 C \nATOM 3255 OE1 GLU B 97 5.335 12.133 -17.070 1.00107.38 O \nANISOU 3255 OE1 GLU B 97 13927 12625 14247 -1158 -771 -64 O \nATOM 3256 OE2 GLU B 97 5.301 12.193 -19.246 1.00 97.81 O \nANISOU 3256 OE2 GLU B 97 12763 11381 13020 -1196 -768 -58 O \nATOM 3257 N LEU B 98 3.398 6.949 -15.562 1.00 85.26 N \nANISOU 3257 N LEU B 98 10457 10229 11709 -1087 -642 -62 N \nATOM 3258 CA LEU B 98 2.555 6.395 -14.475 1.00 80.87 C \nANISOU 3258 CA LEU B 98 9825 9771 11132 -1080 -645 -64 C \nATOM 3259 C LEU B 98 3.230 5.286 -13.721 1.00 66.03 C \nANISOU 3259 C LEU B 98 7908 7881 9299 -1164 -640 -39 C \nATOM 3260 O LEU B 98 2.974 5.094 -12.541 1.00 62.69 O \nANISOU 3260 O LEU B 98 7454 7506 8859 -1180 -646 -36 O \nATOM 3261 CB LEU B 98 1.199 5.913 -14.974 1.00 89.12 C \nANISOU 3261 CB LEU B 98 10798 10937 12126 -1060 -646 -74 C \nATOM 3262 CG LEU B 98 0.215 7.028 -15.377 1.00 96.70 C \nANISOU 3262 CG LEU B 98 11776 11964 13000 -923 -661 -115 C \nATOM 3263 CD1 LEU B 98 -1.188 6.453 -15.399 1.00104.89 C \nANISOU 3263 CD1 LEU B 98 12687 13211 13954 -917 -661 -128 C \nATOM 3264 CD2 LEU B 98 0.225 8.231 -14.451 1.00 97.24 C \nANISOU 3264 CD2 LEU B 98 11918 12017 13013 -816 -687 -145 C \nATOM 3265 N LEU B 99 4.159 4.626 -14.367 1.00 63.60 N \nANISOU 3265 N LEU B 99 7617 7515 9035 -1202 -636 -27 N \nATOM 3266 CA LEU B 99 4.985 3.685 -13.640 1.00 65.42 C \nANISOU 3266 CA LEU B 99 7845 7724 9288 -1239 -646 -14 C \nATOM 3267 C LEU B 99 5.801 4.389 -12.573 1.00 74.28 C \nANISOU 3267 C LEU B 99 8968 8837 10417 -1240 -641 -16 C \nATOM 3268 O LEU B 99 5.891 3.911 -11.459 1.00 91.07 O \nANISOU 3268 O LEU B 99 11084 10974 12545 -1258 -651 -10 O \nATOM 3269 CB LEU B 99 5.925 2.949 -14.578 1.00 62.35 C \nANISOU 3269 CB LEU B 99 7474 7301 8916 -1229 -652 -16 C \nATOM 3270 CG LEU B 99 6.815 1.921 -13.870 1.00 70.61 C \nANISOU 3270 CG LEU B 99 8541 8331 9958 -1219 -678 -16 C \nATOM 3271 CD1 LEU B 99 5.975 0.912 -13.105 1.00 65.83 C \nANISOU 3271 CD1 LEU B 99 7984 7704 9326 -1266 -712 1 C \nATOM 3272 CD2 LEU B 99 7.723 1.189 -14.860 1.00 75.56 C \nANISOU 3272 CD2 LEU B 99 9187 8953 10569 -1159 -694 -33 C \nATOM 3273 N VAL B 100 6.400 5.526 -12.916 1.00 81.29 N \nANISOU 3273 N VAL B 100 9887 9704 11297 -1237 -631 -22 N \nATOM 3274 CA VAL B 100 7.265 6.263 -11.980 1.00 71.14 C \nANISOU 3274 CA VAL B 100 8620 8410 9998 -1268 -632 -20 C \nATOM 3275 C VAL B 100 6.477 6.848 -10.817 1.00 71.93 C \nANISOU 3275 C VAL B 100 8744 8509 10079 -1238 -643 -25 C \nATOM 3276 O VAL B 100 6.834 6.639 -9.663 1.00 84.90 O \nANISOU 3276 O VAL B 100 10363 10164 11730 -1256 -645 -20 O \nATOM 3277 CB VAL B 100 8.040 7.367 -12.702 1.00 67.44 C \nANISOU 3277 CB VAL B 100 8213 7921 9490 -1319 -631 -17 C \nATOM 3278 CG1 VAL B 100 8.590 8.388 -11.731 1.00 67.42 C \nANISOU 3278 CG1 VAL B 100 8277 7896 9445 -1372 -645 -11 C \nATOM 3279 CG2 VAL B 100 9.188 6.752 -13.493 1.00 70.56 C \nANISOU 3279 CG2 VAL B 100 8544 8383 9884 -1358 -618 -16 C \nATOM 3280 N LEU B 101 5.412 7.572 -11.117 1.00 68.89 N \nANISOU 3280 N LEU B 101 8400 8122 9652 -1174 -655 -41 N \nATOM 3281 CA LEU B 101 4.574 8.186 -10.067 1.00 73.38 C \nANISOU 3281 CA LEU B 101 8986 8726 10171 -1103 -673 -60 C \nATOM 3282 C LEU B 101 4.097 7.148 -9.069 1.00 75.13 C \nANISOU 3282 C LEU B 101 9100 9038 10407 -1125 -664 -53 C \nATOM 3283 O LEU B 101 4.276 7.303 -7.880 1.00 77.99 O \nANISOU 3283 O LEU B 101 9458 9412 10764 -1129 -670 -52 O \nATOM 3284 CB LEU B 101 3.348 8.917 -10.670 1.00 73.24 C \nANISOU 3284 CB LEU B 101 9007 8742 10077 -983 -695 -93 C \nATOM 3285 CG LEU B 101 3.627 10.085 -11.640 1.00 75.17 C \nANISOU 3285 CG LEU B 101 9413 8874 10275 -949 -723 -104 C \nATOM 3286 CD1 LEU B 101 2.351 10.675 -12.210 1.00 70.03 C \nANISOU 3286 CD1 LEU B 101 8804 8270 9535 -792 -752 -146 C \nATOM 3287 CD2 LEU B 101 4.436 11.163 -10.943 1.00 80.59 C \nANISOU 3287 CD2 LEU B 101 10252 9451 10916 -976 -756 -100 C \nATOM 3288 N MET B 102 3.496 6.079 -9.574 1.00 78.16 N \nANISOU 3288 N MET B 102 9417 9482 10798 -1159 -657 -43 N \nATOM 3289 CA MET B 102 2.939 5.036 -8.720 1.00 75.38 C \nANISOU 3289 CA MET B 102 8997 9218 10428 -1223 -662 -29 C \nATOM 3290 C MET B 102 4.029 4.443 -7.864 1.00 79.94 C \nANISOU 3290 C MET B 102 9597 9723 11054 -1280 -665 -9 C \nATOM 3291 O MET B 102 3.876 4.301 -6.659 1.00 77.43 O \nANISOU 3291 O MET B 102 9255 9448 10718 -1305 -672 -4 O \nATOM 3292 CB MET B 102 2.285 3.947 -9.577 1.00 73.44 C \nANISOU 3292 CB MET B 102 8725 9016 10163 -1290 -666 -13 C \nATOM 3293 CG MET B 102 0.887 4.316 -10.079 1.00 76.01 C \nANISOU 3293 CG MET B 102 8982 9494 10404 -1249 -665 -34 C \nATOM 3294 SD MET B 102 0.294 3.228 -11.373 1.00 79.55 S \nANISOU 3294 SD MET B 102 9423 9971 10830 -1339 -670 -14 S \nATOM 3295 CE MET B 102 1.016 1.666 -10.917 1.00 72.27 C \nANISOU 3295 CE MET B 102 8586 8939 9934 -1484 -699 30 C \nATOM 3296 N GLU B 103 5.153 4.126 -8.497 1.00 81.30 N \nANISOU 3296 N GLU B 103 9808 9807 11274 -1289 -663 -3 N \nATOM 3297 CA GLU B 103 6.211 3.378 -7.838 1.00 71.14 C \nANISOU 3297 CA GLU B 103 8539 8479 10011 -1312 -675 7 C \nATOM 3298 C GLU B 103 7.027 4.248 -6.905 1.00 66.51 C \nANISOU 3298 C GLU B 103 7947 7887 9436 -1302 -665 1 C \nATOM 3299 O GLU B 103 7.568 3.771 -5.896 1.00 60.55 O \nANISOU 3299 O GLU B 103 7191 7130 8687 -1317 -675 6 O \nATOM 3300 CB GLU B 103 7.113 2.729 -8.887 1.00 69.09 C \nANISOU 3300 CB GLU B 103 8306 8180 9767 -1290 -682 2 C \nATOM 3301 CG GLU B 103 7.494 1.304 -8.534 1.00 81.75 C \nANISOU 3301 CG GLU B 103 9966 9744 11349 -1289 -723 6 C \nATOM 3302 CD GLU B 103 6.309 0.352 -8.449 1.00 87.92 C \nANISOU 3302 CD GLU B 103 10807 10511 12089 -1362 -756 29 C \nATOM 3303 OE1 GLU B 103 6.486 -0.747 -7.887 1.00 89.68 O \nANISOU 3303 OE1 GLU B 103 11125 10678 12270 -1386 -806 38 O \nATOM 3304 OE2 GLU B 103 5.206 0.697 -8.916 1.00 99.70 O \nANISOU 3304 OE2 GLU B 103 12260 12056 13567 -1404 -740 36 O \nATOM 3305 N ASN B 104 7.149 5.526 -7.243 1.00 66.22 N \nANISOU 3305 N ASN B 104 7932 7839 9390 -1284 -653 -8 N \nATOM 3306 CA ASN B 104 7.836 6.451 -6.357 1.00 70.64 C \nANISOU 3306 CA ASN B 104 8519 8385 9938 -1300 -653 -9 C \nATOM 3307 C ASN B 104 7.051 6.592 -5.068 1.00 73.75 C \nANISOU 3307 C ASN B 104 8903 8804 10316 -1276 -662 -12 C \nATOM 3308 O ASN B 104 7.630 6.572 -3.982 1.00 84.87 O \nANISOU 3308 O ASN B 104 10304 10212 11732 -1299 -664 -7 O \nATOM 3309 CB ASN B 104 7.977 7.824 -7.006 1.00 75.47 C \nANISOU 3309 CB ASN B 104 9217 8950 10507 -1304 -659 -14 C \nATOM 3310 CG ASN B 104 9.224 7.947 -7.853 1.00 66.80 C \nANISOU 3310 CG ASN B 104 8122 7861 9398 -1379 -650 -5 C \nATOM 3311 OD1 ASN B 104 10.103 7.073 -7.842 1.00 68.59 O \nANISOU 3311 OD1 ASN B 104 8269 8149 9643 -1397 -639 -4 O \nATOM 3312 ND2 ASN B 104 9.337 9.068 -8.534 1.00 59.22 N \nANISOU 3312 ND2 ASN B 104 7264 6853 8383 -1419 -664 -2 N \nATOM 3313 N GLU B 105 5.733 6.732 -5.167 1.00 70.10 N \nANISOU 3313 N GLU B 105 8425 8393 9816 -1225 -668 -25 N \nATOM 3314 CA GLU B 105 4.900 6.716 -3.976 1.00 76.73 C \nANISOU 3314 CA GLU B 105 9220 9316 10616 -1202 -676 -33 C \nATOM 3315 C GLU B 105 5.098 5.461 -3.101 1.00 82.84 C \nANISOU 3315 C GLU B 105 9945 10115 11414 -1286 -677 -9 C \nATOM 3316 O GLU B 105 5.265 5.555 -1.881 1.00 82.66 O \nANISOU 3316 O GLU B 105 9912 10108 11386 -1295 -681 -7 O \nATOM 3317 CB GLU B 105 3.436 6.806 -4.329 1.00 77.80 C \nANISOU 3317 CB GLU B 105 9304 9576 10680 -1142 -682 -54 C \nATOM 3318 CG GLU B 105 2.613 7.083 -3.085 1.00 94.57 C \nANISOU 3318 CG GLU B 105 11370 11833 12729 -1095 -693 -74 C \nATOM 3319 CD GLU B 105 1.233 6.494 -3.143 1.00108.23 C \nANISOU 3319 CD GLU B 105 12979 13773 14370 -1109 -693 -82 C \nATOM 3320 OE1 GLU B 105 0.293 7.299 -3.056 1.00115.97 O \nANISOU 3320 OE1 GLU B 105 13920 14896 15247 -975 -706 -127 O \nATOM 3321 OE2 GLU B 105 1.060 5.245 -3.277 1.00115.31 O \nANISOU 3321 OE2 GLU B 105 13830 14708 15272 -1251 -688 -47 O \nATOM 3322 N ARG B 106 5.106 4.289 -3.722 1.00 79.35 N \nANISOU 3322 N ARG B 106 9502 9661 10987 -1344 -682 9 N \nATOM 3323 CA ARG B 106 5.253 3.060 -2.956 1.00 75.48 C \nANISOU 3323 CA ARG B 106 9026 9163 10490 -1422 -704 32 C \nATOM 3324 C ARG B 106 6.605 3.075 -2.287 1.00 75.50 C \nANISOU 3324 C ARG B 106 9059 9092 10536 -1401 -706 30 C \nATOM 3325 O ARG B 106 6.746 2.683 -1.125 1.00 82.26 O \nANISOU 3325 O ARG B 106 9922 9952 11383 -1433 -721 40 O \nATOM 3326 CB ARG B 106 5.082 1.833 -3.846 1.00 77.60 C \nANISOU 3326 CB ARG B 106 9348 9396 10742 -1477 -729 48 C \nATOM 3327 CG ARG B 106 3.644 1.679 -4.393 1.00 83.28 C \nANISOU 3327 CG ARG B 106 10024 10226 11393 -1535 -730 55 C \nATOM 3328 CD ARG B 106 3.544 0.651 -5.507 1.00101.31 C \nANISOU 3328 CD ARG B 106 12383 12452 13660 -1587 -756 71 C \nATOM 3329 NE ARG B 106 4.047 -0.637 -5.041 1.00120.35 N \nANISOU 3329 NE ARG B 106 14923 14762 16042 -1657 -810 94 N \nATOM 3330 CZ ARG B 106 5.320 -1.043 -5.097 1.00133.79 C \nANISOU 3330 CZ ARG B 106 16711 16339 17784 -1574 -832 82 C \nATOM 3331 NH1 ARG B 106 6.276 -0.274 -5.612 1.00128.56 N \nANISOU 3331 NH1 ARG B 106 15996 15661 17192 -1454 -797 53 N \nATOM 3332 NH2 ARG B 106 5.637 -2.238 -4.630 1.00139.22 N \nANISOU 3332 NH2 ARG B 106 17549 16932 18415 -1614 -898 96 N \nATOM 3333 N THR B 107 7.617 3.559 -2.997 1.00 77.05 N \nANISOU 3333 N THR B 107 9264 9245 10765 -1357 -693 19 N \nATOM 3334 CA THR B 107 8.979 3.633 -2.418 1.00 71.91 C \nANISOU 3334 CA THR B 107 8613 8580 10130 -1344 -692 13 C \nATOM 3335 C THR B 107 8.983 4.490 -1.156 1.00 69.47 C \nANISOU 3335 C THR B 107 8290 8286 9819 -1358 -684 14 C \nATOM 3336 O THR B 107 9.588 4.136 -0.147 1.00 69.33 O \nANISOU 3336 O THR B 107 8268 8270 9804 -1365 -693 17 O \nATOM 3337 CB THR B 107 9.979 4.203 -3.423 1.00 73.80 C \nANISOU 3337 CB THR B 107 8839 8832 10370 -1329 -676 1 C \nATOM 3338 OG1 THR B 107 10.131 3.301 -4.523 1.00 74.69 O \nANISOU 3338 OG1 THR B 107 8962 8940 10478 -1295 -688 -6 O \nATOM 3339 CG2 THR B 107 11.335 4.421 -2.785 1.00 77.42 C \nANISOU 3339 CG2 THR B 107 9266 9338 10812 -1336 -673 -6 C \nATOM 3340 N LEU B 108 8.304 5.628 -1.208 1.00 67.63 N \nANISOU 3340 N LEU B 108 8067 8060 9569 -1343 -675 8 N \nATOM 3341 CA LEU B 108 8.338 6.575 -0.088 1.00 66.39 C \nANISOU 3341 CA LEU B 108 7929 7904 9393 -1335 -678 3 C \nATOM 3342 C LEU B 108 7.647 6.038 1.152 1.00 69.65 C \nANISOU 3342 C LEU B 108 8301 8368 9796 -1339 -685 7 C \nATOM 3343 O LEU B 108 8.192 6.137 2.254 1.00 86.09 O \nANISOU 3343 O LEU B 108 10383 10444 11885 -1354 -688 10 O \nATOM 3344 CB LEU B 108 7.768 7.941 -0.483 1.00 62.18 C \nANISOU 3344 CB LEU B 108 7467 7347 8812 -1283 -687 -14 C \nATOM 3345 CG LEU B 108 8.594 8.746 -1.519 1.00 62.88 C \nANISOU 3345 CG LEU B 108 7637 7371 8885 -1319 -690 -11 C \nATOM 3346 CD1 LEU B 108 8.055 10.183 -1.646 1.00 61.34 C \nANISOU 3346 CD1 LEU B 108 7583 7111 8612 -1262 -724 -28 C \nATOM 3347 CD2 LEU B 108 10.084 8.775 -1.193 1.00 57.55 C \nANISOU 3347 CD2 LEU B 108 6954 6698 8214 -1413 -682 5 C \nATOM 3348 N ASP B 109 6.464 5.457 1.017 1.00 65.40 N \nANISOU 3348 N ASP B 109 7723 7900 9226 -1344 -690 8 N \nATOM 3349 CA ASP B 109 5.864 4.888 2.208 1.00 72.19 C \nANISOU 3349 CA ASP B 109 8540 8837 10052 -1388 -701 17 C \nATOM 3350 C ASP B 109 6.340 3.455 2.533 1.00 64.65 C \nANISOU 3350 C ASP B 109 7617 7837 9111 -1474 -721 44 C \nATOM 3351 O ASP B 109 6.084 2.945 3.606 1.00 68.75 O \nANISOU 3351 O ASP B 109 8130 8393 9599 -1533 -737 58 O \nATOM 3352 CB ASP B 109 4.351 5.100 2.241 1.00 80.62 C \nANISOU 3352 CB ASP B 109 9536 10062 11033 -1369 -702 3 C \nATOM 3353 CG ASP B 109 3.666 4.473 1.137 1.00 84.28 C \nANISOU 3353 CG ASP B 109 9980 10572 11470 -1410 -704 10 C \nATOM 3354 OD1 ASP B 109 4.195 3.451 0.651 1.00 99.27 O \nANISOU 3354 OD1 ASP B 109 11933 12379 13405 -1485 -714 36 O \nATOM 3355 OD2 ASP B 109 2.584 5.001 0.773 1.00 84.63 O \nANISOU 3355 OD2 ASP B 109 9962 10754 11440 -1351 -701 -15 O \nATOM 3356 N PHE B 110 7.105 2.850 1.649 1.00 60.01 N \nANISOU 3356 N PHE B 110 7081 7165 8555 -1468 -730 48 N \nATOM 3357 CA PHE B 110 7.918 1.709 2.018 1.00 62.32 C \nANISOU 3357 CA PHE B 110 7445 7388 8848 -1485 -765 58 C \nATOM 3358 C PHE B 110 8.869 2.136 3.159 1.00 67.56 C \nANISOU 3358 C PHE B 110 8091 8044 9535 -1455 -758 50 C \nATOM 3359 O PHE B 110 8.937 1.473 4.184 1.00 81.07 O \nANISOU 3359 O PHE B 110 9839 9740 11224 -1488 -785 61 O \nATOM 3360 CB PHE B 110 8.735 1.235 0.828 1.00 61.36 C \nANISOU 3360 CB PHE B 110 7369 7206 8739 -1427 -776 45 C \nATOM 3361 CG PHE B 110 9.673 0.099 1.130 1.00 58.97 C \nANISOU 3361 CG PHE B 110 7159 6839 8408 -1383 -826 38 C \nATOM 3362 CD1 PHE B 110 9.198 -1.079 1.687 1.00 60.32 C \nANISOU 3362 CD1 PHE B 110 7455 6948 8518 -1444 -886 59 C \nATOM 3363 CD2 PHE B 110 11.013 0.174 0.795 1.00 57.98 C \nANISOU 3363 CD2 PHE B 110 7013 6731 8288 -1278 -824 8 C \nATOM 3364 CE1 PHE B 110 10.036 -2.174 1.916 1.00 60.95 C \nANISOU 3364 CE1 PHE B 110 7674 6941 8544 -1372 -953 45 C \nATOM 3365 CE2 PHE B 110 11.879 -0.913 1.036 1.00 61.27 C \nANISOU 3365 CE2 PHE B 110 7521 7110 8648 -1185 -883 -14 C \nATOM 3366 CZ PHE B 110 11.388 -2.096 1.583 1.00 61.46 C \nANISOU 3366 CZ PHE B 110 7708 7030 8614 -1215 -953 2 C \nATOM 3367 N HIS B 111 9.568 3.247 2.977 1.00 57.29 N \nANISOU 3367 N HIS B 111 6747 6754 8265 -1411 -727 34 N \nATOM 3368 CA HIS B 111 10.465 3.797 4.001 1.00 57.57 C \nANISOU 3368 CA HIS B 111 6764 6799 8311 -1404 -719 29 C \nATOM 3369 C HIS B 111 9.746 4.148 5.297 1.00 59.52 C \nANISOU 3369 C HIS B 111 6997 7070 8548 -1431 -719 37 C \nATOM 3370 O HIS B 111 10.209 3.810 6.408 1.00 56.98 O \nANISOU 3370 O HIS B 111 6678 6745 8226 -1443 -731 41 O \nATOM 3371 CB HIS B 111 11.153 5.078 3.496 1.00 54.22 C \nANISOU 3371 CB HIS B 111 6325 6388 7888 -1403 -694 20 C \nATOM 3372 CG HIS B 111 12.131 4.849 2.394 1.00 51.68 C \nANISOU 3372 CG HIS B 111 5986 6093 7556 -1390 -690 10 C \nATOM 3373 ND1 HIS B 111 13.084 3.857 2.448 1.00 57.23 N \nANISOU 3373 ND1 HIS B 111 6668 6836 8240 -1342 -708 -5 N \nATOM 3374 CD2 HIS B 111 12.314 5.475 1.212 1.00 54.50 C \nANISOU 3374 CD2 HIS B 111 6344 6463 7900 -1406 -676 7 C \nATOM 3375 CE1 HIS B 111 13.826 3.888 1.360 1.00 55.74 C \nANISOU 3375 CE1 HIS B 111 6445 6711 8024 -1323 -701 -20 C \nATOM 3376 NE2 HIS B 111 13.374 4.857 0.586 1.00 57.25 N \nANISOU 3376 NE2 HIS B 111 6646 6883 8222 -1379 -679 -8 N \nATOM 3377 N ASP B 112 8.594 4.803 5.169 1.00 58.12 N \nANISOU 3377 N ASP B 112 6801 6935 8348 -1425 -710 33 N \nATOM 3378 CA ASP B 112 7.765 5.084 6.367 1.00 58.01 C \nANISOU 3378 CA ASP B 112 6754 6992 8297 -1430 -714 32 C \nATOM 3379 C ASP B 112 7.386 3.803 7.104 1.00 60.11 C \nANISOU 3379 C ASP B 112 7015 7290 8536 -1513 -736 54 C \nATOM 3380 O ASP B 112 7.448 3.738 8.333 1.00 65.11 O \nANISOU 3380 O ASP B 112 7638 7946 9157 -1538 -742 60 O \nATOM 3381 CB ASP B 112 6.518 5.887 6.016 1.00 56.16 C \nANISOU 3381 CB ASP B 112 6487 6846 8005 -1373 -709 11 C \nATOM 3382 CG ASP B 112 6.847 7.314 5.535 1.00 61.08 C \nANISOU 3382 CG ASP B 112 7177 7406 8623 -1286 -709 -13 C \nATOM 3383 OD1 ASP B 112 8.037 7.686 5.592 1.00 67.04 O \nANISOU 3383 OD1 ASP B 112 7987 8069 9415 -1312 -707 -5 O \nATOM 3384 OD2 ASP B 112 5.936 8.045 5.049 1.00 66.53 O \nANISOU 3384 OD2 ASP B 112 7878 8146 9254 -1199 -718 -40 O \nATOM 3385 N SER B 113 7.021 2.776 6.353 1.00 63.23 N \nANISOU 3385 N SER B 113 7441 7674 8908 -1569 -754 70 N \nATOM 3386 CA SER B 113 6.625 1.501 6.964 1.00 69.33 C \nANISOU 3386 CA SER B 113 8267 8453 9622 -1684 -795 99 C \nATOM 3387 C SER B 113 7.822 0.873 7.691 1.00 66.29 C \nANISOU 3387 C SER B 113 7970 7955 9263 -1667 -824 103 C \nATOM 3388 O SER B 113 7.691 0.359 8.793 1.00 70.94 O \nANISOU 3388 O SER B 113 8593 8550 9811 -1737 -851 120 O \nATOM 3389 CB SER B 113 6.054 0.525 5.922 1.00 73.91 C \nANISOU 3389 CB SER B 113 8913 9017 10153 -1761 -824 118 C \nATOM 3390 OG SER B 113 6.853 -0.652 5.878 1.00 87.60 O \nANISOU 3390 OG SER B 113 10801 10608 11877 -1775 -878 130 O \nATOM 3391 N ASN B 114 8.985 0.901 7.071 1.00 60.31 N \nANISOU 3391 N ASN B 114 7242 7119 8554 -1572 -822 83 N \nATOM 3392 CA ASN B 114 10.181 0.309 7.691 1.00 60.84 C \nANISOU 3392 CA ASN B 114 7376 7120 8621 -1517 -855 74 C \nATOM 3393 C ASN B 114 10.615 1.046 8.945 1.00 61.02 C \nANISOU 3393 C ASN B 114 7332 7181 8670 -1508 -831 69 C \nATOM 3394 O ASN B 114 11.034 0.438 9.917 1.00 61.43 O \nANISOU 3394 O ASN B 114 7441 7201 8700 -1511 -864 73 O \nATOM 3395 CB ASN B 114 11.350 0.300 6.693 1.00 67.65 C \nANISOU 3395 CB ASN B 114 8239 7965 9502 -1402 -853 44 C \nATOM 3396 CG ASN B 114 11.214 -0.774 5.623 1.00 67.86 C \nANISOU 3396 CG ASN B 114 8377 7925 9484 -1377 -900 41 C \nATOM 3397 OD1 ASN B 114 10.640 -1.827 5.845 1.00 69.81 O \nANISOU 3397 OD1 ASN B 114 8761 8097 9669 -1438 -959 62 O \nATOM 3398 ND2 ASN B 114 11.728 -0.486 4.449 1.00 74.13 N \nANISOU 3398 ND2 ASN B 114 9127 8745 10295 -1303 -880 19 N \nATOM 3399 N VAL B 115 10.532 2.376 8.920 1.00 63.50 N \nANISOU 3399 N VAL B 115 7553 7551 9022 -1494 -782 60 N \nATOM 3400 CA VAL B 115 10.834 3.179 10.116 1.00 57.32 C \nANISOU 3400 CA VAL B 115 6728 6797 8253 -1493 -765 57 C \nATOM 3401 C VAL B 115 9.875 2.784 11.232 1.00 58.84 C \nANISOU 3401 C VAL B 115 6921 7025 8409 -1560 -781 75 C \nATOM 3402 O VAL B 115 10.300 2.514 12.350 1.00 58.17 O \nANISOU 3402 O VAL B 115 6852 6929 8321 -1573 -795 80 O \nATOM 3403 CB VAL B 115 10.722 4.705 9.839 1.00 52.25 C \nANISOU 3403 CB VAL B 115 6047 6181 7625 -1470 -730 45 C \nATOM 3404 CG1 VAL B 115 10.640 5.515 11.127 1.00 53.75 C \nANISOU 3404 CG1 VAL B 115 6224 6393 7806 -1470 -726 43 C \nATOM 3405 CG2 VAL B 115 11.911 5.185 9.047 1.00 44.97 C \nANISOU 3405 CG2 VAL B 115 5126 5246 6716 -1452 -718 35 C \nATOM 3406 N LYS B 116 8.577 2.776 10.927 1.00 63.28 N \nANISOU 3406 N LYS B 116 7455 7660 8929 -1607 -778 83 N \nATOM 3407 CA LYS B 116 7.547 2.328 11.897 1.00 69.04 C \nANISOU 3407 CA LYS B 116 8161 8485 9587 -1703 -795 102 C \nATOM 3408 C LYS B 116 7.849 0.952 12.504 1.00 66.59 C \nANISOU 3408 C LYS B 116 7962 8101 9239 -1797 -846 131 C \nATOM 3409 O LYS B 116 7.541 0.702 13.658 1.00 70.46 O \nANISOU 3409 O LYS B 116 8450 8639 9684 -1873 -862 146 O \nATOM 3410 CB LYS B 116 6.154 2.265 11.246 1.00 78.25 C \nANISOU 3410 CB LYS B 116 9268 9784 10677 -1760 -791 106 C \nATOM 3411 CG LYS B 116 5.298 3.508 11.386 1.00 85.08 C \nANISOU 3411 CG LYS B 116 10016 10805 11505 -1676 -761 75 C \nATOM 3412 CD LYS B 116 4.806 3.612 12.809 1.00102.49 C \nANISOU 3412 CD LYS B 116 12156 13142 13645 -1712 -765 75 C \nATOM 3413 CE LYS B 116 4.045 4.896 13.037 1.00114.46 C \nANISOU 3413 CE LYS B 116 13574 14813 15101 -1573 -749 28 C \nATOM 3414 NZ LYS B 116 3.752 5.053 14.488 1.00122.45 N \nANISOU 3414 NZ LYS B 116 14524 15948 16054 -1584 -754 23 N \nATOM 3415 N ASN B 117 8.429 0.054 11.721 1.00 60.76 N \nANISOU 3415 N ASN B 117 7340 7244 8501 -1785 -883 135 N \nATOM 3416 CA ASN B 117 8.777 -1.268 12.229 1.00 71.08 C \nANISOU 3416 CA ASN B 117 8816 8444 9747 -1842 -955 154 C \nATOM 3417 C ASN B 117 9.871 -1.237 13.268 1.00 80.89 C \nANISOU 3417 C ASN B 117 10080 9634 11020 -1763 -965 139 C \nATOM 3418 O ASN B 117 9.805 -1.959 14.273 1.00 98.56 O \nANISOU 3418 O ASN B 117 12418 11833 13197 -1837 -1014 159 O \nATOM 3419 CB ASN B 117 9.158 -2.213 11.096 1.00 76.93 C \nANISOU 3419 CB ASN B 117 9706 9065 10459 -1803 -1007 151 C \nATOM 3420 CG ASN B 117 7.942 -2.918 10.511 1.00 84.33 C \nANISOU 3420 CG ASN B 117 10719 10018 11303 -1967 -1041 186 C \nATOM 3421 OD1 ASN B 117 7.063 -3.354 11.255 1.00 93.67 O \nANISOU 3421 OD1 ASN B 117 11937 11259 12393 -2145 -1070 224 O \nATOM 3422 ND2 ASN B 117 7.892 -3.046 9.190 1.00 84.57 N \nANISOU 3422 ND2 ASN B 117 10774 10016 11343 -1925 -1042 178 N \nATOM 3423 N LEU B 118 10.873 -0.398 13.048 1.00 75.45 N \nANISOU 3423 N LEU B 118 9303 8956 10409 -1630 -922 106 N \nATOM 3424 CA LEU B 118 11.878 -0.165 14.070 1.00 66.83 C \nANISOU 3424 CA LEU B 118 8192 7861 9340 -1565 -920 90 C \nATOM 3425 C LEU B 118 11.279 0.374 15.355 1.00 67.58 C \nANISOU 3425 C LEU B 118 8222 8018 9438 -1645 -898 108 C \nATOM 3426 O LEU B 118 11.557 -0.142 16.460 1.00 64.79 O \nANISOU 3426 O LEU B 118 7928 7634 9056 -1667 -932 116 O \nATOM 3427 CB LEU B 118 12.931 0.773 13.564 1.00 71.52 C \nANISOU 3427 CB LEU B 118 8684 8500 9988 -1463 -875 59 C \nATOM 3428 CG LEU B 118 14.262 0.115 13.227 1.00 72.78 C \nANISOU 3428 CG LEU B 118 8889 8649 10116 -1337 -910 26 C \nATOM 3429 CD1 LEU B 118 14.028 -1.143 12.419 1.00 75.40 C \nANISOU 3429 CD1 LEU B 118 9370 8891 10387 -1300 -975 23 C \nATOM 3430 CD2 LEU B 118 15.152 1.097 12.475 1.00 69.08 C \nANISOU 3430 CD2 LEU B 118 8295 8280 9672 -1287 -860 1 C \nATOM 3431 N TYR B 119 10.446 1.406 15.218 1.00 66.47 N \nANISOU 3431 N TYR B 119 7970 7970 9317 -1670 -850 108 N \nATOM 3432 CA TYR B 119 9.748 2.012 16.390 1.00 65.15 C \nANISOU 3432 CA TYR B 119 7728 7895 9130 -1717 -832 115 C \nATOM 3433 C TYR B 119 8.964 1.000 17.172 1.00 70.15 C \nANISOU 3433 C TYR B 119 8413 8563 9680 -1851 -873 146 C \nATOM 3434 O TYR B 119 8.956 1.061 18.390 1.00 77.26 O \nANISOU 3434 O TYR B 119 9295 9498 10563 -1884 -877 152 O \nATOM 3435 CB TYR B 119 8.837 3.147 15.944 1.00 59.13 C \nANISOU 3435 CB TYR B 119 6867 7238 8361 -1684 -793 99 C \nATOM 3436 CG TYR B 119 8.205 3.924 17.072 1.00 64.54 C \nANISOU 3436 CG TYR B 119 7476 8037 9010 -1674 -780 89 C \nATOM 3437 CD1 TYR B 119 8.867 5.009 17.671 1.00 64.31 C \nANISOU 3437 CD1 TYR B 119 7442 7975 9020 -1590 -764 68 C \nATOM 3438 CD2 TYR B 119 6.926 3.596 17.537 1.00 70.52 C \nANISOU 3438 CD2 TYR B 119 8166 8958 9669 -1754 -788 98 C \nATOM 3439 CE1 TYR B 119 8.275 5.731 18.703 1.00 69.64 C \nANISOU 3439 CE1 TYR B 119 8065 8747 9647 -1554 -761 53 C \nATOM 3440 CE2 TYR B 119 6.324 4.306 18.572 1.00 68.71 C \nANISOU 3440 CE2 TYR B 119 7850 8871 9384 -1719 -779 79 C \nATOM 3441 CZ TYR B 119 6.991 5.363 19.154 1.00 72.32 C \nANISOU 3441 CZ TYR B 119 8321 9266 9891 -1604 -768 54 C \nATOM 3442 OH TYR B 119 6.379 6.045 20.174 1.00 70.44 O \nANISOU 3442 OH TYR B 119 8015 9164 9584 -1547 -768 30 O \nATOM 3443 N ASP B 120 8.327 0.055 16.469 1.00 79.40 N \nANISOU 3443 N ASP B 120 9661 9724 10785 -1948 -908 169 N \nATOM 3444 CA ASP B 120 7.488 -0.980 17.119 1.00 86.98 C \nANISOU 3444 CA ASP B 120 10699 10725 11623 -2138 -961 210 C \nATOM 3445 C ASP B 120 8.322 -2.110 17.779 1.00 87.02 C \nANISOU 3445 C ASP B 120 10909 10559 11595 -2165 -1035 227 C \nATOM 3446 O ASP B 120 8.031 -2.510 18.884 1.00 84.60 O \nANISOU 3446 O ASP B 120 10645 10279 11219 -2282 -1065 252 O \nATOM 3447 CB ASP B 120 6.484 -1.575 16.131 1.00 95.83 C \nANISOU 3447 CB ASP B 120 11854 11902 12655 -2266 -983 234 C \nATOM 3448 CG ASP B 120 5.229 -0.724 15.971 1.00111.09 C \nANISOU 3448 CG ASP B 120 13583 14085 14541 -2298 -930 224 C \nATOM 3449 OD1 ASP B 120 5.175 0.416 16.497 1.00115.31 O \nANISOU 3449 OD1 ASP B 120 13970 14724 15117 -2183 -880 192 O \nATOM 3450 OD2 ASP B 120 4.281 -1.200 15.294 1.00125.79 O \nANISOU 3450 OD2 ASP B 120 15441 16049 16305 -2430 -946 246 O \nATOM 3451 N LYS B 121 9.353 -2.612 17.104 1.00 83.10 N \nANISOU 3451 N LYS B 121 10543 9901 11131 -2041 -1070 207 N \nATOM 3452 CA LYS B 121 10.309 -3.528 17.732 1.00 89.35 C \nANISOU 3452 CA LYS B 121 11527 10539 11883 -1987 -1146 202 C \nATOM 3453 C LYS B 121 10.792 -3.036 19.113 1.00 90.23 C \nANISOU 3453 C LYS B 121 11561 10689 12032 -1955 -1122 194 C \nATOM 3454 O LYS B 121 10.939 -3.822 20.047 1.00 91.10 O \nANISOU 3454 O LYS B 121 11823 10722 12069 -2012 -1188 211 O \nATOM 3455 CB LYS B 121 11.529 -3.712 16.846 1.00 96.92 C \nANISOU 3455 CB LYS B 121 12543 11401 12879 -1776 -1163 157 C \nATOM 3456 CG LYS B 121 11.347 -4.594 15.619 1.00107.82 C \nANISOU 3456 CG LYS B 121 14091 12682 14193 -1772 -1224 159 C \nATOM 3457 CD LYS B 121 12.621 -4.619 14.761 1.00110.20 C \nANISOU 3457 CD LYS B 121 14399 12948 14525 -1530 -1231 102 C \nATOM 3458 CE LYS B 121 13.875 -5.001 15.559 1.00108.61 C \nANISOU 3458 CE LYS B 121 14273 12704 14288 -1359 -1280 61 C \nATOM 3459 NZ LYS B 121 14.103 -6.456 15.624 1.00116.69 N \nANISOU 3459 NZ LYS B 121 15627 13548 15164 -1299 -1418 53 N \nATOM 3460 N VAL B 122 11.055 -1.738 19.224 1.00 90.68 N \nANISOU 3460 N VAL B 122 11410 10851 12194 -1869 -1037 169 N \nATOM 3461 CA VAL B 122 11.489 -1.133 20.482 1.00 90.34 C \nANISOU 3461 CA VAL B 122 11285 10851 12188 -1841 -1010 162 C \nATOM 3462 C VAL B 122 10.341 -1.032 21.473 1.00 89.26 C \nANISOU 3462 C VAL B 122 11097 10821 11996 -1999 -1004 193 C \nATOM 3463 O VAL B 122 10.455 -1.518 22.596 1.00 86.62 O \nANISOU 3463 O VAL B 122 10834 10461 11618 -2059 -1040 210 O \nATOM 3464 CB VAL B 122 12.090 0.266 20.267 1.00 91.94 C \nANISOU 3464 CB VAL B 122 11322 11121 12491 -1725 -935 129 C \nATOM 3465 CG1 VAL B 122 12.539 0.880 21.576 1.00 96.34 C \nANISOU 3465 CG1 VAL B 122 11817 11714 13076 -1708 -915 124 C \nATOM 3466 CG2 VAL B 122 13.280 0.176 19.334 1.00 93.18 C \nANISOU 3466 CG2 VAL B 122 11499 11229 12676 -1592 -939 98 C \nATOM 3467 N ARG B 123 9.224 -0.456 21.037 1.00 87.28 N \nANISOU 3467 N ARG B 123 10723 10710 11727 -2061 -964 199 N \nATOM 3468 CA ARG B 123 8.045 -0.277 21.901 1.00 84.14 C \nANISOU 3468 CA ARG B 123 10230 10493 11245 -2195 -953 219 C \nATOM 3469 C ARG B 123 7.584 -1.553 22.563 1.00 82.14 C \nANISOU 3469 C ARG B 123 10120 10228 10863 -2402 -1024 266 C \nATOM 3470 O ARG B 123 7.100 -1.504 23.685 1.00 92.49 O \nANISOU 3470 O ARG B 123 11374 11658 12109 -2502 -1025 282 O \nATOM 3471 CB ARG B 123 6.865 0.293 21.132 1.00 80.85 C \nANISOU 3471 CB ARG B 123 9676 10260 10785 -2217 -917 211 C \nATOM 3472 CG ARG B 123 5.659 0.580 21.995 1.00 81.75 C \nANISOU 3472 CG ARG B 123 9647 10631 10783 -2318 -903 216 C \nATOM 3473 CD ARG B 123 4.626 1.371 21.208 1.00 93.44 C \nANISOU 3473 CD ARG B 123 10969 12320 12216 -2260 -865 187 C \nATOM 3474 NE ARG B 123 3.377 1.566 21.963 1.00108.57 N \nANISOU 3474 NE ARG B 123 12720 14554 13977 -2344 -858 182 N \nATOM 3475 CZ ARG B 123 2.164 1.665 21.412 1.00118.48 C \nANISOU 3475 CZ ARG B 123 13839 16076 15101 -2391 -848 171 C \nATOM 3476 NH1 ARG B 123 1.999 1.580 20.092 1.00113.29 N \nANISOU 3476 NH1 ARG B 123 13206 15378 14463 -2371 -845 168 N \nATOM 3477 NH2 ARG B 123 1.101 1.849 22.189 1.00120.83 N \nANISOU 3477 NH2 ARG B 123 13962 16715 15232 -2454 -843 159 N \nATOM 3478 N LEU B 124 7.725 -2.686 21.885 1.00 81.03 N \nANISOU 3478 N LEU B 124 10181 9941 10665 -2474 -1093 290 N \nATOM 3479 CA LEU B 124 7.323 -3.969 22.475 1.00 90.37 C \nANISOU 3479 CA LEU B 124 11574 11069 11692 -2699 -1185 342 C \nATOM 3480 C LEU B 124 8.260 -4.434 23.573 1.00 88.70 C \nANISOU 3480 C LEU B 124 11514 10704 11484 -2654 -1236 342 C \nATOM 3481 O LEU B 124 7.806 -5.043 24.546 1.00 83.10 O \nANISOU 3481 O LEU B 124 10903 10018 10654 -2848 -1288 382 O \nATOM 3482 CB LEU B 124 7.210 -5.069 21.426 1.00 91.49 C \nANISOU 3482 CB LEU B 124 11951 11065 11747 -2784 -1264 366 C \nATOM 3483 CG LEU B 124 5.941 -4.983 20.589 1.00100.15 C \nANISOU 3483 CG LEU B 124 12940 12347 12763 -2946 -1240 389 C \nATOM 3484 CD1 LEU B 124 5.768 -6.254 19.759 1.00100.47 C \nANISOU 3484 CD1 LEU B 124 13270 12225 12678 -3090 -1341 427 C \nATOM 3485 CD2 LEU B 124 4.708 -4.703 21.446 1.00 98.01 C \nANISOU 3485 CD2 LEU B 124 12492 12377 12372 -3163 -1212 418 C \nATOM 3486 N GLN B 125 9.546 -4.110 23.439 1.00 89.81 N \nANISOU 3486 N GLN B 125 11660 10718 11747 -2409 -1221 295 N \nATOM 3487 CA GLN B 125 10.541 -4.532 24.424 1.00 93.02 C \nANISOU 3487 CA GLN B 125 12198 10995 12152 -2327 -1270 284 C \nATOM 3488 C GLN B 125 10.508 -3.791 25.754 1.00 85.48 C \nANISOU 3488 C GLN B 125 11083 10157 11237 -2345 -1219 284 C \nATOM 3489 O GLN B 125 10.992 -4.323 26.733 1.00 98.96 O \nANISOU 3489 O GLN B 125 12921 11776 12903 -2353 -1272 291 O \nATOM 3490 CB GLN B 125 11.956 -4.460 23.869 1.00 92.08 C \nANISOU 3490 CB GLN B 125 12109 10762 12115 -2059 -1274 229 C \nATOM 3491 CG GLN B 125 12.291 -5.566 22.887 1.00 89.94 C \nANISOU 3491 CG GLN B 125 12090 10323 11760 -1996 -1367 220 C \nATOM 3492 CD GLN B 125 13.708 -5.456 22.406 1.00 91.42 C \nANISOU 3492 CD GLN B 125 12265 10470 12002 -1713 -1368 154 C \nATOM 3493 OE1 GLN B 125 14.542 -6.288 22.720 1.00 94.66 O \nANISOU 3493 OE1 GLN B 125 12876 10758 12330 -1579 -1458 126 O \nATOM 3494 NE2 GLN B 125 13.999 -4.394 21.672 1.00 97.00 N \nANISOU 3494 NE2 GLN B 125 12732 11300 12825 -1619 -1271 127 N \nATOM 3495 N LEU B 126 9.886 -2.623 25.833 1.00 86.21 N \nANISOU 3495 N LEU B 126 10923 10442 11391 -2350 -1128 275 N \nATOM 3496 CA LEU B 126 9.990 -1.836 27.059 1.00 85.13 C \nANISOU 3496 CA LEU B 126 10648 10401 11296 -2323 -1084 265 C \nATOM 3497 C LEU B 126 8.706 -1.150 27.506 1.00 83.40 C \nANISOU 3497 C LEU B 126 10239 10426 11022 -2433 -1036 276 C \nATOM 3498 O LEU B 126 8.727 -0.104 28.125 1.00 93.36 O \nANISOU 3498 O LEU B 126 11347 11789 12338 -2342 -983 249 O \nATOM 3499 CB LEU B 126 11.154 -0.849 26.914 1.00 87.49 C \nANISOU 3499 CB LEU B 126 10850 10657 11734 -2101 -1030 218 C \nATOM 3500 CG LEU B 126 11.358 -0.108 25.596 1.00 80.90 C \nANISOU 3500 CG LEU B 126 9929 9832 10976 -1985 -982 189 C \nATOM 3501 CD1 LEU B 126 10.385 1.047 25.464 1.00 85.92 C \nANISOU 3501 CD1 LEU B 126 10392 10631 11622 -1991 -921 181 C \nATOM 3502 CD2 LEU B 126 12.769 0.391 25.491 1.00 74.43 C \nANISOU 3502 CD2 LEU B 126 9089 8949 10241 -1821 -962 154 C \nATOM 3503 N ARG B 127 7.595 -1.809 27.250 1.00 93.37 N \nANISOU 3503 N ARG B 127 11528 11798 12151 -2635 -1067 312 N \nATOM 3504 CA ARG B 127 6.222 -1.315 27.537 1.00 96.98 C \nANISOU 3504 CA ARG B 127 11783 12562 12501 -2752 -1030 317 C \nATOM 3505 C ARG B 127 6.139 -0.154 28.534 1.00 95.72 C \nANISOU 3505 C ARG B 127 11431 12559 12380 -2631 -974 281 C \nATOM 3506 O ARG B 127 5.937 1.000 28.141 1.00 95.85 O \nANISOU 3506 O ARG B 127 11294 12675 12449 -2460 -919 235 O \nATOM 3507 CB ARG B 127 5.276 -2.468 27.982 1.00 97.52 C \nANISOU 3507 CB ARG B 127 11944 12744 12365 -3073 -1096 379 C \nATOM 3508 CG ARG B 127 5.672 -3.862 27.487 1.00 99.35 C \nANISOU 3508 CG ARG B 127 12493 12720 12535 -3209 -1193 424 C \nATOM 3509 CD ARG B 127 6.230 -4.715 28.628 1.00103.58 C \nANISOU 3509 CD ARG B 127 13252 13092 13012 -3308 -1271 456 C \nATOM 3510 NE ARG B 127 7.336 -5.564 28.223 1.00109.25 N \nANISOU 3510 NE ARG B 127 14272 13473 13765 -3204 -1352 453 N \nATOM 3511 CZ ARG B 127 7.236 -6.682 27.517 1.00117.68 C \nANISOU 3511 CZ ARG B 127 15619 14377 14716 -3327 -1448 487 C \nATOM 3512 NH1 ARG B 127 6.055 -7.100 27.088 1.00127.54 N \nANISOU 3512 NH1 ARG B 127 16879 15771 15808 -3602 -1472 535 N \nATOM 3513 NH2 ARG B 127 8.330 -7.377 27.219 1.00120.91 N \nANISOU 3513 NH2 ARG B 127 16301 14491 15147 -3164 -1527 466 N \nATOM 3514 N ASP B 128 6.270 -0.476 29.814 1.00 96.99 N \nANISOU 3514 N ASP B 128 11625 12730 12497 -2720 -997 301 N \nATOM 3515 CA ASP B 128 6.124 0.513 30.881 1.00101.05 C \nANISOU 3515 CA ASP B 128 11972 13400 13021 -2624 -954 270 C \nATOM 3516 C ASP B 128 7.482 0.905 31.498 1.00 99.41 C \nANISOU 3516 C ASP B 128 11837 12972 12962 -2464 -947 250 C \nATOM 3517 O ASP B 128 7.535 1.720 32.417 1.00105.10 O \nANISOU 3517 O ASP B 128 12457 13773 13702 -2377 -918 225 O \nATOM 3518 CB ASP B 128 5.129 0.043 31.958 1.00100.40 C \nANISOU 3518 CB ASP B 128 11819 13569 12758 -2847 -977 301 C \nATOM 3519 CG ASP B 128 5.404 -1.383 32.460 1.00104.97 C \nANISOU 3519 CG ASP B 128 12630 13994 13258 -3091 -1056 367 C \nATOM 3520 OD1 ASP B 128 6.450 -1.974 32.120 1.00 97.53 O \nANISOU 3520 OD1 ASP B 128 11907 12743 12407 -3036 -1097 376 O \nATOM 3521 OD2 ASP B 128 4.540 -1.913 33.189 1.00108.64 O \nANISOU 3521 OD2 ASP B 128 13067 14667 13544 -3337 -1085 405 O \nATOM 3522 N ASN B 129 8.562 0.349 30.960 1.00 85.98 N \nANISOU 3522 N ASN B 129 10302 11019 11347 -2415 -975 257 N \nATOM 3523 CA ASN B 129 9.884 0.799 31.299 1.00 85.19 C \nANISOU 3523 CA ASN B 129 10237 10760 11372 -2252 -962 231 C \nATOM 3524 C ASN B 129 10.261 2.156 30.657 1.00 85.14 C \nANISOU 3524 C ASN B 129 10122 10760 11468 -2067 -903 187 C \nATOM 3525 O ASN B 129 11.251 2.759 31.056 1.00 76.91 O \nANISOU 3525 O ASN B 129 9079 9639 10505 -1961 -886 167 O \nATOM 3526 CB ASN B 129 10.896 -0.274 30.919 1.00 87.76 C \nANISOU 3526 CB ASN B 129 10763 10867 11715 -2238 -1019 242 C \nATOM 3527 CG ASN B 129 10.901 -1.422 31.917 1.00 96.60 C \nANISOU 3527 CG ASN B 129 12047 11918 12737 -2377 -1093 278 C \nATOM 3528 OD1 ASN B 129 9.993 -1.538 32.750 1.00101.98 O \nANISOU 3528 OD1 ASN B 129 12687 12737 13326 -2540 -1099 307 O \nATOM 3529 ND2 ASN B 129 11.937 -2.257 31.864 1.00 92.63 N \nANISOU 3529 ND2 ASN B 129 11739 11219 12236 -2304 -1156 273 N \nATOM 3530 N ALA B 130 9.469 2.624 29.686 1.00 78.13 N \nANISOU 3530 N ALA B 130 9160 9968 10560 -2044 -879 174 N \nATOM 3531 CA ALA B 130 9.649 3.930 29.052 1.00 73.69 C \nANISOU 3531 CA ALA B 130 8534 9407 10060 -1887 -838 135 C \nATOM 3532 C ALA B 130 8.346 4.657 28.715 1.00 74.59 C \nANISOU 3532 C ALA B 130 8532 9717 10091 -1846 -820 110 C \nATOM 3533 O ALA B 130 7.302 4.024 28.531 1.00 73.33 O \nANISOU 3533 O ALA B 130 8320 9711 9831 -1956 -830 125 O \nATOM 3534 CB ALA B 130 10.473 3.776 27.772 1.00 76.88 C \nANISOU 3534 CB ALA B 130 9011 9664 10537 -1837 -837 132 C \nATOM 3535 N LYS B 131 8.451 5.985 28.577 1.00 77.01 N \nANISOU 3535 N LYS B 131 8818 10020 10421 -1687 -802 69 N \nATOM 3536 CA LYS B 131 7.340 6.873 28.175 1.00 82.90 C \nANISOU 3536 CA LYS B 131 9486 10936 11077 -1573 -796 27 C \nATOM 3537 C LYS B 131 7.433 7.122 26.670 1.00 85.56 C \nANISOU 3537 C LYS B 131 9870 11186 11453 -1520 -790 18 C \nATOM 3538 O LYS B 131 8.460 7.555 26.193 1.00 67.77 O \nANISOU 3538 O LYS B 131 7713 8747 9288 -1479 -787 19 O \nATOM 3539 CB LYS B 131 7.394 8.263 28.845 1.00 91.50 C \nANISOU 3539 CB LYS B 131 10594 12033 12141 -1400 -804 -20 C \nATOM 3540 CG LYS B 131 6.786 8.397 30.234 1.00102.40 C \nANISOU 3540 CG LYS B 131 11885 13595 13429 -1380 -812 -37 C \nATOM 3541 CD LYS B 131 6.780 9.854 30.735 1.00103.18 C \nANISOU 3541 CD LYS B 131 12042 13683 13479 -1169 -834 -93 C \nATOM 3542 CE LYS B 131 6.377 10.003 32.232 1.00104.49 C \nANISOU 3542 CE LYS B 131 12130 14010 13561 -1136 -844 -112 C \nATOM 3543 NZ LYS B 131 5.320 9.042 32.681 1.00103.77 N \nANISOU 3543 NZ LYS B 131 11853 14215 13361 -1257 -832 -99 N \nATOM 3544 N GLU B 132 6.347 6.852 25.935 1.00 96.43 N \nANISOU 3544 N GLU B 132 11169 12723 12746 -1534 -789 11 N \nATOM 3545 CA GLU B 132 6.238 7.264 24.534 1.00 93.28 C \nANISOU 3545 CA GLU B 132 10804 12273 12365 -1456 -784 -7 C \nATOM 3546 C GLU B 132 5.978 8.762 24.462 1.00 93.86 C \nANISOU 3546 C GLU B 132 10910 12364 12387 -1243 -797 -65 C \nATOM 3547 O GLU B 132 4.871 9.218 24.765 1.00 96.34 O \nANISOU 3547 O GLU B 132 11134 12902 12568 -1131 -810 -110 O \nATOM 3548 CB GLU B 132 5.104 6.525 23.829 1.00 93.00 C \nANISOU 3548 CB GLU B 132 10673 12426 12238 -1539 -783 1 C \nATOM 3549 CG GLU B 132 5.293 5.026 23.720 1.00 93.84 C \nANISOU 3549 CG GLU B 132 10811 12480 12363 -1759 -791 60 C \nATOM 3550 CD GLU B 132 4.197 4.365 22.904 1.00 96.89 C \nANISOU 3550 CD GLU B 132 11129 13041 12644 -1867 -796 73 C \nATOM 3551 OE1 GLU B 132 4.160 4.558 21.678 1.00 91.07 O \nANISOU 3551 OE1 GLU B 132 10414 12250 11938 -1807 -789 62 O \nATOM 3552 OE2 GLU B 132 3.365 3.648 23.495 1.00102.08 O \nANISOU 3552 OE2 GLU B 132 11710 13904 13173 -2032 -810 97 O \nATOM 3553 N LEU B 133 6.993 9.514 24.055 1.00 88.37 N \nANISOU 3553 N LEU B 133 10358 11448 11772 -1187 -804 -68 N \nATOM 3554 CA LEU B 133 6.905 10.979 24.013 1.00 90.50 C \nANISOU 3554 CA LEU B 133 10741 11667 11977 -1002 -838 -117 C \nATOM 3555 C LEU B 133 5.974 11.455 22.902 1.00 93.14 C \nANISOU 3555 C LEU B 133 11081 12083 12225 -869 -855 -158 C \nATOM 3556 O LEU B 133 5.556 12.639 22.889 1.00 88.93 O \nANISOU 3556 O LEU B 133 10653 11552 11586 -669 -902 -214 O \nATOM 3557 CB LEU B 133 8.285 11.626 23.851 1.00 82.07 C \nANISOU 3557 CB LEU B 133 9846 10348 10989 -1038 -848 -97 C \nATOM 3558 CG LEU B 133 9.204 11.755 25.036 1.00 79.92 C \nANISOU 3558 CG LEU B 133 9614 9996 10758 -1099 -850 -79 C \nATOM 3559 CD1 LEU B 133 8.845 10.747 26.083 1.00 81.43 C \nANISOU 3559 CD1 LEU B 133 9655 10327 10959 -1165 -828 -63 C \nATOM 3560 CD2 LEU B 133 10.651 11.609 24.600 1.00 81.16 C \nANISOU 3560 CD2 LEU B 133 9838 9990 11010 -1234 -835 -38 C \nATOM 3561 N GLY B 134 5.647 10.536 21.987 1.00 82.52 N \nANISOU 3561 N GLY B 134 9645 10799 10910 -968 -827 -133 N \nATOM 3562 CA GLY B 134 4.776 10.845 20.854 1.00 81.29 C \nANISOU 3562 CA GLY B 134 9474 10734 10678 -860 -837 -168 C \nATOM 3563 C GLY B 134 5.513 11.603 19.785 1.00 82.46 C \nANISOU 3563 C GLY B 134 9803 10648 10880 -816 -854 -169 C \nATOM 3564 O GLY B 134 4.927 12.419 19.077 1.00 90.47 O \nANISOU 3564 O GLY B 134 10890 11679 11805 -655 -887 -214 O \nATOM 3565 N ASN B 135 6.807 11.317 19.667 1.00 86.16 N \nANISOU 3565 N ASN B 135 10345 10919 11475 -961 -835 -120 N \nATOM 3566 CA ASN B 135 7.722 12.107 18.829 1.00 84.07 C \nANISOU 3566 CA ASN B 135 10255 10445 11242 -968 -853 -113 C \nATOM 3567 C ASN B 135 8.760 11.224 18.109 1.00 82.76 C \nANISOU 3567 C ASN B 135 10059 10191 11196 -1139 -815 -62 C \nATOM 3568 O ASN B 135 9.607 11.724 17.368 1.00 76.32 O \nANISOU 3568 O ASN B 135 9352 9246 10399 -1184 -822 -50 O \nATOM 3569 CB ASN B 135 8.427 13.173 19.670 1.00 83.17 C \nANISOU 3569 CB ASN B 135 10304 10202 11093 -939 -892 -120 C \nATOM 3570 CG ASN B 135 9.508 12.597 20.531 1.00 85.67 C \nANISOU 3570 CG ASN B 135 10572 10477 11501 -1091 -863 -77 C \nATOM 3571 OD1 ASN B 135 9.449 11.419 20.931 1.00 95.67 O \nANISOU 3571 OD1 ASN B 135 11683 11837 12830 -1167 -825 -55 O \nATOM 3572 ND2 ASN B 135 10.523 13.406 20.807 1.00 78.52 N \nANISOU 3572 ND2 ASN B 135 9816 9432 10586 -1146 -888 -65 N \nATOM 3573 N GLY B 136 8.693 9.914 18.332 1.00 77.23 N \nANISOU 3573 N GLY B 136 9224 9569 10550 -1231 -783 -36 N \nATOM 3574 CA GLY B 136 9.646 9.007 17.749 1.00 67.41 C \nANISOU 3574 CA GLY B 136 7966 8255 9394 -1345 -761 -1 C \nATOM 3575 C GLY B 136 10.569 8.486 18.800 1.00 68.87 C \nANISOU 3575 C GLY B 136 8132 8413 9623 -1417 -756 20 C \nATOM 3576 O GLY B 136 11.267 7.500 18.570 1.00 58.83 O \nANISOU 3576 O GLY B 136 6838 7116 8399 -1480 -748 40 O \nATOM 3577 N CYS B 137 10.555 9.145 19.961 1.00 78.61 N \nANISOU 3577 N CYS B 137 9386 9656 10827 -1385 -767 9 N \nATOM 3578 CA CYS B 137 11.482 8.848 21.046 1.00 79.96 C \nANISOU 3578 CA CYS B 137 9548 9800 11033 -1444 -764 26 C \nATOM 3579 C CYS B 137 10.780 8.306 22.240 1.00 78.43 C \nANISOU 3579 C CYS B 137 9287 9697 10818 -1447 -768 27 C \nATOM 3580 O CYS B 137 9.635 8.657 22.494 1.00 83.35 O \nANISOU 3580 O CYS B 137 9874 10423 11372 -1383 -775 6 O \nATOM 3581 CB CYS B 137 12.188 10.116 21.497 1.00 73.98 C \nANISOU 3581 CB CYS B 137 8889 8971 10250 -1434 -780 18 C \nATOM 3582 SG CYS B 137 13.010 10.967 20.168 1.00 81.40 S \nANISOU 3582 SG CYS B 137 9938 9819 11171 -1478 -788 23 S \nATOM 3583 N PHE B 138 11.489 7.473 22.989 1.00 74.17 N \nANISOU 3583 N PHE B 138 8728 9138 10316 -1515 -766 48 N \nATOM 3584 CA PHE B 138 11.008 7.010 24.257 1.00 73.67 C \nANISOU 3584 CA PHE B 138 8620 9146 10226 -1543 -773 55 C \nATOM 3585 C PHE B 138 11.876 7.633 25.358 1.00 75.73 C \nANISOU 3585 C PHE B 138 8909 9361 10505 -1532 -775 52 C \nATOM 3586 O PHE B 138 13.104 7.582 25.295 1.00 64.93 O \nANISOU 3586 O PHE B 138 7570 7921 9179 -1558 -772 60 O \nATOM 3587 CB PHE B 138 11.107 5.489 24.359 1.00 83.44 C \nANISOU 3587 CB PHE B 138 9857 10376 11472 -1635 -787 83 C \nATOM 3588 CG PHE B 138 10.407 4.732 23.256 1.00 81.92 C \nANISOU 3588 CG PHE B 138 9667 10205 11254 -1677 -794 94 C \nATOM 3589 CD1 PHE B 138 9.074 4.399 23.367 1.00 78.11 C \nANISOU 3589 CD1 PHE B 138 9129 9860 10689 -1738 -800 101 C \nATOM 3590 CD2 PHE B 138 11.112 4.314 22.132 1.00 80.21 C \nANISOU 3590 CD2 PHE B 138 9501 9896 11078 -1663 -797 96 C \nATOM 3591 CE1 PHE B 138 8.446 3.686 22.375 1.00 83.79 C \nANISOU 3591 CE1 PHE B 138 9858 10608 11372 -1801 -810 115 C \nATOM 3592 CE2 PHE B 138 10.489 3.602 21.134 1.00 78.56 C \nANISOU 3592 CE2 PHE B 138 9312 9696 10843 -1703 -809 106 C \nATOM 3593 CZ PHE B 138 9.155 3.285 21.258 1.00 86.03 C \nANISOU 3593 CZ PHE B 138 10216 10760 11710 -1781 -816 118 C \nATOM 3594 N GLU B 139 11.235 8.219 26.368 1.00 75.49 N \nANISOU 3594 N GLU B 139 8859 9398 10425 -1489 -783 37 N \nATOM 3595 CA GLU B 139 11.930 8.588 27.590 1.00 78.03 C \nANISOU 3595 CA GLU B 139 9202 9686 10758 -1495 -787 39 C \nATOM 3596 C GLU B 139 11.876 7.389 28.510 1.00 76.81 C \nANISOU 3596 C GLU B 139 8993 9578 10612 -1572 -789 61 C \nATOM 3597 O GLU B 139 10.813 7.036 29.046 1.00 64.44 O \nANISOU 3597 O GLU B 139 7365 8133 8986 -1591 -794 61 O \nATOM 3598 CB GLU B 139 11.316 9.819 28.275 1.00 86.26 C \nANISOU 3598 CB GLU B 139 10278 10767 11730 -1393 -806 7 C \nATOM 3599 CG GLU B 139 12.071 10.233 29.533 1.00 86.14 C \nANISOU 3599 CG GLU B 139 10300 10706 11724 -1407 -814 10 C \nATOM 3600 CD GLU B 139 11.749 11.631 30.042 1.00 89.00 C \nANISOU 3600 CD GLU B 139 10763 11048 12005 -1292 -848 -24 C \nATOM 3601 OE1 GLU B 139 11.140 12.451 29.327 1.00 89.94 O \nANISOU 3601 OE1 GLU B 139 10961 11157 12055 -1186 -874 -55 O \nATOM 3602 OE2 GLU B 139 12.134 11.924 31.186 1.00 96.17 O \nANISOU 3602 OE2 GLU B 139 11694 11940 12907 -1297 -858 -23 O \nATOM 3603 N PHE B 140 13.037 6.768 28.702 1.00 81.16 N \nANISOU 3603 N PHE B 140 9571 10051 11214 -1617 -791 78 N \nATOM 3604 CA PHE B 140 13.156 5.616 29.566 1.00 77.99 C \nANISOU 3604 CA PHE B 140 9169 9653 10809 -1679 -809 98 C \nATOM 3605 C PHE B 140 12.747 6.062 30.940 1.00 85.81 C \nANISOU 3605 C PHE B 140 10125 10708 11770 -1681 -809 95 C \nATOM 3606 O PHE B 140 13.006 7.189 31.370 1.00 91.72 O \nANISOU 3606 O PHE B 140 10878 11449 12522 -1623 -801 77 O \nATOM 3607 CB PHE B 140 14.585 5.139 29.680 1.00 74.18 C \nANISOU 3607 CB PHE B 140 8725 9095 10365 -1670 -819 99 C \nATOM 3608 CG PHE B 140 15.061 4.388 28.502 1.00 80.26 C \nANISOU 3608 CG PHE B 140 9531 9823 11142 -1652 -830 97 C \nATOM 3609 CD1 PHE B 140 15.441 5.049 27.347 1.00 74.42 C \nANISOU 3609 CD1 PHE B 140 8774 9082 10421 -1619 -809 84 C \nATOM 3610 CD2 PHE B 140 15.155 3.010 28.551 1.00 79.78 C \nANISOU 3610 CD2 PHE B 140 9545 9715 11051 -1665 -874 107 C \nATOM 3611 CE1 PHE B 140 15.873 4.337 26.257 1.00 80.62 C \nANISOU 3611 CE1 PHE B 140 9582 9847 11203 -1590 -821 78 C \nATOM 3612 CE2 PHE B 140 15.609 2.296 27.460 1.00 81.52 C \nANISOU 3612 CE2 PHE B 140 9820 9893 11262 -1617 -896 97 C \nATOM 3613 CZ PHE B 140 15.964 2.958 26.307 1.00 78.03 C \nANISOU 3613 CZ PHE B 140 9325 9475 10846 -1575 -865 81 C \nATOM 3614 N TYR B 141 12.095 5.178 31.660 1.00 96.01 N \nANISOU 3614 N TYR B 141 11401 12063 13016 -1759 -826 114 N \nATOM 3615 CA TYR B 141 11.819 5.496 33.032 1.00 97.97 C \nANISOU 3615 CA TYR B 141 11608 12384 13231 -1766 -827 111 C \nATOM 3616 C TYR B 141 13.181 5.362 33.670 1.00106.16 C \nANISOU 3616 C TYR B 141 12699 13307 14330 -1757 -833 116 C \nATOM 3617 O TYR B 141 13.768 6.349 34.134 1.00124.83 O \nANISOU 3617 O TYR B 141 15060 15649 16720 -1700 -820 100 O \nATOM 3618 CB TYR B 141 10.750 4.576 33.619 1.00 93.55 C \nANISOU 3618 CB TYR B 141 11013 11953 12580 -1888 -847 135 C \nATOM 3619 CG TYR B 141 9.360 5.061 33.276 1.00 86.89 C \nANISOU 3619 CG TYR B 141 10061 11310 11643 -1871 -834 116 C \nATOM 3620 CD1 TYR B 141 8.997 6.373 33.543 1.00 82.08 C \nANISOU 3620 CD1 TYR B 141 9391 10789 11008 -1725 -819 72 C \nATOM 3621 CD2 TYR B 141 8.415 4.230 32.681 1.00 92.74 C \nANISOU 3621 CD2 TYR B 141 10774 12163 12299 -1991 -847 137 C \nATOM 3622 CE1 TYR B 141 7.753 6.846 33.224 1.00 82.56 C \nANISOU 3622 CE1 TYR B 141 9350 11059 10958 -1660 -817 40 C \nATOM 3623 CE2 TYR B 141 7.146 4.694 32.373 1.00 91.87 C \nANISOU 3623 CE2 TYR B 141 10536 12290 12080 -1964 -835 112 C \nATOM 3624 CZ TYR B 141 6.832 6.005 32.652 1.00 92.52 C \nANISOU 3624 CZ TYR B 141 10545 12473 12137 -1779 -819 59 C \nATOM 3625 OH TYR B 141 5.578 6.492 32.363 1.00115.92 O \nANISOU 3625 OH TYR B 141 13378 15700 14966 -1703 -816 19 O \nATOM 3626 N HIS B 142 13.741 4.166 33.565 1.00 96.95 N \nANISOU 3626 N HIS B 142 11600 12066 13170 -1803 -861 134 N \nATOM 3627 CA HIS B 142 15.055 3.892 34.153 1.00 89.34 C \nANISOU 3627 CA HIS B 142 10678 11028 12239 -1769 -874 130 C \nATOM 3628 C HIS B 142 16.304 4.519 33.515 1.00 90.55 C \nANISOU 3628 C HIS B 142 10815 11152 12436 -1692 -855 108 C \nATOM 3629 O HIS B 142 16.276 5.201 32.486 1.00 99.44 O \nANISOU 3629 O HIS B 142 11920 12286 13577 -1671 -832 98 O \nATOM 3630 CB HIS B 142 15.257 2.383 34.343 1.00 83.69 C \nANISOU 3630 CB HIS B 142 10077 10242 11481 -1808 -931 147 C \nATOM 3631 CG HIS B 142 15.234 1.578 33.095 1.00 80.13 C \nANISOU 3631 CG HIS B 142 9706 9733 11009 -1798 -959 148 C \nATOM 3632 ND1 HIS B 142 14.053 1.124 32.545 1.00 89.83 N \nANISOU 3632 ND1 HIS B 142 10962 10983 12186 -1897 -972 171 N \nATOM 3633 CD2 HIS B 142 16.230 1.058 32.344 1.00 75.66 C \nANISOU 3633 CD2 HIS B 142 9202 9102 10443 -1701 -984 126 C \nATOM 3634 CE1 HIS B 142 14.323 0.398 31.476 1.00 92.07 C \nANISOU 3634 CE1 HIS B 142 11341 11188 12454 -1865 -1005 168 C \nATOM 3635 NE2 HIS B 142 15.636 0.347 31.329 1.00 88.59 N \nANISOU 3635 NE2 HIS B 142 10921 10695 12043 -1733 -1013 137 N \nATOM 3636 N LYS B 143 17.397 4.311 34.227 1.00 88.60 N \nANISOU 3636 N LYS B 143 10576 10897 12193 -1664 -866 100 N \nATOM 3637 CA LYS B 143 18.725 4.587 33.752 1.00 86.41 C \nANISOU 3637 CA LYS B 143 10266 10648 11917 -1611 -857 78 C \nATOM 3638 C LYS B 143 19.086 3.489 32.791 1.00 85.78 C \nANISOU 3638 C LYS B 143 10233 10550 11809 -1546 -889 64 C \nATOM 3639 O LYS B 143 18.982 2.304 33.136 1.00 89.76 O \nANISOU 3639 O LYS B 143 10832 10994 12278 -1519 -940 66 O \nATOM 3640 CB LYS B 143 19.690 4.536 34.926 1.00 88.04 C \nANISOU 3640 CB LYS B 143 10454 10886 12109 -1592 -867 69 C \nATOM 3641 CG LYS B 143 21.155 4.690 34.552 1.00 96.26 C \nANISOU 3641 CG LYS B 143 11433 12025 13115 -1542 -862 41 C \nATOM 3642 CD LYS B 143 22.066 4.314 35.708 1.00104.21 C \nANISOU 3642 CD LYS B 143 12423 13083 14088 -1498 -882 26 C \nATOM 3643 CE LYS B 143 21.860 5.250 36.893 1.00106.43 C \nANISOU 3643 CE LYS B 143 12685 13354 14398 -1582 -859 46 C \nATOM 3644 NZ LYS B 143 22.805 4.974 37.999 1.00102.39 N \nANISOU 3644 NZ LYS B 143 12145 12905 13853 -1546 -875 31 N \nATOM 3645 N CYS B 144 19.540 3.886 31.608 1.00 82.12 N \nANISOU 3645 N CYS B 144 9726 10132 11345 -1521 -869 50 N \nATOM 3646 CA CYS B 144 19.856 2.944 30.554 1.00 74.82 C \nANISOU 3646 CA CYS B 144 8841 9202 10386 -1440 -899 30 C \nATOM 3647 C CYS B 144 21.255 3.207 30.040 1.00 76.00 C \nANISOU 3647 C CYS B 144 8900 9489 10489 -1372 -889 -5 C \nATOM 3648 O CYS B 144 21.460 4.013 29.122 1.00 65.00 O \nANISOU 3648 O CYS B 144 7438 8162 9096 -1416 -853 -5 O \nATOM 3649 CB CYS B 144 18.837 3.032 29.421 1.00 70.38 C \nANISOU 3649 CB CYS B 144 8302 8591 9848 -1481 -886 46 C \nATOM 3650 SG CYS B 144 18.768 1.630 28.253 1.00 77.47 S \nANISOU 3650 SG CYS B 144 9308 9427 10698 -1399 -941 32 S \nATOM 3651 N ASP B 145 22.224 2.511 30.641 1.00 87.83 N \nANISOU 3651 N ASP B 145 10398 11050 11924 -1266 -925 -37 N \nATOM 3652 CA ASP B 145 23.638 2.626 30.226 1.00 91.70 C \nANISOU 3652 CA ASP B 145 10768 11744 12328 -1182 -921 -81 C \nATOM 3653 C ASP B 145 23.828 2.191 28.774 1.00 87.20 C \nANISOU 3653 C ASP B 145 10192 11228 11713 -1096 -934 -109 C \nATOM 3654 O ASP B 145 22.930 1.639 28.155 1.00 88.85 O \nANISOU 3654 O ASP B 145 10512 11290 11956 -1084 -955 -95 O \nATOM 3655 CB ASP B 145 24.593 1.861 31.178 1.00 99.75 C \nANISOU 3655 CB ASP B 145 11791 12845 13265 -1040 -969 -123 C \nATOM 3656 CG ASP B 145 24.229 0.381 31.354 1.00102.08 C \nANISOU 3656 CG ASP B 145 12282 12982 13522 -893 -1055 -140 C \nATOM 3657 OD1 ASP B 145 23.685 -0.242 30.432 1.00107.40 O \nANISOU 3657 OD1 ASP B 145 13062 13555 14189 -853 -1087 -140 O \nATOM 3658 OD2 ASP B 145 24.512 -0.177 32.433 1.00106.54 O \nANISOU 3658 OD2 ASP B 145 12919 13513 14047 -822 -1101 -154 O \nATOM 3659 N ASN B 146 25.001 2.458 28.230 1.00 90.67 N \nANISOU 3659 N ASN B 146 10489 11902 12059 -1047 -920 -147 N \nATOM 3660 CA ASN B 146 25.289 2.115 26.847 1.00 89.98 C \nANISOU 3660 CA ASN B 146 10369 11908 11912 -959 -929 -179 C \nATOM 3661 C ASN B 146 24.948 0.671 26.500 1.00 89.65 C \nANISOU 3661 C ASN B 146 10495 11730 11839 -762 -1007 -210 C \nATOM 3662 O ASN B 146 24.431 0.408 25.425 1.00 87.69 O \nANISOU 3662 O ASN B 146 10303 11408 11606 -749 -1014 -206 O \nATOM 3663 CB ASN B 146 26.755 2.412 26.516 1.00 90.44 C \nANISOU 3663 CB ASN B 146 10229 12310 11826 -909 -916 -229 C \nATOM 3664 CG ASN B 146 27.073 3.881 26.583 1.00 98.98 C \nANISOU 3664 CG ASN B 146 11182 13519 12907 -1156 -850 -189 C \nATOM 3665 OD1 ASN B 146 28.082 4.283 27.161 1.00116.04 O \nANISOU 3665 OD1 ASN B 146 13209 15911 14970 -1198 -839 -205 O \nATOM 3666 ND2 ASN B 146 26.198 4.704 26.019 1.00105.22 N \nANISOU 3666 ND2 ASN B 146 12033 14157 13790 -1325 -815 -136 N \nATOM 3667 N GLU B 147 25.240 -0.257 27.405 1.00 96.57 N \nANISOU 3667 N GLU B 147 11477 12560 12656 -615 -1075 -240 N \nATOM 3668 CA GLU B 147 24.950 -1.670 27.157 1.00102.26 C \nANISOU 3668 CA GLU B 147 12426 13116 13311 -433 -1174 -269 C \nATOM 3669 C GLU B 147 23.454 -1.946 27.183 1.00100.66 C \nANISOU 3669 C GLU B 147 12411 12627 13210 -588 -1186 -202 C \nATOM 3670 O GLU B 147 22.973 -2.785 26.430 1.00102.73 O \nANISOU 3670 O GLU B 147 12841 12758 13435 -529 -1245 -206 O \nATOM 3671 CB GLU B 147 25.710 -2.584 28.126 1.00106.22 C \nANISOU 3671 CB GLU B 147 13031 13636 13692 -223 -1261 -323 C \nATOM 3672 CG GLU B 147 27.204 -2.613 27.846 1.00115.37 C \nANISOU 3672 CG GLU B 147 14012 15129 14693 0 -1273 -411 C \nATOM 3673 CD GLU B 147 27.956 -3.630 28.687 1.00126.22 C \nANISOU 3673 CD GLU B 147 15514 16528 15916 273 -1378 -481 C \nATOM 3674 OE1 GLU B 147 28.434 -3.253 29.778 1.00128.24 O \nANISOU 3674 OE1 GLU B 147 15672 16883 16169 241 -1356 -482 O \nATOM 3675 OE2 GLU B 147 28.065 -4.808 28.272 1.00134.93 O \nANISOU 3675 OE2 GLU B 147 16838 17539 16891 527 -1492 -538 O \nATOM 3676 N CYS B 148 22.724 -1.245 28.047 1.00 98.79 N \nANISOU 3676 N CYS B 148 12141 12316 13077 -786 -1134 -144 N \nATOM 3677 CA CYS B 148 21.262 -1.319 28.066 1.00 91.41 C \nANISOU 3677 CA CYS B 148 11320 11193 12218 -955 -1130 -83 C \nATOM 3678 C CYS B 148 20.700 -0.798 26.743 1.00 96.00 C \nANISOU 3678 C CYS B 148 11834 11788 12852 -1025 -1082 -67 C \nATOM 3679 O CYS B 148 19.741 -1.344 26.210 1.00107.10 O \nANISOU 3679 O CYS B 148 13365 13068 14261 -1079 -1110 -41 O \nATOM 3680 CB CYS B 148 20.689 -0.512 29.250 1.00 93.48 C \nANISOU 3680 CB CYS B 148 11516 11441 12563 -1120 -1080 -38 C \nATOM 3681 SG CYS B 148 18.913 -0.145 29.285 1.00 96.93 S \nANISOU 3681 SG CYS B 148 11980 11774 13074 -1332 -1046 27 S \nATOM 3682 N MET B 149 21.327 0.237 26.199 1.00 90.10 N \nANISOU 3682 N MET B 149 10903 11201 12129 -1036 -1015 -81 N \nATOM 3683 CA MET B 149 20.928 0.792 24.928 1.00 83.48 C \nANISOU 3683 CA MET B 149 10007 10383 11329 -1094 -973 -69 C \nATOM 3684 C MET B 149 21.265 -0.160 23.792 1.00 82.94 C \nANISOU 3684 C MET B 149 10006 10320 11186 -945 -1023 -108 C \nATOM 3685 O MET B 149 20.433 -0.398 22.907 1.00 84.45 O \nANISOU 3685 O MET B 149 10270 10414 11403 -984 -1028 -89 O \nATOM 3686 CB MET B 149 21.608 2.147 24.684 1.00 87.12 C \nANISOU 3686 CB MET B 149 10290 11010 11802 -1170 -903 -71 C \nATOM 3687 CG MET B 149 20.645 3.303 24.520 1.00 87.79 C \nANISOU 3687 CG MET B 149 10358 11028 11969 -1331 -851 -26 C \nATOM 3688 SD MET B 149 20.281 4.031 26.100 1.00104.44 S \nANISOU 3688 SD MET B 149 12469 13090 14122 -1426 -833 2 S \nATOM 3689 CE MET B 149 19.059 5.264 25.699 1.00 76.04 C \nANISOU 3689 CE MET B 149 8891 9420 10582 -1538 -795 35 C \nATOM 3690 N GLU B 150 22.486 -0.688 23.772 1.00 85.41 N \nANISOU 3690 N GLU B 150 10294 10768 11391 -761 -1064 -168 N \nATOM 3691 CA GLU B 150 22.843 -1.658 22.731 1.00 93.42 C \nANISOU 3691 CA GLU B 150 11393 11794 12308 -572 -1128 -217 C \nATOM 3692 C GLU B 150 21.814 -2.778 22.745 1.00 92.55 C \nANISOU 3692 C GLU B 150 11556 11418 12191 -571 -1208 -193 C \nATOM 3693 O GLU B 150 21.434 -3.283 21.680 1.00 99.66 O \nANISOU 3693 O GLU B 150 12554 12246 13067 -533 -1239 -197 O \nATOM 3694 CB GLU B 150 24.260 -2.209 22.903 1.00 99.77 C \nANISOU 3694 CB GLU B 150 12152 12798 12959 -323 -1181 -299 C \nATOM 3695 CG GLU B 150 24.722 -3.175 21.805 1.00109.41 C \nANISOU 3695 CG GLU B 150 13458 14065 14047 -77 -1256 -367 C \nATOM 3696 CD GLU B 150 24.757 -2.547 20.412 1.00116.33 C \nANISOU 3696 CD GLU B 150 14177 15078 14945 -133 -1193 -366 C \nATOM 3697 OE1 GLU B 150 25.378 -1.468 20.257 1.00128.78 O \nANISOU 3697 OE1 GLU B 150 15505 16900 16527 -237 -1111 -364 O \nATOM 3698 OE2 GLU B 150 24.181 -3.126 19.469 1.00109.97 O \nANISOU 3698 OE2 GLU B 150 13509 14137 14138 -90 -1230 -365 O \nATOM 3699 N SER B 151 21.366 -3.130 23.953 1.00 88.47 N \nANISOU 3699 N SER B 151 11165 10766 11683 -638 -1243 -163 N \nATOM 3700 CA SER B 151 20.482 -4.271 24.162 1.00 91.95 C \nANISOU 3700 CA SER B 151 11895 10968 12074 -675 -1336 -135 C \nATOM 3701 C SER B 151 19.121 -4.044 23.526 1.00 95.03 C \nANISOU 3701 C SER B 151 12303 11264 12539 -886 -1299 -73 C \nATOM 3702 O SER B 151 18.553 -4.975 22.950 1.00106.14 O \nANISOU 3702 O SER B 151 13924 12526 13878 -896 -1374 -62 O \nATOM 3703 CB SER B 151 20.306 -4.626 25.649 1.00 93.74 C \nANISOU 3703 CB SER B 151 12240 11097 12279 -735 -1378 -112 C \nATOM 3704 OG SER B 151 19.251 -3.909 26.241 1.00100.11 O \nANISOU 3704 OG SER B 151 12962 11884 13193 -983 -1308 -44 O \nATOM 3705 N VAL B 152 18.612 -2.818 23.607 1.00 90.07 N \nANISOU 3705 N VAL B 152 11465 10725 12031 -1044 -1194 -38 N \nATOM 3706 CA VAL B 152 17.317 -2.510 22.990 1.00 93.14 C \nANISOU 3706 CA VAL B 152 11841 11072 12476 -1215 -1156 10 C \nATOM 3707 C VAL B 152 17.398 -2.431 21.458 1.00 93.11 C \nANISOU 3707 C VAL B 152 11801 11098 12478 -1153 -1141 -9 C \nATOM 3708 O VAL B 152 16.396 -2.609 20.773 1.00104.73 O \nANISOU 3708 O VAL B 152 13327 12508 13956 -1254 -1142 22 O \nATOM 3709 CB VAL B 152 16.658 -1.217 23.537 1.00 94.23 C \nANISOU 3709 CB VAL B 152 11798 11293 12713 -1362 -1065 44 C \nATOM 3710 CG1 VAL B 152 16.571 -1.247 25.048 1.00 93.55 C \nANISOU 3710 CG1 VAL B 152 11731 11193 12620 -1421 -1076 61 C \nATOM 3711 CG2 VAL B 152 17.382 0.028 23.077 1.00 97.72 C \nANISOU 3711 CG2 VAL B 152 12048 11865 13216 -1317 -989 21 C \nATOM 3712 N ARG B 153 18.589 -2.167 20.932 1.00 91.08 N \nANISOU 3712 N ARG B 153 11441 10961 12203 -996 -1125 -60 N \nATOM 3713 CA ARG B 153 18.788 -2.097 19.484 1.00 90.87 C \nANISOU 3713 CA ARG B 153 11369 10988 12169 -929 -1112 -83 C \nATOM 3714 C ARG B 153 18.806 -3.468 18.838 1.00 98.16 C \nANISOU 3714 C ARG B 153 12517 11794 12987 -797 -1214 -108 C \nATOM 3715 O ARG B 153 18.233 -3.651 17.775 1.00 89.39 O \nANISOU 3715 O ARG B 153 11452 10631 11881 -828 -1217 -97 O \nATOM 3716 CB ARG B 153 20.099 -1.378 19.133 1.00 85.91 C \nANISOU 3716 CB ARG B 153 10542 10578 11521 -825 -1066 -130 C \nATOM 3717 CG ARG B 153 20.129 0.100 19.506 1.00 78.37 C \nANISOU 3717 CG ARG B 153 9401 9727 10649 -977 -974 -102 C \nATOM 3718 CD ARG B 153 21.266 0.808 18.802 1.00 79.98 C \nANISOU 3718 CD ARG B 153 9430 10154 10805 -941 -933 -135 C \nATOM 3719 NE ARG B 153 21.956 1.781 19.647 1.00 83.23 N \nANISOU 3719 NE ARG B 153 9710 10699 11213 -1025 -890 -130 N \nATOM 3720 CZ ARG B 153 23.150 1.589 20.207 1.00 89.55 C \nANISOU 3720 CZ ARG B 153 10427 11678 11919 -928 -907 -172 C \nATOM 3721 NH1 ARG B 153 23.829 0.466 20.003 1.00 90.36 N \nANISOU 3721 NH1 ARG B 153 10563 11855 11914 -707 -971 -232 N \nATOM 3722 NH2 ARG B 153 23.685 2.536 20.959 1.00 95.05 N \nANISOU 3722 NH2 ARG B 153 11013 12491 12610 -1043 -867 -159 N \nATOM 3723 N ASN B 154 19.479 -4.421 19.480 1.00111.76 N \nANISOU 3723 N ASN B 154 14397 13467 14598 -639 -1306 -146 N \nATOM 3724 CA ASN B 154 19.647 -5.778 18.920 1.00116.70 C \nANISOU 3724 CA ASN B 154 15297 13960 15083 -465 -1432 -184 C \nATOM 3725 C ASN B 154 18.572 -6.769 19.371 1.00111.68 C \nANISOU 3725 C ASN B 154 14977 13065 14390 -607 -1526 -131 C \nATOM 3726 O ASN B 154 18.716 -7.966 19.152 1.00113.71 O \nANISOU 3726 O ASN B 154 15538 13164 14500 -476 -1657 -157 O \nATOM 3727 CB ASN B 154 21.040 -6.331 19.264 1.00123.89 C \nANISOU 3727 CB ASN B 154 16247 14970 15857 -164 -1505 -270 C \nATOM 3728 CG ASN B 154 21.353 -6.234 20.742 1.00131.45 C \nANISOU 3728 CG ASN B 154 17196 15935 16814 -181 -1510 -265 C \nATOM 3729 OD1 ASN B 154 20.492 -5.828 21.515 1.00131.56 O \nANISOU 3729 OD1 ASN B 154 17196 15863 16926 -419 -1465 -196 O \nATOM 3730 ND2 ASN B 154 22.591 -6.555 21.150 1.00146.28 N \nANISOU 3730 ND2 ASN B 154 19058 17947 18574 78 -1561 -342 N \nATOM 3731 N GLY B 155 17.520 -6.273 20.025 1.00107.30 N \nANISOU 3731 N GLY B 155 14364 12480 13924 -874 -1468 -59 N \nATOM 3732 CA GLY B 155 16.434 -7.124 20.500 1.00102.99 C \nANISOU 3732 CA GLY B 155 14081 11747 13304 -1072 -1548 1 C \nATOM 3733 C GLY B 155 16.735 -7.852 21.804 1.00107.43 C \nANISOU 3733 C GLY B 155 14855 12197 13766 -1052 -1641 1 C \nATOM 3734 O GLY B 155 15.828 -8.318 22.491 1.00110.30 O \nANISOU 3734 O GLY B 155 15385 12450 14074 -1277 -1687 62 O \nATOM 3735 N THR B 156 18.006 -7.938 22.167 1.00106.71 N \nANISOU 3735 N THR B 156 14749 12158 13637 -792 -1669 -67 N \nATOM 3736 CA THR B 156 18.422 -8.691 23.326 1.00113.84 C \nANISOU 3736 CA THR B 156 15878 12948 14429 -720 -1771 -81 C \nATOM 3737 C THR B 156 18.349 -7.855 24.591 1.00104.06 C \nANISOU 3737 C THR B 156 14428 11815 13296 -853 -1683 -50 C \nATOM 3738 O THR B 156 19.318 -7.775 25.329 1.00 99.47 O \nANISOU 3738 O THR B 156 13797 11303 12694 -685 -1692 -96 O \nATOM 3739 CB THR B 156 19.864 -9.175 23.142 1.00125.14 C \nANISOU 3739 CB THR B 156 17375 14428 15744 -338 -1848 -182 C \nATOM 3740 OG1 THR B 156 20.739 -8.045 23.126 1.00126.62 O \nANISOU 3740 OG1 THR B 156 17173 14898 16038 -235 -1723 -223 O \nATOM 3741 CG2 THR B 156 20.014 -9.947 21.840 1.00125.91 C \nANISOU 3741 CG2 THR B 156 17669 14444 15727 -161 -1936 -225 C \nATOM 3742 N TYR B 157 17.186 -7.263 24.850 1.00105.53 N \nANISOU 3742 N TYR B 157 14494 12027 13574 -1142 -1605 23 N \nATOM 3743 CA TYR B 157 16.984 -6.398 26.017 1.00103.47 C \nANISOU 3743 CA TYR B 157 14032 11874 13409 -1270 -1520 52 C \nATOM 3744 C TYR B 157 16.190 -7.118 27.081 1.00109.24 C \nANISOU 3744 C TYR B 157 14981 12478 14048 -1475 -1595 108 C \nATOM 3745 O TYR B 157 15.113 -7.644 26.805 1.00126.83 O \nANISOU 3745 O TYR B 157 17357 14629 16205 -1689 -1636 163 O \nATOM 3746 CB TYR B 157 16.248 -5.117 25.614 1.00102.57 C \nANISOU 3746 CB TYR B 157 13617 11918 13439 -1416 -1385 82 C \nATOM 3747 CG TYR B 157 15.618 -4.326 26.766 1.00 93.08 C \nANISOU 3747 CG TYR B 157 12259 10804 12302 -1585 -1316 121 C \nATOM 3748 CD1 TYR B 157 16.381 -3.474 27.571 1.00 94.40 C \nANISOU 3748 CD1 TYR B 157 12252 11072 12545 -1504 -1256 97 C \nATOM 3749 CD2 TYR B 157 14.265 -4.416 27.030 1.00 87.90 C \nANISOU 3749 CD2 TYR B 157 11622 10160 11614 -1824 -1313 179 C \nATOM 3750 CE1 TYR B 157 15.809 -2.742 28.605 1.00 89.91 C \nANISOU 3750 CE1 TYR B 157 11556 10579 12026 -1636 -1201 127 C \nATOM 3751 CE2 TYR B 157 13.678 -3.692 28.063 1.00 88.90 C \nANISOU 3751 CE2 TYR B 157 11595 10402 11780 -1949 -1254 205 C \nATOM 3752 CZ TYR B 157 14.458 -2.853 28.848 1.00 92.77 C \nANISOU 3752 CZ TYR B 157 11935 10958 12354 -1843 -1200 177 C \nATOM 3753 OH TYR B 157 13.877 -2.144 29.868 1.00 82.10 O \nANISOU 3753 OH TYR B 157 10451 9715 11031 -1947 -1150 198 O \nATOM 3754 N ASP B 158 16.711 -7.123 28.305 1.00115.78 N \nANISOU 3754 N ASP B 158 15822 13305 14866 -1433 -1611 99 N \nATOM 3755 CA ASP B 158 16.056 -7.787 29.440 1.00117.31 C \nANISOU 3755 CA ASP B 158 16223 13389 14960 -1635 -1684 152 C \nATOM 3756 C ASP B 158 15.113 -6.829 30.170 1.00111.28 C \nANISOU 3756 C ASP B 158 15201 12788 14291 -1872 -1575 204 C \nATOM 3757 O ASP B 158 15.554 -5.952 30.904 1.00104.85 O \nANISOU 3757 O ASP B 158 14168 12092 13578 -1809 -1496 186 O \nATOM 3758 CB ASP B 158 17.099 -8.333 30.425 1.00120.05 C \nANISOU 3758 CB ASP B 158 16735 13647 15231 -1452 -1768 111 C \nATOM 3759 CG ASP B 158 16.475 -9.111 31.563 1.00121.57 C \nANISOU 3759 CG ASP B 158 17192 13702 15298 -1667 -1862 168 C \nATOM 3760 OD1 ASP B 158 15.748 -10.086 31.271 1.00131.89 O \nANISOU 3760 OD1 ASP B 158 18813 14844 16456 -1837 -1970 213 O \nATOM 3761 OD2 ASP B 158 16.713 -8.747 32.733 1.00104.31 O \nANISOU 3761 OD2 ASP B 158 14909 11574 13151 -1682 -1830 171 O \nATOM 3762 N TYR B 159 13.813 -7.018 29.970 1.00115.67 N \nANISOU 3762 N TYR B 159 15790 13368 14791 -2138 -1577 265 N \nATOM 3763 CA TYR B 159 12.791 -6.196 30.631 1.00110.72 C \nANISOU 3763 CA TYR B 159 14923 12937 14210 -2348 -1487 306 C \nATOM 3764 C TYR B 159 12.779 -6.320 32.153 1.00114.36 C \nANISOU 3764 C TYR B 159 15421 13406 14626 -2445 -1510 329 C \nATOM 3765 O TYR B 159 12.741 -5.298 32.841 1.00109.13 O \nANISOU 3765 O TYR B 159 14501 12900 14062 -2427 -1416 319 O \nATOM 3766 CB TYR B 159 11.389 -6.507 30.061 1.00107.82 C \nANISOU 3766 CB TYR B 159 14581 12642 13743 -2618 -1497 362 C \nATOM 3767 CG TYR B 159 10.255 -5.804 30.795 1.00102.70 C \nANISOU 3767 CG TYR B 159 13693 12244 13084 -2826 -1422 397 C \nATOM 3768 CD1 TYR B 159 9.841 -4.517 30.413 1.00104.73 C \nANISOU 3768 CD1 TYR B 159 13623 12713 13458 -2755 -1302 371 C \nATOM 3769 CD2 TYR B 159 9.614 -6.408 31.868 1.00 99.74 C \nANISOU 3769 CD2 TYR B 159 13429 11905 12562 -3078 -1479 449 C \nATOM 3770 CE1 TYR B 159 8.817 -3.858 31.075 1.00100.82 C \nANISOU 3770 CE1 TYR B 159 12909 12471 12927 -2891 -1243 387 C \nATOM 3771 CE2 TYR B 159 8.590 -5.765 32.541 1.00100.39 C \nANISOU 3771 CE2 TYR B 159 13267 12267 12611 -3247 -1412 472 C \nATOM 3772 CZ TYR B 159 8.196 -4.493 32.145 1.00108.22 C \nANISOU 3772 CZ TYR B 159 13926 13478 13714 -3133 -1295 436 C \nATOM 3773 OH TYR B 159 7.193 -3.846 32.828 1.00102.80 O \nANISOU 3773 OH TYR B 159 13000 13090 12969 -3249 -1238 443 O \nATOM 3774 N PRO B 160 12.787 -7.567 32.687 1.00125.57 N \nANISOU 3774 N PRO B 160 17185 14646 15880 -2551 -1643 359 N \nATOM 3775 CA PRO B 160 12.578 -7.716 34.137 1.00123.16 C \nANISOU 3775 CA PRO B 160 16920 14362 15511 -2699 -1667 392 C \nATOM 3776 C PRO B 160 13.642 -7.108 35.031 1.00114.62 C \nANISOU 3776 C PRO B 160 15708 13296 14545 -2479 -1622 344 C \nATOM 3777 O PRO B 160 13.348 -6.813 36.192 1.00124.45 O \nANISOU 3777 O PRO B 160 16865 14631 15788 -2595 -1596 367 O \nATOM 3778 CB PRO B 160 12.508 -9.238 34.345 1.00135.26 C \nANISOU 3778 CB PRO B 160 18920 15650 16824 -2838 -1841 430 C \nATOM 3779 CG PRO B 160 13.119 -9.837 33.128 1.00135.33 C \nANISOU 3779 CG PRO B 160 19140 15474 16804 -2637 -1914 391 C \nATOM 3780 CD PRO B 160 12.839 -8.878 32.010 1.00126.46 C \nANISOU 3780 CD PRO B 160 17689 14527 15832 -2575 -1786 371 C \nATOM 3781 N GLN B 161 14.847 -6.899 34.511 1.00108.02 N \nANISOU 3781 N GLN B 161 14843 12405 13795 -2179 -1611 278 N \nATOM 3782 CA GLN B 161 15.909 -6.261 35.312 1.00100.95 C \nANISOU 3782 CA GLN B 161 13797 11563 12995 -1983 -1564 231 C \nATOM 3783 C GLN B 161 15.459 -4.926 35.854 1.00 88.80 C \nANISOU 3783 C GLN B 161 11922 10232 11586 -2064 -1432 243 C \nATOM 3784 O GLN B 161 15.643 -4.641 37.017 1.00 81.01 O \nANISOU 3784 O GLN B 161 10877 9284 10617 -2080 -1416 246 O \nATOM 3785 CB GLN B 161 17.183 -6.043 34.490 1.00103.56 C \nANISOU 3785 CB GLN B 161 14066 11898 13385 -1678 -1550 158 C \nATOM 3786 CG GLN B 161 18.447 -6.512 35.172 1.00113.51 C \nANISOU 3786 CG GLN B 161 15445 13095 14589 -1452 -1619 105 C \nATOM 3787 CD GLN B 161 19.673 -6.082 34.410 1.00124.40 C \nANISOU 3787 CD GLN B 161 16669 14584 16014 -1173 -1583 29 C \nATOM 3788 OE1 GLN B 161 19.570 -5.450 33.363 1.00126.26 O \nANISOU 3788 OE1 GLN B 161 16730 14915 16326 -1166 -1509 22 O \nATOM 3789 NE2 GLN B 161 20.847 -6.423 34.932 1.00138.44 N \nANISOU 3789 NE2 GLN B 161 18504 16372 17725 -944 -1637 -30 N \nATOM 3790 N TYR B 162 14.861 -4.117 34.983 1.00 90.04 N \nANISOU 3790 N TYR B 162 11878 10513 11821 -2098 -1348 246 N \nATOM 3791 CA TYR B 162 14.523 -2.730 35.317 1.00 92.00 C \nANISOU 3791 CA TYR B 162 11833 10945 12180 -2111 -1234 241 C \nATOM 3792 C TYR B 162 13.070 -2.600 35.713 1.00 91.93 C \nANISOU 3792 C TYR B 162 11750 11071 12107 -2338 -1214 287 C \nATOM 3793 O TYR B 162 12.575 -1.484 35.887 1.00 91.05 O \nANISOU 3793 O TYR B 162 11416 11125 12055 -2335 -1133 277 O \nATOM 3794 CB TYR B 162 14.830 -1.793 34.127 1.00 87.66 C \nANISOU 3794 CB TYR B 162 11117 10456 11734 -1979 -1160 206 C \nATOM 3795 CG TYR B 162 16.165 -2.069 33.482 1.00 82.13 C \nANISOU 3795 CG TYR B 162 10478 9674 11053 -1778 -1186 161 C \nATOM 3796 CD1 TYR B 162 16.249 -2.934 32.394 1.00 79.70 C \nANISOU 3796 CD1 TYR B 162 10325 9272 10687 -1730 -1245 153 C \nATOM 3797 CD2 TYR B 162 17.352 -1.510 33.975 1.00 76.02 C \nANISOU 3797 CD2 TYR B 162 9609 8944 10330 -1636 -1157 123 C \nATOM 3798 CE1 TYR B 162 17.457 -3.217 31.803 1.00 81.70 C \nANISOU 3798 CE1 TYR B 162 10620 9493 10929 -1520 -1274 102 C \nATOM 3799 CE2 TYR B 162 18.572 -1.804 33.388 1.00 71.71 C \nANISOU 3799 CE2 TYR B 162 9090 8390 9765 -1450 -1184 75 C \nATOM 3800 CZ TYR B 162 18.609 -2.650 32.306 1.00 77.27 C \nANISOU 3800 CZ TYR B 162 9933 9017 10407 -1380 -1241 61 C \nATOM 3801 OH TYR B 162 19.786 -2.955 31.686 1.00 87.56 O \nANISOU 3801 OH TYR B 162 11249 10352 11667 -1170 -1271 4 O \nATOM 3802 N SER B 163 12.410 -3.745 35.882 1.00 97.10 N \nANISOU 3802 N SER B 163 12607 11670 12616 -2535 -1299 333 N \nATOM 3803 CA SER B 163 10.976 -3.784 36.146 1.00101.40 C \nANISOU 3803 CA SER B 163 13079 12396 13052 -2791 -1290 379 C \nATOM 3804 C SER B 163 10.505 -2.881 37.270 1.00 98.66 C \nANISOU 3804 C SER B 163 12504 12259 12722 -2826 -1223 377 C \nATOM 3805 O SER B 163 9.763 -1.930 37.015 1.00 96.90 O \nANISOU 3805 O SER B 163 12049 12246 12523 -2810 -1148 360 O \nATOM 3806 CB SER B 163 10.536 -5.205 36.405 1.00114.14 C \nANISOU 3806 CB SER B 163 14989 13903 14476 -3034 -1408 437 C \nATOM 3807 OG SER B 163 10.729 -5.958 35.232 1.00124.34 O \nANISOU 3807 OG SER B 163 16488 15026 15729 -3008 -1472 438 O \nATOM 3808 N GLU B 164 10.931 -3.170 38.500 1.00101.48 N \nANISOU 3808 N GLU B 164 12940 12561 13056 -2854 -1257 387 N \nATOM 3809 CA GLU B 164 10.426 -2.425 39.661 1.00104.22 C \nANISOU 3809 CA GLU B 164 13091 13113 13397 -2903 -1204 387 C \nATOM 3810 C GLU B 164 11.068 -1.063 39.775 1.00 94.06 C \nANISOU 3810 C GLU B 164 11606 11860 12272 -2658 -1119 332 C \nATOM 3811 O GLU B 164 10.441 -0.109 40.232 1.00 81.75 O \nANISOU 3811 O GLU B 164 9845 10503 10713 -2640 -1061 315 O \nATOM 3812 CB GLU B 164 10.563 -3.210 40.969 1.00111.34 C \nANISOU 3812 CB GLU B 164 14148 13954 14201 -3045 -1272 422 C \nATOM 3813 CG GLU B 164 11.968 -3.493 41.458 1.00110.60 C \nANISOU 3813 CG GLU B 164 14213 13622 14187 -2871 -1311 399 C \nATOM 3814 CD GLU B 164 11.952 -4.380 42.694 1.00110.77 C \nANISOU 3814 CD GLU B 164 14427 13577 14085 -3036 -1393 439 C \nATOM 3815 OE1 GLU B 164 10.865 -4.840 43.098 1.00104.47 O \nANISOU 3815 OE1 GLU B 164 13655 12909 13128 -3317 -1424 492 O \nATOM 3816 OE2 GLU B 164 13.027 -4.627 43.264 1.00119.28 O \nANISOU 3816 OE2 GLU B 164 15629 14487 15203 -2895 -1430 417 O \nATOM 3817 N GLU B 165 12.321 -0.979 39.344 1.00 96.92 N \nANISOU 3817 N GLU B 165 12040 12039 12747 -2471 -1120 301 N \nATOM 3818 CA GLU B 165 12.983 0.316 39.154 1.00 89.62 C \nANISOU 3818 CA GLU B 165 10958 11137 11956 -2274 -1047 255 C \nATOM 3819 C GLU B 165 12.086 1.235 38.338 1.00 89.16 C \nANISOU 3819 C GLU B 165 10742 11227 11907 -2253 -991 240 C \nATOM 3820 O GLU B 165 11.834 2.374 38.746 1.00 88.52 O \nANISOU 3820 O GLU B 165 10520 11260 11854 -2179 -943 214 O \nATOM 3821 CB GLU B 165 14.321 0.141 38.446 1.00 87.19 C \nANISOU 3821 CB GLU B 165 10736 10670 11724 -2116 -1061 227 C \nATOM 3822 CG GLU B 165 15.097 1.447 38.308 1.00 86.71 C \nANISOU 3822 CG GLU B 165 10535 10641 11770 -1968 -995 189 C \nATOM 3823 CD GLU B 165 16.544 1.220 37.901 1.00 82.35 C \nANISOU 3823 CD GLU B 165 10036 9997 11255 -1833 -1011 160 C \nATOM 3824 OE1 GLU B 165 16.997 0.041 38.025 1.00 85.48 O \nANISOU 3824 OE1 GLU B 165 10588 10297 11594 -1814 -1080 162 O \nATOM 3825 OE2 GLU B 165 17.200 2.206 37.436 1.00 70.91 O \nANISOU 3825 OE2 GLU B 165 8487 8588 9868 -1750 -963 135 O \nATOM 3826 N ALA B 166 11.578 0.716 37.209 1.00 85.87 N \nANISOU 3826 N ALA B 166 10370 10805 11450 -2311 -1007 252 N \nATOM 3827 CA ALA B 166 10.688 1.482 36.338 1.00 82.20 C \nANISOU 3827 CA ALA B 166 9769 10486 10978 -2284 -962 235 C \nATOM 3828 C ALA B 166 9.396 1.803 37.046 1.00 93.58 C \nANISOU 3828 C ALA B 166 11068 12183 12307 -2378 -947 239 C \nATOM 3829 O ALA B 166 8.877 2.918 36.904 1.00 80.36 O \nANISOU 3829 O ALA B 166 9247 10654 10632 -2262 -903 201 O \nATOM 3830 CB ALA B 166 10.401 0.727 35.061 1.00 94.15 C \nANISOU 3830 CB ALA B 166 11368 11947 12459 -2346 -988 252 C \nATOM 3831 N ARG B 167 8.888 0.819 37.806 1.00105.09 N \nANISOU 3831 N ARG B 167 12580 13704 13643 -2584 -991 283 N \nATOM 3832 CA ARG B 167 7.612 0.937 38.508 1.00111.52 C \nANISOU 3832 CA ARG B 167 13243 14823 14306 -2717 -983 291 C \nATOM 3833 C ARG B 167 7.743 1.932 39.647 1.00105.14 C \nANISOU 3833 C ARG B 167 12310 14110 13529 -2586 -948 255 C \nATOM 3834 O ARG B 167 6.906 2.824 39.836 1.00 98.24 O \nANISOU 3834 O ARG B 167 11252 13487 12587 -2503 -914 216 O \nATOM 3835 CB ARG B 167 7.158 -0.465 39.017 1.00125.47 C \nANISOU 3835 CB ARG B 167 15145 16614 15915 -3022 -1052 357 C \nATOM 3836 CG ARG B 167 6.622 -0.556 40.451 1.00128.64 C \nANISOU 3836 CG ARG B 167 15469 17217 16193 -3168 -1062 376 C \nATOM 3837 CD ARG B 167 6.374 -2.007 40.882 1.00133.01 C \nANISOU 3837 CD ARG B 167 16231 17722 16583 -3494 -1149 450 C \nATOM 3838 NE ARG B 167 7.304 -2.501 41.913 1.00137.27 N \nANISOU 3838 NE ARG B 167 16957 18036 17164 -3502 -1196 469 N \nATOM 3839 CZ ARG B 167 7.589 -3.786 42.150 1.00134.83 C \nANISOU 3839 CZ ARG B 167 16947 17523 16758 -3696 -1295 524 C \nATOM 3840 NH1 ARG B 167 7.075 -4.756 41.402 1.00132.96 N \nANISOU 3840 NH1 ARG B 167 16890 17248 16381 -3917 -1364 572 N \nATOM 3841 NH2 ARG B 167 8.433 -4.106 43.130 1.00135.91 N \nANISOU 3841 NH2 ARG B 167 17234 17475 16929 -3660 -1335 529 N \nATOM 3842 N LEU B 168 8.821 1.773 40.392 1.00101.37 N \nANISOU 3842 N LEU B 168 11943 13431 13142 -2549 -963 262 N \nATOM 3843 CA LEU B 168 9.041 2.595 41.575 1.00112.46 C \nANISOU 3843 CA LEU B 168 13260 14894 14573 -2449 -938 236 C \nATOM 3844 C LEU B 168 9.300 4.056 41.204 1.00112.53 C \nANISOU 3844 C LEU B 168 13186 14898 14672 -2205 -893 178 C \nATOM 3845 O LEU B 168 8.863 4.972 41.897 1.00105.93 O \nANISOU 3845 O LEU B 168 12240 14214 13792 -2105 -875 142 O \nATOM 3846 CB LEU B 168 10.200 2.045 42.408 1.00110.49 C \nANISOU 3846 CB LEU B 168 13157 14428 14395 -2467 -968 257 C \nATOM 3847 CG LEU B 168 10.259 2.498 43.861 1.00109.42 C \nANISOU 3847 CG LEU B 168 12954 14374 14247 -2450 -959 248 C \nATOM 3848 CD1 LEU B 168 8.916 2.348 44.579 1.00105.70 C \nANISOU 3848 CD1 LEU B 168 12352 14206 13603 -2603 -962 261 C \nATOM 3849 CD2 LEU B 168 11.358 1.714 44.571 1.00112.51 C \nANISOU 3849 CD2 LEU B 168 13511 14552 14687 -2487 -1000 273 C \nATOM 3850 N LYS B 169 9.989 4.268 40.089 1.00113.05 N \nANISOU 3850 N LYS B 169 13324 14789 14840 -2112 -884 168 N \nATOM 3851 CA LYS B 169 10.297 5.621 39.670 1.00111.73 C \nANISOU 3851 CA LYS B 169 13130 14584 14736 -1918 -855 122 C \nATOM 3852 C LYS B 169 9.190 6.204 38.818 1.00 98.81 C \nANISOU 3852 C LYS B 169 11405 13116 13023 -1845 -844 90 C \nATOM 3853 O LYS B 169 9.224 7.385 38.482 1.00 78.70 O \nANISOU 3853 O LYS B 169 8862 10552 10489 -1675 -835 47 O \nATOM 3854 CB LYS B 169 11.606 5.637 38.926 1.00129.65 C \nANISOU 3854 CB LYS B 169 15509 16623 17129 -1869 -853 125 C \nATOM 3855 CG LYS B 169 12.317 6.996 38.877 1.00135.70 C \nANISOU 3855 CG LYS B 169 16298 17307 17953 -1728 -836 92 C \nATOM 3856 CD LYS B 169 12.812 7.242 37.455 1.00136.78 C \nANISOU 3856 CD LYS B 169 16486 17341 18143 -1688 -828 87 C \nATOM 3857 CE LYS B 169 12.811 5.946 36.613 1.00149.44 C \nANISOU 3857 CE LYS B 169 18112 18911 19757 -1775 -837 114 C \nATOM 3858 NZ LYS B 169 13.774 4.820 36.897 1.00152.65 N \nANISOU 3858 NZ LYS B 169 18592 19212 20196 -1832 -861 137 N \nATOM 3859 N ARG B 170 8.214 5.363 38.477 1.00108.66 N \nANISOU 3859 N ARG B 170 12591 14527 14169 -1980 -852 112 N \nATOM 3860 CA ARG B 170 6.961 5.806 37.866 1.00110.81 C \nANISOU 3860 CA ARG B 170 12734 15046 14321 -1924 -843 78 C \nATOM 3861 C ARG B 170 6.182 6.398 39.024 1.00113.36 C \nANISOU 3861 C ARG B 170 12921 15634 14518 -1857 -843 42 C \nATOM 3862 O ARG B 170 5.741 7.544 39.002 1.00 97.24 O \nANISOU 3862 O ARG B 170 10821 13706 12419 -1641 -841 -21 O \nATOM 3863 CB ARG B 170 6.210 4.609 37.311 1.00116.30 C \nANISOU 3863 CB ARG B 170 13404 15862 14922 -2141 -857 122 C \nATOM 3864 CG ARG B 170 5.210 4.878 36.198 1.00122.90 C \nANISOU 3864 CG ARG B 170 14139 16887 15669 -2096 -846 95 C \nATOM 3865 CD ARG B 170 4.635 3.540 35.718 1.00120.96 C \nANISOU 3865 CD ARG B 170 13909 16721 15329 -2368 -869 153 C \nATOM 3866 NE ARG B 170 5.711 2.622 35.302 1.00114.11 N \nANISOU 3866 NE ARG B 170 13257 15513 14586 -2463 -895 202 N \nATOM 3867 CZ ARG B 170 5.652 1.288 35.333 1.00106.97 C \nANISOU 3867 CZ ARG B 170 12478 14552 13613 -2711 -942 263 C \nATOM 3868 NH1 ARG B 170 4.549 0.665 35.738 1.00118.29 N \nANISOU 3868 NH1 ARG B 170 13840 16255 14851 -2949 -965 296 N \nATOM 3869 NH2 ARG B 170 6.696 0.566 34.940 1.00 89.09 N \nANISOU 3869 NH2 ARG B 170 10426 11973 11450 -2723 -976 289 N \nATOM 3870 N GLU B 171 6.095 5.598 40.082 1.00121.18 N \nANISOU 3870 N GLU B 171 13886 16703 15455 -2036 -854 81 N \nATOM 3871 CA GLU B 171 5.367 5.948 41.299 1.00124.58 C \nANISOU 3871 CA GLU B 171 14172 17415 15748 -2014 -855 54 C \nATOM 3872 C GLU B 171 5.864 7.210 42.013 1.00119.60 C \nANISOU 3872 C GLU B 171 13565 16707 15171 -1767 -852 -1 C \nATOM 3873 O GLU B 171 5.178 7.716 42.905 1.00117.57 O \nANISOU 3873 O GLU B 171 13183 16704 14783 -1679 -857 -42 O \nATOM 3874 CB GLU B 171 5.342 4.746 42.250 1.00124.14 C \nANISOU 3874 CB GLU B 171 14130 17405 15633 -2293 -874 118 C \nATOM 3875 CG GLU B 171 4.463 3.611 41.729 1.00123.69 C \nANISOU 3875 CG GLU B 171 14038 17529 15431 -2565 -893 167 C \nATOM 3876 CD GLU B 171 4.776 2.260 42.347 1.00127.80 C \nANISOU 3876 CD GLU B 171 14703 17934 15920 -2866 -936 246 C \nATOM 3877 OE1 GLU B 171 4.478 1.231 41.702 1.00120.67 O \nANISOU 3877 OE1 GLU B 171 13894 17012 14944 -3092 -970 298 O \nATOM 3878 OE2 GLU B 171 5.315 2.225 43.479 1.00134.50 O \nANISOU 3878 OE2 GLU B 171 15598 18701 16805 -2875 -945 256 O \nATOM 3879 N GLU B 172 7.024 7.731 41.620 1.00114.44 N \nANISOU 3879 N GLU B 172 13071 15727 14683 -1662 -850 -2 N \nATOM 3880 CA GLU B 172 7.381 9.105 42.004 1.00120.28 C \nANISOU 3880 CA GLU B 172 13871 16388 15441 -1426 -860 -57 C \nATOM 3881 C GLU B 172 6.396 10.141 41.445 1.00130.81 C \nANISOU 3881 C GLU B 172 15154 17906 16642 -1193 -877 -132 C \nATOM 3882 O GLU B 172 6.193 11.181 42.069 1.00140.19 O \nANISOU 3882 O GLU B 172 16363 19152 17752 -986 -904 -191 O \nATOM 3883 CB GLU B 172 8.794 9.498 41.599 1.00120.43 C \nANISOU 3883 CB GLU B 172 14073 16058 15628 -1399 -860 -40 C \nATOM 3884 CG GLU B 172 9.230 10.813 42.250 1.00115.79 C \nANISOU 3884 CG GLU B 172 13584 15378 15035 -1222 -883 -82 C \nATOM 3885 CD GLU B 172 10.714 11.106 42.141 1.00115.78 C \nANISOU 3885 CD GLU B 172 13741 15081 15169 -1264 -883 -55 C \nATOM 3886 OE1 GLU B 172 11.528 10.240 42.518 1.00117.91 O \nANISOU 3886 OE1 GLU B 172 14006 15265 15530 -1412 -865 -8 O \nATOM 3887 OE2 GLU B 172 11.071 12.219 41.707 1.00109.89 O \nANISOU 3887 OE2 GLU B 172 13134 14204 14416 -1150 -908 -81 O \nATOM 3888 N ILE B 173 5.811 9.871 40.274 1.00135.17 N \nANISOU 3888 N ILE B 173 15660 18540 17159 -1208 -870 -134 N \nATOM 3889 CA ILE B 173 4.766 10.749 39.713 1.00139.98 C \nANISOU 3889 CA ILE B 173 16206 19366 17613 -973 -891 -212 C \nATOM 3890 C ILE B 173 3.397 10.443 40.337 1.00135.43 C \nANISOU 3890 C ILE B 173 15382 19258 16817 -976 -891 -245 C \nATOM 3891 O ILE B 173 2.969 11.096 41.296 1.00130.50 O \nANISOU 3891 O ILE B 173 14693 18823 16066 -807 -913 -302 O \nATOM 3892 CB ILE B 173 4.684 10.702 38.160 1.00136.68 C \nANISOU 3892 CB ILE B 173 15836 18861 17235 -965 -886 -208 C \nATOM 3893 CG1 ILE B 173 3.793 11.836 37.623 1.00137.36 C \nANISOU 3893 CG1 ILE B 173 15916 19111 17165 -662 -923 -300 C \nATOM 3894 CG2 ILE B 173 4.147 9.381 37.640 1.00140.38 C \nANISOU 3894 CG2 ILE B 173 16173 19486 17680 -1212 -858 -155 C \nATOM 3895 CD1 ILE B 173 4.284 13.225 37.977 1.00135.00 C \nANISOU 3895 CD1 ILE B 173 15823 18615 16856 -405 -975 -355 C \nTER 3896 ILE B 173 \nHETATM 3897 C1 NAG A 401 22.977 -19.859 -66.680 1.00 83.68 C \nHETATM 3898 C2 NAG A 401 23.300 -21.348 -66.364 1.00 90.43 C \nHETATM 3899 C3 NAG A 401 22.099 -22.328 -66.439 1.00 98.70 C \nHETATM 3900 C4 NAG A 401 20.740 -21.714 -66.142 1.00 98.24 C \nHETATM 3901 C5 NAG A 401 20.704 -20.361 -66.848 1.00 96.14 C \nHETATM 3902 C6 NAG A 401 19.388 -19.613 -66.749 1.00 96.77 C \nHETATM 3903 C7 NAG A 401 24.735 -23.065 -67.433 1.00 96.37 C \nHETATM 3904 C8 NAG A 401 25.782 -23.325 -68.484 1.00 91.89 C \nHETATM 3905 N2 NAG A 401 24.308 -21.793 -67.319 1.00 98.43 N \nHETATM 3906 O3 NAG A 401 22.254 -23.429 -65.565 1.00109.88 O \nHETATM 3907 O4 NAG A 401 19.757 -22.606 -66.614 1.00 88.78 O \nHETATM 3908 O5 NAG A 401 21.679 -19.568 -66.215 1.00 93.39 O \nHETATM 3909 O6 NAG A 401 19.208 -19.149 -68.069 1.00 86.27 O \nHETATM 3910 O7 NAG A 401 24.325 -23.993 -66.729 1.00 82.71 O \nHETATM 3911 C1 NAG B 201 23.733 -7.140 20.478 1.00139.78 C \nHETATM 3912 C2 NAG B 201 24.856 -7.195 19.448 1.00152.91 C \nHETATM 3913 C3 NAG B 201 24.999 -8.641 18.949 1.00145.45 C \nHETATM 3914 C4 NAG B 201 25.108 -9.639 20.111 1.00144.30 C \nHETATM 3915 C5 NAG B 201 24.021 -9.375 21.154 1.00151.00 C \nHETATM 3916 C6 NAG B 201 24.136 -10.225 22.425 1.00150.19 C \nHETATM 3917 C7 NAG B 201 25.501 -5.536 17.716 1.00154.15 C \nHETATM 3918 C8 NAG B 201 25.007 -4.653 16.601 1.00138.57 C \nHETATM 3919 N2 NAG B 201 24.576 -6.284 18.344 1.00167.86 N \nHETATM 3920 O3 NAG B 201 26.121 -8.748 18.095 1.00132.58 O \nHETATM 3921 O4 NAG B 201 25.052 -10.973 19.647 1.00138.55 O \nHETATM 3922 O5 NAG B 201 24.207 -8.013 21.495 1.00150.86 O \nHETATM 3923 O6 NAG B 201 23.268 -9.746 23.442 1.00134.09 O \nHETATM 3924 O7 NAG B 201 26.703 -5.531 17.996 1.00142.23 O \nHETATM 3925 O HOH A 501 8.447 2.486 -54.237 1.00 31.99 O \nHETATM 3926 O HOH A 502 11.798 -0.482 -60.932 1.00 31.51 O \nHETATM 3927 O HOH A 503 7.610 4.429 -68.956 1.00 32.53 O \nHETATM 3928 O HOH A 504 13.118 -1.114 -86.140 1.00 46.03 O \nHETATM 3929 O HOH A 505 18.048 -3.423 -41.933 1.00 48.80 O \nHETATM 3930 O HOH A 506 20.879 10.872 -6.059 1.00 55.30 O \nHETATM 3931 O HOH A 507 28.888 4.157 -58.123 1.00 53.39 O \nHETATM 3932 O HOH A 508 16.509 -12.363 -53.601 1.00 57.16 O \nHETATM 3933 O HOH A 509 5.244 -1.566 -49.620 1.00 19.76 O \nHETATM 3934 O HOH A 510 11.971 -3.594 -51.498 1.00 30.40 O \nHETATM 3935 O HOH A 511 26.271 -2.751 -80.663 1.00 46.19 O \nHETATM 3936 O HOH A 512 5.287 1.865 -71.495 1.00 53.73 O \nHETATM 3937 O HOH A 513 13.669 -6.940 -43.271 1.00 49.29 O \nHETATM 3938 O HOH A 514 9.996 1.954 -85.354 1.00 45.37 O \nHETATM 3939 O HOH A 515 5.116 4.962 -83.670 1.00 31.59 O \nHETATM 3940 O HOH A 516 16.018 -13.181 -60.468 1.00 24.07 O \nHETATM 3941 O HOH A 517 6.691 4.125 -70.839 1.00 33.39 O \nHETATM 3942 O HOH A 518 6.610 8.033 -66.919 1.00 48.02 O \nHETATM 3943 O HOH A 519 6.559 5.579 -79.177 1.00 30.05 O \nHETATM 3944 O HOH A 520 17.096 15.689 -54.297 1.00 59.15 O \nHETATM 3945 O HOH A 521 10.721 -2.250 -59.558 1.00 31.17 O \nHETATM 3946 O HOH A 522 7.243 3.606 -58.475 1.00 62.33 O \nHETATM 3947 O HOH A 523 3.669 8.357 -77.759 1.00 39.73 O \nHETATM 3948 O HOH A 524 6.273 -0.159 -79.745 1.00 39.76 O \nHETATM 3949 O HOH A 525 8.894 5.799 -56.488 1.00 54.88 O \nHETATM 3950 O HOH A 526 9.546 -8.863 -72.184 1.00 56.61 O \nHETATM 3951 O HOH A 527 30.738 7.276 -46.407 1.00 59.63 O \nHETATM 3952 O HOH A 528 9.164 5.080 -80.075 1.00 69.83 O \nHETATM 3953 O HOH A 529 16.530 10.819 -52.670 1.00 62.21 O \nHETATM 3954 O HOH A 530 14.716 9.739 35.056 1.00 54.80 O \nHETATM 3955 O HOH A 531 19.135 18.657 -57.881 1.00 80.59 O \nHETATM 3956 O HOH A 532 31.453 2.923 -44.042 1.00 54.44 O \nHETATM 3957 O HOH A 533 34.120 -1.633 -70.831 1.00 64.06 O \nHETATM 3958 O HOH A 534 6.854 -8.094 -65.090 1.00 49.74 O \nHETATM 3959 O HOH A 535 25.919 -14.209 -68.898 1.00 76.55 O \nHETATM 3960 O HOH A 536 13.721 -8.935 -73.586 1.00 57.63 O \nHETATM 3961 O HOH A 537 12.079 -3.918 -58.992 1.00 52.13 O \nHETATM 3962 O HOH A 538 6.856 9.370 -64.661 1.00 59.98 O \nHETATM 3963 O HOH A 539 22.465 5.257 -16.014 1.00 57.50 O \nHETATM 3964 O HOH B 301 1.329 12.125 -42.737 1.00 32.60 O \nHETATM 3965 O HOH B 302 7.798 9.850 -46.582 1.00 29.21 O \nHETATM 3966 O HOH B 303 6.744 8.592 21.045 1.00 46.54 O \nHETATM 3967 O HOH B 304 14.820 10.928 11.821 1.00 48.88 O \nHETATM 3968 O HOH B 305 0.530 11.792 -44.863 1.00 42.66 O \nHETATM 3969 O HOH B 306 7.917 9.283 -44.178 1.00 37.94 O \nHETATM 3970 O HOH B 307 5.026 8.329 2.088 1.00 36.93 O \nHETATM 3971 O HOH B 308 1.572 1.625 -52.116 1.00 23.26 O \nHETATM 3972 O HOH B 309 6.169 8.268 -42.204 1.00 55.67 O \nHETATM 3973 O HOH B 310 20.435 -4.861 12.617 1.00 58.09 O \nHETATM 3974 O HOH B 311 0.000 0.000 -21.930 0.33 55.81 O \nHETATM 3975 O HOH B 312 26.537 6.825 25.208 1.00 76.02 O \nHETATM 3976 O HOH B 313 13.711 -3.926 38.528 1.00 74.49 O \nHETATM 3977 O HOH B 314 14.179 -9.387 7.576 1.00 67.10 O \nHETATM 3978 O HOH B 315 22.396 6.168 19.677 1.00 66.83 O \nHETATM 3979 O HOH B 316 -0.643 13.466 -46.099 1.00 84.95 O \nHETATM 3980 O HOH B 317 3.801 11.485 -42.559 1.00 51.73 O \nHETATM 3981 O HOH B 318 0.000 0.000 -18.054 0.33 75.84 O \nENDMDL \nMODEL 2 \nATOM 1 N PRO A -1 -21.268 6.795 33.812 1.00108.74 N \nANISOU 1 N PRO A -1 13644 13962 13711 -3983 -1018 181 N \nATOM 2 CA PRO A -1 -20.214 6.132 33.040 1.00107.88 C \nANISOU 2 CA PRO A -1 13518 13817 13656 -3861 -1014 198 C \nATOM 3 C PRO A -1 -18.915 6.964 33.107 1.00112.82 C \nANISOU 3 C PRO A -1 14031 14488 14346 -3841 -1113 272 C \nATOM 4 O PRO A -1 -18.542 7.398 34.202 1.00118.90 O \nANISOU 4 O PRO A -1 14761 15326 15088 -3913 -1170 308 O \nATOM 5 CB PRO A -1 -20.814 6.100 31.636 1.00101.66 C \nANISOU 5 CB PRO A -1 12763 12951 12912 -3793 -964 163 C \nATOM 6 CG PRO A -1 -21.530 7.420 31.560 1.00104.61 C \nANISOU 6 CG PRO A -1 13094 13350 13303 -3869 -1001 171 C \nATOM 7 CD PRO A -1 -22.086 7.673 32.955 1.00106.32 C \nANISOU 7 CD PRO A -1 13326 13631 13440 -3997 -1015 167 C \nATOM 8 N GLY A 0 -18.235 7.176 31.973 1.00102.11 N \nANISOU 8 N GLY A 0 12632 13095 13071 -3746 -1132 293 N \nATOM 9 CA GLY A 0 -17.125 8.125 31.903 1.00 89.42 C \nANISOU 9 CA GLY A 0 10930 11519 11529 -3726 -1226 361 C \nATOM 10 C GLY A 0 -17.146 8.855 30.578 1.00 79.86 C \nANISOU 10 C GLY A 0 9680 10264 10401 -3657 -1239 366 C \nATOM 11 O GLY A 0 -17.802 8.419 29.641 1.00 73.60 O \nANISOU 11 O GLY A 0 8934 9413 9619 -3611 -1172 320 O \nATOM 12 N ASP A 1 -16.421 9.969 30.515 1.00 76.06 N \nANISOU 12 N ASP A 1 9117 9808 9973 -3648 -1324 421 N \nATOM 13 CA ASP A 1 -16.373 10.797 29.313 1.00 76.02 C \nANISOU 13 CA ASP A 1 9067 9771 10046 -3582 -1346 430 C \nATOM 14 C ASP A 1 -15.698 10.033 28.209 1.00 72.75 C \nANISOU 14 C ASP A 1 8670 9292 9681 -3475 -1313 423 C \nATOM 15 O ASP A 1 -14.909 9.126 28.463 1.00 79.13 O \nANISOU 15 O ASP A 1 9497 10097 10471 -3450 -1304 433 O \nATOM 16 CB ASP A 1 -15.622 12.114 29.566 1.00 76.89 C \nANISOU 16 CB ASP A 1 9092 9925 10199 -3584 -1449 495 C \nATOM 17 CG ASP A 1 -16.203 12.919 30.712 1.00 77.18 C \nANISOU 17 CG ASP A 1 9101 10039 10185 -3688 -1489 509 C \nATOM 18 OD1 ASP A 1 -17.388 12.715 31.093 1.00 79.02 O \nANISOU 18 OD1 ASP A 1 9375 10290 10361 -3763 -1437 463 O \nATOM 19 OD2 ASP A 1 -15.464 13.769 31.224 1.00 76.73 O \nANISOU 19 OD2 ASP A 1 8986 10024 10142 -3696 -1573 566 O \nATOM 20 N GLN A 2 -15.990 10.420 26.977 1.00 73.15 N \nANISOU 20 N GLN A 2 8707 9298 9789 -3414 -1298 407 N \nATOM 21 CA GLN A 2 -15.490 9.708 25.812 1.00 68.19 C \nANISOU 21 CA GLN A 2 8096 8606 9206 -3312 -1260 395 C \nATOM 22 C GLN A 2 -15.078 10.634 24.695 1.00 65.93 C \nANISOU 22 C GLN A 2 7752 8293 9004 -3243 -1301 418 C \nATOM 23 O GLN A 2 -15.753 11.619 24.441 1.00 72.46 O \nANISOU 23 O GLN A 2 8547 9134 9850 -3264 -1318 413 O \nATOM 24 CB GLN A 2 -16.567 8.758 25.288 1.00 67.85 C \nANISOU 24 CB GLN A 2 8133 8516 9130 -3299 -1160 329 C \nATOM 25 CG GLN A 2 -16.718 7.489 26.117 1.00 69.48 C \nANISOU 25 CG GLN A 2 8410 8731 9258 -3326 -1106 302 C \nATOM 26 CD GLN A 2 -17.565 6.450 25.426 1.00 65.59 C \nANISOU 26 CD GLN A 2 8003 8178 8739 -3282 -1008 241 C \nATOM 27 OE1 GLN A 2 -17.739 6.483 24.205 1.00 59.84 O \nANISOU 27 OE1 GLN A 2 7279 7399 8061 -3215 -981 225 O \nATOM 28 NE2 GLN A 2 -18.129 5.536 26.210 1.00 66.69 N \nANISOU 28 NE2 GLN A 2 8217 8324 8798 -3321 -953 206 N \nATOM 29 N ILE A 3 -14.003 10.284 23.994 1.00 63.89 N \nANISOU 29 N ILE A 3 7482 8001 8793 -3162 -1313 439 N \nATOM 30 CA ILE A 3 -13.731 10.865 22.689 1.00 60.05 C \nANISOU 30 CA ILE A 3 6961 7472 8383 -3081 -1327 445 C \nATOM 31 C ILE A 3 -13.642 9.753 21.677 1.00 60.33 C \nANISOU 31 C ILE A 3 7039 7450 8432 -3006 -1257 411 C \nATOM 32 O ILE A 3 -13.159 8.675 21.989 1.00 63.82 O \nANISOU 32 O ILE A 3 7515 7895 8840 -2996 -1229 409 O \nATOM 33 CB ILE A 3 -12.483 11.773 22.695 1.00 57.90 C \nANISOU 33 CB ILE A 3 6627 7209 8161 -3052 -1421 507 C \nATOM 34 CG1 ILE A 3 -12.519 12.693 21.484 1.00 57.67 C \nANISOU 34 CG1 ILE A 3 6557 7149 8205 -2984 -1439 508 C \nATOM 35 CG2 ILE A 3 -11.201 10.952 22.699 1.00 58.66 C \nANISOU 35 CG2 ILE A 3 6737 7290 8259 -3016 -1431 534 C \nATOM 36 CD1 ILE A 3 -11.717 13.950 21.654 1.00 56.73 C \nANISOU 36 CD1 ILE A 3 6379 7050 8126 -2969 -1535 564 C \nATOM 37 N CYS A 4 -14.075 10.028 20.451 1.00 66.68 N \nANISOU 37 N CYS A 4 7838 8211 9285 -2950 -1229 387 N \nATOM 38 CA CYS A 4 -14.058 9.018 19.354 1.00 68.22 C \nANISOU 38 CA CYS A 4 8074 8351 9496 -2871 -1161 354 C \nATOM 39 C CYS A 4 -13.388 9.523 18.070 1.00 66.44 C \nANISOU 39 C CYS A 4 7806 8088 9352 -2786 -1186 371 C \nATOM 40 O CYS A 4 -13.414 10.697 17.766 1.00 63.02 O \nANISOU 40 O CYS A 4 7322 7659 8963 -2783 -1234 388 O \nATOM 41 CB CYS A 4 -15.469 8.561 19.046 1.00 68.04 C \nANISOU 41 CB CYS A 4 8113 8301 9438 -2886 -1078 295 C \nATOM 42 SG CYS A 4 -16.327 7.790 20.454 1.00 72.81 S \nANISOU 42 SG CYS A 4 8788 8937 9940 -2979 -1034 266 S \nATOM 43 N ILE A 5 -12.747 8.616 17.338 1.00 72.56 N \nANISOU 43 N ILE A 5 8599 8830 10141 -2715 -1154 366 N \nATOM 44 CA ILE A 5 -12.193 8.935 16.024 1.00 67.14 C \nANISOU 44 CA ILE A 5 7882 8102 9526 -2634 -1165 374 C \nATOM 45 C ILE A 5 -13.082 8.336 14.990 1.00 62.66 C \nANISOU 45 C ILE A 5 7355 7489 8962 -2588 -1084 323 C \nATOM 46 O ILE A 5 -13.433 7.176 15.079 1.00 64.50 O \nANISOU 46 O ILE A 5 7645 7715 9148 -2579 -1019 293 O \nATOM 47 CB ILE A 5 -10.770 8.390 15.852 1.00 73.95 C \nANISOU 47 CB ILE A 5 8733 8963 10403 -2590 -1191 408 C \nATOM 48 CG1 ILE A 5 -9.899 8.778 17.057 1.00 81.95 C \nANISOU 48 CG1 ILE A 5 9723 10022 11395 -2648 -1266 458 C \nATOM 49 CG2 ILE A 5 -10.142 8.929 14.577 1.00 71.79 C \nANISOU 49 CG2 ILE A 5 8426 8648 10204 -2515 -1215 420 C \nATOM 50 CD1 ILE A 5 -9.877 10.259 17.403 1.00 84.12 C \nANISOU 50 CD1 ILE A 5 9952 10309 11701 -2678 -1343 491 C \nATOM 51 N GLY A 6 -13.478 9.147 14.021 1.00 66.85 N \nANISOU 51 N GLY A 6 7860 7994 9546 -2558 -1087 312 N \nATOM 52 CA GLY A 6 -14.443 8.720 13.008 1.00 68.04 C \nANISOU 52 CA GLY A 6 8051 8100 9699 -2523 -1012 263 C \nATOM 53 C GLY A 6 -14.272 9.466 11.691 1.00 69.78 C \nANISOU 53 C GLY A 6 8229 8289 9993 -2460 -1027 265 C \nATOM 54 O GLY A 6 -13.314 10.238 11.511 1.00 67.75 O \nANISOU 54 O GLY A 6 7915 8041 9788 -2433 -1095 303 O \nATOM 55 N TYR A 7 -15.226 9.266 10.782 1.00 68.78 N \nANISOU 55 N TYR A 7 8135 8127 9871 -2439 -965 222 N \nATOM 56 CA TYR A 7 -15.131 9.838 9.436 1.00 69.70 C \nANISOU 56 CA TYR A 7 8216 8213 10053 -2375 -969 217 C \nATOM 57 C TYR A 7 -16.491 10.176 8.808 1.00 78.28 C \nANISOU 57 C TYR A 7 9324 9284 11134 -2397 -921 174 C \nATOM 58 O TYR A 7 -17.545 9.831 9.331 1.00 82.04 O \nANISOU 58 O TYR A 7 9857 9763 11553 -2459 -876 145 O \nATOM 59 CB TYR A 7 -14.330 8.910 8.514 1.00 65.47 C \nANISOU 59 CB TYR A 7 7695 7638 9542 -2288 -940 218 C \nATOM 60 CG TYR A 7 -14.881 7.496 8.370 1.00 64.07 C \nANISOU 60 CG TYR A 7 7597 7434 9313 -2268 -855 182 C \nATOM 61 CD1 TYR A 7 -15.729 7.171 7.325 1.00 66.90 C \nANISOU 61 CD1 TYR A 7 7996 7747 9675 -2232 -791 142 C \nATOM 62 CD2 TYR A 7 -14.527 6.491 9.249 1.00 60.43 C \nANISOU 62 CD2 TYR A 7 7170 6993 8796 -2279 -840 188 C \nATOM 63 CE1 TYR A 7 -16.202 5.892 7.157 1.00 68.07 C \nANISOU 63 CE1 TYR A 7 8222 7867 9774 -2202 -715 111 C \nATOM 64 CE2 TYR A 7 -15.015 5.205 9.099 1.00 65.66 C \nANISOU 64 CE2 TYR A 7 7906 7634 9408 -2248 -763 154 C \nATOM 65 CZ TYR A 7 -15.851 4.914 8.043 1.00 68.68 C \nANISOU 65 CZ TYR A 7 8332 7966 9796 -2206 -701 117 C \nATOM 66 OH TYR A 7 -16.369 3.646 7.881 1.00 76.12 O \nANISOU 66 OH TYR A 7 9355 8882 10685 -2166 -624 84 O \nATOM 67 N HIS A 8 -16.440 10.871 7.683 1.00 80.73 N \nANISOU 67 N HIS A 8 9591 9578 11502 -2350 -932 172 N \nATOM 68 CA HIS A 8 -17.634 11.360 7.013 1.00 81.79 C \nANISOU 68 CA HIS A 8 9733 9708 11637 -2373 -896 135 C \nATOM 69 C HIS A 8 -18.551 10.238 6.552 1.00 85.24 C \nANISOU 69 C HIS A 8 10264 10094 12031 -2370 -805 90 C \nATOM 70 O HIS A 8 -18.104 9.152 6.186 1.00 95.04 O \nANISOU 70 O HIS A 8 11547 11295 13269 -2309 -768 86 O \nATOM 71 CB HIS A 8 -17.225 12.224 5.829 1.00 83.51 C \nANISOU 71 CB HIS A 8 9884 9919 11926 -2309 -926 143 C \nATOM 72 CG HIS A 8 -18.281 13.177 5.358 1.00 94.32 C \nANISOU 72 CG HIS A 8 11226 11313 13298 -2347 -919 117 C \nATOM 73 ND1 HIS A 8 -19.563 12.790 5.043 1.00 95.94 N \nANISOU 73 ND1 HIS A 8 11492 11500 13461 -2391 -849 73 N \nATOM 74 CD2 HIS A 8 -18.225 14.508 5.110 1.00 99.29 C \nANISOU 74 CD2 HIS A 8 11772 11989 13964 -2344 -973 130 C \nATOM 75 CE1 HIS A 8 -20.254 13.838 4.640 1.00 99.71 C \nANISOU 75 CE1 HIS A 8 11923 12016 13947 -2424 -860 60 C \nATOM 76 NE2 HIS A 8 -19.464 14.895 4.673 1.00 98.21 N \nANISOU 76 NE2 HIS A 8 11640 11870 13804 -2392 -935 93 N \nATOM 77 N ALA A 9 -19.848 10.492 6.622 1.00 85.74 N \nANISOU 77 N ALA A 9 10362 10161 12054 -2440 -769 57 N \nATOM 78 CA ALA A 9 -20.837 9.626 5.988 1.00 91.53 C \nANISOU 78 CA ALA A 9 11189 10838 12750 -2437 -684 12 C \nATOM 79 C ALA A 9 -21.909 10.510 5.370 1.00 94.22 C \nANISOU 79 C ALA A 9 11518 11190 13091 -2487 -671 -14 C \nATOM 80 O ALA A 9 -22.055 11.668 5.751 1.00 97.60 O \nANISOU 80 O ALA A 9 11875 11680 13527 -2543 -722 -2 O \nATOM 81 CB ALA A 9 -21.457 8.659 6.982 1.00 92.44 C \nANISOU 81 CB ALA A 9 11401 10939 12783 -2489 -637 -8 C \nATOM 82 N ASN A 10 -22.622 9.965 4.390 1.00 88.75 N \nANISOU 82 N ASN A 10 10892 10441 12388 -2465 -604 -49 N \nATOM 83 CA ASN A 10 -23.756 10.652 3.791 1.00 87.25 C \nANISOU 83 CA ASN A 10 10708 10258 12185 -2524 -581 -79 C \nATOM 84 C ASN A 10 -24.758 9.659 3.170 1.00 93.65 C \nANISOU 84 C ASN A 10 11643 10993 12947 -2526 -492 -122 C \nATOM 85 O ASN A 10 -24.733 8.463 3.465 1.00100.06 O \nANISOU 85 O ASN A 10 12544 11753 13720 -2495 -447 -131 O \nATOM 86 CB ASN A 10 -23.322 11.778 2.830 1.00 76.62 C \nANISOU 86 CB ASN A 10 9253 8947 10913 -2482 -627 -66 C \nATOM 87 CG ASN A 10 -22.536 11.274 1.615 1.00 81.72 C \nANISOU 87 CG ASN A 10 9892 9539 11618 -2365 -612 -61 C \nATOM 88 OD1 ASN A 10 -22.628 10.111 1.239 1.00 84.90 O \nANISOU 88 OD1 ASN A 10 10379 9879 12001 -2322 -554 -77 O \nATOM 89 ND2 ASN A 10 -21.786 12.176 0.968 1.00 70.36 N \nANISOU 89 ND2 ASN A 10 8355 8130 10249 -2312 -665 -40 N \nATOM 90 N ASN A 11 -25.657 10.173 2.348 1.00102.82 N \nANISOU 90 N ASN A 11 12812 12150 14103 -2563 -466 -148 N \nATOM 91 CA ASN A 11 -26.712 9.375 1.731 1.00112.57 C \nANISOU 91 CA ASN A 11 14172 13312 15287 -2577 -384 -189 C \nATOM 92 C ASN A 11 -26.373 9.040 0.275 1.00117.73 C \nANISOU 92 C ASN A 11 14824 13916 15993 -2474 -358 -193 C \nATOM 93 O ASN A 11 -27.181 8.446 -0.443 1.00120.99 O \nANISOU 93 O ASN A 11 15333 14266 16372 -2472 -293 -223 O \nATOM 94 CB ASN A 11 -28.051 10.124 1.820 1.00113.91 C \nANISOU 94 CB ASN A 11 14367 13512 15403 -2706 -368 -218 C \nATOM 95 CG ASN A 11 -27.948 11.578 1.369 1.00110.15 C \nANISOU 95 CG ASN A 11 13756 13120 14975 -2731 -424 -206 C \nATOM 96 OD1 ASN A 11 -26.945 11.999 0.779 1.00 99.60 O \nANISOU 96 OD1 ASN A 11 12323 11804 13718 -2641 -467 -181 O \nATOM 97 ND2 ASN A 11 -28.988 12.360 1.663 1.00109.74 N \nANISOU 97 ND2 ASN A 11 13700 13123 14872 -2853 -423 -225 N \nATOM 98 N SER A 12 -25.174 9.435 -0.147 1.00118.09 N \nANISOU 98 N SER A 12 14763 13989 16117 -2391 -410 -161 N \nATOM 99 CA SER A 12 -24.684 9.175 -1.496 1.00111.27 C \nANISOU 99 CA SER A 12 13883 13087 15309 -2291 -394 -161 C \nATOM 100 C SER A 12 -24.761 7.693 -1.814 1.00106.06 C \nANISOU 100 C SER A 12 13335 12348 14616 -2225 -326 -175 C \nATOM 101 O SER A 12 -24.517 6.850 -0.945 1.00108.41 O \nANISOU 101 O SER A 12 13683 12633 14876 -2214 -315 -169 O \nATOM 102 CB SER A 12 -23.242 9.670 -1.642 1.00113.56 C \nANISOU 102 CB SER A 12 14055 13414 15678 -2214 -463 -122 C \nATOM 103 OG SER A 12 -22.603 9.037 -2.720 1.00121.50 O \nANISOU 103 OG SER A 12 15064 14374 16725 -2110 -441 -119 O \nATOM 104 N THR A 13 -25.105 7.394 -3.062 1.00 99.86 N \nANISOU 104 N THR A 13 12587 11515 13842 -2179 -281 -194 N \nATOM 105 CA THR A 13 -25.272 6.012 -3.524 1.00 98.16 C \nANISOU 105 CA THR A 13 12482 11224 13591 -2107 -213 -209 C \nATOM 106 C THR A 13 -24.326 5.686 -4.687 1.00 91.16 C \nANISOU 106 C THR A 13 11547 10322 12768 -1989 -215 -195 C \nATOM 107 O THR A 13 -24.394 4.610 -5.260 1.00 86.71 O \nANISOU 107 O THR A 13 11059 9704 12182 -1917 -162 -205 O \nATOM 108 CB THR A 13 -26.704 5.782 -4.013 1.00 98.65 C \nANISOU 108 CB THR A 13 12661 11229 13593 -2161 -146 -249 C \nATOM 109 OG1 THR A 13 -27.026 6.814 -4.946 1.00103.60 O \nANISOU 109 OG1 THR A 13 13225 11879 14259 -2193 -160 -256 O \nATOM 110 CG2 THR A 13 -27.682 5.816 -2.861 1.00101.45 C \nANISOU 110 CG2 THR A 13 13093 11583 13869 -2275 -130 -267 C \nATOM 111 N GLU A 14 -23.456 6.623 -5.027 1.00 88.48 N \nANISOU 111 N GLU A 14 11084 10032 12503 -1969 -277 -171 N \nATOM 112 CA GLU A 14 -22.467 6.415 -6.066 1.00 93.03 C \nANISOU 112 CA GLU A 14 11606 10600 13140 -1865 -286 -155 C \nATOM 113 C GLU A 14 -21.535 5.274 -5.663 1.00 95.31 C \nANISOU 113 C GLU A 14 11914 10882 13418 -1790 -281 -135 C \nATOM 114 O GLU A 14 -20.926 5.278 -4.585 1.00 96.87 O \nANISOU 114 O GLU A 14 12081 11115 13609 -1809 -320 -113 O \nATOM 115 CB GLU A 14 -21.655 7.680 -6.331 1.00 94.45 C \nANISOU 115 CB GLU A 14 11656 10834 13396 -1862 -359 -133 C \nATOM 116 CG GLU A 14 -22.483 8.844 -6.864 1.00 99.20 C \nANISOU 116 CG GLU A 14 12222 11459 14012 -1923 -366 -152 C \nATOM 117 CD GLU A 14 -21.760 10.179 -6.777 1.00 97.35 C \nANISOU 117 CD GLU A 14 11861 11289 13837 -1927 -444 -129 C \nATOM 118 OE1 GLU A 14 -20.989 10.377 -5.821 1.00 87.98 O \nANISOU 118 OE1 GLU A 14 10633 10135 12662 -1930 -495 -101 O \nATOM 119 OE2 GLU A 14 -21.960 11.031 -7.665 1.00 98.69 O \nANISOU 119 OE2 GLU A 14 11977 11479 14042 -1925 -453 -139 O \nATOM 120 N GLN A 15 -21.481 4.273 -6.527 1.00 87.84 N \nANISOU 120 N GLN A 15 11020 9892 12462 -1708 -230 -144 N \nATOM 121 CA GLN A 15 -20.627 3.132 -6.326 1.00 82.06 C \nANISOU 121 CA GLN A 15 10301 9163 11715 -1628 -219 -128 C \nATOM 122 C GLN A 15 -19.326 3.308 -7.099 1.00 84.99 C \nANISOU 122 C GLN A 15 10576 9561 12155 -1557 -258 -101 C \nATOM 123 O GLN A 15 -19.199 4.182 -7.956 1.00 86.16 O \nANISOU 123 O GLN A 15 10664 9712 12361 -1556 -282 -101 O \nATOM 124 CB GLN A 15 -21.332 1.870 -6.751 1.00 80.23 C \nANISOU 124 CB GLN A 15 10186 8875 11422 -1575 -139 -152 C \nATOM 125 CG GLN A 15 -22.393 1.422 -5.772 1.00 90.71 C \nANISOU 125 CG GLN A 15 11624 10174 12669 -1633 -100 -175 C \nATOM 126 CD GLN A 15 -23.175 0.220 -6.280 1.00 94.03 C \nANISOU 126 CD GLN A 15 12175 10528 13026 -1573 -19 -201 C \nATOM 127 OE1 GLN A 15 -22.878 -0.321 -7.350 1.00 90.17 O \nANISOU 127 OE1 GLN A 15 11688 10021 12553 -1483 7 -199 O \nATOM 128 NE2 GLN A 15 -24.168 -0.210 -5.508 1.00 93.41 N \nANISOU 128 NE2 GLN A 15 12209 10411 12870 -1620 21 -224 N \nATOM 129 N VAL A 16 -18.362 2.455 -6.785 1.00 78.41 N \nANISOU 129 N VAL A 16 9730 8751 11310 -1500 -264 -80 N \nATOM 130 CA VAL A 16 -17.017 2.579 -7.319 1.00 70.53 C \nANISOU 130 CA VAL A 16 8645 7785 10368 -1446 -306 -52 C \nATOM 131 C VAL A 16 -16.370 1.236 -7.235 1.00 72.90 C \nANISOU 131 C VAL A 16 8968 8102 10628 -1375 -278 -42 C \nATOM 132 O VAL A 16 -16.704 0.440 -6.359 1.00 80.06 O \nANISOU 132 O VAL A 16 9935 9014 11471 -1380 -250 -48 O \nATOM 133 CB VAL A 16 -16.217 3.621 -6.517 1.00 73.84 C \nANISOU 133 CB VAL A 16 8980 8248 10828 -1501 -387 -23 C \nATOM 134 CG1 VAL A 16 -14.852 3.101 -6.126 1.00 75.37 C \nANISOU 134 CG1 VAL A 16 9131 8483 11023 -1466 -420 9 C \nATOM 135 CG2 VAL A 16 -16.111 4.919 -7.287 1.00 69.16 C \nANISOU 135 CG2 VAL A 16 8318 7653 10305 -1513 -427 -22 C \nATOM 136 N ASP A 17 -15.481 0.952 -8.171 1.00 73.77 N \nANISOU 136 N ASP A 17 9033 8226 10771 -1306 -283 -29 N \nATOM 137 CA ASP A 17 -14.813 -0.360 -8.170 1.00 79.02 C \nANISOU 137 CA ASP A 17 9709 8923 11392 -1234 -256 -19 C \nATOM 138 C ASP A 17 -13.342 -0.380 -7.765 1.00 71.97 C \nANISOU 138 C ASP A 17 8738 8093 10516 -1233 -312 17 C \nATOM 139 O ASP A 17 -12.662 0.659 -7.713 1.00 67.50 O \nANISOU 139 O ASP A 17 8103 7536 10006 -1274 -375 37 O \nATOM 140 CB ASP A 17 -14.955 -1.003 -9.541 1.00 87.52 C \nANISOU 140 CB ASP A 17 10808 9976 12470 -1150 -206 -32 C \nATOM 141 CG ASP A 17 -16.317 -1.604 -9.745 1.00 88.39 C \nANISOU 141 CG ASP A 17 11026 10030 12527 -1130 -134 -64 C \nATOM 142 OD1 ASP A 17 -17.317 -0.858 -9.833 1.00 93.76 O \nANISOU 142 OD1 ASP A 17 11741 10663 13219 -1186 -127 -85 O \nATOM 143 OD2 ASP A 17 -16.380 -2.847 -9.807 1.00 89.54 O \nANISOU 143 OD2 ASP A 17 11224 10182 12614 -1058 -85 -70 O \nATOM 144 N THR A 18 -12.906 -1.605 -7.480 1.00 66.87 N \nANISOU 144 N THR A 18 8107 7488 9812 -1184 -284 24 N \nATOM 145 CA THR A 18 -11.591 -1.910 -6.957 1.00 66.87 C \nANISOU 145 CA THR A 18 8046 7558 9803 -1186 -326 56 C \nATOM 146 C THR A 18 -11.196 -3.290 -7.481 1.00 70.20 C \nANISOU 146 C THR A 18 8476 8024 10174 -1098 -278 55 C \nATOM 147 O THR A 18 -12.057 -4.119 -7.830 1.00 72.57 O \nANISOU 147 O THR A 18 8845 8301 10429 -1038 -212 31 O \nATOM 148 CB THR A 18 -11.639 -1.905 -5.404 1.00 68.47 C \nANISOU 148 CB THR A 18 8262 7789 9966 -1252 -349 64 C \nATOM 149 OG1 THR A 18 -11.657 -0.554 -4.927 1.00 76.74 O \nANISOU 149 OG1 THR A 18 9277 8816 11064 -1333 -408 75 O \nATOM 150 CG2 THR A 18 -10.473 -2.586 -4.780 1.00 74.10 C \nANISOU 150 CG2 THR A 18 8933 8581 10641 -1248 -372 92 C \nATOM 151 N ILE A 19 -9.898 -3.553 -7.509 1.00 75.39 N \nANISOU 151 N ILE A 19 9067 8747 10831 -1090 -312 84 N \nATOM 152 CA ILE A 19 -9.359 -4.860 -7.965 1.00 82.57 C \nANISOU 152 CA ILE A 19 9967 9721 11685 -1011 -274 88 C \nATOM 153 C ILE A 19 -9.821 -6.039 -7.118 1.00 86.42 C \nANISOU 153 C ILE A 19 10506 10248 12083 -975 -226 76 C \nATOM 154 O ILE A 19 -9.885 -7.149 -7.605 1.00 94.85 O \nANISOU 154 O ILE A 19 11592 11350 13098 -889 -174 67 O \nATOM 155 CB ILE A 19 -7.817 -4.851 -8.091 1.00 83.86 C \nANISOU 155 CB ILE A 19 10047 9956 11861 -1028 -324 121 C \nATOM 156 CG1 ILE A 19 -7.184 -4.552 -6.748 1.00 93.97 C \nANISOU 156 CG1 ILE A 19 11301 11277 13125 -1108 -378 145 C \nATOM 157 CG2 ILE A 19 -7.366 -3.799 -9.096 1.00 79.08 C \nANISOU 157 CG2 ILE A 19 9400 9307 11339 -1044 -363 129 C \nATOM 158 CD1 ILE A 19 -6.762 -5.800 -6.023 1.00 99.86 C \nANISOU 158 CD1 ILE A 19 12042 12118 13783 -1086 -355 153 C \nATOM 159 N MET A 20 -10.169 -5.779 -5.862 1.00 92.36 N \nANISOU 159 N MET A 20 11284 10996 12815 -1038 -242 75 N \nATOM 160 CA MET A 20 -10.624 -6.808 -4.921 1.00 91.38 C \nANISOU 160 CA MET A 20 11212 10906 12603 -1013 -200 62 C \nATOM 161 C MET A 20 -12.090 -6.689 -4.544 1.00 89.12 C \nANISOU 161 C MET A 20 11023 10539 12298 -1024 -160 29 C \nATOM 162 O MET A 20 -12.645 -7.606 -3.941 1.00 88.33 O \nANISOU 162 O MET A 20 10987 10451 12123 -986 -113 12 O \nATOM 163 CB MET A 20 -9.810 -6.739 -3.624 1.00 96.50 C \nANISOU 163 CB MET A 20 11816 11624 13227 -1083 -249 87 C \nATOM 164 CG MET A 20 -8.456 -7.407 -3.683 1.00 94.25 C \nANISOU 164 CG MET A 20 11455 11443 12911 -1064 -269 114 C \nATOM 165 SD MET A 20 -7.656 -7.167 -2.096 1.00105.99 S \nANISOU 165 SD MET A 20 12903 12999 14371 -1164 -329 143 S \nATOM 166 CE MET A 20 -6.039 -7.844 -2.447 1.00114.92 C \nANISOU 166 CE MET A 20 13945 14249 15472 -1150 -353 175 C \nATOM 167 N GLU A 21 -12.701 -5.549 -4.841 1.00 91.25 N \nANISOU 167 N GLU A 21 11307 10733 12632 -1079 -179 21 N \nATOM 168 CA GLU A 21 -14.093 -5.301 -4.446 1.00 95.53 C \nANISOU 168 CA GLU A 21 11940 11201 13156 -1111 -146 -9 C \nATOM 169 C GLU A 21 -14.880 -4.587 -5.544 1.00 81.26 C \nANISOU 169 C GLU A 21 10159 9314 11402 -1112 -131 -27 C \nATOM 170 O GLU A 21 -14.405 -3.628 -6.133 1.00 69.74 O \nANISOU 170 O GLU A 21 8633 7848 10016 -1141 -176 -13 O \nATOM 171 CB GLU A 21 -14.149 -4.473 -3.155 1.00107.67 C \nANISOU 171 CB GLU A 21 13464 12743 14701 -1217 -195 -1 C \nATOM 172 CG GLU A 21 -13.912 -5.255 -1.873 1.00115.80 C \nANISOU 172 CG GLU A 21 14509 13833 15658 -1226 -190 4 C \nATOM 173 CD GLU A 21 -14.214 -4.439 -0.620 1.00122.34 C \nANISOU 173 CD GLU A 21 15341 14654 16488 -1333 -230 7 C \nATOM 174 OE1 GLU A 21 -15.273 -4.675 -0.001 1.00126.19 O \nANISOU 174 OE1 GLU A 21 15913 15106 16926 -1353 -192 -19 O \nATOM 175 OE2 GLU A 21 -13.407 -3.551 -0.258 1.00114.17 O \nANISOU 175 OE2 GLU A 21 14229 13649 15503 -1397 -300 37 O \nATOM 176 N LYS A 22 -16.096 -5.057 -5.771 1.00 83.38 N \nANISOU 176 N LYS A 22 10531 9521 11628 -1082 -68 -59 N \nATOM 177 CA LYS A 22 -16.966 -4.532 -6.795 1.00 92.47 C \nANISOU 177 CA LYS A 22 11723 10598 12814 -1083 -44 -79 C \nATOM 178 C LYS A 22 -18.169 -3.885 -6.113 1.00102.06 C \nANISOU 178 C LYS A 22 13009 11755 14014 -1172 -37 -102 C \nATOM 179 O LYS A 22 -18.640 -4.373 -5.091 1.00109.16 O \nANISOU 179 O LYS A 22 13973 12654 14850 -1191 -16 -114 O \nATOM 180 CB LYS A 22 -17.373 -5.676 -7.743 1.00103.61 C \nANISOU 180 CB LYS A 22 13204 11984 14180 -972 26 -96 C \nATOM 181 CG LYS A 22 -18.627 -5.432 -8.611 1.00110.35 C \nANISOU 181 CG LYS A 22 14146 12746 15036 -972 71 -125 C \nATOM 182 CD LYS A 22 -18.272 -4.620 -9.860 1.00110.72 C \nANISOU 182 CD LYS A 22 14121 12784 15164 -973 46 -116 C \nATOM 183 CE LYS A 22 -19.468 -4.259 -10.759 1.00105.57 C \nANISOU 183 CE LYS A 22 13544 12048 14518 -985 85 -143 C \nATOM 184 NZ LYS A 22 -19.305 -2.892 -11.356 1.00 97.45 N \nANISOU 184 NZ LYS A 22 12435 11016 13575 -1050 38 -138 N \nATOM 185 N ASN A 23 -18.654 -2.780 -6.683 1.00110.43 N \nANISOU 185 N ASN A 23 14055 12775 15130 -1229 -55 -110 N \nATOM 186 CA ASN A 23 -19.881 -2.100 -6.215 1.00110.96 C \nANISOU 186 CA ASN A 23 14187 12793 15181 -1320 -45 -134 C \nATOM 187 C ASN A 23 -19.750 -1.589 -4.782 1.00105.13 C \nANISOU 187 C ASN A 23 13422 12091 14431 -1408 -90 -124 C \nATOM 188 O ASN A 23 -20.519 -1.953 -3.902 1.00 99.02 O \nANISOU 188 O ASN A 23 12731 11297 13594 -1445 -61 -142 O \nATOM 189 CB ASN A 23 -21.133 -2.991 -6.373 1.00107.65 C \nANISOU 189 CB ASN A 23 13914 12304 14685 -1290 35 -168 C \nATOM 190 CG ASN A 23 -21.490 -3.278 -7.831 1.00114.09 C \nANISOU 190 CG ASN A 23 14766 13072 15513 -1221 78 -180 C \nATOM 191 OD1 ASN A 23 -21.536 -4.443 -8.250 1.00123.92 O \nANISOU 191 OD1 ASN A 23 16073 14301 16711 -1122 129 -186 O \nATOM 192 ND2 ASN A 23 -21.763 -2.230 -8.606 1.00113.90 N \nANISOU 192 ND2 ASN A 23 14702 13027 15546 -1269 58 -184 N \nATOM 193 N VAL A 24 -18.748 -0.748 -4.565 1.00106.45 N \nANISOU 193 N VAL A 24 13477 12311 14660 -1441 -161 -94 N \nATOM 194 CA VAL A 24 -18.465 -0.193 -3.235 1.00 97.07 C \nANISOU 194 CA VAL A 24 12251 11164 13468 -1521 -212 -78 C \nATOM 195 C VAL A 24 -18.973 1.229 -3.109 1.00 85.94 C \nANISOU 195 C VAL A 24 10807 9748 12100 -1615 -252 -81 C \nATOM 196 O VAL A 24 -18.477 2.132 -3.788 1.00 77.13 O \nANISOU 196 O VAL A 24 9610 8642 11053 -1615 -295 -67 O \nATOM 197 CB VAL A 24 -16.954 -0.208 -2.941 1.00 98.85 C \nANISOU 197 CB VAL A 24 12379 11456 13725 -1498 -269 -39 C \nATOM 198 CG1 VAL A 24 -16.631 0.618 -1.699 1.00 96.83 C \nANISOU 198 CG1 VAL A 24 12075 11238 13477 -1587 -332 -19 C \nATOM 199 CG2 VAL A 24 -16.492 -1.647 -2.785 1.00 97.62 C \nANISOU 199 CG2 VAL A 24 12252 11327 13510 -1420 -230 -37 C \nATOM 200 N THR A 25 -19.955 1.423 -2.227 1.00 82.14 N \nANISOU 200 N THR A 25 10386 9253 11572 -1694 -239 -99 N \nATOM 201 CA THR A 25 -20.622 2.707 -2.112 1.00 77.97 C \nANISOU 201 CA THR A 25 9832 8725 11068 -1788 -269 -106 C \nATOM 202 C THR A 25 -19.663 3.730 -1.519 1.00 75.38 C \nANISOU 202 C THR A 25 9390 8457 10792 -1826 -353 -71 C \nATOM 203 O THR A 25 -18.933 3.431 -0.582 1.00 75.32 O \nANISOU 203 O THR A 25 9361 8488 10770 -1829 -382 -49 O \nATOM 204 CB THR A 25 -21.900 2.592 -1.275 1.00 73.10 C \nANISOU 204 CB THR A 25 9314 8084 10378 -1869 -232 -135 C \nATOM 205 OG1 THR A 25 -22.533 1.331 -1.535 1.00 78.39 O \nANISOU 205 OG1 THR A 25 10104 8696 10984 -1816 -155 -162 O \nATOM 206 CG2 THR A 25 -22.856 3.724 -1.607 1.00 67.26 C \nANISOU 206 CG2 THR A 25 8568 7335 9652 -1954 -238 -153 C \nATOM 207 N VAL A 26 -19.655 4.931 -2.079 1.00 71.56 N \nANISOU 207 N VAL A 26 8837 7985 10367 -1851 -392 -66 N \nATOM 208 CA VAL A 26 -18.673 5.927 -1.695 1.00 72.27 C \nANISOU 208 CA VAL A 26 8822 8127 10511 -1868 -474 -32 C \nATOM 209 C VAL A 26 -19.355 7.256 -1.388 1.00 80.10 C \nANISOU 209 C VAL A 26 9776 9144 11514 -1953 -508 -37 C \nATOM 210 O VAL A 26 -20.513 7.465 -1.747 1.00 84.30 O \nANISOU 210 O VAL A 26 10352 9657 12023 -1995 -469 -68 O \nATOM 211 CB VAL A 26 -17.577 6.074 -2.787 1.00 75.81 C \nANISOU 211 CB VAL A 26 9203 8574 11028 -1786 -499 -12 C \nATOM 212 CG1 VAL A 26 -17.770 7.325 -3.653 1.00 76.72 C \nANISOU 212 CG1 VAL A 26 9257 8692 11202 -1794 -527 -17 C \nATOM 213 CG2 VAL A 26 -16.191 6.058 -2.168 1.00 76.17 C \nANISOU 213 CG2 VAL A 26 9189 8657 11093 -1768 -558 28 C \nATOM 214 N THR A 27 -18.623 8.139 -0.713 1.00 80.37 N \nANISOU 214 N THR A 27 9730 9228 11579 -1980 -582 -5 N \nATOM 215 CA THR A 27 -19.151 9.392 -0.239 1.00 74.19 C \nANISOU 215 CA THR A 27 8901 8487 10800 -2057 -623 -5 C \nATOM 216 C THR A 27 -19.078 10.465 -1.329 1.00 78.11 C \nANISOU 216 C THR A 27 9325 8994 11360 -2030 -649 -6 C \nATOM 217 O THR A 27 -20.044 11.190 -1.538 1.00 79.94 O \nANISOU 217 O THR A 27 9549 9244 11581 -2083 -640 -28 O \nATOM 218 CB THR A 27 -18.483 9.761 1.089 1.00 76.71 C \nANISOU 218 CB THR A 27 9180 8855 11113 -2097 -686 29 C \nATOM 219 OG1 THR A 27 -19.463 10.247 2.009 1.00 87.66 O \nANISOU 219 OG1 THR A 27 10581 10274 12451 -2195 -688 17 O \nATOM 220 CG2 THR A 27 -17.360 10.759 0.938 1.00 73.22 C \nANISOU 220 CG2 THR A 27 8640 8443 10736 -2062 -765 66 C \nATOM 221 N HIS A 28 -17.954 10.543 -2.042 1.00 84.49 N \nANISOU 221 N HIS A 28 10083 9793 12227 -1949 -679 15 N \nATOM 222 CA HIS A 28 -17.775 11.452 -3.183 1.00 80.07 C \nANISOU 222 CA HIS A 28 9459 9237 11728 -1908 -700 12 C \nATOM 223 C HIS A 28 -17.006 10.709 -4.272 1.00 82.77 C \nANISOU 223 C HIS A 28 9810 9535 12105 -1816 -676 14 C \nATOM 224 O HIS A 28 -16.078 9.941 -3.995 1.00 71.41 O \nANISOU 224 O HIS A 28 8384 8085 10665 -1779 -684 36 O \nATOM 225 CB HIS A 28 -16.984 12.720 -2.816 1.00 81.45 C \nANISOU 225 CB HIS A 28 9541 9459 11946 -1905 -785 44 C \nATOM 226 CG HIS A 28 -17.659 13.636 -1.841 1.00 88.38 C \nANISOU 226 CG HIS A 28 10390 10395 12796 -1988 -818 46 C \nATOM 227 ND1 HIS A 28 -17.736 15.001 -2.037 1.00 89.12 N \nANISOU 227 ND1 HIS A 28 10404 10540 12920 -1993 -866 50 N \nATOM 228 CD2 HIS A 28 -18.243 13.398 -0.644 1.00 91.11 C \nANISOU 228 CD2 HIS A 28 10772 10762 13082 -2067 -811 44 C \nATOM 229 CE1 HIS A 28 -18.362 15.555 -1.012 1.00 91.86 C \nANISOU 229 CE1 HIS A 28 10737 10942 13226 -2073 -887 52 C \nATOM 230 NE2 HIS A 28 -18.681 14.605 -0.155 1.00 91.06 N \nANISOU 230 NE2 HIS A 28 10707 10822 13071 -2123 -854 48 N \nATOM 231 N ALA A 29 -17.357 10.991 -5.520 1.00 89.36 N \nANISOU 231 N ALA A 29 10633 10352 12969 -1783 -651 -7 N \nATOM 232 CA ALA A 29 -16.717 10.343 -6.643 1.00 91.12 C \nANISOU 232 CA ALA A 29 10862 10536 13224 -1699 -627 -8 C \nATOM 233 C ALA A 29 -16.688 11.246 -7.874 1.00 93.60 C \nANISOU 233 C ALA A 29 11119 10851 13594 -1663 -639 -18 C \nATOM 234 O ALA A 29 -17.424 12.226 -7.948 1.00 98.89 O \nANISOU 234 O ALA A 29 11756 11551 14266 -1705 -650 -33 O \nATOM 235 CB ALA A 29 -17.431 9.035 -6.945 1.00 88.96 C \nANISOU 235 CB ALA A 29 10682 10220 12901 -1688 -546 -33 C \nATOM 236 N GLN A 30 -15.817 10.910 -8.825 1.00 92.96 N \nANISOU 236 N GLN A 30 11023 10744 13552 -1586 -638 -11 N \nATOM 237 CA GLN A 30 -15.773 11.584 -10.122 1.00 89.35 C \nANISOU 237 CA GLN A 30 10521 10282 13145 -1543 -640 -24 C \nATOM 238 C GLN A 30 -15.897 10.584 -11.274 1.00 94.69 C \nANISOU 238 C GLN A 30 11244 10915 13819 -1489 -576 -43 C \nATOM 239 O GLN A 30 -15.095 9.664 -11.416 1.00 92.94 O \nANISOU 239 O GLN A 30 11043 10674 13597 -1441 -566 -28 O \nATOM 240 CB GLN A 30 -14.498 12.391 -10.290 1.00 84.39 C \nANISOU 240 CB GLN A 30 9823 9667 12575 -1497 -710 3 C \nATOM 241 CG GLN A 30 -14.629 13.843 -9.897 1.00 84.48 C \nANISOU 241 CG GLN A 30 9768 9724 12608 -1524 -768 9 C \nATOM 242 CD GLN A 30 -13.566 14.719 -10.552 1.00 82.37 C \nANISOU 242 CD GLN A 30 9438 9456 12402 -1459 -824 24 C \nATOM 243 OE1 GLN A 30 -13.523 14.853 -11.773 1.00 88.05 O \nANISOU 243 OE1 GLN A 30 10142 10159 13153 -1411 -804 6 O \nATOM 244 NE2 GLN A 30 -12.719 15.336 -9.742 1.00 78.42 N \nANISOU 244 NE2 GLN A 30 8908 8972 11915 -1457 -893 57 N \nATOM 245 N ASP A 31 -16.938 10.756 -12.073 1.00 95.43 N \nANISOU 245 N ASP A 31 11355 10998 13905 -1503 -532 -75 N \nATOM 246 CA ASP A 31 -17.042 10.074 -13.348 1.00 93.72 C \nANISOU 246 CA ASP A 31 11169 10744 13697 -1447 -479 -92 C \nATOM 247 C ASP A 31 -16.089 10.821 -14.262 1.00 85.58 C \nANISOU 247 C ASP A 31 10061 9722 12733 -1390 -521 -83 C \nATOM 248 O ASP A 31 -16.124 12.055 -14.317 1.00 90.46 O \nANISOU 248 O ASP A 31 10615 10372 13382 -1406 -563 -85 O \nATOM 249 CB ASP A 31 -18.481 10.127 -13.897 1.00 91.48 C \nANISOU 249 CB ASP A 31 10930 10447 13381 -1489 -423 -128 C \nATOM 250 CG ASP A 31 -18.690 9.227 -15.119 1.00 93.00 C \nANISOU 250 CG ASP A 31 11173 10594 13568 -1433 -361 -145 C \nATOM 251 OD1 ASP A 31 -17.951 8.242 -15.288 1.00 94.87 O \nANISOU 251 OD1 ASP A 31 11433 10809 13804 -1371 -347 -130 O \nATOM 252 OD2 ASP A 31 -19.605 9.497 -15.931 1.00 99.73 O \nANISOU 252 OD2 ASP A 31 12042 11436 14413 -1453 -326 -172 O \nATOM 253 N ILE A 32 -15.245 10.075 -14.962 1.00 75.45 N \nANISOU 253 N ILE A 32 8785 8415 11468 -1322 -508 -73 N \nATOM 254 CA ILE A 32 -14.377 10.658 -15.991 1.00 74.12 C \nANISOU 254 CA ILE A 32 8558 8247 11360 -1265 -538 -69 C \nATOM 255 C ILE A 32 -14.773 10.230 -17.430 1.00 76.04 C \nANISOU 255 C ILE A 32 8819 8464 11610 -1223 -482 -94 C \nATOM 256 O ILE A 32 -14.445 10.904 -18.378 1.00 68.42 O \nANISOU 256 O ILE A 32 7805 7500 10690 -1189 -498 -101 O \nATOM 257 CB ILE A 32 -12.895 10.327 -15.708 1.00 75.54 C \nANISOU 257 CB ILE A 32 8719 8425 11558 -1227 -580 -35 C \nATOM 258 CG1 ILE A 32 -12.683 8.809 -15.488 1.00 68.92 C \nANISOU 258 CG1 ILE A 32 7939 7574 10675 -1209 -537 -27 C \nATOM 259 CG2 ILE A 32 -12.409 11.140 -14.514 1.00 75.50 C \nANISOU 259 CG2 ILE A 32 8680 8446 11561 -1264 -649 -10 C \nATOM 260 CD1 ILE A 32 -11.248 8.427 -15.200 1.00 60.33 C \nANISOU 260 CD1 ILE A 32 6833 6496 9595 -1183 -576 6 C \nATOM 261 N LEU A 33 -15.471 9.099 -17.574 1.00 79.05 N \nANISOU 261 N LEU A 33 9274 8819 11944 -1221 -417 -107 N \nATOM 262 CA LEU A 33 -16.041 8.666 -18.865 1.00 78.69 C \nANISOU 262 CA LEU A 33 9258 8746 11895 -1188 -359 -130 C \nATOM 263 C LEU A 33 -17.236 9.488 -19.363 1.00 76.79 C \nANISOU 263 C LEU A 33 9015 8510 11654 -1234 -340 -161 C \nATOM 264 O LEU A 33 -18.322 9.467 -18.781 1.00 84.27 O \nANISOU 264 O LEU A 33 10009 9454 12555 -1297 -315 -175 O \nATOM 265 CB LEU A 33 -16.472 7.203 -18.771 1.00 82.59 C \nANISOU 265 CB LEU A 33 9842 9210 12330 -1169 -297 -133 C \nATOM 266 CG LEU A 33 -17.046 6.563 -20.028 1.00 79.39 C \nANISOU 266 CG LEU A 33 9482 8772 11911 -1128 -234 -154 C \nATOM 267 CD1 LEU A 33 -15.972 6.375 -21.053 1.00 81.35 C \nANISOU 267 CD1 LEU A 33 9684 9026 12201 -1056 -244 -143 C \nATOM 268 CD2 LEU A 33 -17.684 5.229 -19.723 1.00 84.77 C \nANISOU 268 CD2 LEU A 33 10263 9422 12522 -1115 -173 -158 C \nATOM 269 N GLU A 34 -17.043 10.208 -20.456 1.00 80.36 N \nANISOU 269 N GLU A 34 9412 8971 12151 -1206 -350 -172 N \nATOM 270 CA GLU A 34 -18.134 11.013 -21.053 1.00 79.29 C \nANISOU 270 CA GLU A 34 9263 8849 12012 -1249 -331 -203 C \nATOM 271 C GLU A 34 -19.016 10.144 -21.933 1.00 71.49 C \nANISOU 271 C GLU A 34 8353 7822 10989 -1243 -257 -224 C \nATOM 272 O GLU A 34 -18.512 9.332 -22.684 1.00 70.67 O \nANISOU 272 O GLU A 34 8269 7690 10892 -1178 -232 -218 O \nATOM 273 CB GLU A 34 -17.573 12.160 -21.867 1.00 83.60 C \nANISOU 273 CB GLU A 34 9719 9427 12619 -1216 -372 -208 C \nATOM 274 CG GLU A 34 -18.629 12.969 -22.589 1.00 88.35 C \nANISOU 274 CG GLU A 34 10298 10054 13216 -1256 -351 -240 C \nATOM 275 CD GLU A 34 -19.625 13.568 -21.630 1.00 97.59 C \nANISOU 275 CD GLU A 34 11471 11263 14347 -1346 -358 -249 C \nATOM 276 OE1 GLU A 34 -19.155 14.120 -20.612 1.00108.34 O \nANISOU 276 OE1 GLU A 34 12791 12655 15719 -1359 -412 -230 O \nATOM 277 OE2 GLU A 34 -20.847 13.494 -21.895 1.00 89.27 O \nANISOU 277 OE2 GLU A 34 10460 10209 13249 -1405 -312 -274 O \nATOM 278 N LYS A 35 -20.333 10.282 -21.800 1.00 67.54 N \nANISOU 278 N LYS A 35 7900 7319 10442 -1315 -222 -247 N \nATOM 279 CA LYS A 35 -21.274 9.368 -22.467 1.00 69.50 C \nANISOU 279 CA LYS A 35 8245 7519 10643 -1317 -150 -265 C \nATOM 280 C LYS A 35 -22.376 10.046 -23.293 1.00 73.33 C \nANISOU 280 C LYS A 35 8733 8016 11115 -1372 -122 -296 C \nATOM 281 O LYS A 35 -23.183 9.372 -23.906 1.00 70.62 O \nANISOU 281 O LYS A 35 8473 7629 10731 -1379 -64 -311 O \nATOM 282 CB LYS A 35 -21.912 8.457 -21.430 1.00 70.11 C \nANISOU 282 CB LYS A 35 8424 7563 10653 -1354 -117 -263 C \nATOM 283 CG LYS A 35 -20.991 7.367 -20.906 1.00 73.32 C \nANISOU 283 CG LYS A 35 8856 7949 11054 -1287 -119 -237 C \nATOM 284 CD LYS A 35 -21.526 6.714 -19.630 1.00 73.99 C \nANISOU 284 CD LYS A 35 9022 8016 11076 -1329 -101 -234 C \nATOM 285 CE LYS A 35 -21.395 7.669 -18.447 1.00 72.43 C \nANISOU 285 CE LYS A 35 8766 7865 10889 -1397 -159 -225 C \nATOM 286 NZ LYS A 35 -22.093 7.167 -17.251 1.00 74.90 N \nANISOU 286 NZ LYS A 35 9159 8161 11136 -1454 -139 -228 N \nATOM 287 N THR A 36 -22.395 11.372 -23.324 1.00 74.68 N \nANISOU 287 N THR A 36 8811 8246 11316 -1409 -165 -305 N \nATOM 288 CA THR A 36 -23.493 12.089 -23.928 1.00 76.50 C \nANISOU 288 CA THR A 36 9035 8505 11525 -1477 -142 -334 C \nATOM 289 C THR A 36 -23.035 12.889 -25.111 1.00 82.70 C \nANISOU 289 C THR A 36 9730 9327 12366 -1432 -161 -344 C \nATOM 290 O THR A 36 -21.958 13.471 -25.078 1.00 93.31 O \nANISOU 290 O THR A 36 10987 10700 13767 -1376 -214 -330 O \nATOM 291 CB THR A 36 -24.144 13.059 -22.906 1.00 80.83 C \nANISOU 291 CB THR A 36 9551 9115 12048 -1574 -172 -341 C \nATOM 292 OG1 THR A 36 -24.238 12.422 -21.629 1.00 87.60 O \nANISOU 292 OG1 THR A 36 10472 9946 12866 -1604 -172 -326 O \nATOM 293 CG2 THR A 36 -25.542 13.476 -23.349 1.00 83.00 C \nANISOU 293 CG2 THR A 36 9854 9411 12269 -1669 -133 -373 C \nATOM 294 N HIS A 37 -23.878 12.976 -26.138 1.00 84.03 N \nANISOU 294 N HIS A 37 9920 9493 12514 -1459 -118 -369 N \nATOM 295 CA HIS A 37 -23.609 13.834 -27.293 1.00 75.86 C \nANISOU 295 CA HIS A 37 8798 8502 11525 -1428 -132 -384 C \nATOM 296 C HIS A 37 -24.861 14.506 -27.773 1.00 77.47 C \nANISOU 296 C HIS A 37 8998 8749 11687 -1516 -105 -416 C \nATOM 297 O HIS A 37 -25.951 14.001 -27.542 1.00 78.25 O \nANISOU 297 O HIS A 37 9192 8819 11720 -1592 -59 -426 O \nATOM 298 CB HIS A 37 -23.006 13.001 -28.410 1.00 74.18 C \nANISOU 298 CB HIS A 37 8611 8236 11339 -1340 -104 -380 C \nATOM 299 CG HIS A 37 -23.886 11.903 -28.906 1.00 67.63 C \nANISOU 299 CG HIS A 37 7900 7343 10454 -1358 -33 -388 C \nATOM 300 ND1 HIS A 37 -24.626 12.019 -30.058 1.00 65.45 N \nANISOU 300 ND1 HIS A 37 7641 7067 10161 -1380 7 -411 N \nATOM 301 CD2 HIS A 37 -24.086 10.648 -28.453 1.00 68.45 C \nANISOU 301 CD2 HIS A 37 8113 7381 10515 -1346 4 -375 C \nATOM 302 CE1 HIS A 37 -25.256 10.887 -30.288 1.00 69.90 C \nANISOU 302 CE1 HIS A 37 8325 7561 10673 -1382 65 -411 C \nATOM 303 NE2 HIS A 37 -24.957 10.038 -29.319 1.00 72.47 N \nANISOU 303 NE2 HIS A 37 8709 7847 10981 -1359 65 -390 N \nATOM 304 N ASN A 38 -24.707 15.620 -28.485 1.00 77.50 N \nANISOU 304 N ASN A 38 8899 8823 11727 -1506 -131 -431 N \nATOM 305 CA ASN A 38 -25.862 16.434 -28.905 1.00 72.29 C \nANISOU 305 CA ASN A 38 8214 8228 11025 -1597 -113 -462 C \nATOM 306 C ASN A 38 -26.577 15.943 -30.158 1.00 76.18 C \nANISOU 306 C ASN A 38 8769 8687 11491 -1613 -51 -482 C \nATOM 307 O ASN A 38 -27.446 16.624 -30.685 1.00 81.37 O \nANISOU 307 O ASN A 38 9400 9402 12116 -1685 -35 -509 O \nATOM 308 CB ASN A 38 -25.448 17.900 -29.073 1.00 70.63 C \nANISOU 308 CB ASN A 38 7860 8121 10856 -1579 -168 -472 C \nATOM 309 CG ASN A 38 -24.809 18.182 -30.401 1.00 71.46 C \nANISOU 309 CG ASN A 38 7905 8233 11014 -1496 -170 -482 C \nATOM 310 OD1 ASN A 38 -24.314 17.278 -31.068 1.00 81.12 O \nANISOU 310 OD1 ASN A 38 9181 9382 12260 -1432 -144 -474 O \nATOM 311 ND2 ASN A 38 -24.802 19.438 -30.790 1.00 65.50 N \nANISOU 311 ND2 ASN A 38 7039 7572 10276 -1494 -200 -501 N \nATOM 312 N GLY A 39 -26.198 14.771 -30.644 1.00 80.17 N \nANISOU 312 N GLY A 39 9352 9104 12004 -1547 -18 -470 N \nATOM 313 CA GLY A 39 -26.871 14.124 -31.773 1.00 73.42 C \nANISOU 313 CA GLY A 39 8575 8203 11118 -1556 44 -484 C \nATOM 314 C GLY A 39 -26.836 14.885 -33.083 1.00 68.53 C \nANISOU 314 C GLY A 39 7875 7636 10527 -1540 44 -505 C \nATOM 315 O GLY A 39 -27.531 14.499 -34.016 1.00 65.38 O \nANISOU 315 O GLY A 39 7536 7210 10094 -1565 94 -520 O \nATOM 316 N LYS A 40 -26.064 15.976 -33.161 1.00 70.71 N \nANISOU 316 N LYS A 40 8020 7987 10860 -1499 -10 -509 N \nATOM 317 CA LYS A 40 -26.062 16.841 -34.364 1.00 71.54 C \nANISOU 317 CA LYS A 40 8038 8155 10989 -1486 -12 -534 C \nATOM 318 C LYS A 40 -24.674 17.036 -34.922 1.00 69.08 C \nANISOU 318 C LYS A 40 7649 7841 10757 -1366 -49 -524 C \nATOM 319 O LYS A 40 -23.710 16.808 -34.233 1.00 92.50 O \nANISOU 319 O LYS A 40 10607 10779 13760 -1307 -85 -500 O \nATOM 320 CB LYS A 40 -26.672 18.222 -34.066 1.00 69.88 C \nANISOU 320 CB LYS A 40 7733 8060 10759 -1562 -40 -556 C \nATOM 321 CG LYS A 40 -28.167 18.213 -33.821 1.00 71.60 C \nANISOU 321 CG LYS A 40 8016 8299 10891 -1699 0 -574 C \nATOM 322 CD LYS A 40 -28.938 17.696 -35.019 1.00 76.80 C \nANISOU 322 CD LYS A 40 8746 8923 11511 -1733 62 -591 C \nATOM 323 CE LYS A 40 -30.018 16.704 -34.599 1.00 82.52 C \nANISOU 323 CE LYS A 40 9626 9571 12158 -1822 115 -588 C \nATOM 324 NZ LYS A 40 -30.670 16.062 -35.785 1.00 89.51 N \nANISOU 324 NZ LYS A 40 10598 10404 13007 -1841 176 -599 N \nATOM 325 N LEU A 41 -24.592 17.480 -36.169 1.00 58.71 N \nANISOU 325 N LEU A 41 6282 6559 9465 -1337 -39 -545 N \nATOM 326 CA LEU A 41 -23.361 17.911 -36.747 1.00 55.01 C \nANISOU 326 CA LEU A 41 5732 6103 9067 -1235 -77 -543 C \nATOM 327 C LEU A 41 -23.252 19.421 -36.554 1.00 60.81 C \nANISOU 327 C LEU A 41 6344 6942 9821 -1238 -127 -561 C \nATOM 328 O LEU A 41 -24.171 20.167 -36.861 1.00 62.15 O \nANISOU 328 O LEU A 41 6471 7188 9954 -1305 -115 -588 O \nATOM 329 CB LEU A 41 -23.277 17.591 -38.238 1.00 51.69 C \nANISOU 329 CB LEU A 41 5318 5662 8659 -1196 -40 -557 C \nATOM 330 CG LEU A 41 -23.409 16.124 -38.644 1.00 53.22 C \nANISOU 330 CG LEU A 41 5629 5763 8831 -1182 13 -542 C \nATOM 331 CD1 LEU A 41 -23.094 15.982 -40.122 1.00 52.82 C \nANISOU 331 CD1 LEU A 41 5561 5705 8803 -1129 37 -554 C \nATOM 332 CD2 LEU A 41 -22.530 15.189 -37.830 1.00 50.58 C \nANISOU 332 CD2 LEU A 41 5343 5360 8514 -1125 -2 -507 C \nATOM 333 N CYS A 42 -22.109 19.857 -36.033 1.00 63.73 N \nANISOU 333 N CYS A 42 6657 7314 10242 -1163 -185 -545 N \nATOM 334 CA CYS A 42 -21.927 21.252 -35.650 1.00 72.51 C \nANISOU 334 CA CYS A 42 7660 8521 11371 -1152 -239 -556 C \nATOM 335 C CYS A 42 -20.688 21.854 -36.263 1.00 68.05 C \nANISOU 335 C CYS A 42 7023 7961 10871 -1042 -280 -559 C \nATOM 336 O CYS A 42 -19.850 21.124 -36.807 1.00 71.39 O \nANISOU 336 O CYS A 42 7486 8310 11329 -978 -271 -547 O \nATOM 337 CB CYS A 42 -21.852 21.351 -34.122 1.00 78.66 C \nANISOU 337 CB CYS A 42 8445 9304 12138 -1180 -277 -532 C \nATOM 338 SG CYS A 42 -23.156 20.469 -33.246 1.00 98.90 S \nANISOU 338 SG CYS A 42 11115 11838 14624 -1305 -230 -525 S \nATOM 339 N ASP A 43 -20.550 23.170 -36.120 1.00 64.35 N \nANISOU 339 N ASP A 43 6454 7582 10413 -1018 -325 -573 N \nATOM 340 CA ASP A 43 -19.313 23.829 -36.516 1.00 75.14 C \nANISOU 340 CA ASP A 43 7761 8949 11840 -907 -372 -574 C \nATOM 341 C ASP A 43 -18.152 23.322 -35.669 1.00 77.96 C \nANISOU 341 C ASP A 43 8164 9226 12233 -854 -411 -536 C \nATOM 342 O ASP A 43 -18.370 22.663 -34.656 1.00 86.10 O \nANISOU 342 O ASP A 43 9252 10221 13242 -903 -408 -511 O \nATOM 343 CB ASP A 43 -19.418 25.329 -36.364 1.00 75.10 C \nANISOU 343 CB ASP A 43 7645 9058 11833 -887 -416 -594 C \nATOM 344 CG ASP A 43 -20.567 25.896 -37.154 1.00 83.21 C \nANISOU 344 CG ASP A 43 8617 10182 12817 -946 -379 -632 C \nATOM 345 OD1 ASP A 43 -21.225 25.087 -37.851 1.00 90.38 O \nANISOU 345 OD1 ASP A 43 9583 11056 13701 -1002 -320 -641 O \nATOM 346 OD2 ASP A 43 -20.808 27.121 -37.094 1.00 78.93 O \nANISOU 346 OD2 ASP A 43 7975 9752 12262 -936 -409 -652 O \nATOM 347 N LEU A 44 -16.931 23.580 -36.123 1.00 78.04 N \nANISOU 347 N LEU A 44 8153 9204 12295 -758 -444 -532 N \nATOM 348 CA LEU A 44 -15.755 23.511 -35.263 1.00 78.33 C \nANISOU 348 CA LEU A 44 8211 9186 12363 -705 -497 -499 C \nATOM 349 C LEU A 44 -15.211 24.913 -35.097 1.00 82.47 C \nANISOU 349 C LEU A 44 8654 9769 12911 -637 -559 -508 C \nATOM 350 O LEU A 44 -14.796 25.536 -36.087 1.00 86.28 O \nANISOU 350 O LEU A 44 9092 10270 13419 -570 -565 -532 O \nATOM 351 CB LEU A 44 -14.636 22.648 -35.861 1.00 78.90 C \nANISOU 351 CB LEU A 44 8339 9168 12472 -648 -491 -485 C \nATOM 352 CG LEU A 44 -14.703 21.125 -35.753 1.00 77.92 C \nANISOU 352 CG LEU A 44 8305 8969 12330 -686 -447 -462 C \nATOM 353 CD1 LEU A 44 -13.431 20.489 -36.324 1.00 60.88 C \nANISOU 353 CD1 LEU A 44 6182 6741 10208 -622 -453 -448 C \nATOM 354 CD2 LEU A 44 -14.914 20.713 -34.304 1.00 79.31 C \nANISOU 354 CD2 LEU A 44 8521 9133 12482 -737 -462 -433 C \nATOM 355 N ASP A 45 -15.145 25.382 -33.853 1.00 80.61 N \nANISOU 355 N ASP A 45 8404 9558 12667 -647 -605 -487 N \nATOM 356 CA ASP A 45 -14.457 26.637 -33.547 1.00 90.22 C \nANISOU 356 CA ASP A 45 9557 10817 13906 -568 -671 -487 C \nATOM 357 C ASP A 45 -14.991 27.748 -34.432 1.00 84.94 C \nANISOU 357 C ASP A 45 8795 10249 13230 -540 -666 -528 C \nATOM 358 O ASP A 45 -14.228 28.421 -35.120 1.00 82.09 O \nANISOU 358 O ASP A 45 8401 9888 12900 -447 -691 -543 O \nATOM 359 CB ASP A 45 -12.936 26.489 -33.759 1.00 97.87 C \nANISOU 359 CB ASP A 45 10566 11696 14924 -478 -707 -469 C \nATOM 360 CG ASP A 45 -12.391 25.143 -33.248 1.00102.52 C \nANISOU 360 CG ASP A 45 11250 12185 15517 -510 -695 -433 C \nATOM 361 OD1 ASP A 45 -12.799 24.701 -32.151 1.00 93.69 O \nANISOU 361 OD1 ASP A 45 10159 11065 14372 -573 -696 -410 O \nATOM 362 OD2 ASP A 45 -11.557 24.540 -33.959 1.00111.66 O \nANISOU 362 OD2 ASP A 45 12452 13273 16702 -473 -684 -430 O \nATOM 363 N GLY A 46 -16.318 27.883 -34.454 1.00 80.99 N \nANISOU 363 N GLY A 46 8259 9832 12682 -624 -630 -549 N \nATOM 364 CA GLY A 46 -17.000 28.913 -35.244 1.00 77.84 C \nANISOU 364 CA GLY A 46 7765 9549 12263 -617 -620 -590 C \nATOM 365 C GLY A 46 -16.930 28.770 -36.753 1.00 80.35 C \nANISOU 365 C GLY A 46 8077 9854 12599 -585 -580 -620 C \nATOM 366 O GLY A 46 -17.320 29.686 -37.481 1.00 81.20 O \nANISOU 366 O GLY A 46 8101 10057 12694 -563 -576 -655 O \nATOM 367 N VAL A 47 -16.414 27.634 -37.228 1.00 85.68 N \nANISOU 367 N VAL A 47 8837 10418 13301 -581 -550 -607 N \nATOM 368 CA VAL A 47 -16.317 27.356 -38.665 1.00 81.17 C \nANISOU 368 CA VAL A 47 8270 9826 12746 -555 -509 -633 C \nATOM 369 C VAL A 47 -17.183 26.174 -39.111 1.00 81.80 C \nANISOU 369 C VAL A 47 8416 9870 12797 -645 -440 -634 C \nATOM 370 O VAL A 47 -16.935 25.028 -38.758 1.00 85.16 O \nANISOU 370 O VAL A 47 8927 10204 13226 -668 -423 -606 O \nATOM 371 CB VAL A 47 -14.858 27.086 -39.093 1.00 82.91 C \nANISOU 371 CB VAL A 47 8531 9950 13021 -458 -534 -621 C \nATOM 372 CG1 VAL A 47 -14.797 26.659 -40.554 1.00 81.30 C \nANISOU 372 CG1 VAL A 47 8338 9722 12829 -442 -487 -645 C \nATOM 373 CG2 VAL A 47 -14.000 28.329 -38.852 1.00 78.85 C \nANISOU 373 CG2 VAL A 47 7961 9467 12533 -358 -600 -625 C \nATOM 374 N LYS A 48 -18.168 26.480 -39.949 1.00 80.05 N \nANISOU 374 N LYS A 48 8151 9721 12542 -691 -399 -668 N \nATOM 375 CA LYS A 48 -19.126 25.503 -40.429 1.00 75.42 C \nANISOU 375 CA LYS A 48 7627 9110 11920 -779 -333 -672 C \nATOM 376 C LYS A 48 -18.426 24.436 -41.261 1.00 74.19 C \nANISOU 376 C LYS A 48 7542 8850 11795 -738 -304 -662 C \nATOM 377 O LYS A 48 -17.330 24.687 -41.793 1.00 79.50 O \nANISOU 377 O LYS A 48 8196 9496 12516 -646 -330 -665 O \nATOM 378 CB LYS A 48 -20.168 26.212 -41.269 1.00 75.07 C \nANISOU 378 CB LYS A 48 7515 9173 11837 -827 -302 -712 C \nATOM 379 CG LYS A 48 -21.390 25.393 -41.642 1.00 80.20 C \nANISOU 379 CG LYS A 48 8227 9814 12433 -937 -236 -719 C \nATOM 380 CD LYS A 48 -22.497 26.277 -42.227 1.00 83.56 C \nANISOU 380 CD LYS A 48 8575 10366 12809 -1002 -214 -757 C \nATOM 381 CE LYS A 48 -23.294 25.513 -43.277 1.00 85.67 C \nANISOU 381 CE LYS A 48 8901 10608 13043 -1069 -147 -771 C \nATOM 382 NZ LYS A 48 -24.031 24.358 -42.693 1.00 87.11 N \nANISOU 382 NZ LYS A 48 9200 10713 13184 -1160 -108 -747 N \nATOM 383 N PRO A 49 -19.024 23.223 -41.332 1.00 61.62 N \nANISOU 383 N PRO A 49 6037 7200 10174 -803 -252 -649 N \nATOM 384 CA PRO A 49 -18.450 22.237 -42.223 1.00 59.03 C \nANISOU 384 CA PRO A 49 5767 6791 9869 -764 -222 -642 C \nATOM 385 C PRO A 49 -19.026 22.326 -43.604 1.00 66.71 C \nANISOU 385 C PRO A 49 6721 7798 10828 -778 -176 -674 C \nATOM 386 O PRO A 49 -19.860 23.188 -43.890 1.00 77.54 O \nANISOU 386 O PRO A 49 8029 9260 12172 -819 -169 -704 O \nATOM 387 CB PRO A 49 -18.859 20.915 -41.604 1.00 58.26 C \nANISOU 387 CB PRO A 49 5774 6622 9742 -819 -188 -612 C \nATOM 388 CG PRO A 49 -20.100 21.221 -40.847 1.00 57.39 C \nANISOU 388 CG PRO A 49 5662 6564 9578 -914 -178 -618 C \nATOM 389 CD PRO A 49 -19.986 22.630 -40.392 1.00 55.42 C \nANISOU 389 CD PRO A 49 5312 6404 9340 -898 -230 -633 C \nATOM 390 N LEU A 50 -18.549 21.456 -44.476 1.00 68.84 N \nANISOU 390 N LEU A 50 7038 8002 11115 -743 -147 -668 N \nATOM 391 CA LEU A 50 -18.998 21.432 -45.843 1.00 69.08 C \nANISOU 391 CA LEU A 50 7058 8057 11134 -752 -104 -696 C \nATOM 392 C LEU A 50 -19.900 20.243 -46.046 1.00 66.84 C \nANISOU 392 C LEU A 50 6867 7726 10804 -821 -43 -684 C \nATOM 393 O LEU A 50 -19.422 19.112 -46.220 1.00 75.30 O \nANISOU 393 O LEU A 50 8009 8717 11883 -792 -24 -660 O \nATOM 394 CB LEU A 50 -17.800 21.354 -46.790 1.00 76.64 C \nANISOU 394 CB LEU A 50 8001 8979 12141 -661 -114 -700 C \nATOM 395 CG LEU A 50 -18.132 21.178 -48.278 1.00 79.56 C \nANISOU 395 CG LEU A 50 8365 9362 12501 -663 -67 -725 C \nATOM 396 CD1 LEU A 50 -18.952 22.336 -48.785 1.00 86.25 C \nANISOU 396 CD1 LEU A 50 9130 10315 13327 -695 -61 -765 C \nATOM 397 CD2 LEU A 50 -16.866 21.073 -49.097 1.00 82.63 C \nANISOU 397 CD2 LEU A 50 8745 9714 12938 -575 -80 -727 C \nATOM 398 N ILE A 51 -21.210 20.469 -46.024 1.00 60.37 N \nANISOU 398 N ILE A 51 6052 6957 9931 -912 -13 -700 N \nATOM 399 CA ILE A 51 -22.155 19.370 -46.220 1.00 57.64 C \nANISOU 399 CA ILE A 51 5808 6560 9533 -980 46 -689 C \nATOM 400 C ILE A 51 -22.488 19.203 -47.681 1.00 62.46 C \nANISOU 400 C ILE A 51 6421 7179 10131 -983 90 -710 C \nATOM 401 O ILE A 51 -23.213 20.007 -48.248 1.00 73.30 O \nANISOU 401 O ILE A 51 7740 8631 11478 -1031 102 -741 O \nATOM 402 CB ILE A 51 -23.437 19.501 -45.391 1.00 62.41 C \nANISOU 402 CB ILE A 51 6444 7195 10075 -1090 61 -691 C \nATOM 403 CG1 ILE A 51 -23.149 19.693 -43.877 1.00 58.48 C \nANISOU 403 CG1 ILE A 51 5941 6694 9586 -1092 16 -670 C \nATOM 404 CG2 ILE A 51 -24.257 18.230 -45.522 1.00 71.53 C \nANISOU 404 CG2 ILE A 51 7726 8274 11177 -1145 119 -676 C \nATOM 405 CD1 ILE A 51 -23.106 21.136 -43.449 1.00 61.05 C \nANISOU 405 CD1 ILE A 51 6151 7123 9922 -1094 -32 -690 C \nATOM 406 N LEU A 52 -21.900 18.189 -48.325 1.00 65.42 N \nANISOU 406 N LEU A 52 6852 7480 10523 -929 112 -693 N \nATOM 407 CA LEU A 52 -22.401 17.737 -49.627 1.00 69.17 C \nANISOU 407 CA LEU A 52 7360 7949 10974 -944 164 -706 C \nATOM 408 C LEU A 52 -23.580 16.832 -49.254 1.00 74.12 C \nANISOU 408 C LEU A 52 8100 8529 11532 -1027 210 -690 C \nATOM 409 O LEU A 52 -23.439 15.896 -48.432 1.00 97.83 O \nANISOU 409 O LEU A 52 11183 11461 14527 -1016 213 -658 O \nATOM 410 CB LEU A 52 -21.342 16.972 -50.422 1.00 67.42 C \nANISOU 410 CB LEU A 52 7155 7671 10789 -856 169 -692 C \nATOM 411 CG LEU A 52 -20.008 17.496 -50.982 1.00 59.80 C \nANISOU 411 CG LEU A 52 6111 6721 9888 -765 132 -702 C \nATOM 412 CD1 LEU A 52 -19.553 18.752 -50.314 1.00 58.22 C \nANISOU 412 CD1 LEU A 52 5822 6576 9722 -745 76 -717 C \nATOM 413 CD2 LEU A 52 -18.932 16.417 -50.862 1.00 56.12 C \nANISOU 413 CD2 LEU A 52 5696 6179 9447 -698 126 -668 C \nATOM 414 N ARG A 53 -24.754 17.116 -49.765 1.00 61.50 N \nANISOU 414 N ARG A 53 6515 6970 9882 -1112 246 -712 N \nATOM 415 CA ARG A 53 -25.904 16.483 -49.168 1.00 65.20 C \nANISOU 415 CA ARG A 53 7091 7399 10282 -1201 281 -699 C \nATOM 416 C ARG A 53 -26.061 15.103 -49.751 1.00 58.81 C \nANISOU 416 C ARG A 53 6401 6498 9446 -1180 330 -677 C \nATOM 417 O ARG A 53 -25.913 14.135 -49.039 1.00 59.12 O \nANISOU 417 O ARG A 53 6524 6464 9477 -1156 336 -647 O \nATOM 418 CB ARG A 53 -27.208 17.358 -49.191 1.00 67.81 C \nANISOU 418 CB ARG A 53 7400 7812 10553 -1323 296 -729 C \nATOM 419 CG ARG A 53 -27.692 17.828 -50.549 1.00 75.18 C \nANISOU 419 CG ARG A 53 8295 8804 11467 -1356 325 -759 C \nATOM 420 CD ARG A 53 -29.047 18.535 -50.458 1.00 71.51 C \nANISOU 420 CD ARG A 53 7824 8417 10930 -1491 343 -784 C \nATOM 421 NE ARG A 53 -28.904 19.857 -49.850 1.00 68.90 N \nANISOU 421 NE ARG A 53 7365 8198 10617 -1503 296 -806 N \nATOM 422 CZ ARG A 53 -29.550 20.276 -48.759 1.00 80.26 C \nANISOU 422 CZ ARG A 53 8802 9677 12016 -1585 281 -806 C \nATOM 423 NH1 ARG A 53 -30.423 19.476 -48.137 1.00 83.18 N \nANISOU 423 NH1 ARG A 53 9299 9979 12325 -1669 313 -789 N \nATOM 424 NH2 ARG A 53 -29.348 21.511 -48.286 1.00 78.88 N \nANISOU 424 NH2 ARG A 53 8500 9614 11858 -1582 236 -825 N \nATOM 425 N ASP A 54 -26.395 15.021 -51.023 1.00 58.64 N \nANISOU 425 N ASP A 54 6386 6486 9407 -1189 365 -691 N \nATOM 426 CA ASP A 54 -26.492 13.744 -51.705 1.00 62.14 C \nANISOU 426 CA ASP A 54 6936 6849 9826 -1157 410 -669 C \nATOM 427 C ASP A 54 -25.403 13.649 -52.750 1.00 59.54 C \nANISOU 427 C ASP A 54 6545 6526 9551 -1061 402 -670 C \nATOM 428 O ASP A 54 -25.379 12.720 -53.534 1.00 59.26 O \nANISOU 428 O ASP A 54 6575 6442 9499 -1026 437 -656 O \nATOM 429 CB ASP A 54 -27.871 13.619 -52.356 1.00 70.55 C \nANISOU 429 CB ASP A 54 8079 7912 10815 -1255 462 -682 C \nATOM 430 CG ASP A 54 -28.905 13.088 -51.396 1.00 81.97 C \nANISOU 430 CG ASP A 54 9646 9304 12193 -1335 485 -668 C \nATOM 431 OD1 ASP A 54 -28.548 12.158 -50.621 1.00 85.96 O \nANISOU 431 OD1 ASP A 54 10224 9735 12702 -1283 484 -638 O \nATOM 432 OD2 ASP A 54 -30.056 13.599 -51.415 1.00 81.82 O \nANISOU 432 OD2 ASP A 54 9650 9320 12115 -1450 505 -688 O \nATOM 433 N CYS A 55 -24.499 14.630 -52.751 1.00 63.62 N \nANISOU 433 N CYS A 55 6940 7104 10130 -1017 356 -688 N \nATOM 434 CA CYS A 55 -23.356 14.654 -53.670 1.00 66.71 C \nANISOU 434 CA CYS A 55 7268 7503 10575 -927 342 -692 C \nATOM 435 C CYS A 55 -22.076 14.034 -53.075 1.00 51.29 C \nANISOU 435 C CYS A 55 5319 5501 8668 -838 311 -662 C \nATOM 436 O CYS A 55 -21.845 14.103 -51.871 1.00 43.03 O \nANISOU 436 O CYS A 55 4275 4443 7633 -838 280 -648 O \nATOM 437 CB CYS A 55 -23.111 16.082 -54.171 1.00 69.45 C \nANISOU 437 CB CYS A 55 7488 7943 10956 -927 313 -731 C \nATOM 438 SG CYS A 55 -24.355 16.544 -55.388 1.00 75.47 S \nANISOU 438 SG CYS A 55 8245 8767 11665 -1012 360 -765 S \nATOM 439 N SER A 56 -21.281 13.416 -53.928 1.00 48.75 N \nANISOU 439 N SER A 56 5000 5156 8368 -769 320 -652 N \nATOM 440 CA SER A 56 -19.962 12.884 -53.526 1.00 55.29 C \nANISOU 440 CA SER A 56 5819 5950 9237 -688 289 -627 C \nATOM 441 C SER A 56 -18.857 13.821 -53.895 1.00 54.32 C \nANISOU 441 C SER A 56 5595 5870 9175 -638 246 -648 C \nATOM 442 O SER A 56 -19.063 14.761 -54.676 1.00 69.05 O \nANISOU 442 O SER A 56 7395 7788 11051 -652 246 -682 O \nATOM 443 CB SER A 56 -19.706 11.553 -54.217 1.00 57.07 C \nANISOU 443 CB SER A 56 6112 6130 9441 -641 326 -602 C \nATOM 444 OG SER A 56 -19.485 11.769 -55.598 1.00 61.85 O \nANISOU 444 OG SER A 56 6677 6764 10059 -621 341 -621 O \nATOM 445 N VAL A 57 -17.659 13.545 -53.396 1.00 53.50 N \nANISOU 445 N VAL A 57 5479 5740 9107 -579 211 -628 N \nATOM 446 CA VAL A 57 -16.497 14.440 -53.674 1.00 46.53 C \nANISOU 446 CA VAL A 57 4512 4886 8282 -528 165 -646 C \nATOM 447 C VAL A 57 -16.218 14.582 -55.159 1.00 43.40 C \nANISOU 447 C VAL A 57 4081 4513 7896 -501 185 -669 C \nATOM 448 O VAL A 57 -15.962 15.704 -55.697 1.00 48.93 O \nANISOU 448 O VAL A 57 4706 5259 8626 -488 165 -703 O \nATOM 449 CB VAL A 57 -15.243 13.968 -52.982 1.00 41.07 C \nANISOU 449 CB VAL A 57 3829 4157 7617 -477 129 -617 C \nATOM 450 CG1 VAL A 57 -14.052 14.726 -53.467 1.00 37.55 C \nANISOU 450 CG1 VAL A 57 3319 3728 7222 -426 90 -635 C \nATOM 451 CG2 VAL A 57 -15.362 14.159 -51.482 1.00 41.39 C \nANISOU 451 CG2 VAL A 57 3882 4186 7658 -501 97 -601 C \nATOM 452 N ALA A 58 -16.395 13.486 -55.871 1.00 37.79 N \nANISOU 452 N ALA A 58 3427 3776 7155 -495 228 -652 N \nATOM 453 CA ALA A 58 -16.213 13.542 -57.316 1.00 34.55 C \nANISOU 453 CA ALA A 58 2989 3389 6749 -475 252 -672 C \nATOM 454 C ALA A 58 -17.304 14.309 -58.014 1.00 35.15 C \nANISOU 454 C ALA A 58 3038 3513 6806 -526 277 -707 C \nATOM 455 O ALA A 58 -17.050 15.226 -58.808 1.00 35.21 O \nANISOU 455 O ALA A 58 2974 3568 6838 -514 267 -741 O \nATOM 456 CB ALA A 58 -16.121 12.161 -57.859 1.00 34.81 C \nANISOU 456 CB ALA A 58 3088 3387 6751 -452 290 -643 C \nATOM 457 N GLY A 59 -18.555 13.934 -57.711 1.00 39.95 N \nANISOU 457 N GLY A 59 3707 4109 7363 -589 311 -698 N \nATOM 458 CA GLY A 59 -19.762 14.736 -58.149 1.00 40.19 C \nANISOU 458 CA GLY A 59 3716 4193 7363 -661 334 -730 C \nATOM 459 C GLY A 59 -19.635 16.235 -57.907 1.00 36.07 C \nANISOU 459 C GLY A 59 3091 3739 6873 -668 294 -767 C \nATOM 460 O GLY A 59 -19.904 17.007 -58.763 1.00 34.26 O \nANISOU 460 O GLY A 59 2804 3570 6643 -682 302 -801 O \nATOM 461 N TRP A 60 -19.089 16.607 -56.778 1.00 35.57 N \nANISOU 461 N TRP A 60 3006 3670 6840 -647 248 -758 N \nATOM 462 CA TRP A 60 -18.862 17.987 -56.443 1.00 37.68 C \nANISOU 462 CA TRP A 60 3180 4000 7137 -638 205 -788 C \nATOM 463 C TRP A 60 -17.751 18.597 -57.247 1.00 43.88 C \nANISOU 463 C TRP A 60 3896 4807 7971 -564 180 -811 C \nATOM 464 O TRP A 60 -17.911 19.695 -57.808 1.00 44.98 O \nANISOU 464 O TRP A 60 3957 5018 8116 -562 173 -850 O \nATOM 465 CB TRP A 60 -18.583 18.143 -54.933 1.00 38.49 C \nANISOU 465 CB TRP A 60 3287 4083 7254 -635 163 -767 C \nATOM 466 CG TRP A 60 -17.886 19.428 -54.558 1.00 39.91 C \nANISOU 466 CG TRP A 60 3376 4309 7476 -591 107 -789 C \nATOM 467 CD1 TRP A 60 -18.181 20.659 -54.988 1.00 43.25 C \nANISOU 467 CD1 TRP A 60 3714 4816 7902 -594 97 -829 C \nATOM 468 CD2 TRP A 60 -16.865 19.584 -53.585 1.00 40.79 C \nANISOU 468 CD2 TRP A 60 3482 4390 7628 -539 55 -771 C \nATOM 469 NE1 TRP A 60 -17.368 21.607 -54.393 1.00 47.19 N \nANISOU 469 NE1 TRP A 60 4152 5337 8440 -537 40 -838 N \nATOM 470 CE2 TRP A 60 -16.514 20.952 -53.559 1.00 43.83 C \nANISOU 470 CE2 TRP A 60 3779 4836 8040 -503 14 -801 C \nATOM 471 CE3 TRP A 60 -16.174 18.698 -52.771 1.00 40.17 C \nANISOU 471 CE3 TRP A 60 3463 4239 7560 -518 39 -732 C \nATOM 472 CZ2 TRP A 60 -15.491 21.441 -52.793 1.00 45.83 C \nANISOU 472 CZ2 TRP A 60 4010 5070 8332 -444 -42 -793 C \nATOM 473 CZ3 TRP A 60 -15.141 19.193 -51.987 1.00 42.54 C \nANISOU 473 CZ3 TRP A 60 3738 4525 7900 -468 -17 -723 C \nATOM 474 CH2 TRP A 60 -14.822 20.543 -51.982 1.00 46.73 C \nANISOU 474 CH2 TRP A 60 4190 5107 8457 -432 -57 -752 C \nATOM 475 N LEU A 61 -16.602 17.904 -57.339 1.00 48.90 N \nANISOU 475 N LEU A 61 4559 5385 8636 -502 168 -789 N \nATOM 476 CA LEU A 61 -15.423 18.539 -58.003 1.00 40.09 C \nANISOU 476 CA LEU A 61 3385 4281 7567 -431 138 -811 C \nATOM 477 C LEU A 61 -15.591 18.569 -59.497 1.00 41.42 C \nANISOU 477 C LEU A 61 3531 4481 7725 -429 175 -838 C \nATOM 478 O LEU A 61 -15.137 19.508 -60.156 1.00 48.33 O \nANISOU 478 O LEU A 61 4340 5398 8626 -391 158 -874 O \nATOM 479 CB LEU A 61 -14.134 17.859 -57.620 1.00 37.98 C \nANISOU 479 CB LEU A 61 3154 3950 7328 -378 111 -781 C \nATOM 480 CG LEU A 61 -13.656 18.042 -56.195 1.00 38.55 C \nANISOU 480 CG LEU A 61 3234 3995 7419 -366 64 -759 C \nATOM 481 CD1 LEU A 61 -12.352 17.277 -55.993 1.00 36.18 C \nANISOU 481 CD1 LEU A 61 2972 3636 7140 -322 42 -730 C \nATOM 482 CD2 LEU A 61 -13.418 19.506 -55.895 1.00 40.12 C \nANISOU 482 CD2 LEU A 61 3359 4238 7647 -339 18 -790 C \nATOM 483 N LEU A 62 -16.257 17.586 -60.054 1.00 38.39 N \nANISOU 483 N LEU A 62 3204 4078 7303 -466 224 -822 N \nATOM 484 CA LEU A 62 -16.453 17.599 -61.526 1.00 46.23 C \nANISOU 484 CA LEU A 62 4178 5103 8284 -467 260 -847 C \nATOM 485 C LEU A 62 -17.711 18.361 -61.959 1.00 49.07 C \nANISOU 485 C LEU A 62 4501 5534 8609 -532 286 -879 C \nATOM 486 O LEU A 62 -18.012 18.434 -63.134 1.00 43.42 O \nANISOU 486 O LEU A 62 3768 4853 7878 -543 317 -901 O \nATOM 487 CB LEU A 62 -16.533 16.146 -62.040 1.00 43.82 C \nANISOU 487 CB LEU A 62 3953 4747 7949 -471 303 -813 C \nATOM 488 CG LEU A 62 -15.344 15.266 -61.807 1.00 39.28 C \nANISOU 488 CG LEU A 62 3412 4118 7396 -414 286 -781 C \nATOM 489 CD1 LEU A 62 -15.693 13.855 -62.132 1.00 37.53 C \nANISOU 489 CD1 LEU A 62 3269 3859 7133 -422 329 -745 C \nATOM 490 CD2 LEU A 62 -14.217 15.752 -62.677 1.00 40.11 C \nANISOU 490 CD2 LEU A 62 3463 4240 7539 -361 266 -805 C \nATOM 491 N GLY A 63 -18.507 18.798 -60.985 1.00 55.29 N \nANISOU 491 N GLY A 63 5285 6344 9378 -582 276 -879 N \nATOM 492 CA GLY A 63 -19.691 19.594 -61.247 1.00 57.27 C \nANISOU 492 CA GLY A 63 5495 6674 9590 -653 295 -910 C \nATOM 493 C GLY A 63 -20.864 18.800 -61.780 1.00 60.84 C \nANISOU 493 C GLY A 63 6021 7114 9982 -731 352 -899 C \nATOM 494 O GLY A 63 -21.524 19.213 -62.722 1.00 57.30 O \nANISOU 494 O GLY A 63 5542 6725 9505 -773 381 -927 O \nATOM 495 N ASN A 64 -21.126 17.640 -61.200 1.00 64.41 N \nANISOU 495 N ASN A 64 6573 7489 10411 -749 370 -857 N \nATOM 496 CA ASN A 64 -22.343 16.908 -61.536 1.00 65.85 C \nANISOU 496 CA ASN A 64 6842 7651 10528 -826 423 -845 C \nATOM 497 C ASN A 64 -23.518 17.905 -61.430 1.00 63.41 C \nANISOU 497 C ASN A 64 6493 7423 10178 -920 430 -876 C \nATOM 498 O ASN A 64 -23.653 18.558 -60.416 1.00 57.59 O \nANISOU 498 O ASN A 64 5720 6715 9446 -941 400 -881 O \nATOM 499 CB ASN A 64 -22.525 15.722 -60.567 1.00 64.44 C \nANISOU 499 CB ASN A 64 6773 7383 10327 -830 432 -799 C \nATOM 500 CG ASN A 64 -23.807 14.929 -60.810 1.00 61.36 C \nANISOU 500 CG ASN A 64 6492 6959 9865 -906 485 -784 C \nATOM 501 OD1 ASN A 64 -24.886 15.481 -60.867 1.00 67.28 O \nANISOU 501 OD1 ASN A 64 7241 7752 10570 -994 503 -804 O \nATOM 502 ND2 ASN A 64 -23.688 13.616 -60.889 1.00 59.44 N \nANISOU 502 ND2 ASN A 64 6345 6637 9603 -871 511 -747 N \nATOM 503 N PRO A 65 -24.392 17.959 -62.454 1.00 62.05 N \nANISOU 503 N PRO A 65 6330 7287 9958 -982 472 -894 N \nATOM 504 CA PRO A 65 -25.502 18.895 -62.597 1.00 66.49 C \nANISOU 504 CA PRO A 65 6849 7942 10473 -1080 484 -927 C \nATOM 505 C PRO A 65 -26.459 18.999 -61.403 1.00 71.44 C \nANISOU 505 C PRO A 65 7519 8571 11055 -1168 482 -917 C \nATOM 506 O PRO A 65 -27.139 20.026 -61.227 1.00 77.49 O \nANISOU 506 O PRO A 65 8217 9434 11792 -1239 475 -947 O \nATOM 507 CB PRO A 65 -26.262 18.365 -63.803 1.00 64.14 C \nANISOU 507 CB PRO A 65 6609 7639 10123 -1134 538 -928 C \nATOM 508 CG PRO A 65 -25.269 17.642 -64.599 1.00 59.21 C \nANISOU 508 CG PRO A 65 5999 6961 9538 -1040 543 -914 C \nATOM 509 CD PRO A 65 -24.352 17.013 -63.580 1.00 62.75 C \nANISOU 509 CD PRO A 65 6480 7331 10031 -964 512 -880 C \nATOM 510 N MET A 66 -26.484 17.963 -60.576 1.00 69.01 N \nANISOU 510 N MET A 66 7316 8164 10739 -1163 487 -877 N \nATOM 511 CA MET A 66 -27.332 17.927 -59.396 1.00 68.48 C \nANISOU 511 CA MET A 66 7305 8085 10630 -1242 487 -865 C \nATOM 512 C MET A 66 -26.619 18.425 -58.159 1.00 63.34 C \nANISOU 512 C MET A 66 6596 7444 10027 -1196 433 -860 C \nATOM 513 O MET A 66 -27.161 18.448 -57.076 1.00 72.96 O \nANISOU 513 O MET A 66 7848 8654 11218 -1252 425 -850 O \nATOM 514 CB MET A 66 -27.857 16.510 -59.222 1.00 76.72 C \nANISOU 514 CB MET A 66 8506 9016 11629 -1264 526 -825 C \nATOM 515 CG MET A 66 -28.580 16.047 -60.507 1.00 89.60 C \nANISOU 515 CG MET A 66 10199 10637 13207 -1309 579 -829 C \nATOM 516 SD MET A 66 -29.726 14.671 -60.333 1.00115.98 S \nANISOU 516 SD MET A 66 13738 13867 16463 -1375 633 -792 S \nATOM 517 CE MET A 66 -28.601 13.265 -60.559 1.00123.35 C \nANISOU 517 CE MET A 66 14733 14696 17439 -1234 637 -750 C \nATOM 518 N CYS A 67 -25.399 18.888 -58.337 1.00 67.35 N \nANISOU 518 N CYS A 67 7014 7971 10604 -1096 395 -870 N \nATOM 519 CA CYS A 67 -24.544 19.340 -57.244 1.00 60.23 C \nANISOU 519 CA CYS A 67 6061 7070 9754 -1038 341 -863 C \nATOM 520 C CYS A 67 -24.310 20.848 -57.347 1.00 57.63 C \nANISOU 520 C CYS A 67 5594 6855 9449 -1022 304 -904 C \nATOM 521 O CYS A 67 -23.505 21.409 -56.611 1.00 51.53 O \nANISOU 521 O CYS A 67 4764 6094 8722 -961 255 -903 O \nATOM 522 CB CYS A 67 -23.203 18.558 -57.303 1.00 56.76 C \nANISOU 522 CB CYS A 67 5645 6549 9373 -928 324 -836 C \nATOM 523 SG CYS A 67 -23.372 16.755 -57.128 1.00 61.86 S \nANISOU 523 SG CYS A 67 6444 7073 9989 -927 364 -787 S \nATOM 524 N ASP A 68 -25.075 21.494 -58.208 1.00 63.28 N \nANISOU 524 N ASP A 68 6260 7658 10126 -1080 329 -937 N \nATOM 525 CA ASP A 68 -24.951 22.949 -58.428 1.00 71.76 C \nANISOU 525 CA ASP A 68 7198 8857 11212 -1064 299 -980 C \nATOM 526 C ASP A 68 -24.867 23.823 -57.188 1.00 73.29 C \nANISOU 526 C ASP A 68 7327 9104 11415 -1059 251 -984 C \nATOM 527 O ASP A 68 -24.252 24.884 -57.230 1.00 70.50 O \nANISOU 527 O ASP A 68 6867 8824 11095 -992 212 -1010 O \nATOM 528 CB ASP A 68 -26.072 23.456 -59.321 1.00 78.87 C \nANISOU 528 CB ASP A 68 8063 9853 12049 -1157 337 -1013 C \nATOM 529 CG ASP A 68 -25.696 23.425 -60.779 1.00 79.49 C \nANISOU 529 CG ASP A 68 8116 9943 12143 -1114 360 -1034 C \nATOM 530 OD1 ASP A 68 -26.067 22.445 -61.464 1.00 82.21 O \nANISOU 530 OD1 ASP A 68 8551 10224 12462 -1148 404 -1017 O \nATOM 531 OD2 ASP A 68 -25.030 24.381 -61.235 1.00 84.84 O \nANISOU 531 OD2 ASP A 68 8685 10694 12856 -1043 333 -1067 O \nATOM 532 N GLU A 69 -25.471 23.390 -56.089 1.00 75.05 N \nANISOU 532 N GLU A 69 7617 9292 11607 -1126 252 -958 N \nATOM 533 CA GLU A 69 -25.389 24.161 -54.852 1.00 72.76 C \nANISOU 533 CA GLU A 69 7270 9051 11324 -1124 205 -957 C \nATOM 534 C GLU A 69 -23.984 24.298 -54.315 1.00 76.33 C \nANISOU 534 C GLU A 69 7694 9457 11852 -1001 153 -943 C \nATOM 535 O GLU A 69 -23.748 24.997 -53.324 1.00 67.01 O \nANISOU 535 O GLU A 69 6461 8315 10684 -981 108 -942 O \nATOM 536 CB GLU A 69 -26.291 23.555 -53.780 1.00 76.02 C \nANISOU 536 CB GLU A 69 7774 9424 11687 -1223 220 -930 C \nATOM 537 CG GLU A 69 -26.120 22.077 -53.535 1.00 80.19 C \nANISOU 537 CG GLU A 69 8439 9808 12221 -1213 244 -889 C \nATOM 538 CD GLU A 69 -26.988 21.568 -52.387 1.00 92.21 C \nANISOU 538 CD GLU A 69 10049 11293 13692 -1305 255 -865 C \nATOM 539 OE1 GLU A 69 -26.997 22.190 -51.276 1.00 74.16 O \nANISOU 539 OE1 GLU A 69 7719 9051 11407 -1319 217 -864 O \nATOM 540 OE2 GLU A 69 -27.677 20.542 -52.629 1.00101.36 O \nANISOU 540 OE2 GLU A 69 11326 12379 14806 -1361 302 -849 O \nATOM 541 N PHE A 70 -23.049 23.572 -54.936 1.00 86.21 N \nANISOU 541 N PHE A 70 8986 10620 13148 -922 158 -930 N \nATOM 542 CA PHE A 70 -21.640 23.551 -54.480 1.00 80.85 C \nANISOU 542 CA PHE A 70 8299 9883 12538 -812 111 -913 C \nATOM 543 C PHE A 70 -20.744 24.076 -55.582 1.00 83.94 C \nANISOU 543 C PHE A 70 8626 10296 12970 -723 101 -941 C \nATOM 544 O PHE A 70 -19.545 23.751 -55.638 1.00 83.07 O \nANISOU 544 O PHE A 70 8534 10116 12911 -638 78 -927 O \nATOM 545 CB PHE A 70 -21.199 22.138 -54.045 1.00 76.85 C \nANISOU 545 CB PHE A 70 7905 9248 12044 -798 122 -868 C \nATOM 546 CG PHE A 70 -22.178 21.449 -53.123 1.00 67.09 C \nANISOU 546 CG PHE A 70 6752 7979 10759 -888 144 -842 C \nATOM 547 CD1 PHE A 70 -22.380 21.920 -51.816 1.00 60.56 C \nANISOU 547 CD1 PHE A 70 5908 7178 9926 -915 110 -833 C \nATOM 548 CD2 PHE A 70 -22.911 20.339 -53.573 1.00 62.31 C \nANISOU 548 CD2 PHE A 70 6246 7318 10111 -944 198 -826 C \nATOM 549 CE1 PHE A 70 -23.282 21.281 -50.950 1.00 59.80 C \nANISOU 549 CE1 PHE A 70 5893 7049 9781 -1000 130 -811 C \nATOM 550 CE2 PHE A 70 -23.829 19.717 -52.734 1.00 62.29 C \nANISOU 550 CE2 PHE A 70 6329 7280 10059 -1024 220 -805 C \nATOM 551 CZ PHE A 70 -24.012 20.194 -51.412 1.00 61.54 C \nANISOU 551 CZ PHE A 70 6216 7210 9958 -1055 186 -798 C \nATOM 552 N ILE A 71 -21.338 24.894 -56.455 1.00 84.95 N \nANISOU 552 N ILE A 71 8680 10526 13072 -749 118 -981 N \nATOM 553 CA ILE A 71 -20.616 25.476 -57.554 1.00 83.54 C \nANISOU 553 CA ILE A 71 8436 10381 12926 -671 112 -1014 C \nATOM 554 C ILE A 71 -19.511 26.413 -57.019 1.00 87.10 C \nANISOU 554 C ILE A 71 8822 10846 13426 -565 50 -1023 C \nATOM 555 O ILE A 71 -18.471 26.531 -57.640 1.00 89.58 O \nANISOU 555 O ILE A 71 9124 11129 13783 -478 35 -1033 O \nATOM 556 CB ILE A 71 -21.547 26.221 -58.538 1.00 88.90 C \nANISOU 556 CB ILE A 71 9041 11178 13558 -724 143 -1057 C \nATOM 557 CG1 ILE A 71 -20.799 26.598 -59.818 1.00 89.04 C \nANISOU 557 CG1 ILE A 71 9010 11216 13607 -644 146 -1089 C \nATOM 558 CG2 ILE A 71 -22.101 27.495 -57.900 1.00 97.13 C \nANISOU 558 CG2 ILE A 71 9985 12348 14573 -747 115 -1082 C \nATOM 559 CD1 ILE A 71 -21.714 27.062 -60.938 1.00 90.94 C \nANISOU 559 CD1 ILE A 71 9195 11560 13799 -704 187 -1128 C \nATOM 560 N ASN A 72 -19.731 27.076 -55.882 1.00 84.62 N \nANISOU 560 N ASN A 72 8470 10578 13104 -574 14 -1019 N \nATOM 561 CA ASN A 72 -18.723 27.999 -55.326 1.00 86.61 C \nANISOU 561 CA ASN A 72 8667 10843 13399 -471 -47 -1025 C \nATOM 562 C ASN A 72 -18.814 28.141 -53.823 1.00 86.19 C \nANISOU 562 C ASN A 72 8622 10785 13343 -488 -85 -998 C \nATOM 563 O ASN A 72 -19.201 29.163 -53.284 1.00 93.92 O \nANISOU 563 O ASN A 72 9522 11862 14300 -490 -112 -1014 O \nATOM 564 CB ASN A 72 -18.747 29.346 -56.042 1.00 86.21 C \nANISOU 564 CB ASN A 72 8500 10914 13342 -420 -59 -1076 C \nATOM 565 CG ASN A 72 -17.529 29.538 -56.907 1.00 89.59 C \nANISOU 565 CG ASN A 72 8923 11300 13819 -309 -73 -1094 C \nATOM 566 OD1 ASN A 72 -16.387 29.457 -56.430 1.00108.30 O \nANISOU 566 OD1 ASN A 72 11329 13587 16234 -230 -113 -1075 O \nATOM 567 ND2 ASN A 72 -17.746 29.779 -58.183 1.00 91.89 N \nANISOU 567 ND2 ASN A 72 9173 11644 14096 -307 -41 -1130 N \nATOM 568 N VAL A 73 -18.441 27.060 -53.164 1.00 89.20 N \nANISOU 568 N VAL A 73 9098 11052 13741 -500 -86 -955 N \nATOM 569 CA VAL A 73 -18.497 26.981 -51.722 1.00 82.56 C \nANISOU 569 CA VAL A 73 8282 10190 12897 -522 -118 -923 C \nATOM 570 C VAL A 73 -17.414 27.870 -51.081 1.00 78.32 C \nANISOU 570 C VAL A 73 7700 9655 12401 -420 -184 -923 C \nATOM 571 O VAL A 73 -16.406 28.180 -51.711 1.00 67.51 O \nANISOU 571 O VAL A 73 6318 8261 11072 -328 -203 -937 O \nATOM 572 CB VAL A 73 -18.356 25.509 -51.233 1.00 80.74 C \nANISOU 572 CB VAL A 73 8168 9837 12670 -558 -98 -878 C \nATOM 573 CG1 VAL A 73 -19.461 24.637 -51.808 1.00 82.94 C \nANISOU 573 CG1 VAL A 73 8502 10108 12902 -653 -34 -877 C \nATOM 574 CG2 VAL A 73 -16.980 24.925 -51.553 1.00 77.31 C \nANISOU 574 CG2 VAL A 73 7780 9304 12288 -473 -114 -861 C \nATOM 575 N PRO A 74 -17.608 28.234 -49.807 1.00 80.98 N \nANISOU 575 N PRO A 74 8024 10016 12728 -437 -219 -905 N \nATOM 576 CA PRO A 74 -16.606 28.931 -49.020 1.00 80.10 C \nANISOU 576 CA PRO A 74 7891 9892 12652 -346 -284 -895 C \nATOM 577 C PRO A 74 -15.875 28.016 -48.073 1.00 82.69 C \nANISOU 577 C PRO A 74 8310 10102 13007 -342 -305 -848 C \nATOM 578 O PRO A 74 -16.063 26.807 -48.114 1.00 84.95 O \nANISOU 578 O PRO A 74 8676 10316 13287 -398 -268 -825 O \nATOM 579 CB PRO A 74 -17.440 29.944 -48.232 1.00 86.45 C \nANISOU 579 CB PRO A 74 8614 10817 13418 -379 -306 -906 C \nATOM 580 CG PRO A 74 -18.780 29.303 -48.071 1.00 86.55 C \nANISOU 580 CG PRO A 74 8653 10855 13376 -512 -257 -900 C \nATOM 581 CD PRO A 74 -18.918 28.233 -49.131 1.00 87.25 C \nANISOU 581 CD PRO A 74 8810 10875 13466 -547 -200 -901 C \nATOM 582 N GLU A 75 -15.036 28.608 -47.227 1.00 86.70 N \nANISOU 582 N GLU A 75 8807 10594 13541 -273 -364 -834 N \nATOM 583 CA GLU A 75 -14.145 27.856 -46.345 1.00 84.61 C \nANISOU 583 CA GLU A 75 8624 10219 13303 -258 -392 -791 C \nATOM 584 C GLU A 75 -14.887 26.882 -45.439 1.00 83.01 C \nANISOU 584 C GLU A 75 8479 9988 13072 -357 -369 -758 C \nATOM 585 O GLU A 75 -16.029 27.120 -45.089 1.00 97.18 O \nANISOU 585 O GLU A 75 10241 11857 14825 -429 -352 -765 O \nATOM 586 CB GLU A 75 -13.347 28.846 -45.518 1.00 83.48 C \nANISOU 586 CB GLU A 75 8451 10086 13182 -178 -461 -784 C \nATOM 587 CG GLU A 75 -12.353 28.219 -44.565 1.00 91.48 C \nANISOU 587 CG GLU A 75 9544 10993 14220 -160 -497 -739 C \nATOM 588 CD GLU A 75 -11.513 29.261 -43.857 1.00101.19 C \nANISOU 588 CD GLU A 75 10751 12227 15470 -73 -567 -734 C \nATOM 589 OE1 GLU A 75 -11.516 30.439 -44.299 1.00 98.84 O \nANISOU 589 OE1 GLU A 75 10380 12004 15172 -5 -586 -767 O \nATOM 590 OE2 GLU A 75 -10.836 28.878 -42.868 1.00116.84 O \nANISOU 590 OE2 GLU A 75 12791 14137 17464 -71 -602 -695 O \nATOM 591 N TRP A 76 -14.224 25.795 -45.041 1.00 75.90 N \nANISOU 591 N TRP A 76 7665 8984 12189 -360 -369 -721 N \nATOM 592 CA TRP A 76 -14.864 24.777 -44.210 1.00 70.83 C \nANISOU 592 CA TRP A 76 7087 8308 11519 -445 -345 -690 C \nATOM 593 C TRP A 76 -13.942 24.139 -43.166 1.00 74.52 C \nANISOU 593 C TRP A 76 7619 8691 12007 -427 -379 -648 C \nATOM 594 O TRP A 76 -12.735 24.073 -43.350 1.00 84.77 O \nANISOU 594 O TRP A 76 8938 9932 13340 -361 -407 -638 O \nATOM 595 CB TRP A 76 -15.477 23.674 -45.091 1.00 70.33 C \nANISOU 595 CB TRP A 76 7075 8214 11434 -498 -277 -693 C \nATOM 596 CG TRP A 76 -14.413 22.783 -45.779 1.00 65.53 C \nANISOU 596 CG TRP A 76 6522 7520 10856 -448 -268 -679 C \nATOM 597 CD1 TRP A 76 -13.708 21.797 -45.210 1.00 58.45 C \nANISOU 597 CD1 TRP A 76 5695 6543 9970 -442 -275 -643 C \nATOM 598 CD2 TRP A 76 -13.975 22.854 -47.143 1.00 54.58 C \nANISOU 598 CD2 TRP A 76 5117 6131 9489 -402 -249 -704 C \nATOM 599 NE1 TRP A 76 -12.849 21.263 -46.113 1.00 56.48 N \nANISOU 599 NE1 TRP A 76 5471 6247 9743 -398 -264 -642 N \nATOM 600 CE2 TRP A 76 -13.005 21.893 -47.314 1.00 56.28 C \nANISOU 600 CE2 TRP A 76 5395 6265 9725 -373 -248 -679 C \nATOM 601 CE3 TRP A 76 -14.317 23.648 -48.221 1.00 49.71 C \nANISOU 601 CE3 TRP A 76 4437 5580 8871 -385 -234 -745 C \nATOM 602 CZ2 TRP A 76 -12.378 21.683 -48.534 1.00 56.17 C \nANISOU 602 CZ2 TRP A 76 5383 6230 9729 -331 -231 -694 C \nATOM 603 CZ3 TRP A 76 -13.714 23.446 -49.416 1.00 50.61 C \nANISOU 603 CZ3 TRP A 76 4554 5669 9005 -341 -217 -760 C \nATOM 604 CH2 TRP A 76 -12.748 22.486 -49.570 1.00 52.81 C \nANISOU 604 CH2 TRP A 76 4897 5864 9304 -314 -216 -735 C \nATOM 605 N SER A 77 -14.548 23.608 -42.101 1.00 71.33 N \nANISOU 605 N SER A 77 7252 8278 11574 -495 -373 -623 N \nATOM 606 CA SER A 77 -13.827 22.945 -41.038 1.00 72.43 C \nANISOU 606 CA SER A 77 7450 8347 11722 -492 -401 -582 C \nATOM 607 C SER A 77 -13.629 21.444 -41.325 1.00 67.20 C \nANISOU 607 C SER A 77 6872 7608 11055 -512 -359 -560 C \nATOM 608 O SER A 77 -12.516 20.940 -41.218 1.00 70.95 O \nANISOU 608 O SER A 77 7383 8021 11553 -472 -379 -538 O \nATOM 609 CB SER A 77 -14.550 23.170 -39.706 1.00 78.18 C \nANISOU 609 CB SER A 77 8173 9110 12421 -551 -418 -567 C \nATOM 610 OG SER A 77 -15.877 22.660 -39.716 1.00 81.24 O \nANISOU 610 OG SER A 77 8582 9523 12762 -640 -365 -574 O \nATOM 611 N TYR A 78 -14.692 20.759 -41.738 1.00 64.36 N \nANISOU 611 N TYR A 78 6540 7255 10659 -573 -300 -568 N \nATOM 612 CA TYR A 78 -14.599 19.365 -42.235 1.00 64.38 C \nANISOU 612 CA TYR A 78 6617 7195 10651 -581 -254 -551 C \nATOM 613 C TYR A 78 -15.657 19.099 -43.294 1.00 59.79 C \nANISOU 613 C TYR A 78 6041 6637 10039 -619 -193 -576 C \nATOM 614 O TYR A 78 -16.405 19.979 -43.634 1.00 64.05 O \nANISOU 614 O TYR A 78 6527 7242 10567 -644 -188 -605 O \nATOM 615 CB TYR A 78 -14.725 18.355 -41.094 1.00 69.85 C \nANISOU 615 CB TYR A 78 7380 7843 11318 -619 -248 -516 C \nATOM 616 CG TYR A 78 -16.046 18.449 -40.333 1.00 73.98 C \nANISOU 616 CG TYR A 78 7915 8399 11796 -699 -230 -519 C \nATOM 617 CD1 TYR A 78 -17.042 17.504 -40.548 1.00 78.78 C \nANISOU 617 CD1 TYR A 78 8588 8986 12359 -753 -170 -518 C \nATOM 618 CD2 TYR A 78 -16.285 19.472 -39.424 1.00 69.12 C \nANISOU 618 CD2 TYR A 78 7250 7833 11179 -720 -271 -523 C \nATOM 619 CE1 TYR A 78 -18.240 17.576 -39.882 1.00 78.76 C \nANISOU 619 CE1 TYR A 78 8608 9008 12310 -832 -152 -522 C \nATOM 620 CE2 TYR A 78 -17.467 19.551 -38.739 1.00 78.22 C \nANISOU 620 CE2 TYR A 78 8414 9020 12287 -800 -254 -526 C \nATOM 621 CZ TYR A 78 -18.448 18.603 -38.978 1.00 84.91 C \nANISOU 621 CZ TYR A 78 9332 9841 13089 -860 -194 -527 C \nATOM 622 OH TYR A 78 -19.628 18.666 -38.292 1.00 89.70 O \nANISOU 622 OH TYR A 78 9962 10476 13645 -947 -176 -531 O \nATOM 623 N ILE A 79 -15.670 17.899 -43.863 1.00 55.85 N \nANISOU 623 N ILE A 79 5606 6089 9526 -621 -149 -564 N \nATOM 624 CA ILE A 79 -16.550 17.576 -44.971 1.00 49.94 C \nANISOU 624 CA ILE A 79 4872 5354 8750 -650 -92 -584 C \nATOM 625 C ILE A 79 -17.365 16.377 -44.569 1.00 56.21 C \nANISOU 625 C ILE A 79 5756 6106 9495 -701 -46 -563 C \nATOM 626 O ILE A 79 -16.869 15.444 -43.981 1.00 67.96 O \nANISOU 626 O ILE A 79 7298 7543 10980 -683 -48 -532 O \nATOM 627 CB ILE A 79 -15.773 17.267 -46.276 1.00 51.42 C \nANISOU 627 CB ILE A 79 5052 5522 8962 -591 -77 -592 C \nATOM 628 CG1 ILE A 79 -15.031 18.543 -46.795 1.00 51.56 C \nANISOU 628 CG1 ILE A 79 4985 5581 9025 -537 -119 -619 C \nATOM 629 CG2 ILE A 79 -16.711 16.740 -47.375 1.00 50.58 C \nANISOU 629 CG2 ILE A 79 4976 5421 8821 -623 -15 -606 C \nATOM 630 CD1 ILE A 79 -13.989 18.262 -47.857 1.00 49.26 C \nANISOU 630 CD1 ILE A 79 4690 5262 8763 -475 -117 -623 C \nATOM 631 N VAL A 80 -18.646 16.427 -44.878 1.00 56.68 N \nANISOU 631 N VAL A 80 5835 6190 9512 -766 -5 -580 N \nATOM 632 CA VAL A 80 -19.517 15.341 -44.504 1.00 53.74 C \nANISOU 632 CA VAL A 80 5559 5772 9085 -816 40 -563 C \nATOM 633 C VAL A 80 -20.174 14.820 -45.754 1.00 48.98 C \nANISOU 633 C VAL A 80 4996 5160 8453 -829 96 -575 C \nATOM 634 O VAL A 80 -20.708 15.594 -46.538 1.00 40.49 O \nANISOU 634 O VAL A 80 3875 4137 7374 -858 107 -605 O \nATOM 635 CB VAL A 80 -20.563 15.768 -43.426 1.00 59.73 C \nANISOU 635 CB VAL A 80 6332 6558 9806 -900 36 -566 C \nATOM 636 CG1 VAL A 80 -20.709 17.287 -43.377 1.00 59.03 C \nANISOU 636 CG1 VAL A 80 6140 6556 9734 -920 -1 -595 C \nATOM 637 CG2 VAL A 80 -21.909 15.067 -43.619 1.00 54.63 C \nANISOU 637 CG2 VAL A 80 5777 5887 9092 -974 97 -569 C \nATOM 638 N GLU A 81 -20.127 13.498 -45.894 1.00 46.50 N \nANISOU 638 N GLU A 81 4768 4783 8116 -807 131 -551 N \nATOM 639 CA GLU A 81 -20.568 12.816 -47.074 1.00 53.06 C \nANISOU 639 CA GLU A 81 5647 5595 8920 -802 184 -555 C \nATOM 640 C GLU A 81 -21.406 11.692 -46.585 1.00 56.55 C \nANISOU 640 C GLU A 81 6205 5980 9302 -834 226 -534 C \nATOM 641 O GLU A 81 -21.276 11.287 -45.425 1.00 72.75 O \nANISOU 641 O GLU A 81 8293 8005 11345 -835 211 -513 O \nATOM 642 CB GLU A 81 -19.346 12.274 -47.814 1.00 56.46 C \nANISOU 642 CB GLU A 81 6058 6008 9387 -715 178 -542 C \nATOM 643 CG GLU A 81 -19.575 11.926 -49.278 1.00 53.56 C \nANISOU 643 CG GLU A 81 5703 5641 9007 -701 220 -554 C \nATOM 644 CD GLU A 81 -18.316 11.399 -49.937 1.00 47.54 C \nANISOU 644 CD GLU A 81 4918 4868 8278 -620 211 -541 C \nATOM 645 OE1 GLU A 81 -17.497 10.842 -49.187 1.00 40.79 O \nANISOU 645 OE1 GLU A 81 4076 3989 7434 -582 188 -514 O \nATOM 646 OE2 GLU A 81 -18.197 11.464 -51.185 1.00 42.65 O \nANISOU 646 OE2 GLU A 81 4274 4264 7665 -600 230 -556 O \nATOM 647 N LYS A 82 -22.311 11.212 -47.392 1.00 58.93 N \nANISOU 647 N LYS A 82 6571 6262 9557 -862 278 -540 N \nATOM 648 CA LYS A 82 -23.120 10.095 -46.949 1.00 72.32 C \nANISOU 648 CA LYS A 82 8393 7895 11190 -884 320 -520 C \nATOM 649 C LYS A 82 -22.333 8.862 -47.284 1.00 74.24 C \nANISOU 649 C LYS A 82 8676 8096 11436 -794 334 -492 C \nATOM 650 O LYS A 82 -21.267 8.947 -47.904 1.00 84.02 O \nANISOU 650 O LYS A 82 9845 9357 12721 -731 314 -491 O \nATOM 651 CB LYS A 82 -24.495 10.093 -47.619 1.00 81.91 C \nANISOU 651 CB LYS A 82 9675 9101 12344 -959 370 -538 C \nATOM 652 CG LYS A 82 -25.175 11.467 -47.499 1.00 86.38 C \nANISOU 652 CG LYS A 82 10175 9736 12911 -1051 353 -570 C \nATOM 653 CD LYS A 82 -26.564 11.457 -46.877 1.00 89.80 C \nANISOU 653 CD LYS A 82 10696 10153 13272 -1158 380 -576 C \nATOM 654 CE LYS A 82 -26.938 12.858 -46.372 1.00 89.84 C \nANISOU 654 CE LYS A 82 10609 10242 13283 -1238 347 -603 C \nATOM 655 NZ LYS A 82 -26.242 13.222 -45.088 1.00 89.87 N \nANISOU 655 NZ LYS A 82 10559 10262 13325 -1215 295 -592 N \nATOM 656 N ALA A 83 -22.839 7.713 -46.879 1.00 77.01 N \nANISOU 656 N ALA A 83 9140 8389 11732 -786 370 -470 N \nATOM 657 CA ALA A 83 -22.149 6.458 -47.160 1.00 78.31 C \nANISOU 657 CA ALA A 83 9344 8523 11888 -696 387 -441 C \nATOM 658 C ALA A 83 -22.286 6.097 -48.648 1.00 78.77 C \nANISOU 658 C ALA A 83 9416 8579 11933 -666 424 -446 C \nATOM 659 O ALA A 83 -21.307 5.676 -49.274 1.00 71.15 O \nANISOU 659 O ALA A 83 8410 7630 10994 -592 418 -434 O \nATOM 660 CB ALA A 83 -22.704 5.354 -46.292 1.00 82.82 C \nANISOU 660 CB ALA A 83 10033 9035 12398 -688 415 -419 C \nATOM 661 N ASN A 84 -23.489 6.270 -49.206 1.00 81.27 N \nANISOU 661 N ASN A 84 9791 8880 12207 -728 462 -462 N \nATOM 662 CA ASN A 84 -23.741 6.036 -50.638 1.00 88.11 C \nANISOU 662 CA ASN A 84 10673 9747 13058 -712 498 -468 C \nATOM 663 C ASN A 84 -24.463 7.205 -51.320 1.00 86.62 C \nANISOU 663 C ASN A 84 10440 9598 12873 -796 501 -503 C \nATOM 664 O ASN A 84 -25.675 7.131 -51.574 1.00 93.94 O \nANISOU 664 O ASN A 84 11451 10499 13742 -863 540 -511 O \nATOM 665 CB ASN A 84 -24.570 4.764 -50.848 1.00 99.95 C \nANISOU 665 CB ASN A 84 12318 11178 14481 -693 553 -447 C \nATOM 666 CG ASN A 84 -23.799 3.491 -50.553 1.00101.26 C \nANISOU 666 CG ASN A 84 12519 11320 14636 -590 558 -412 C \nATOM 667 OD1 ASN A 84 -22.811 3.491 -49.832 1.00109.47 O \nANISOU 667 OD1 ASN A 84 13494 12383 15715 -552 520 -402 O \nATOM 668 ND2 ASN A 84 -24.264 2.392 -51.117 1.00110.90 N \nANISOU 668 ND2 ASN A 84 13842 12496 15798 -544 604 -394 N \nATOM 669 N PRO A 85 -23.732 8.298 -51.599 1.00 81.09 N \nANISOU 669 N PRO A 85 9610 8963 12236 -795 461 -525 N \nATOM 670 CA PRO A 85 -24.299 9.482 -52.246 1.00 73.66 C \nANISOU 670 CA PRO A 85 8609 8078 11302 -866 460 -561 C \nATOM 671 C PRO A 85 -24.934 9.144 -53.554 1.00 71.71 C \nANISOU 671 C PRO A 85 8408 7822 11017 -879 507 -567 C \nATOM 672 O PRO A 85 -24.355 8.401 -54.348 1.00 74.50 O \nANISOU 672 O PRO A 85 8772 8159 11377 -806 522 -552 O \nATOM 673 CB PRO A 85 -23.079 10.385 -52.476 1.00 73.98 C \nANISOU 673 CB PRO A 85 8511 8178 11419 -818 410 -576 C \nATOM 674 CG PRO A 85 -21.899 9.680 -51.886 1.00 74.51 C \nANISOU 674 CG PRO A 85 8574 8218 11518 -736 384 -547 C \nATOM 675 CD PRO A 85 -22.421 8.596 -51.006 1.00 78.92 C \nANISOU 675 CD PRO A 85 9246 8714 12025 -739 408 -518 C \nATOM 676 N ALA A 86 -26.121 9.679 -53.787 1.00 75.69 N \nANISOU 676 N ALA A 86 8942 8341 11477 -975 530 -589 N \nATOM 677 CA ALA A 86 -26.856 9.369 -55.010 1.00 78.23 C \nANISOU 677 CA ALA A 86 9320 8651 11752 -1001 577 -595 C \nATOM 678 C ALA A 86 -26.273 10.095 -56.225 1.00 79.05 C \nANISOU 678 C ALA A 86 9311 8822 11901 -978 567 -619 C \nATOM 679 O ALA A 86 -26.485 9.684 -57.367 1.00 85.29 O \nANISOU 679 O ALA A 86 10134 9605 12669 -967 601 -618 O \nATOM 680 CB ALA A 86 -28.326 9.714 -54.846 1.00 81.05 C \nANISOU 680 CB ALA A 86 9750 9004 12040 -1124 606 -610 C \nATOM 681 N ASN A 87 -25.526 11.162 -55.980 1.00 69.72 N \nANISOU 681 N ASN A 87 8002 7708 10782 -966 520 -640 N \nATOM 682 CA ASN A 87 -24.996 11.981 -57.041 1.00 67.26 C \nANISOU 682 CA ASN A 87 7582 7464 10512 -945 507 -668 C \nATOM 683 C ASN A 87 -23.472 11.930 -57.108 1.00 70.42 C \nANISOU 683 C ASN A 87 7905 7868 10981 -842 470 -661 C \nATOM 684 O ASN A 87 -22.774 12.822 -56.646 1.00 68.35 O \nANISOU 684 O ASN A 87 7550 7648 10770 -823 424 -676 O \nATOM 685 CB ASN A 87 -25.456 13.412 -56.838 1.00 75.95 C \nANISOU 685 CB ASN A 87 8592 8647 11618 -1019 485 -706 C \nATOM 686 CG ASN A 87 -26.967 13.532 -56.825 1.00 70.63 C \nANISOU 686 CG ASN A 87 7989 7980 10869 -1137 521 -716 C \nATOM 687 OD1 ASN A 87 -27.659 12.940 -57.661 1.00 63.42 O \nANISOU 687 OD1 ASN A 87 7155 7037 9905 -1167 567 -712 O \nATOM 688 ND2 ASN A 87 -27.480 14.339 -55.905 1.00 69.58 N \nANISOU 688 ND2 ASN A 87 7825 7891 10723 -1208 501 -731 N \nATOM 689 N ASP A 88 -22.966 10.872 -57.724 1.00 70.49 N \nANISOU 689 N ASP A 88 7959 7837 10988 -776 491 -637 N \nATOM 690 CA ASP A 88 -21.551 10.648 -57.849 1.00 61.21 C \nANISOU 690 CA ASP A 88 6728 6663 9866 -686 461 -626 C \nATOM 691 C ASP A 88 -21.136 10.952 -59.290 1.00 61.48 C \nANISOU 691 C ASP A 88 6702 6737 9920 -660 470 -647 C \nATOM 692 O ASP A 88 -21.375 12.053 -59.839 1.00 56.82 O \nANISOU 692 O ASP A 88 6040 6205 9344 -697 464 -684 O \nATOM 693 CB ASP A 88 -21.258 9.195 -57.468 1.00 73.38 C \nANISOU 693 CB ASP A 88 8357 8141 11382 -630 477 -583 C \nATOM 694 CG ASP A 88 -19.777 8.930 -57.179 1.00 80.61 C \nANISOU 694 CG ASP A 88 9221 9060 12347 -551 440 -567 C \nATOM 695 OD1 ASP A 88 -18.940 9.871 -57.202 1.00 92.05 O \nANISOU 695 OD1 ASP A 88 10576 10549 13852 -538 398 -587 O \nATOM 696 OD2 ASP A 88 -19.457 7.759 -56.953 1.00 80.03 O \nANISOU 696 OD2 ASP A 88 9205 8951 12251 -502 453 -533 O \nATOM 697 N LEU A 89 -20.514 9.993 -59.942 1.00 55.22 N \nANISOU 697 N LEU A 89 5935 5921 9124 -597 486 -625 N \nATOM 698 CA LEU A 89 -20.348 10.089 -61.379 1.00 53.39 C \nANISOU 698 CA LEU A 89 5669 5721 8895 -582 506 -641 C \nATOM 699 C LEU A 89 -21.711 9.810 -62.019 1.00 50.38 C \nANISOU 699 C LEU A 89 5363 5328 8450 -643 558 -643 C \nATOM 700 O LEU A 89 -22.556 9.154 -61.466 1.00 54.28 O \nANISOU 700 O LEU A 89 5954 5774 8894 -672 582 -622 O \nATOM 701 CB LEU A 89 -19.289 9.080 -61.902 1.00 47.51 C \nANISOU 701 CB LEU A 89 4931 4961 8160 -500 509 -615 C \nATOM 702 CG LEU A 89 -17.957 9.103 -61.169 1.00 46.50 C \nANISOU 702 CG LEU A 89 4754 4834 8081 -447 462 -604 C \nATOM 703 CD1 LEU A 89 -16.990 8.092 -61.763 1.00 41.47 C \nANISOU 703 CD1 LEU A 89 4122 4193 7440 -378 469 -579 C \nATOM 704 CD2 LEU A 89 -17.359 10.540 -61.172 1.00 43.06 C \nANISOU 704 CD2 LEU A 89 4215 4443 7705 -454 418 -643 C \nATOM 705 N CYS A 90 -21.874 10.281 -63.223 1.00 55.37 N \nANISOU 705 N CYS A 90 5953 6002 9081 -661 574 -669 N \nATOM 706 CA CYS A 90 -23.092 10.070 -63.967 1.00 60.82 C \nANISOU 706 CA CYS A 90 6712 6687 9711 -722 622 -672 C \nATOM 707 C CYS A 90 -22.829 9.222 -65.204 1.00 61.07 C \nANISOU 707 C CYS A 90 6772 6709 9724 -674 653 -656 C \nATOM 708 O CYS A 90 -23.737 8.742 -65.894 1.00 74.54 O \nANISOU 708 O CYS A 90 8555 8396 11372 -707 696 -648 O \nATOM 709 CB CYS A 90 -23.647 11.436 -64.353 1.00 62.18 C \nANISOU 709 CB CYS A 90 6807 6931 9888 -796 616 -718 C \nATOM 710 SG CYS A 90 -22.572 12.538 -65.285 1.00 70.46 S \nANISOU 710 SG CYS A 90 7708 8061 11002 -754 586 -759 S \nATOM 711 N TYR A 91 -21.567 9.083 -65.524 1.00 57.38 N \nANISOU 711 N TYR A 91 6240 6259 9302 -598 630 -653 N \nATOM 712 CA TYR A 91 -21.161 8.080 -66.443 1.00 59.22 C \nANISOU 712 CA TYR A 91 6505 6480 9516 -541 655 -629 C \nATOM 713 C TYR A 91 -20.403 7.067 -65.601 1.00 55.15 C \nANISOU 713 C TYR A 91 6023 5925 9004 -470 641 -590 C \nATOM 714 O TYR A 91 -19.635 7.452 -64.730 1.00 62.43 O \nANISOU 714 O TYR A 91 6894 6853 9972 -452 600 -593 O \nATOM 715 CB TYR A 91 -20.265 8.699 -67.503 1.00 57.43 C \nANISOU 715 CB TYR A 91 6176 6312 9334 -515 641 -658 C \nATOM 716 CG TYR A 91 -20.579 8.289 -68.916 1.00 56.27 C \nANISOU 716 CG TYR A 91 6049 6180 9151 -515 681 -657 C \nATOM 717 CD1 TYR A 91 -21.716 8.783 -69.584 1.00 49.98 C \nANISOU 717 CD1 TYR A 91 5271 5401 8318 -589 711 -679 C \nATOM 718 CD2 TYR A 91 -19.687 7.455 -69.633 1.00 48.12 C \nANISOU 718 CD2 TYR A 91 5011 5152 8119 -445 686 -636 C \nATOM 719 CE1 TYR A 91 -21.965 8.416 -70.910 1.00 53.69 C \nANISOU 719 CE1 TYR A 91 5759 5887 8755 -590 746 -678 C \nATOM 720 CE2 TYR A 91 -19.920 7.094 -70.988 1.00 54.47 C \nANISOU 720 CE2 TYR A 91 5828 5976 8891 -443 721 -635 C \nATOM 721 CZ TYR A 91 -21.040 7.570 -71.615 1.00 58.73 C \nANISOU 721 CZ TYR A 91 6390 6527 9398 -513 750 -656 C \nATOM 722 OH TYR A 91 -21.261 7.178 -72.921 1.00 69.93 O \nANISOU 722 OH TYR A 91 7826 7963 10782 -510 784 -652 O \nATOM 723 N PRO A 92 -20.628 5.776 -65.832 1.00 51.57 N \nANISOU 723 N PRO A 92 5659 5436 8500 -430 674 -552 N \nATOM 724 CA PRO A 92 -19.859 4.773 -65.087 1.00 50.97 C \nANISOU 724 CA PRO A 92 5606 5336 8421 -357 661 -515 C \nATOM 725 C PRO A 92 -18.366 4.746 -65.478 1.00 44.32 C \nANISOU 725 C PRO A 92 4674 4541 7626 -299 632 -516 C \nATOM 726 O PRO A 92 -18.018 5.025 -66.606 1.00 48.35 O \nANISOU 726 O PRO A 92 5134 5089 8149 -294 637 -533 O \nATOM 727 CB PRO A 92 -20.528 3.440 -65.477 1.00 50.16 C \nANISOU 727 CB PRO A 92 5619 5196 8246 -322 708 -478 C \nATOM 728 CG PRO A 92 -21.126 3.690 -66.827 1.00 51.28 C \nANISOU 728 CG PRO A 92 5766 5354 8365 -354 740 -494 C \nATOM 729 CD PRO A 92 -21.314 5.191 -66.986 1.00 55.64 C \nANISOU 729 CD PRO A 92 6236 5944 8962 -432 720 -543 C \nATOM 730 N GLY A 93 -17.496 4.449 -64.527 1.00 38.26 N \nANISOU 730 N GLY A 93 3887 3769 6879 -261 600 -498 N \nATOM 731 CA GLY A 93 -16.084 4.528 -64.780 1.00 39.91 C \nANISOU 731 CA GLY A 93 4015 4019 7129 -221 569 -501 C \nATOM 732 C GLY A 93 -15.272 4.674 -63.536 1.00 43.49 C \nANISOU 732 C GLY A 93 4440 4466 7616 -210 525 -493 C \nATOM 733 O GLY A 93 -15.801 4.712 -62.425 1.00 45.79 O \nANISOU 733 O GLY A 93 4772 4725 7903 -231 518 -486 O \nATOM 734 N ASN A 94 -13.955 4.711 -63.721 1.00 45.00 N \nANISOU 734 N ASN A 94 4568 4691 7839 -180 495 -494 N \nATOM 735 CA ASN A 94 -13.046 4.828 -62.609 1.00 51.33 C \nANISOU 735 CA ASN A 94 5344 5490 8671 -171 451 -485 C \nATOM 736 C ASN A 94 -12.630 6.284 -62.352 1.00 52.85 C \nANISOU 736 C ASN A 94 5468 5684 8926 -204 408 -523 C \nATOM 737 O ASN A 94 -12.334 7.051 -63.278 1.00 70.53 O \nANISOU 737 O ASN A 94 7656 7949 11195 -212 403 -555 O \nATOM 738 CB ASN A 94 -11.787 3.994 -62.926 1.00 60.33 C \nANISOU 738 CB ASN A 94 6457 6665 9799 -124 442 -461 C \nATOM 739 CG ASN A 94 -10.878 3.813 -61.719 1.00 74.23 C \nANISOU 739 CG ASN A 94 8206 8423 11573 -115 402 -442 C \nATOM 740 OD1 ASN A 94 -9.700 4.212 -61.762 1.00 69.04 O \nANISOU 740 OD1 ASN A 94 7496 7787 10948 -116 366 -451 O \nATOM 741 ND2 ASN A 94 -11.419 3.250 -60.626 1.00 81.60 N \nANISOU 741 ND2 ASN A 94 9195 9330 12481 -109 408 -418 N \nATOM 742 N PHE A 95 -12.538 6.653 -61.090 1.00 51.55 N \nANISOU 742 N PHE A 95 5306 5499 8784 -219 375 -519 N \nATOM 743 CA PHE A 95 -11.865 7.872 -60.705 1.00 36.28 C \nANISOU 743 CA PHE A 95 3311 3568 6906 -233 326 -547 C \nATOM 744 C PHE A 95 -10.529 7.488 -60.139 1.00 34.40 C \nANISOU 744 C PHE A 95 3058 3331 6680 -206 290 -526 C \nATOM 745 O PHE A 95 -10.409 7.074 -58.975 1.00 38.15 O \nANISOU 745 O PHE A 95 3560 3788 7147 -205 274 -500 O \nATOM 746 CB PHE A 95 -12.667 8.639 -59.702 1.00 40.50 C \nANISOU 746 CB PHE A 95 3852 4082 7454 -271 312 -559 C \nATOM 747 CG PHE A 95 -12.315 10.089 -59.595 1.00 37.50 C \nANISOU 747 CG PHE A 95 3406 3716 7126 -285 271 -595 C \nATOM 748 CD1 PHE A 95 -13.246 11.032 -59.827 1.00 46.25 C \nANISOU 748 CD1 PHE A 95 4492 4841 8241 -321 279 -627 C \nATOM 749 CD2 PHE A 95 -11.101 10.493 -59.150 1.00 38.92 C \nANISOU 749 CD2 PHE A 95 3551 3892 7343 -263 223 -596 C \nATOM 750 CE1 PHE A 95 -12.949 12.398 -59.729 1.00 49.79 C \nANISOU 750 CE1 PHE A 95 4875 5311 8734 -324 242 -662 C \nATOM 751 CE2 PHE A 95 -10.773 11.860 -59.006 1.00 43.63 C \nANISOU 751 CE2 PHE A 95 4093 4497 7986 -265 183 -630 C \nATOM 752 CZ PHE A 95 -11.705 12.824 -59.322 1.00 45.16 C \nANISOU 752 CZ PHE A 95 4257 4716 8187 -291 193 -664 C \nATOM 753 N ASN A 96 -9.465 7.631 -60.949 1.00 33.07 N \nANISOU 753 N ASN A 96 2848 3187 6530 -188 276 -537 N \nATOM 754 CA ASN A 96 -8.099 7.270 -60.555 1.00 33.01 C \nANISOU 754 CA ASN A 96 2829 3186 6528 -172 242 -518 C \nATOM 755 C ASN A 96 -7.627 7.950 -59.253 1.00 33.89 C \nANISOU 755 C ASN A 96 2934 3270 6673 -186 191 -517 C \nATOM 756 O ASN A 96 -7.900 9.115 -58.995 1.00 45.85 O \nANISOU 756 O ASN A 96 4425 4768 8225 -201 168 -546 O \nATOM 757 CB ASN A 96 -7.152 7.564 -61.680 1.00 36.62 C \nANISOU 757 CB ASN A 96 3246 3668 7000 -163 235 -538 C \nATOM 758 CG ASN A 96 -5.906 6.699 -61.629 1.00 41.93 C \nANISOU 758 CG ASN A 96 3919 4363 7650 -151 221 -510 C \nATOM 759 OD1 ASN A 96 -6.000 5.452 -61.628 1.00 38.89 O \nANISOU 759 OD1 ASN A 96 3558 4004 7215 -134 248 -476 O \nATOM 760 ND2 ASN A 96 -4.725 7.343 -61.528 1.00 45.59 N \nANISOU 760 ND2 ASN A 96 4359 4820 8144 -160 177 -524 N \nATOM 761 N ASP A 97 -6.925 7.185 -58.419 1.00 36.12 N \nANISOU 761 N ASP A 97 3235 3552 6937 -180 173 -484 N \nATOM 762 CA ASP A 97 -6.424 7.591 -57.099 1.00 31.35 C \nANISOU 762 CA ASP A 97 2633 2923 6354 -194 126 -474 C \nATOM 763 C ASP A 97 -7.418 8.468 -56.385 1.00 32.58 C \nANISOU 763 C ASP A 97 2793 3052 6534 -213 118 -491 C \nATOM 764 O ASP A 97 -7.079 9.495 -55.826 1.00 40.77 O \nANISOU 764 O ASP A 97 3809 4072 7611 -222 75 -507 O \nATOM 765 CB ASP A 97 -5.071 8.294 -57.229 1.00 32.25 C \nANISOU 765 CB ASP A 97 2719 3033 6503 -196 79 -488 C \nATOM 766 CG ASP A 97 -3.964 7.380 -57.672 1.00 36.04 C \nANISOU 766 CG ASP A 97 3198 3543 6950 -191 80 -467 C \nATOM 767 OD1 ASP A 97 -3.694 6.318 -57.021 1.00 33.92 O \nANISOU 767 OD1 ASP A 97 2951 3294 6643 -191 83 -430 O \nATOM 768 OD2 ASP A 97 -3.360 7.697 -58.670 1.00 45.68 O \nANISOU 768 OD2 ASP A 97 4399 4776 8183 -188 78 -488 O \nATOM 769 N TYR A 98 -8.651 8.018 -56.332 1.00 33.33 N \nANISOU 769 N TYR A 98 2920 3144 6601 -220 158 -484 N \nATOM 770 CA TYR A 98 -9.745 8.719 -55.615 1.00 33.40 C \nANISOU 770 CA TYR A 98 2938 3132 6619 -249 157 -497 C \nATOM 771 C TYR A 98 -9.494 8.948 -54.204 1.00 35.19 C \nANISOU 771 C TYR A 98 3172 3340 6858 -262 117 -483 C \nATOM 772 O TYR A 98 -9.640 10.062 -53.716 1.00 44.12 O \nANISOU 772 O TYR A 98 4277 4464 8024 -279 86 -503 O \nATOM 773 CB TYR A 98 -11.082 7.926 -55.815 1.00 33.46 C \nANISOU 773 CB TYR A 98 2999 3135 6579 -258 212 -486 C \nATOM 774 CG TYR A 98 -12.303 8.725 -55.464 1.00 40.52 C \nANISOU 774 CG TYR A 98 3900 4018 7476 -299 220 -508 C \nATOM 775 CD1 TYR A 98 -12.316 10.143 -55.577 1.00 36.40 C \nANISOU 775 CD1 TYR A 98 3321 3511 6998 -319 191 -544 C \nATOM 776 CD2 TYR A 98 -13.466 8.088 -54.988 1.00 41.16 C \nANISOU 776 CD2 TYR A 98 4048 4078 7513 -321 255 -492 C \nATOM 777 CE1 TYR A 98 -13.444 10.875 -55.193 1.00 37.65 C \nANISOU 777 CE1 TYR A 98 3479 3674 7154 -363 196 -563 C \nATOM 778 CE2 TYR A 98 -14.581 8.825 -54.633 1.00 44.18 C \nANISOU 778 CE2 TYR A 98 4438 4455 7893 -370 261 -512 C \nATOM 779 CZ TYR A 98 -14.570 10.206 -54.778 1.00 41.44 C \nANISOU 779 CZ TYR A 98 4025 4134 7587 -394 232 -547 C \nATOM 780 OH TYR A 98 -15.711 10.904 -54.467 1.00 47.79 O \nANISOU 780 OH TYR A 98 4833 4946 8381 -448 240 -567 O \nATOM 781 N GLU A 99 -9.089 7.861 -53.507 1.00 36.43 N \nANISOU 781 N GLU A 99 3364 3494 6985 -251 118 -446 N \nATOM 782 CA GLU A 99 -8.936 7.888 -52.041 1.00 36.32 C \nANISOU 782 CA GLU A 99 3365 3461 6972 -267 85 -426 C \nATOM 783 C GLU A 99 -7.766 8.764 -51.654 1.00 36.83 C \nANISOU 783 C GLU A 99 3392 3520 7080 -269 26 -433 C \nATOM 784 O GLU A 99 -7.790 9.404 -50.617 1.00 45.25 O \nANISOU 784 O GLU A 99 4456 4569 8167 -286 -10 -433 O \nATOM 785 CB GLU A 99 -8.748 6.494 -51.495 1.00 37.33 C \nANISOU 785 CB GLU A 99 3535 3596 7052 -251 102 -387 C \nATOM 786 CG GLU A 99 -9.908 5.560 -51.730 1.00 37.12 C \nANISOU 786 CG GLU A 99 3561 3567 6976 -240 159 -377 C \nATOM 787 CD GLU A 99 -9.971 5.035 -53.137 1.00 45.73 C \nANISOU 787 CD GLU A 99 4651 4680 8046 -212 198 -381 C \nATOM 788 OE1 GLU A 99 -8.965 5.136 -53.885 1.00 43.44 O \nANISOU 788 OE1 GLU A 99 4319 4415 7773 -198 184 -386 O \nATOM 789 OE2 GLU A 99 -11.049 4.499 -53.515 1.00 58.19 O \nANISOU 789 OE2 GLU A 99 6275 6248 9588 -205 245 -378 O \nATOM 790 N GLU A 100 -6.793 8.864 -52.533 1.00 35.41 N \nANISOU 790 N GLU A 100 3188 3353 6915 -252 16 -442 N \nATOM 791 CA GLU A 100 -5.643 9.764 -52.270 1.00 37.89 C \nANISOU 791 CA GLU A 100 3477 3652 7268 -252 -41 -452 C \nATOM 792 C GLU A 100 -6.018 11.170 -52.420 1.00 36.62 C \nANISOU 792 C GLU A 100 3285 3481 7150 -251 -61 -488 C \nATOM 793 O GLU A 100 -5.679 12.020 -51.579 1.00 50.09 O \nANISOU 793 O GLU A 100 4982 5167 8883 -255 -107 -492 O \nATOM 794 CB GLU A 100 -4.480 9.411 -53.208 1.00 43.53 C \nANISOU 794 CB GLU A 100 4181 4381 7976 -239 -43 -451 C \nATOM 795 CG GLU A 100 -3.676 8.186 -52.761 1.00 41.40 C \nANISOU 795 CG GLU A 100 3934 4130 7665 -245 -45 -412 C \nATOM 796 CD GLU A 100 -2.717 8.526 -51.669 1.00 44.03 C \nANISOU 796 CD GLU A 100 4277 4442 8011 -264 -101 -397 C \nATOM 797 OE1 GLU A 100 -2.203 9.690 -51.721 1.00 49.52 O \nANISOU 797 OE1 GLU A 100 4960 5107 8747 -264 -140 -420 O \nATOM 798 OE2 GLU A 100 -2.527 7.654 -50.755 1.00 34.34 O \nANISOU 798 OE2 GLU A 100 3071 3227 6749 -277 -104 -363 O \nATOM 799 N LEU A 101 -6.800 11.449 -53.442 1.00 37.39 N \nANISOU 799 N LEU A 101 3363 3596 7249 -246 -25 -516 N \nATOM 800 CA LEU A 101 -7.506 12.816 -53.589 1.00 38.64 C \nANISOU 800 CA LEU A 101 3482 3760 7438 -249 -35 -554 C \nATOM 801 C LEU A 101 -8.347 13.159 -52.372 1.00 39.59 C \nANISOU 801 C LEU A 101 3610 3875 7557 -275 -47 -547 C \nATOM 802 O LEU A 101 -8.188 14.204 -51.768 1.00 40.24 O \nANISOU 802 O LEU A 101 3667 3954 7668 -272 -89 -560 O \nATOM 803 CB LEU A 101 -8.387 12.842 -54.807 1.00 33.86 C \nANISOU 803 CB LEU A 101 2861 3181 6822 -251 13 -579 C \nATOM 804 CG LEU A 101 -9.063 14.155 -55.075 1.00 37.64 C \nANISOU 804 CG LEU A 101 3293 3682 7324 -256 7 -619 C \nATOM 805 CD1 LEU A 101 -8.097 15.356 -55.037 1.00 40.88 C \nANISOU 805 CD1 LEU A 101 3665 4089 7778 -223 -46 -643 C \nATOM 806 CD2 LEU A 101 -9.799 14.124 -56.417 1.00 35.79 C \nANISOU 806 CD2 LEU A 101 3044 3479 7076 -261 55 -644 C \nATOM 807 N LYS A 102 -9.233 12.254 -52.013 1.00 37.69 N \nANISOU 807 N LYS A 102 3408 3633 7278 -299 -10 -526 N \nATOM 808 CA LYS A 102 -10.033 12.414 -50.813 1.00 40.86 C \nANISOU 808 CA LYS A 102 3827 4028 7671 -330 -18 -517 C \nATOM 809 C LYS A 102 -9.150 12.742 -49.591 1.00 42.17 C \nANISOU 809 C LYS A 102 3991 4176 7858 -327 -75 -499 C \nATOM 810 O LYS A 102 -9.465 13.573 -48.727 1.00 45.62 O \nANISOU 810 O LYS A 102 4411 4613 8309 -343 -105 -504 O \nATOM 811 CB LYS A 102 -10.830 11.127 -50.525 1.00 41.20 C \nANISOU 811 CB LYS A 102 3930 4061 7663 -348 28 -490 C \nATOM 812 CG LYS A 102 -12.291 11.193 -50.950 1.00 45.48 C \nANISOU 812 CG LYS A 102 4490 4613 8180 -380 74 -507 C \nATOM 813 CD LYS A 102 -12.898 9.796 -50.990 1.00 46.81 C \nANISOU 813 CD LYS A 102 4729 4763 8294 -380 124 -481 C \nATOM 814 CE LYS A 102 -14.385 9.879 -51.044 1.00 47.93 C \nANISOU 814 CE LYS A 102 4906 4902 8403 -424 163 -493 C \nATOM 815 NZ LYS A 102 -14.914 10.226 -49.717 1.00 48.21 N \nANISOU 815 NZ LYS A 102 4958 4927 8433 -464 143 -488 N \nATOM 816 N HIS A 103 -8.051 12.036 -49.463 1.00 39.58 N \nANISOU 816 N HIS A 103 3682 3833 7525 -310 -90 -474 N \nATOM 817 CA HIS A 103 -7.193 12.219 -48.281 1.00 35.63 C \nANISOU 817 CA HIS A 103 3188 3312 7036 -314 -142 -452 C \nATOM 818 C HIS A 103 -6.512 13.593 -48.384 1.00 38.16 C \nANISOU 818 C HIS A 103 3471 3625 7402 -293 -192 -477 C \nATOM 819 O HIS A 103 -6.199 14.247 -47.442 1.00 33.51 O \nANISOU 819 O HIS A 103 2879 3022 6831 -296 -238 -471 O \nATOM 820 CB HIS A 103 -6.123 11.158 -48.225 1.00 32.71 C \nANISOU 820 CB HIS A 103 2845 2938 6646 -307 -146 -421 C \nATOM 821 CG HIS A 103 -5.172 11.359 -47.117 1.00 32.27 C \nANISOU 821 CG HIS A 103 2800 2863 6599 -316 -200 -400 C \nATOM 822 ND1 HIS A 103 -3.876 11.785 -47.312 1.00 31.62 N \nANISOU 822 ND1 HIS A 103 2712 2764 6536 -305 -242 -401 N \nATOM 823 CD2 HIS A 103 -5.318 11.191 -45.783 1.00 33.33 C \nANISOU 823 CD2 HIS A 103 2954 2987 6721 -338 -220 -376 C \nATOM 824 CE1 HIS A 103 -3.267 11.902 -46.143 1.00 33.11 C \nANISOU 824 CE1 HIS A 103 2919 2934 6726 -321 -287 -378 C \nATOM 825 NE2 HIS A 103 -4.111 11.509 -45.199 1.00 33.28 N \nANISOU 825 NE2 HIS A 103 2954 2963 6730 -341 -274 -362 N \nATOM 826 N LEU A 104 -6.291 14.042 -49.566 1.00 39.07 N \nANISOU 826 N LEU A 104 3561 3750 7535 -269 -183 -505 N \nATOM 827 CA LEU A 104 -5.702 15.342 -49.714 1.00 45.13 C \nANISOU 827 CA LEU A 104 4297 4510 8341 -241 -228 -531 C \nATOM 828 C LEU A 104 -6.625 16.463 -49.213 1.00 52.71 C \nANISOU 828 C LEU A 104 5220 5491 9316 -244 -242 -552 C \nATOM 829 O LEU A 104 -6.160 17.447 -48.619 1.00 54.75 O \nANISOU 829 O LEU A 104 5464 5740 9599 -223 -292 -558 O \nATOM 830 CB LEU A 104 -5.439 15.500 -51.191 1.00 46.51 C \nANISOU 830 CB LEU A 104 4451 4696 8524 -216 -205 -560 C \nATOM 831 CG LEU A 104 -4.774 16.764 -51.647 1.00 50.41 C \nANISOU 831 CG LEU A 104 4917 5183 9054 -176 -242 -593 C \nATOM 832 CD1 LEU A 104 -3.406 16.920 -51.041 1.00 50.33 C \nANISOU 832 CD1 LEU A 104 4940 5128 9055 -163 -296 -576 C \nATOM 833 CD2 LEU A 104 -4.698 16.713 -53.167 1.00 52.08 C \nANISOU 833 CD2 LEU A 104 5110 5412 9266 -158 -208 -622 C \nATOM 834 N LEU A 105 -7.935 16.283 -49.390 1.00 54.01 N \nANISOU 834 N LEU A 105 5374 5686 9460 -272 -198 -562 N \nATOM 835 CA LEU A 105 -8.911 17.215 -48.813 1.00 55.08 C \nANISOU 835 CA LEU A 105 5476 5853 9598 -290 -208 -578 C \nATOM 836 C LEU A 105 -9.048 17.173 -47.342 1.00 57.60 C \nANISOU 836 C LEU A 105 5815 6161 9910 -315 -236 -551 C \nATOM 837 O LEU A 105 -10.110 17.525 -46.804 1.00 73.55 O \nANISOU 837 O LEU A 105 7820 8209 11915 -349 -228 -557 O \nATOM 838 CB LEU A 105 -10.303 16.932 -49.329 1.00 52.18 C \nANISOU 838 CB LEU A 105 5106 5520 9202 -328 -152 -592 C \nATOM 839 CG LEU A 105 -10.432 16.903 -50.865 1.00 55.53 C \nANISOU 839 CG LEU A 105 5511 5964 9626 -313 -113 -620 C \nATOM 840 CD1 LEU A 105 -11.839 16.543 -51.199 1.00 56.67 C \nANISOU 840 CD1 LEU A 105 5665 6133 9733 -361 -60 -627 C \nATOM 841 CD2 LEU A 105 -10.048 18.207 -51.550 1.00 56.80 C \nANISOU 841 CD2 LEU A 105 5610 6154 9819 -272 -139 -659 C \nATOM 842 N SER A 106 -8.005 16.757 -46.668 1.00 55.02 N \nANISOU 842 N SER A 106 5522 5796 9589 -305 -270 -521 N \nATOM 843 CA SER A 106 -8.126 16.535 -45.254 1.00 56.99 C \nANISOU 843 CA SER A 106 5795 6033 9826 -333 -292 -492 C \nATOM 844 C SER A 106 -7.115 17.427 -44.645 1.00 54.76 C \nANISOU 844 C SER A 106 5502 5732 9572 -303 -357 -488 C \nATOM 845 O SER A 106 -6.942 17.443 -43.439 1.00 48.73 O \nANISOU 845 O SER A 106 4756 4955 8805 -319 -391 -463 O \nATOM 846 CB SER A 106 -7.820 15.084 -44.930 1.00 56.32 C \nANISOU 846 CB SER A 106 5764 5922 9711 -352 -271 -456 C \nATOM 847 OG SER A 106 -6.743 14.642 -45.716 1.00 60.13 O \nANISOU 847 OG SER A 106 6257 6388 10199 -325 -271 -452 O \nATOM 848 N ARG A 107 -6.402 18.131 -45.518 1.00 53.75 N \nANISOU 848 N ARG A 107 5353 5599 9472 -258 -375 -512 N \nATOM 849 CA ARG A 107 -5.406 19.056 -45.063 1.00 65.00 C \nANISOU 849 CA ARG A 107 6776 6998 10922 -219 -437 -511 C \nATOM 850 C ARG A 107 -5.724 20.376 -45.755 1.00 58.91 C \nANISOU 850 C ARG A 107 5948 6261 10173 -175 -446 -554 C \nATOM 851 O ARG A 107 -5.030 21.357 -45.629 1.00 56.89 O \nANISOU 851 O ARG A 107 5684 5992 9939 -127 -494 -564 O \nATOM 852 CB ARG A 107 -3.993 18.506 -45.418 1.00 73.17 C \nANISOU 852 CB ARG A 107 7857 7984 11960 -205 -453 -496 C \nATOM 853 CG ARG A 107 -3.052 18.330 -44.180 1.00 82.78 C \nANISOU 853 CG ARG A 107 9120 9160 13174 -219 -504 -457 C \nATOM 854 CD ARG A 107 -3.288 19.461 -43.131 1.00 90.52 C \nANISOU 854 CD ARG A 107 10080 10144 14168 -203 -553 -457 C \nATOM 855 NE ARG A 107 -2.354 20.597 -42.968 1.00 88.76 N \nANISOU 855 NE ARG A 107 9866 9889 13970 -151 -614 -464 N \nATOM 856 CZ ARG A 107 -1.546 21.114 -43.899 1.00 97.36 C \nANISOU 856 CZ ARG A 107 10964 10951 15075 -104 -627 -487 C \nATOM 857 NH1 ARG A 107 -1.456 20.609 -45.128 1.00 93.23 N \nANISOU 857 NH1 ARG A 107 10440 10434 14551 -104 -585 -506 N \nATOM 858 NH2 ARG A 107 -0.778 22.162 -43.580 1.00107.09 N \nANISOU 858 NH2 ARG A 107 12214 12150 16324 -54 -684 -491 N \nATOM 859 N ILE A 108 -6.839 20.364 -46.453 1.00 53.21 N \nANISOU 859 N ILE A 108 5189 5587 9440 -193 -398 -578 N \nATOM 860 CA ILE A 108 -7.309 21.503 -47.173 1.00 50.85 C \nANISOU 860 CA ILE A 108 4829 5339 9154 -159 -397 -621 C \nATOM 861 C ILE A 108 -8.569 21.985 -46.510 1.00 53.56 C \nANISOU 861 C ILE A 108 5131 5741 9480 -195 -391 -627 C \nATOM 862 O ILE A 108 -9.293 21.193 -45.922 1.00 52.39 O \nANISOU 862 O ILE A 108 5009 5593 9306 -254 -365 -605 O \nATOM 863 CB ILE A 108 -7.681 21.187 -48.595 1.00 45.27 C \nANISOU 863 CB ILE A 108 4106 4653 8441 -161 -345 -648 C \nATOM 864 CG1 ILE A 108 -6.428 20.775 -49.360 1.00 41.89 C \nANISOU 864 CG1 ILE A 108 3713 4175 8027 -127 -350 -646 C \nATOM 865 CG2 ILE A 108 -8.335 22.415 -49.234 1.00 47.31 C \nANISOU 865 CG2 ILE A 108 4292 4979 8706 -134 -342 -693 C \nATOM 866 CD1 ILE A 108 -6.655 20.519 -50.850 1.00 41.63 C \nANISOU 866 CD1 ILE A 108 3663 4162 7990 -122 -301 -674 C \nATOM 867 N ASN A 109 -8.775 23.294 -46.594 1.00 52.11 N \nANISOU 867 N ASN A 109 4886 5608 9307 -156 -417 -656 N \nATOM 868 CA ASN A 109 -9.788 23.975 -45.850 1.00 54.08 C \nANISOU 868 CA ASN A 109 5087 5922 9537 -184 -425 -662 C \nATOM 869 C ASN A 109 -10.693 24.828 -46.710 1.00 55.86 C \nANISOU 869 C ASN A 109 5238 6235 9753 -180 -401 -707 C \nATOM 870 O ASN A 109 -11.842 25.118 -46.311 1.00 63.78 O \nANISOU 870 O ASN A 109 6202 7304 10726 -232 -386 -714 O \nATOM 871 CB ASN A 109 -9.124 24.911 -44.879 1.00 60.08 C \nANISOU 871 CB ASN A 109 5835 6678 10314 -134 -492 -652 C \nATOM 872 CG ASN A 109 -8.886 24.296 -43.521 1.00 63.67 C \nANISOU 872 CG ASN A 109 6341 7087 10762 -171 -517 -608 C \nATOM 873 OD1 ASN A 109 -7.929 24.667 -42.806 1.00 71.56 O \nANISOU 873 OD1 ASN A 109 7364 8048 11778 -131 -572 -588 O \nATOM 874 ND2 ASN A 109 -9.757 23.394 -43.128 1.00 57.63 N \nANISOU 874 ND2 ASN A 109 5599 6328 9969 -247 -478 -591 N \nATOM 875 N HIS A 110 -10.156 25.241 -47.864 1.00 51.91 N \nANISOU 875 N HIS A 110 4715 5736 9271 -122 -397 -737 N \nATOM 876 CA HIS A 110 -10.853 26.120 -48.790 1.00 58.65 C \nANISOU 876 CA HIS A 110 5492 6675 10115 -108 -377 -782 C \nATOM 877 C HIS A 110 -10.260 26.141 -50.212 1.00 54.24 C \nANISOU 877 C HIS A 110 4932 6103 9575 -59 -357 -811 C \nATOM 878 O HIS A 110 -9.056 26.065 -50.398 1.00 47.31 O \nANISOU 878 O HIS A 110 4095 5158 8725 -4 -383 -805 O \nATOM 879 CB HIS A 110 -10.967 27.521 -48.208 1.00 66.69 C \nANISOU 879 CB HIS A 110 6442 7766 11134 -61 -423 -799 C \nATOM 880 CG HIS A 110 -11.767 28.465 -49.050 1.00 71.38 C \nANISOU 880 CG HIS A 110 6946 8468 11709 -50 -403 -847 C \nATOM 881 ND1 HIS A 110 -11.411 29.794 -49.212 1.00 75.44 N \nANISOU 881 ND1 HIS A 110 7393 9038 12231 38 -442 -877 N \nATOM 882 CD2 HIS A 110 -12.909 28.286 -49.757 1.00 69.97 C \nANISOU 882 CD2 HIS A 110 6732 8354 11499 -116 -350 -868 C \nATOM 883 CE1 HIS A 110 -12.296 30.389 -49.988 1.00 76.01 C \nANISOU 883 CE1 HIS A 110 7387 9215 12279 26 -412 -916 C \nATOM 884 NE2 HIS A 110 -13.215 29.499 -50.330 1.00 77.29 N \nANISOU 884 NE2 HIS A 110 7567 9382 12416 -72 -356 -912 N \nATOM 885 N PHE A 111 -11.152 26.182 -51.198 1.00 55.28 N \nANISOU 885 N PHE A 111 5022 6296 9687 -90 -309 -841 N \nATOM 886 CA PHE A 111 -10.817 26.189 -52.591 1.00 61.01 C \nANISOU 886 CA PHE A 111 5737 7020 10421 -57 -283 -871 C \nATOM 887 C PHE A 111 -11.114 27.519 -53.242 1.00 73.40 C \nANISOU 887 C PHE A 111 7218 8682 11988 -8 -290 -920 C \nATOM 888 O PHE A 111 -11.780 28.377 -52.666 1.00 89.25 O \nANISOU 888 O PHE A 111 9164 10769 13978 -12 -307 -932 O \nATOM 889 CB PHE A 111 -11.713 25.198 -53.306 1.00 69.28 C \nANISOU 889 CB PHE A 111 6805 8077 11443 -133 -218 -869 C \nATOM 890 CG PHE A 111 -11.188 23.781 -53.317 1.00 64.47 C \nANISOU 890 CG PHE A 111 6282 7378 10837 -157 -198 -832 C \nATOM 891 CD1 PHE A 111 -9.839 23.532 -53.228 1.00 65.93 C \nANISOU 891 CD1 PHE A 111 6509 7489 11050 -106 -230 -816 C \nATOM 892 CD2 PHE A 111 -12.062 22.721 -53.447 1.00 60.48 C \nANISOU 892 CD2 PHE A 111 5813 6866 10300 -229 -147 -815 C \nATOM 893 CE1 PHE A 111 -9.372 22.247 -53.248 1.00 68.32 C \nANISOU 893 CE1 PHE A 111 6881 7727 11350 -129 -212 -783 C \nATOM 894 CE2 PHE A 111 -11.605 21.426 -53.439 1.00 62.20 C \nANISOU 894 CE2 PHE A 111 6104 7014 10517 -243 -130 -781 C \nATOM 895 CZ PHE A 111 -10.253 21.179 -53.369 1.00 64.41 C \nANISOU 895 CZ PHE A 111 6416 7233 10825 -193 -161 -765 C \nATOM 896 N GLU A 112 -10.619 27.693 -54.461 1.00 73.60 N \nANISOU 896 N GLU A 112 7234 8705 12026 39 -275 -951 N \nATOM 897 CA GLU A 112 -11.082 28.786 -55.323 1.00 71.37 C \nANISOU 897 CA GLU A 112 6864 8523 11733 74 -266 -1002 C \nATOM 898 C GLU A 112 -11.152 28.325 -56.787 1.00 65.48 C \nANISOU 898 C GLU A 112 6120 7778 10983 60 -215 -1026 C \nATOM 899 O GLU A 112 -10.160 28.250 -57.494 1.00 63.54 O \nANISOU 899 O GLU A 112 5902 7478 10760 115 -221 -1037 O \nATOM 900 CB GLU A 112 -10.236 30.052 -55.155 1.00 72.80 C \nANISOU 900 CB GLU A 112 7010 8717 11934 185 -321 -1025 C \nATOM 901 CG GLU A 112 -10.885 31.288 -55.785 1.00 85.59 C \nANISOU 901 CG GLU A 112 8524 10464 13532 222 -315 -1077 C \nATOM 902 CD GLU A 112 -10.058 32.569 -55.653 1.00 87.10 C \nANISOU 902 CD GLU A 112 8682 10672 13739 347 -370 -1102 C \nATOM 903 OE1 GLU A 112 -9.183 32.624 -54.776 1.00 98.71 O \nANISOU 903 OE1 GLU A 112 10206 12066 15232 394 -418 -1075 O \nATOM 904 OE2 GLU A 112 -10.293 33.517 -56.426 1.00 81.47 O \nANISOU 904 OE2 GLU A 112 7892 10051 13013 400 -364 -1150 O \nATOM 905 N LYS A 113 -12.350 27.941 -57.184 1.00 62.54 N \nANISOU 905 N LYS A 113 5725 7461 10575 -22 -165 -1032 N \nATOM 906 CA LYS A 113 -12.648 27.482 -58.532 1.00 61.71 C \nANISOU 906 CA LYS A 113 5620 7370 10459 -49 -113 -1052 C \nATOM 907 C LYS A 113 -12.256 28.541 -59.566 1.00 64.66 C \nANISOU 907 C LYS A 113 5927 7800 10841 27 -119 -1104 C \nATOM 908 O LYS A 113 -12.738 29.640 -59.536 1.00 66.74 O \nANISOU 908 O LYS A 113 6109 8160 11088 50 -131 -1136 O \nATOM 909 CB LYS A 113 -14.124 27.185 -58.599 1.00 59.59 C \nANISOU 909 CB LYS A 113 5331 7166 10143 -150 -67 -1052 C \nATOM 910 CG LYS A 113 -14.635 26.530 -59.854 1.00 62.14 C \nANISOU 910 CG LYS A 113 5667 7497 10444 -198 -9 -1063 C \nATOM 911 CD LYS A 113 -16.163 26.666 -59.791 1.00 71.61 C \nANISOU 911 CD LYS A 113 6834 8784 11591 -294 26 -1072 C \nATOM 912 CE LYS A 113 -16.922 25.798 -60.765 1.00 71.75 C \nANISOU 912 CE LYS A 113 6888 8798 11575 -367 87 -1070 C \nATOM 913 NZ LYS A 113 -17.074 24.489 -60.116 1.00 75.41 N \nANISOU 913 NZ LYS A 113 7451 9170 12033 -415 102 -1021 N \nATOM 914 N ILE A 114 -11.325 28.184 -60.440 1.00 73.59 N \nANISOU 914 N ILE A 114 7095 8870 11995 70 -113 -1111 N \nATOM 915 CA ILE A 114 -10.785 29.085 -61.452 1.00 73.58 C \nANISOU 915 CA ILE A 114 7048 8905 12004 149 -119 -1160 C \nATOM 916 C ILE A 114 -11.052 28.544 -62.833 1.00 76.16 C \nANISOU 916 C ILE A 114 7374 9246 12318 114 -65 -1179 C \nATOM 917 O ILE A 114 -10.797 27.330 -63.098 1.00 77.02 O \nANISOU 917 O ILE A 114 7554 9280 12430 72 -39 -1148 O \nATOM 918 CB ILE A 114 -9.237 29.177 -61.377 1.00 85.37 C \nANISOU 918 CB ILE A 114 8599 10303 13537 235 -161 -1156 C \nATOM 919 CG1 ILE A 114 -8.809 29.997 -60.176 1.00 90.48 C \nANISOU 919 CG1 ILE A 114 9241 10941 14198 296 -221 -1147 C \nATOM 920 CG2 ILE A 114 -8.677 29.836 -62.639 1.00 86.45 C \nANISOU 920 CG2 ILE A 114 8707 10460 13679 306 -155 -1206 C \nATOM 921 CD1 ILE A 114 -7.305 30.111 -60.066 1.00 88.91 C \nANISOU 921 CD1 ILE A 114 9110 10641 14030 375 -265 -1142 C \nATOM 922 N GLN A 115 -11.453 29.428 -63.744 1.00 70.34 N \nANISOU 922 N GLN A 115 6559 8603 11564 138 -48 -1229 N \nATOM 923 CA GLN A 115 -11.503 29.023 -65.155 1.00 69.84 C \nANISOU 923 CA GLN A 115 6495 8549 11492 119 -2 -1252 C \nATOM 924 C GLN A 115 -10.092 28.945 -65.751 1.00 70.34 C \nANISOU 924 C GLN A 115 6605 8532 11588 195 -19 -1262 C \nATOM 925 O GLN A 115 -9.344 29.911 -65.715 1.00 69.79 O \nANISOU 925 O GLN A 115 6516 8465 11537 286 -57 -1290 O \nATOM 926 CB GLN A 115 -12.337 29.949 -65.961 1.00 67.21 C \nANISOU 926 CB GLN A 115 6066 8343 11128 117 22 -1302 C \nATOM 927 CG GLN A 115 -12.784 29.335 -67.264 1.00 69.55 C \nANISOU 927 CG GLN A 115 6365 8660 11403 62 78 -1315 C \nATOM 928 CD GLN A 115 -13.549 30.315 -68.126 1.00 67.72 C \nANISOU 928 CD GLN A 115 6033 8562 11137 61 101 -1369 C \nATOM 929 OE1 GLN A 115 -13.168 31.479 -68.205 1.00 75.43 O \nANISOU 929 OE1 GLN A 115 6946 9595 12120 146 72 -1410 O \nATOM 930 NE2 GLN A 115 -14.638 29.856 -68.744 1.00 61.37 N \nANISOU 930 NE2 GLN A 115 5215 7809 10292 -35 152 -1370 N \nATOM 931 N ILE A 116 -9.734 27.775 -66.275 1.00 72.32 N \nANISOU 931 N ILE A 116 6923 8714 11844 157 8 -1237 N \nATOM 932 CA ILE A 116 -8.349 27.448 -66.592 1.00 67.44 C \nANISOU 932 CA ILE A 116 6366 8004 11252 208 -11 -1232 C \nATOM 933 C ILE A 116 -8.125 27.423 -68.094 1.00 65.60 C \nANISOU 933 C ILE A 116 6121 7793 11013 218 24 -1269 C \nATOM 934 O ILE A 116 -7.049 27.798 -68.587 1.00 65.52 O \nANISOU 934 O ILE A 116 6130 7744 11021 284 5 -1293 O \nATOM 935 CB ILE A 116 -7.942 26.123 -65.879 1.00 70.09 C \nANISOU 935 CB ILE A 116 6790 8247 11596 160 -14 -1172 C \nATOM 936 CG1 ILE A 116 -6.533 26.219 -65.354 1.00 72.44 C \nANISOU 936 CG1 ILE A 116 7146 8457 11922 219 -63 -1160 C \nATOM 937 CG2 ILE A 116 -8.186 24.851 -66.699 1.00 67.51 C \nANISOU 937 CG2 ILE A 116 6497 7904 11250 97 37 -1152 C \nATOM 938 CD1 ILE A 116 -6.464 27.134 -64.158 1.00 71.30 C \nANISOU 938 CD1 ILE A 116 6985 8314 11790 264 -114 -1158 C \nATOM 939 N ILE A 117 -9.129 26.944 -68.819 1.00 62.30 N \nANISOU 939 N ILE A 117 5675 7430 10566 150 75 -1271 N \nATOM 940 CA ILE A 117 -9.204 27.065 -70.279 1.00 66.78 C \nANISOU 940 CA ILE A 117 6210 8043 11119 153 113 -1310 C \nATOM 941 C ILE A 117 -10.689 27.128 -70.665 1.00 78.62 C \nANISOU 941 C ILE A 117 7651 9641 12580 82 157 -1322 C \nATOM 942 O ILE A 117 -11.408 26.111 -70.598 1.00 85.19 O \nANISOU 942 O ILE A 117 8518 10459 13390 2 189 -1285 O \nATOM 943 CB ILE A 117 -8.477 25.932 -71.061 1.00 61.46 C \nANISOU 943 CB ILE A 117 5602 7300 10448 133 136 -1291 C \nATOM 944 CG1 ILE A 117 -8.613 24.589 -70.378 1.00 62.49 C \nANISOU 944 CG1 ILE A 117 5801 7369 10573 72 145 -1228 C \nATOM 945 CG2 ILE A 117 -6.996 26.254 -71.186 1.00 61.72 C \nANISOU 945 CG2 ILE A 117 5673 7266 10510 208 99 -1306 C \nATOM 946 CD1 ILE A 117 -7.945 23.429 -71.086 1.00 60.78 C \nANISOU 946 CD1 ILE A 117 5642 7100 10353 52 168 -1205 C \nATOM 947 N PRO A 118 -11.147 28.329 -71.074 1.00 85.28 N \nANISOU 947 N PRO A 118 8407 10584 13410 111 157 -1373 N \nATOM 948 CA PRO A 118 -12.550 28.616 -71.346 1.00 80.21 C \nANISOU 948 CA PRO A 118 7699 10050 12725 43 192 -1389 C \nATOM 949 C PRO A 118 -13.191 27.691 -72.369 1.00 78.19 C \nANISOU 949 C PRO A 118 7466 9804 12439 -37 249 -1380 C \nATOM 950 O PRO A 118 -12.536 27.238 -73.311 1.00 90.78 O \nANISOU 950 O PRO A 118 9089 11361 14043 -19 265 -1386 O \nATOM 951 CB PRO A 118 -12.517 30.047 -71.888 1.00 82.27 C \nANISOU 951 CB PRO A 118 7866 10413 12979 112 181 -1453 C \nATOM 952 CG PRO A 118 -11.270 30.641 -71.342 1.00 80.41 C \nANISOU 952 CG PRO A 118 7650 10118 12785 221 127 -1460 C \nATOM 953 CD PRO A 118 -10.291 29.514 -71.318 1.00 82.31 C \nANISOU 953 CD PRO A 118 7993 10226 13054 217 123 -1421 C \nATOM 954 N LYS A 119 -14.478 27.453 -72.173 1.00 73.71 N \nANISOU 954 N LYS A 119 6886 9288 11832 -127 278 -1366 N \nATOM 955 CA LYS A 119 -15.281 26.522 -72.954 1.00 72.76 C \nANISOU 955 CA LYS A 119 6799 9172 11675 -214 332 -1349 C \nATOM 956 C LYS A 119 -15.528 27.071 -74.337 1.00 74.88 C \nANISOU 956 C LYS A 119 7004 9527 11920 -215 362 -1399 C \nATOM 957 O LYS A 119 -15.800 26.325 -75.291 1.00 83.96 O \nANISOU 957 O LYS A 119 8184 10669 13048 -262 404 -1391 O \nATOM 958 CB LYS A 119 -16.622 26.272 -72.234 1.00 72.11 C \nANISOU 958 CB LYS A 119 6727 9121 11552 -310 349 -1323 C \nATOM 959 CG LYS A 119 -17.519 25.214 -72.854 1.00 76.56 C \nANISOU 959 CG LYS A 119 7347 9670 12071 -403 403 -1298 C \nATOM 960 CD LYS A 119 -18.931 25.267 -72.252 1.00 79.50 C \nANISOU 960 CD LYS A 119 7719 10093 12392 -503 420 -1286 C \nATOM 961 CE LYS A 119 -19.854 24.215 -72.868 1.00 81.55 C \nANISOU 961 CE LYS A 119 8050 10331 12604 -595 474 -1260 C \nATOM 962 NZ LYS A 119 -19.702 22.914 -72.168 1.00 93.01 N \nANISOU 962 NZ LYS A 119 9612 11665 14063 -603 476 -1200 N \nATOM 963 N SER A 120 -15.437 28.388 -74.451 1.00 78.87 N \nANISOU 963 N SER A 120 7420 10121 12427 -161 342 -1450 N \nATOM 964 CA SER A 120 -15.672 29.078 -75.724 1.00 73.77 C \nANISOU 964 CA SER A 120 6699 9574 11756 -154 369 -1504 C \nATOM 965 C SER A 120 -14.371 29.182 -76.567 1.00 70.95 C \nANISOU 965 C SER A 120 6353 9171 11435 -63 359 -1531 C \nATOM 966 O SER A 120 -14.407 29.612 -77.711 1.00 79.61 O \nANISOU 966 O SER A 120 7400 10333 12514 -53 383 -1574 O \nATOM 967 CB SER A 120 -16.291 30.436 -75.439 1.00 69.62 C \nANISOU 967 CB SER A 120 6068 9180 11206 -141 354 -1548 C \nATOM 968 OG SER A 120 -15.701 31.009 -74.281 1.00 73.20 O \nANISOU 968 OG SER A 120 6514 9607 11692 -66 301 -1543 O \nATOM 969 N SER A 121 -13.246 28.719 -76.036 1.00 62.73 N \nANISOU 969 N SER A 121 5381 8015 10438 -8 327 -1503 N \nATOM 970 CA SER A 121 -12.002 28.671 -76.807 1.00 65.36 C \nANISOU 970 CA SER A 121 5742 8293 10799 62 320 -1523 C \nATOM 971 C SER A 121 -11.983 27.554 -77.844 1.00 61.08 C \nANISOU 971 C SER A 121 5247 7717 10243 8 364 -1505 C \nATOM 972 O SER A 121 -11.295 27.652 -78.835 1.00 70.96 O \nANISOU 972 O SER A 121 6496 8965 11500 45 372 -1534 O \nATOM 973 CB SER A 121 -10.823 28.476 -75.877 1.00 66.20 C \nANISOU 973 CB SER A 121 5914 8290 10950 124 272 -1496 C \nATOM 974 OG SER A 121 -10.754 27.110 -75.528 1.00 77.55 O \nANISOU 974 OG SER A 121 7434 9641 12391 66 283 -1436 O \nATOM 975 N TRP A 122 -12.733 26.488 -77.610 1.00 63.73 N \nANISOU 975 N TRP A 122 5629 8027 10557 -77 390 -1456 N \nATOM 976 CA TRP A 122 -12.749 25.299 -78.495 1.00 66.18 C \nANISOU 976 CA TRP A 122 5993 8301 10850 -125 430 -1429 C \nATOM 977 C TRP A 122 -13.508 25.657 -79.768 1.00 70.67 C \nANISOU 977 C TRP A 122 6504 8967 11380 -164 473 -1468 C \nATOM 978 O TRP A 122 -14.669 25.273 -79.979 1.00 80.89 O \nANISOU 978 O TRP A 122 7800 10302 12633 -247 510 -1453 O \nATOM 979 CB TRP A 122 -13.373 24.057 -77.784 1.00 65.17 C \nANISOU 979 CB TRP A 122 5938 8116 10706 -195 445 -1364 C \nATOM 980 CG TRP A 122 -12.739 23.724 -76.443 1.00 57.49 C \nANISOU 980 CG TRP A 122 5017 7058 9767 -164 404 -1325 C \nATOM 981 CD1 TRP A 122 -13.296 23.859 -75.238 1.00 57.99 C \nANISOU 981 CD1 TRP A 122 5086 7118 9831 -185 385 -1303 C \nATOM 982 CD2 TRP A 122 -11.407 23.281 -76.224 1.00 54.09 C \nANISOU 982 CD2 TRP A 122 4636 6544 9372 -110 376 -1307 C \nATOM 983 NE1 TRP A 122 -12.399 23.537 -74.257 1.00 57.28 N \nANISOU 983 NE1 TRP A 122 5044 6946 9776 -144 346 -1273 N \nATOM 984 CE2 TRP A 122 -11.219 23.189 -74.848 1.00 52.15 C \nANISOU 984 CE2 TRP A 122 4422 6246 9147 -99 339 -1274 C \nATOM 985 CE3 TRP A 122 -10.337 22.998 -77.070 1.00 56.64 C \nANISOU 985 CE3 TRP A 122 4980 6835 9708 -75 377 -1317 C \nATOM 986 CZ2 TRP A 122 -10.019 22.768 -74.275 1.00 53.09 C \nANISOU 986 CZ2 TRP A 122 4594 6282 9297 -58 305 -1249 C \nATOM 987 CZ3 TRP A 122 -9.129 22.578 -76.497 1.00 56.12 C \nANISOU 987 CZ3 TRP A 122 4967 6685 9670 -36 342 -1292 C \nATOM 988 CH2 TRP A 122 -9.000 22.458 -75.109 1.00 55.26 C \nANISOU 988 CH2 TRP A 122 4890 6525 9579 -29 307 -1258 C \nATOM 989 N SER A 123 -12.821 26.383 -80.634 1.00 72.74 N \nANISOU 989 N SER A 123 6722 9263 11653 -104 470 -1519 N \nATOM 990 CA SER A 123 -13.379 26.859 -81.905 1.00 80.01 C \nANISOU 990 CA SER A 123 7579 10281 12538 -129 507 -1565 C \nATOM 991 C SER A 123 -13.542 25.778 -82.965 1.00 88.82 C \nANISOU 991 C SER A 123 8739 11380 13629 -186 552 -1543 C \nATOM 992 O SER A 123 -14.438 25.873 -83.803 1.00 99.52 O \nANISOU 992 O SER A 123 10058 12813 14942 -244 590 -1560 O \nATOM 993 CB SER A 123 -12.477 27.944 -82.467 1.00 81.84 C \nANISOU 993 CB SER A 123 7759 10547 12791 -36 487 -1627 C \nATOM 994 OG SER A 123 -11.956 28.700 -81.397 1.00 92.97 O \nANISOU 994 OG SER A 123 9158 11934 14233 37 438 -1635 O \nATOM 995 N ASP A 124 -12.677 24.760 -82.940 1.00 93.21 N \nANISOU 995 N ASP A 124 9371 11838 14207 -171 546 -1504 N \nATOM 996 CA ASP A 124 -12.639 23.757 -84.013 1.00 90.10 C \nANISOU 996 CA ASP A 124 9015 11430 13789 -210 585 -1485 C \nATOM 997 C ASP A 124 -13.258 22.430 -83.586 1.00 86.91 C \nANISOU 997 C ASP A 124 8685 10973 13363 -273 604 -1417 C \nATOM 998 O ASP A 124 -13.285 21.455 -84.364 1.00 83.48 O \nANISOU 998 O ASP A 124 8291 10523 12905 -304 636 -1391 O \nATOM 999 CB ASP A 124 -11.194 23.558 -84.484 1.00 90.61 C \nANISOU 999 CB ASP A 124 9106 11439 13883 -149 568 -1494 C \nATOM 1000 CG ASP A 124 -10.492 24.884 -84.772 1.00 97.37 C \nANISOU 1000 CG ASP A 124 9905 12330 14762 -73 544 -1561 C \nATOM 1001 OD1 ASP A 124 -11.082 25.723 -85.485 1.00102.63 O \nANISOU 1001 OD1 ASP A 124 10500 13090 15406 -78 563 -1610 O \nATOM 1002 OD2 ASP A 124 -9.372 25.101 -84.270 1.00 95.48 O \nANISOU 1002 OD2 ASP A 124 9693 12026 14558 -9 505 -1565 O \nATOM 1003 N HIS A 125 -13.754 22.385 -82.353 1.00 75.71 N \nANISOU 1003 N HIS A 125 7288 9530 11950 -290 586 -1388 N \nATOM 1004 CA HIS A 125 -14.388 21.183 -81.863 1.00 73.12 C \nANISOU 1004 CA HIS A 125 7033 9150 11597 -344 605 -1326 C \nATOM 1005 C HIS A 125 -15.750 21.556 -81.311 1.00 73.17 C \nANISOU 1005 C HIS A 125 7025 9203 11572 -409 616 -1325 C \nATOM 1006 O HIS A 125 -15.993 22.689 -80.885 1.00 69.97 O \nANISOU 1006 O HIS A 125 6555 8855 11175 -399 596 -1362 O \nATOM 1007 CB HIS A 125 -13.567 20.532 -80.754 1.00 71.18 C \nANISOU 1007 CB HIS A 125 6847 8812 11386 -306 570 -1283 C \nATOM 1008 CG HIS A 125 -12.148 20.244 -81.126 1.00 67.26 C \nANISOU 1008 CG HIS A 125 6367 8271 10919 -248 552 -1284 C \nATOM 1009 ND1 HIS A 125 -11.174 21.224 -81.163 1.00 61.50 N \nANISOU 1009 ND1 HIS A 125 5596 7546 10226 -185 519 -1329 N \nATOM 1010 CD2 HIS A 125 -11.526 19.071 -81.411 1.00 69.94 C \nANISOU 1010 CD2 HIS A 125 6762 8560 11251 -245 562 -1245 C \nATOM 1011 CE1 HIS A 125 -10.027 20.670 -81.521 1.00 69.89 C \nANISOU 1011 CE1 HIS A 125 6694 8560 11301 -154 510 -1319 C \nATOM 1012 NE2 HIS A 125 -10.205 19.362 -81.662 1.00 70.44 N \nANISOU 1012 NE2 HIS A 125 6818 8602 11346 -191 535 -1268 N \nATOM 1013 N GLU A 126 -16.642 20.585 -81.322 1.00 71.70 N \nANISOU 1013 N GLU A 126 6904 8994 11345 -475 649 -1282 N \nATOM 1014 CA GLU A 126 -17.980 20.797 -80.832 1.00 70.90 C \nANISOU 1014 CA GLU A 126 6806 8929 11205 -551 664 -1276 C \nATOM 1015 C GLU A 126 -18.046 20.506 -79.329 1.00 74.15 C \nANISOU 1015 C GLU A 126 7264 9277 11633 -548 636 -1238 C \nATOM 1016 O GLU A 126 -18.215 19.367 -78.922 1.00 78.04 O \nANISOU 1016 O GLU A 126 7842 9696 12111 -564 647 -1186 O \nATOM 1017 CB GLU A 126 -18.971 19.915 -81.591 1.00 68.36 C \nANISOU 1017 CB GLU A 126 6543 8606 10823 -627 715 -1249 C \nATOM 1018 CG GLU A 126 -20.410 20.325 -81.379 1.00 74.35 C \nANISOU 1018 CG GLU A 126 7299 9422 11530 -721 736 -1256 C \nATOM 1019 CD GLU A 126 -20.620 21.771 -81.770 1.00 76.82 C \nANISOU 1019 CD GLU A 126 7497 9850 11839 -729 729 -1320 C \nATOM 1020 OE1 GLU A 126 -20.888 22.545 -80.832 1.00 87.42 O \nANISOU 1020 OE1 GLU A 126 8800 11226 13190 -735 704 -1335 O \nATOM 1021 OE2 GLU A 126 -20.474 22.126 -82.981 1.00 73.42 O \nANISOU 1021 OE2 GLU A 126 7017 9482 11399 -725 748 -1356 O \nATOM 1022 N ALA A 127 -17.968 21.565 -78.523 1.00 82.80 N \nANISOU 1022 N ALA A 127 8300 10407 12753 -526 601 -1266 N \nATOM 1023 CA ALA A 127 -17.995 21.463 -77.060 1.00 86.86 C \nANISOU 1023 CA ALA A 127 8846 10872 13285 -522 571 -1237 C \nATOM 1024 C ALA A 127 -19.393 21.184 -76.501 1.00 89.41 C \nANISOU 1024 C ALA A 127 9210 11204 13557 -615 594 -1213 C \nATOM 1025 O ALA A 127 -19.592 20.267 -75.705 1.00 81.18 O \nANISOU 1025 O ALA A 127 8251 10087 12508 -632 595 -1164 O \nATOM 1026 CB ALA A 127 -17.412 22.731 -76.429 1.00 80.60 C \nANISOU 1026 CB ALA A 127 7973 10117 12532 -462 524 -1275 C \nATOM 1027 N SER A 128 -20.361 21.977 -76.951 1.00110.04 N \nANISOU 1027 N SER A 128 11768 13913 16129 -678 614 -1248 N \nATOM 1028 CA SER A 128 -21.716 21.985 -76.369 1.00116.37 C \nANISOU 1028 CA SER A 128 12597 14741 16878 -777 631 -1235 C \nATOM 1029 C SER A 128 -22.487 20.659 -76.476 1.00110.26 C \nANISOU 1029 C SER A 128 11943 13894 16056 -844 671 -1185 C \nATOM 1030 O SER A 128 -23.462 20.451 -75.727 1.00100.42 O \nANISOU 1030 O SER A 128 10749 12634 14770 -917 681 -1163 O \nATOM 1031 CB SER A 128 -22.539 23.093 -77.023 1.00119.22 C \nANISOU 1031 CB SER A 128 12869 15233 17197 -836 648 -1286 C \nATOM 1032 OG SER A 128 -22.735 22.813 -78.399 1.00120.95 O \nANISOU 1032 OG SER A 128 13092 15478 17386 -862 687 -1298 O \nATOM 1033 N SER A 129 -22.051 19.778 -77.385 1.00 98.09 N \nANISOU 1033 N SER A 129 10448 12306 14515 -816 694 -1166 N \nATOM 1034 CA SER A 129 -22.658 18.449 -77.521 1.00 97.01 C \nANISOU 1034 CA SER A 129 10431 12095 14335 -858 730 -1115 C \nATOM 1035 C SER A 129 -22.041 17.456 -76.535 1.00 91.46 C \nANISOU 1035 C SER A 129 9803 11286 13660 -802 711 -1065 C \nATOM 1036 O SER A 129 -22.287 16.253 -76.598 1.00 73.18 O \nANISOU 1036 O SER A 129 7588 8902 11316 -808 736 -1020 O \nATOM 1037 CB SER A 129 -22.528 17.923 -78.939 1.00104.37 C \nANISOU 1037 CB SER A 129 11377 13032 15247 -853 764 -1115 C \nATOM 1038 OG SER A 129 -22.596 16.509 -78.945 1.00113.76 O \nANISOU 1038 OG SER A 129 12679 14131 16413 -845 786 -1059 O \nATOM 1039 N GLY A 130 -21.228 17.974 -75.628 1.00 91.36 N \nANISOU 1039 N GLY A 130 9744 11267 13703 -745 666 -1074 N \nATOM 1040 CA GLY A 130 -20.693 17.167 -74.568 1.00 87.03 C \nANISOU 1040 CA GLY A 130 9257 10631 13178 -702 644 -1030 C \nATOM 1041 C GLY A 130 -21.754 16.791 -73.569 1.00 78.69 C \nANISOU 1041 C GLY A 130 8275 9540 12082 -767 654 -1001 C \nATOM 1042 O GLY A 130 -21.655 17.177 -72.405 1.00 75.64 O \nANISOU 1042 O GLY A 130 7876 9144 11719 -761 622 -999 O \nATOM 1043 N VAL A 131 -22.741 16.009 -74.023 1.00 71.60 N \nANISOU 1043 N VAL A 131 7463 8618 11123 -827 698 -977 N \nATOM 1044 CA VAL A 131 -23.962 15.755 -73.244 1.00 65.95 C \nANISOU 1044 CA VAL A 131 6828 7877 10355 -909 715 -956 C \nATOM 1045 C VAL A 131 -24.420 14.302 -73.399 1.00 61.88 C \nANISOU 1045 C VAL A 131 6446 7274 9791 -915 752 -905 C \nATOM 1046 O VAL A 131 -24.174 13.672 -74.427 1.00 56.66 O \nANISOU 1046 O VAL A 131 5808 6602 9119 -886 776 -894 O \nATOM 1047 CB VAL A 131 -25.073 16.730 -73.695 1.00 66.10 C \nANISOU 1047 CB VAL A 131 6803 7985 10328 -1009 734 -995 C \nATOM 1048 CG1 VAL A 131 -26.473 16.205 -73.347 1.00 73.34 C \nANISOU 1048 CG1 VAL A 131 7832 8866 11168 -1111 769 -970 C \nATOM 1049 CG2 VAL A 131 -24.845 18.098 -73.079 1.00 61.14 C \nANISOU 1049 CG2 VAL A 131 6060 7437 9735 -1007 695 -1037 C \nATOM 1050 N SER A 132 -25.092 13.772 -72.390 1.00 62.28 N \nANISOU 1050 N SER A 132 6587 7265 9810 -949 758 -875 N \nATOM 1051 CA SER A 132 -25.610 12.402 -72.468 1.00 77.03 C \nANISOU 1051 CA SER A 132 8594 9048 11626 -950 793 -827 C \nATOM 1052 C SER A 132 -26.778 12.146 -71.511 1.00 77.12 C \nANISOU 1052 C SER A 132 8707 9012 11581 -1027 808 -808 C \nATOM 1053 O SER A 132 -26.928 12.810 -70.493 1.00 62.42 O \nANISOU 1053 O SER A 132 6813 7167 9735 -1058 782 -822 O \nATOM 1054 CB SER A 132 -24.470 11.392 -72.191 1.00 87.12 C \nANISOU 1054 CB SER A 132 9894 10266 12940 -840 778 -790 C \nATOM 1055 OG SER A 132 -24.938 10.045 -72.188 1.00 93.84 O \nANISOU 1055 OG SER A 132 10878 11040 13738 -826 811 -742 O \nATOM 1056 N SER A 133 -27.568 11.136 -71.851 1.00 93.04 N \nANISOU 1056 N SER A 133 10855 10965 13532 -1052 849 -775 N \nATOM 1057 CA SER A 133 -28.756 10.732 -71.066 1.00 93.25 C \nANISOU 1057 CA SER A 133 11008 10931 13493 -1127 870 -754 C \nATOM 1058 C SER A 133 -28.353 10.059 -69.757 1.00 89.94 C \nANISOU 1058 C SER A 133 10640 10440 13094 -1068 850 -722 C \nATOM 1059 O SER A 133 -29.115 10.064 -68.793 1.00 79.48 O \nANISOU 1059 O SER A 133 9383 9080 11735 -1127 852 -716 O \nATOM 1060 CB SER A 133 -29.625 9.751 -71.865 1.00 93.82 C \nANISOU 1060 CB SER A 133 11218 10943 13485 -1155 920 -725 C \nATOM 1061 OG SER A 133 -29.558 10.014 -73.257 1.00106.53 O \nANISOU 1061 OG SER A 133 12778 12609 15090 -1164 938 -743 O \nATOM 1062 N ALA A 134 -27.159 9.457 -69.737 1.00 95.63 N \nANISOU 1062 N ALA A 134 11331 11140 13864 -954 831 -702 N \nATOM 1063 CA ALA A 134 -26.621 8.823 -68.518 1.00 86.44 C \nANISOU 1063 CA ALA A 134 10201 9919 12723 -890 809 -672 C \nATOM 1064 C ALA A 134 -26.469 9.849 -67.389 1.00 77.21 C \nANISOU 1064 C ALA A 134 8955 8785 11597 -923 768 -697 C \nATOM 1065 O ALA A 134 -26.527 9.507 -66.203 1.00 70.52 O \nANISOU 1065 O ALA A 134 8157 7891 10748 -916 755 -678 O \nATOM 1066 CB ALA A 134 -25.297 8.154 -68.814 1.00 75.39 C \nANISOU 1066 CB ALA A 134 8761 8515 11368 -774 794 -652 C \nATOM 1067 N CYS A 135 -26.288 11.107 -67.782 1.00 79.24 N \nANISOU 1067 N CYS A 135 9091 9128 11889 -956 748 -741 N \nATOM 1068 CA CYS A 135 -26.150 12.219 -66.848 1.00 88.59 C \nANISOU 1068 CA CYS A 135 10189 10361 13111 -985 708 -769 C \nATOM 1069 C CYS A 135 -27.330 13.198 -66.961 1.00 92.71 C \nANISOU 1069 C CYS A 135 10691 10945 13588 -1104 721 -802 C \nATOM 1070 O CYS A 135 -27.265 14.191 -67.681 1.00 90.21 O \nANISOU 1070 O CYS A 135 10273 10715 13287 -1126 715 -841 O \nATOM 1071 CB CYS A 135 -24.827 12.967 -67.110 1.00 85.79 C \nANISOU 1071 CB CYS A 135 9698 10064 12836 -910 667 -794 C \nATOM 1072 SG CYS A 135 -24.091 13.809 -65.694 1.00103.82 S \nANISOU 1072 SG CYS A 135 11900 12367 15181 -882 607 -805 S \nATOM 1073 N PRO A 136 -28.405 12.935 -66.220 1.00102.37 N \nANISOU 1073 N PRO A 136 12014 12130 14754 -1184 739 -789 N \nATOM 1074 CA PRO A 136 -29.516 13.859 -66.186 1.00109.90 C \nANISOU 1074 CA PRO A 136 12949 13148 15659 -1307 749 -819 C \nATOM 1075 C PRO A 136 -29.201 15.113 -65.376 1.00109.56 C \nANISOU 1075 C PRO A 136 12781 13188 15660 -1319 703 -851 C \nATOM 1076 O PRO A 136 -28.249 15.137 -64.601 1.00123.73 O \nANISOU 1076 O PRO A 136 14531 14966 17515 -1240 665 -842 O \nATOM 1077 CB PRO A 136 -30.634 13.039 -65.517 1.00116.42 C \nANISOU 1077 CB PRO A 136 13936 13890 16410 -1379 780 -789 C \nATOM 1078 CG PRO A 136 -30.176 11.615 -65.574 1.00117.29 C \nANISOU 1078 CG PRO A 136 14150 13893 16521 -1285 796 -744 C \nATOM 1079 CD PRO A 136 -28.694 11.716 -65.450 1.00115.07 C \nANISOU 1079 CD PRO A 136 13761 13631 16328 -1166 755 -744 C \nATOM 1080 N TYR A 137 -30.016 16.138 -65.567 1.00110.05 N \nANISOU 1080 N TYR A 137 12787 13343 15685 -1420 708 -886 N \nATOM 1081 CA TYR A 137 -29.921 17.395 -64.834 1.00110.16 C \nANISOU 1081 CA TYR A 137 12682 13452 15723 -1442 668 -918 C \nATOM 1082 C TYR A 137 -31.279 17.718 -64.233 1.00116.15 C \nANISOU 1082 C TYR A 137 13489 14240 16404 -1583 685 -925 C \nATOM 1083 O TYR A 137 -31.523 17.557 -63.031 1.00121.73 O \nANISOU 1083 O TYR A 137 14242 14909 17100 -1608 671 -908 O \nATOM 1084 CB TYR A 137 -29.490 18.538 -65.769 1.00103.23 C \nANISOU 1084 CB TYR A 137 11655 12693 14876 -1421 654 -964 C \nATOM 1085 CG TYR A 137 -29.820 19.948 -65.283 1.00 93.84 C \nANISOU 1085 CG TYR A 137 10345 11630 13680 -1476 626 -1003 C \nATOM 1086 CD1 TYR A 137 -29.793 20.278 -63.930 1.00 95.50 C \nANISOU 1086 CD1 TYR A 137 10541 11844 13903 -1481 592 -997 C \nATOM 1087 CD2 TYR A 137 -30.148 20.951 -66.190 1.00 95.91 C \nANISOU 1087 CD2 TYR A 137 10506 12017 13920 -1519 634 -1047 C \nATOM 1088 CE1 TYR A 137 -30.091 21.561 -63.498 1.00 93.12 C \nANISOU 1088 CE1 TYR A 137 10125 11666 13590 -1526 566 -1032 C \nATOM 1089 CE2 TYR A 137 -30.444 22.240 -65.769 1.00 94.89 C \nANISOU 1089 CE2 TYR A 137 10259 12016 13778 -1562 609 -1084 C \nATOM 1090 CZ TYR A 137 -30.408 22.536 -64.422 1.00 93.61 C \nANISOU 1090 CZ TYR A 137 10084 11855 13628 -1564 574 -1075 C \nATOM 1091 OH TYR A 137 -30.689 23.803 -64.000 1.00 95.91 O \nANISOU 1091 OH TYR A 137 10255 12281 13903 -1601 548 -1109 O \nATOM 1092 N GLN A 138 -32.153 18.213 -65.089 1.00105.69 N \nANISOU 1092 N GLN A 138 12148 12990 15020 -1681 713 -951 N \nATOM 1093 CA GLN A 138 -33.491 18.522 -64.693 1.00100.73 C \nANISOU 1093 CA GLN A 138 11569 12398 14305 -1830 734 -959 C \nATOM 1094 C GLN A 138 -34.350 17.724 -65.664 1.00 97.92 C \nANISOU 1094 C GLN A 138 11342 11987 13877 -1900 788 -945 C \nATOM 1095 O GLN A 138 -35.244 18.268 -66.332 1.00 87.06 O \nANISOU 1095 O GLN A 138 9952 10692 12437 -2013 813 -970 O \nATOM 1096 CB GLN A 138 -33.697 20.025 -64.805 1.00 97.01 C \nANISOU 1096 CB GLN A 138 10940 12094 13827 -1886 712 -1008 C \nATOM 1097 CG GLN A 138 -34.839 20.541 -63.979 1.00 97.74 C \nANISOU 1097 CG GLN A 138 11049 12244 13845 -2029 715 -1018 C \nATOM 1098 CD GLN A 138 -34.529 20.680 -62.502 1.00 88.57 C \nANISOU 1098 CD GLN A 138 9874 11064 12715 -2001 676 -1006 C \nATOM 1099 OE1 GLN A 138 -33.596 21.377 -62.108 1.00 85.11 O \nANISOU 1099 OE1 GLN A 138 9311 10680 12347 -1909 631 -1019 O \nATOM 1100 NE2 GLN A 138 -35.354 20.069 -61.674 1.00 90.71 N \nANISOU 1100 NE2 GLN A 138 10276 11262 12928 -2088 694 -981 N \nATOM 1101 N GLY A 139 -34.069 16.417 -65.728 1.00 92.23 N \nANISOU 1101 N GLY A 139 10747 11131 13164 -1830 806 -904 N \nATOM 1102 CA GLY A 139 -34.684 15.516 -66.696 1.00 95.76 C \nANISOU 1102 CA GLY A 139 11324 11509 13552 -1862 855 -884 C \nATOM 1103 C GLY A 139 -33.921 15.520 -68.012 1.00104.82 C \nANISOU 1103 C GLY A 139 12398 12687 14742 -1780 860 -893 C \nATOM 1104 O GLY A 139 -33.615 14.467 -68.582 1.00114.48 O \nANISOU 1104 O GLY A 139 13705 13823 15968 -1710 881 -862 O \nATOM 1105 N THR A 140 -33.621 16.721 -68.496 1.00105.65 N \nANISOU 1105 N THR A 140 12344 12922 14876 -1788 840 -937 N \nATOM 1106 CA THR A 140 -32.885 16.911 -69.734 1.00111.10 C \nANISOU 1106 CA THR A 140 12949 13658 15607 -1716 841 -954 C \nATOM 1107 C THR A 140 -31.543 16.184 -69.666 1.00108.80 C \nANISOU 1107 C THR A 140 12652 13289 15397 -1561 820 -929 C \nATOM 1108 O THR A 140 -30.953 16.072 -68.592 1.00111.94 O \nANISOU 1108 O THR A 140 13042 13649 15841 -1501 788 -915 O \nATOM 1109 CB THR A 140 -32.596 18.407 -69.994 1.00113.46 C \nANISOU 1109 CB THR A 140 13064 14110 15936 -1725 814 -1008 C \nATOM 1110 OG1 THR A 140 -31.746 18.910 -68.957 1.00124.97 O \nANISOU 1110 OG1 THR A 140 14436 15583 17463 -1648 764 -1014 O \nATOM 1111 CG2 THR A 140 -33.878 19.236 -70.034 1.00115.31 C \nANISOU 1111 CG2 THR A 140 13280 14447 16086 -1883 831 -1037 C \nATOM 1112 N PRO A 141 -31.058 15.690 -70.815 1.00105.42 N \nANISOU 1112 N PRO A 141 12228 12844 14983 -1500 838 -922 N \nATOM 1113 CA PRO A 141 -29.718 15.137 -70.838 1.00108.41 C \nANISOU 1113 CA PRO A 141 12582 13173 15438 -1360 816 -904 C \nATOM 1114 C PRO A 141 -28.663 16.221 -70.632 1.00109.79 C \nANISOU 1114 C PRO A 141 12597 13428 15691 -1294 768 -940 C \nATOM 1115 O PRO A 141 -28.624 17.195 -71.377 1.00119.55 O \nANISOU 1115 O PRO A 141 13726 14764 16933 -1312 765 -982 O \nATOM 1116 CB PRO A 141 -29.602 14.540 -72.246 1.00104.30 C \nANISOU 1116 CB PRO A 141 12090 12639 14900 -1334 848 -896 C \nATOM 1117 CG PRO A 141 -30.582 15.284 -73.070 1.00100.54 C \nANISOU 1117 CG PRO A 141 11587 12247 14365 -1447 874 -929 C \nATOM 1118 CD PRO A 141 -31.713 15.601 -72.134 1.00106.28 C \nANISOU 1118 CD PRO A 141 12367 12980 15036 -1562 879 -931 C \nATOM 1119 N SER A 142 -27.840 16.063 -69.602 1.00110.56 N \nANISOU 1119 N SER A 142 12682 13482 15843 -1218 732 -923 N \nATOM 1120 CA SER A 142 -26.761 17.015 -69.314 1.00 98.64 C \nANISOU 1120 CA SER A 142 11040 12032 14409 -1145 684 -952 C \nATOM 1121 C SER A 142 -25.451 16.248 -69.086 1.00 85.82 C \nANISOU 1121 C SER A 142 9429 10332 12846 -1026 661 -923 C \nATOM 1122 O SER A 142 -25.286 15.113 -69.556 1.00 80.42 O \nANISOU 1122 O SER A 142 8827 9580 12149 -992 686 -891 O \nATOM 1123 CB SER A 142 -27.151 17.911 -68.136 1.00 99.38 C \nANISOU 1123 CB SER A 142 11086 12174 14501 -1194 654 -968 C \nATOM 1124 OG SER A 142 -27.219 17.121 -66.969 1.00105.97 O \nANISOU 1124 OG SER A 142 12014 12918 15333 -1188 648 -929 O \nATOM 1125 N PHE A 143 -24.535 16.873 -68.360 1.00 77.68 N \nANISOU 1125 N PHE A 143 8319 9319 11877 -965 614 -935 N \nATOM 1126 CA PHE A 143 -23.179 16.378 -68.186 1.00 69.93 C \nANISOU 1126 CA PHE A 143 7330 8286 10955 -858 587 -916 C \nATOM 1127 C PHE A 143 -22.443 17.246 -67.184 1.00 61.66 C \nANISOU 1127 C PHE A 143 6205 7261 9963 -816 533 -931 C \nATOM 1128 O PHE A 143 -22.874 18.319 -66.879 1.00 59.83 O \nANISOU 1128 O PHE A 143 5906 7100 9727 -855 518 -962 O \nATOM 1129 CB PHE A 143 -22.449 16.408 -69.508 1.00 63.84 C \nANISOU 1129 CB PHE A 143 6510 7539 10206 -806 595 -934 C \nATOM 1130 CG PHE A 143 -21.116 15.741 -69.470 1.00 61.83 C \nANISOU 1130 CG PHE A 143 6263 7231 10000 -710 574 -911 C \nATOM 1131 CD1 PHE A 143 -21.018 14.346 -69.499 1.00 61.68 C \nANISOU 1131 CD1 PHE A 143 6339 7136 9959 -686 597 -864 C \nATOM 1132 CD2 PHE A 143 -19.953 16.489 -69.424 1.00 60.18 C \nANISOU 1132 CD2 PHE A 143 5967 7047 9852 -643 532 -935 C \nATOM 1133 CE1 PHE A 143 -19.772 13.717 -69.502 1.00 51.67 C \nANISOU 1133 CE1 PHE A 143 5071 5832 8729 -603 578 -843 C \nATOM 1134 CE2 PHE A 143 -18.715 15.864 -69.416 1.00 52.19 C \nANISOU 1134 CE2 PHE A 143 4965 5987 8877 -566 514 -914 C \nATOM 1135 CZ PHE A 143 -18.626 14.487 -69.445 1.00 48.32 C \nANISOU 1135 CZ PHE A 143 4562 5434 8364 -550 536 -868 C \nATOM 1136 N PHE A 144 -21.349 16.750 -66.653 1.00 55.82 N \nANISOU 1136 N PHE A 144 5478 6463 9268 -738 505 -906 N \nATOM 1137 CA PHE A 144 -20.536 17.505 -65.705 1.00 57.88 C \nANISOU 1137 CA PHE A 144 5675 6735 9581 -691 451 -916 C \nATOM 1138 C PHE A 144 -20.353 18.943 -66.176 1.00 57.64 C \nANISOU 1138 C PHE A 144 5529 6798 9574 -680 430 -968 C \nATOM 1139 O PHE A 144 -20.210 19.206 -67.373 1.00 58.92 O \nANISOU 1139 O PHE A 144 5652 7001 9737 -668 447 -995 O \nATOM 1140 CB PHE A 144 -19.142 16.860 -65.544 1.00 58.15 C \nANISOU 1140 CB PHE A 144 5724 6708 9663 -602 426 -891 C \nATOM 1141 CG PHE A 144 -19.166 15.430 -65.044 1.00 49.70 C \nANISOU 1141 CG PHE A 144 4757 5556 8571 -596 444 -840 C \nATOM 1142 CD1 PHE A 144 -18.780 14.360 -65.879 1.00 44.33 C \nANISOU 1142 CD1 PHE A 144 4123 4841 7879 -562 471 -817 C \nATOM 1143 CD2 PHE A 144 -19.594 15.173 -63.774 1.00 44.60 C \nANISOU 1143 CD2 PHE A 144 4159 4875 7912 -623 433 -816 C \nATOM 1144 CE1 PHE A 144 -18.825 13.050 -65.409 1.00 52.12 C \nANISOU 1144 CE1 PHE A 144 5201 5762 8839 -549 487 -771 C \nATOM 1145 CE2 PHE A 144 -19.625 13.887 -63.278 1.00 48.27 C \nANISOU 1145 CE2 PHE A 144 4718 5269 8354 -612 449 -771 C \nATOM 1146 CZ PHE A 144 -19.250 12.816 -64.083 1.00 54.92 C \nANISOU 1146 CZ PHE A 144 5605 6080 9183 -572 476 -748 C \nATOM 1147 N ARG A 145 -20.362 19.866 -65.228 1.00 53.10 N \nANISOU 1147 N ARG A 145 4901 6260 9016 -681 393 -983 N \nATOM 1148 CA ARG A 145 -20.253 21.287 -65.539 1.00 53.25 C \nANISOU 1148 CA ARG A 145 4807 6376 9050 -664 370 -1032 C \nATOM 1149 C ARG A 145 -18.838 21.802 -65.570 1.00 49.47 C \nANISOU 1149 C ARG A 145 4275 5887 8633 -560 326 -1046 C \nATOM 1150 O ARG A 145 -18.587 22.834 -66.183 1.00 53.55 O \nANISOU 1150 O ARG A 145 4708 6476 9164 -527 314 -1090 O \nATOM 1151 CB ARG A 145 -21.058 22.083 -64.524 1.00 57.78 C \nANISOU 1151 CB ARG A 145 5345 7008 9600 -719 352 -1041 C \nATOM 1152 CG ARG A 145 -22.548 21.751 -64.567 1.00 68.12 C \nANISOU 1152 CG ARG A 145 6705 8340 10839 -837 396 -1035 C \nATOM 1153 CD ARG A 145 -23.375 22.782 -63.836 1.00 79.87 C \nANISOU 1153 CD ARG A 145 8131 9919 12296 -900 381 -1057 C \nATOM 1154 NE ARG A 145 -24.766 22.363 -63.695 1.00 92.62 N \nANISOU 1154 NE ARG A 145 9813 11540 13838 -1021 421 -1045 N \nATOM 1155 CZ ARG A 145 -25.710 22.481 -64.632 1.00 98.78 C \nANISOU 1155 CZ ARG A 145 10592 12378 14563 -1102 462 -1065 C \nATOM 1156 NH1 ARG A 145 -25.437 22.996 -65.839 1.00101.66 N \nANISOU 1156 NH1 ARG A 145 10884 12806 14936 -1072 472 -1100 N \nATOM 1157 NH2 ARG A 145 -26.945 22.075 -64.361 1.00 93.39 N \nANISOU 1157 NH2 ARG A 145 9984 11688 13810 -1217 495 -1052 N \nATOM 1158 N ASN A 146 -17.915 21.097 -64.895 1.00 44.55 N \nANISOU 1158 N ASN A 146 3705 5177 8045 -510 302 -1011 N \nATOM 1159 CA ASN A 146 -16.564 21.615 -64.697 1.00 42.09 C \nANISOU 1159 CA ASN A 146 3356 4847 7789 -420 254 -1021 C \nATOM 1160 C ASN A 146 -15.573 21.074 -65.719 1.00 42.18 C \nANISOU 1160 C ASN A 146 3386 4819 7822 -368 263 -1021 C \nATOM 1161 O ASN A 146 -14.346 21.251 -65.617 1.00 35.93 O \nANISOU 1161 O ASN A 146 2586 3993 7071 -299 228 -1023 O \nATOM 1162 CB ASN A 146 -16.061 21.285 -63.332 1.00 43.14 C \nANISOU 1162 CB ASN A 146 3530 4917 7944 -401 217 -985 C \nATOM 1163 CG ASN A 146 -16.595 22.168 -62.285 1.00 42.23 C \nANISOU 1163 CG ASN A 146 3374 4848 7823 -422 189 -993 C \nATOM 1164 OD1 ASN A 146 -16.880 23.317 -62.549 1.00 50.07 O \nANISOU 1164 OD1 ASN A 146 4286 5924 8813 -417 179 -1033 O \nATOM 1165 ND2 ASN A 146 -16.814 21.602 -61.072 1.00 47.67 N \nANISOU 1165 ND2 ASN A 146 4118 5489 8505 -451 178 -955 N \nATOM 1166 N VAL A 147 -16.119 20.401 -66.716 1.00 42.98 N \nANISOU 1166 N VAL A 147 3514 4925 7890 -407 312 -1018 N \nATOM 1167 CA VAL A 147 -15.351 19.567 -67.592 1.00 42.38 C \nANISOU 1167 CA VAL A 147 3472 4807 7823 -374 328 -1006 C \nATOM 1168 C VAL A 147 -16.107 19.410 -68.906 1.00 46.55 C \nANISOU 1168 C VAL A 147 3994 5380 8314 -415 378 -1024 C \nATOM 1169 O VAL A 147 -17.317 19.250 -68.929 1.00 60.91 O \nANISOU 1169 O VAL A 147 5833 7222 10088 -484 411 -1019 O \nATOM 1170 CB VAL A 147 -15.127 18.230 -66.849 1.00 44.27 C \nANISOU 1170 CB VAL A 147 3799 4965 8056 -376 331 -950 C \nATOM 1171 CG1 VAL A 147 -15.780 17.044 -67.536 1.00 42.60 C \nANISOU 1171 CG1 VAL A 147 3653 4734 7800 -414 383 -924 C \nATOM 1172 CG2 VAL A 147 -13.635 18.001 -66.613 1.00 44.14 C \nANISOU 1172 CG2 VAL A 147 3791 4899 8081 -309 294 -937 C \nATOM 1173 N VAL A 148 -15.382 19.518 -70.008 1.00 50.00 N \nANISOU 1173 N VAL A 148 4403 5830 8766 -374 384 -1047 N \nATOM 1174 CA VAL A 148 -15.964 19.523 -71.327 1.00 46.31 C \nANISOU 1174 CA VAL A 148 3917 5411 8267 -406 427 -1069 C \nATOM 1175 C VAL A 148 -15.719 18.216 -72.089 1.00 45.32 C \nANISOU 1175 C VAL A 148 3856 5240 8123 -405 460 -1037 C \nATOM 1176 O VAL A 148 -14.578 17.792 -72.255 1.00 41.59 O \nANISOU 1176 O VAL A 148 3395 4728 7677 -352 444 -1026 O \nATOM 1177 CB VAL A 148 -15.394 20.676 -72.156 1.00 41.66 C \nANISOU 1177 CB VAL A 148 3242 4884 7702 -361 413 -1125 C \nATOM 1178 CG1 VAL A 148 -16.206 20.831 -73.422 1.00 43.15 C \nANISOU 1178 CG1 VAL A 148 3403 5140 7852 -407 458 -1152 C \nATOM 1179 CG2 VAL A 148 -15.401 21.934 -71.327 1.00 43.40 C \nANISOU 1179 CG2 VAL A 148 3399 5147 7944 -339 373 -1154 C \nATOM 1180 N TRP A 149 -16.784 17.667 -72.640 1.00 42.57 N \nANISOU 1180 N TRP A 149 3545 4905 7726 -465 506 -1025 N \nATOM 1181 CA TRP A 149 -16.709 16.479 -73.486 1.00 42.92 C \nANISOU 1181 CA TRP A 149 3647 4918 7744 -464 541 -996 C \nATOM 1182 C TRP A 149 -16.682 16.852 -74.925 1.00 48.44 C \nANISOU 1182 C TRP A 149 4299 5672 8433 -467 565 -1032 C \nATOM 1183 O TRP A 149 -17.730 17.046 -75.553 1.00 57.95 O \nANISOU 1183 O TRP A 149 5499 6921 9597 -525 599 -1046 O \nATOM 1184 CB TRP A 149 -17.943 15.608 -73.246 1.00 40.77 C \nANISOU 1184 CB TRP A 149 3457 4618 7416 -526 579 -960 C \nATOM 1185 CG TRP A 149 -17.959 14.334 -73.975 1.00 42.16 C \nANISOU 1185 CG TRP A 149 3701 4760 7558 -518 614 -924 C \nATOM 1186 CD1 TRP A 149 -17.107 13.945 -74.928 1.00 43.79 C \nANISOU 1186 CD1 TRP A 149 3893 4971 7774 -475 620 -924 C \nATOM 1187 CD2 TRP A 149 -18.927 13.274 -73.842 1.00 43.35 C \nANISOU 1187 CD2 TRP A 149 3949 4868 7653 -556 651 -882 C \nATOM 1188 NE1 TRP A 149 -17.458 12.698 -75.391 1.00 44.14 N \nANISOU 1188 NE1 TRP A 149 4013 4986 7773 -479 656 -884 N \nATOM 1189 CE2 TRP A 149 -18.579 12.277 -74.738 1.00 44.23 C \nANISOU 1189 CE2 TRP A 149 4097 4965 7744 -524 676 -858 C \nATOM 1190 CE3 TRP A 149 -20.054 13.087 -73.048 1.00 47.20 C \nANISOU 1190 CE3 TRP A 149 4502 5330 8103 -612 664 -864 C \nATOM 1191 CZ2 TRP A 149 -19.275 11.081 -74.830 1.00 48.25 C \nANISOU 1191 CZ2 TRP A 149 4705 5430 8197 -535 712 -814 C \nATOM 1192 CZ3 TRP A 149 -20.766 11.921 -73.168 1.00 47.45 C \nANISOU 1192 CZ3 TRP A 149 4637 5312 8079 -629 701 -823 C \nATOM 1193 CH2 TRP A 149 -20.375 10.935 -74.043 1.00 49.34 C \nANISOU 1193 CH2 TRP A 149 4911 5535 8300 -586 724 -798 C \nATOM 1194 N LEU A 150 -15.481 17.014 -75.468 1.00 47.86 N \nANISOU 1194 N LEU A 150 4190 5599 8394 -408 547 -1049 N \nATOM 1195 CA LEU A 150 -15.318 17.573 -76.826 1.00 44.09 C \nANISOU 1195 CA LEU A 150 3656 5181 7915 -403 564 -1092 C \nATOM 1196 C LEU A 150 -15.678 16.531 -77.835 1.00 48.92 C \nANISOU 1196 C LEU A 150 4316 5789 8484 -429 609 -1067 C \nATOM 1197 O LEU A 150 -15.455 15.343 -77.602 1.00 67.14 O \nANISOU 1197 O LEU A 150 6690 8041 10779 -417 617 -1019 O \nATOM 1198 CB LEU A 150 -13.909 18.089 -77.025 1.00 46.03 C \nANISOU 1198 CB LEU A 150 3859 5421 8208 -333 529 -1119 C \nATOM 1199 CG LEU A 150 -13.477 19.223 -76.106 1.00 50.59 C \nANISOU 1199 CG LEU A 150 4390 6005 8827 -296 482 -1147 C \nATOM 1200 CD1 LEU A 150 -12.008 19.545 -76.331 1.00 57.50 C \nANISOU 1200 CD1 LEU A 150 5249 6856 9743 -227 449 -1167 C \nATOM 1201 CD2 LEU A 150 -14.305 20.472 -76.352 1.00 58.25 C \nANISOU 1201 CD2 LEU A 150 5287 7059 9787 -319 487 -1196 C \nATOM 1202 N ILE A 151 -16.240 16.959 -78.956 1.00 49.54 N \nANISOU 1202 N ILE A 151 4358 5929 8536 -462 639 -1099 N \nATOM 1203 CA ILE A 151 -16.493 16.091 -80.096 1.00 52.16 C \nANISOU 1203 CA ILE A 151 4726 6265 8828 -482 681 -1082 C \nATOM 1204 C ILE A 151 -16.149 16.811 -81.386 1.00 51.48 C \nANISOU 1204 C ILE A 151 4569 6244 8746 -474 691 -1132 C \nATOM 1205 O ILE A 151 -15.844 17.984 -81.369 1.00 49.78 O \nANISOU 1205 O ILE A 151 4281 6073 8561 -454 668 -1181 O \nATOM 1206 CB ILE A 151 -17.920 15.528 -80.152 1.00 58.08 C \nANISOU 1206 CB ILE A 151 5540 7011 9518 -554 721 -1054 C \nATOM 1207 CG1 ILE A 151 -18.962 16.621 -80.380 1.00 68.44 C \nANISOU 1207 CG1 ILE A 151 6801 8396 10807 -620 733 -1097 C \nATOM 1208 CG2 ILE A 151 -18.220 14.756 -78.890 1.00 56.04 C \nANISOU 1208 CG2 ILE A 151 5359 6682 9252 -557 713 -1005 C \nATOM 1209 CD1 ILE A 151 -20.241 16.125 -81.030 1.00 76.96 C \nANISOU 1209 CD1 ILE A 151 7937 9487 11817 -699 781 -1081 C \nATOM 1210 N LYS A 152 -16.158 16.062 -82.487 1.00 55.38 N \nANISOU 1210 N LYS A 152 5088 6744 9208 -483 724 -1118 N \nATOM 1211 CA LYS A 152 -15.751 16.587 -83.776 1.00 56.67 C \nANISOU 1211 CA LYS A 152 5192 6966 9373 -474 736 -1162 C \nATOM 1212 C LYS A 152 -16.678 17.643 -84.333 1.00 69.78 C \nANISOU 1212 C LYS A 152 6793 8708 11012 -524 754 -1210 C \nATOM 1213 O LYS A 152 -17.907 17.572 -84.171 1.00 73.36 O \nANISOU 1213 O LYS A 152 7274 9176 11424 -591 778 -1197 O \nATOM 1214 CB LYS A 152 -15.630 15.437 -84.785 1.00 50.98 C \nANISOU 1214 CB LYS A 152 4517 6236 8618 -477 769 -1129 C \nATOM 1215 CG LYS A 152 -16.903 14.757 -85.149 1.00 49.04 C \nANISOU 1215 CG LYS A 152 4330 5991 8311 -538 812 -1098 C \nATOM 1216 CD LYS A 152 -16.637 13.608 -86.111 1.00 54.03 C \nANISOU 1216 CD LYS A 152 5005 6613 8909 -525 839 -1064 C \nATOM 1217 CE LYS A 152 -17.909 12.915 -86.592 1.00 53.46 C \nANISOU 1217 CE LYS A 152 5003 6539 8770 -582 883 -1032 C \nATOM 1218 NZ LYS A 152 -17.681 12.261 -87.919 1.00 58.12 N \nANISOU 1218 NZ LYS A 152 5601 7155 9328 -576 912 -1021 N \nATOM 1219 N LYS A 153 -16.076 18.611 -85.017 1.00 82.99 N \nANISOU 1219 N LYS A 153 8387 10436 12708 -494 744 -1266 N \nATOM 1220 CA LYS A 153 -16.808 19.641 -85.744 1.00 83.60 C \nANISOU 1220 CA LYS A 153 8394 10609 12762 -534 763 -1318 C \nATOM 1221 C LYS A 153 -16.623 19.367 -87.230 1.00 83.52 C \nANISOU 1221 C LYS A 153 8372 10633 12726 -542 795 -1332 C \nATOM 1222 O LYS A 153 -15.514 19.094 -87.674 1.00 79.91 O \nANISOU 1222 O LYS A 153 7916 10152 12295 -489 786 -1335 O \nATOM 1223 CB LYS A 153 -16.263 21.008 -85.382 1.00 87.87 C \nANISOU 1223 CB LYS A 153 8850 11192 13343 -483 727 -1374 C \nATOM 1224 CG LYS A 153 -17.236 22.138 -85.632 1.00 91.94 C \nANISOU 1224 CG LYS A 153 9291 11812 13830 -528 739 -1421 C \nATOM 1225 CD LYS A 153 -16.550 23.473 -85.368 1.00100.23 C \nANISOU 1225 CD LYS A 153 10255 12908 14920 -457 703 -1478 C \nATOM 1226 CE LYS A 153 -17.510 24.513 -84.818 1.00 98.34 C \nANISOU 1226 CE LYS A 153 9952 12755 14660 -492 697 -1507 C \nATOM 1227 NZ LYS A 153 -16.803 25.501 -83.956 1.00101.96 N \nANISOU 1227 NZ LYS A 153 10360 13218 15164 -410 649 -1535 N \nATOM 1228 N ASN A 154 -17.709 19.448 -87.995 1.00 87.02 N \nANISOU 1228 N ASN A 154 8808 11137 13117 -613 834 -1341 N \nATOM 1229 CA ASN A 154 -17.762 18.826 -89.315 1.00 82.84 C \nANISOU 1229 CA ASN A 154 8297 10626 12553 -636 870 -1334 C \nATOM 1230 C ASN A 154 -17.422 17.368 -89.104 1.00 80.70 C \nANISOU 1230 C ASN A 154 8119 10267 12276 -617 875 -1267 C \nATOM 1231 O ASN A 154 -17.810 16.801 -88.079 1.00 83.62 O \nANISOU 1231 O ASN A 154 8552 10578 12644 -626 867 -1224 O \nATOM 1232 CB ASN A 154 -16.811 19.505 -90.303 1.00 84.47 C \nANISOU 1232 CB ASN A 154 8430 10882 12782 -589 865 -1389 C \nATOM 1233 CG ASN A 154 -17.399 20.771 -90.884 1.00 88.00 C \nANISOU 1233 CG ASN A 154 8788 11437 13210 -620 877 -1453 C \nATOM 1234 OD1 ASN A 154 -17.612 20.889 -92.101 1.00 82.64 O \nANISOU 1234 OD1 ASN A 154 8080 10820 12500 -649 907 -1477 O \nATOM 1235 ND2 ASN A 154 -17.648 21.742 -90.015 1.00 87.90 N \nANISOU 1235 ND2 ASN A 154 8728 11455 13216 -612 852 -1480 N \nATOM 1236 N ASN A 155 -16.726 16.748 -90.044 1.00 72.98 N \nANISOU 1236 N ASN A 155 7151 9285 11294 -592 887 -1259 N \nATOM 1237 CA ASN A 155 -16.117 15.465 -89.757 1.00 79.64 C \nANISOU 1237 CA ASN A 155 8064 10056 12139 -555 882 -1201 C \nATOM 1238 C ASN A 155 -14.614 15.623 -89.506 1.00 73.88 C \nANISOU 1238 C ASN A 155 7305 9302 11464 -483 845 -1216 C \nATOM 1239 O ASN A 155 -13.767 15.219 -90.306 1.00 71.20 O \nANISOU 1239 O ASN A 155 6960 8969 11123 -458 850 -1217 O \nATOM 1240 CB ASN A 155 -16.435 14.494 -90.874 1.00 86.10 C \nANISOU 1240 CB ASN A 155 8925 10886 12905 -580 922 -1170 C \nATOM 1241 CG ASN A 155 -17.917 14.235 -90.979 1.00 89.12 C \nANISOU 1241 CG ASN A 155 9359 11274 13229 -652 956 -1148 C \nATOM 1242 OD1 ASN A 155 -18.704 14.760 -90.187 1.00 81.04 O \nANISOU 1242 OD1 ASN A 155 8339 10248 12204 -689 950 -1155 O \nATOM 1243 ND2 ASN A 155 -18.308 13.435 -91.958 1.00 97.75 N \nANISOU 1243 ND2 ASN A 155 10495 12375 14270 -676 991 -1120 N \nATOM 1244 N THR A 156 -14.304 16.285 -88.403 1.00 63.08 N \nANISOU 1244 N THR A 156 5919 7910 10140 -455 808 -1231 N \nATOM 1245 CA THR A 156 -12.932 16.629 -88.088 1.00 70.55 C \nANISOU 1245 CA THR A 156 6839 8830 11135 -393 770 -1251 C \nATOM 1246 C THR A 156 -12.686 16.881 -86.583 1.00 72.45 C \nANISOU 1246 C THR A 156 7094 9018 11415 -364 729 -1239 C \nATOM 1247 O THR A 156 -13.274 17.780 -85.985 1.00 67.73 O \nANISOU 1247 O THR A 156 6465 8441 10830 -375 718 -1263 O \nATOM 1248 CB THR A 156 -12.485 17.865 -88.859 1.00 70.27 C \nANISOU 1248 CB THR A 156 6727 8853 11119 -373 764 -1323 C \nATOM 1249 OG1 THR A 156 -12.876 17.720 -90.223 1.00 83.70 O \nANISOU 1249 OG1 THR A 156 8410 10611 12780 -408 804 -1337 O \nATOM 1250 CG2 THR A 156 -10.958 18.024 -88.778 1.00 75.58 C \nANISOU 1250 CG2 THR A 156 7395 9491 11833 -311 730 -1340 C \nATOM 1251 N TYR A 157 -11.798 16.076 -86.003 1.00 69.12 N \nANISOU 1251 N TYR A 157 6716 8535 11009 -331 708 -1200 N \nATOM 1252 CA TYR A 157 -11.298 16.302 -84.652 1.00 57.87 C \nANISOU 1252 CA TYR A 157 5304 7059 9625 -298 665 -1190 C \nATOM 1253 C TYR A 157 -9.788 16.618 -84.812 1.00 60.10 C \nANISOU 1253 C TYR A 157 5570 7323 9942 -248 634 -1215 C \nATOM 1254 O TYR A 157 -8.942 15.742 -84.740 1.00 56.32 O \nANISOU 1254 O TYR A 157 5128 6809 9461 -234 625 -1182 O \nATOM 1255 CB TYR A 157 -11.553 15.068 -83.781 1.00 51.99 C \nANISOU 1255 CB TYR A 157 4631 6260 8863 -306 667 -1122 C \nATOM 1256 CG TYR A 157 -11.304 15.277 -82.269 1.00 43.14 C \nANISOU 1256 CG TYR A 157 3526 5088 7777 -285 627 -1107 C \nATOM 1257 CD1 TYR A 157 -12.309 15.136 -81.371 1.00 40.66 C \nANISOU 1257 CD1 TYR A 157 3241 4756 7451 -313 631 -1082 C \nATOM 1258 CD2 TYR A 157 -10.042 15.591 -81.773 1.00 37.98 C \nANISOU 1258 CD2 TYR A 157 2863 4403 7164 -240 585 -1118 C \nATOM 1259 CE1 TYR A 157 -12.111 15.344 -80.025 1.00 39.26 C \nANISOU 1259 CE1 TYR A 157 3077 4538 7304 -296 595 -1069 C \nATOM 1260 CE2 TYR A 157 -9.814 15.756 -80.416 1.00 35.86 C \nANISOU 1260 CE2 TYR A 157 2612 4088 6924 -223 548 -1102 C \nATOM 1261 CZ TYR A 157 -10.844 15.652 -79.558 1.00 36.45 C \nANISOU 1261 CZ TYR A 157 2708 4152 6989 -249 553 -1079 C \nATOM 1262 OH TYR A 157 -10.652 15.830 -78.200 1.00 35.95 O \nANISOU 1262 OH TYR A 157 2660 4048 6953 -234 517 -1063 O \nATOM 1263 N PRO A 158 -9.462 17.883 -85.066 1.00 62.35 N \nANISOU 1263 N PRO A 158 5801 7636 10254 -222 617 -1275 N \nATOM 1264 CA PRO A 158 -8.060 18.216 -85.200 1.00 58.68 C \nANISOU 1264 CA PRO A 158 5333 7144 9817 -176 587 -1300 C \nATOM 1265 C PRO A 158 -7.329 17.988 -83.906 1.00 54.77 C \nANISOU 1265 C PRO A 158 4880 6579 9352 -150 545 -1270 C \nATOM 1266 O PRO A 158 -7.951 17.943 -82.838 1.00 57.90 O \nANISOU 1266 O PRO A 158 5289 6955 9755 -157 534 -1244 O \nATOM 1267 CB PRO A 158 -8.086 19.747 -85.556 1.00 63.23 C \nANISOU 1267 CB PRO A 158 5846 7765 10415 -146 577 -1373 C \nATOM 1268 CG PRO A 158 -9.404 20.258 -85.083 1.00 59.38 C \nANISOU 1268 CG PRO A 158 5325 7317 9918 -172 587 -1377 C \nATOM 1269 CD PRO A 158 -10.338 19.086 -85.190 1.00 65.97 C \nANISOU 1269 CD PRO A 158 6199 8153 10714 -232 623 -1323 C \nATOM 1270 N THR A 159 -6.007 17.925 -83.978 1.00 52.84 N \nANISOU 1270 N THR A 159 4656 6298 9122 -122 520 -1276 N \nATOM 1271 CA THR A 159 -5.233 17.589 -82.803 1.00 48.72 C \nANISOU 1271 CA THR A 159 4180 5712 8621 -105 480 -1243 C \nATOM 1272 C THR A 159 -5.121 18.755 -81.849 1.00 54.89 C \nANISOU 1272 C THR A 159 4946 6466 9442 -66 440 -1271 C \nATOM 1273 O THR A 159 -4.693 19.812 -82.237 1.00 67.55 O \nANISOU 1273 O THR A 159 6524 8080 11064 -29 426 -1325 O \nATOM 1274 CB THR A 159 -3.878 17.005 -83.182 1.00 39.32 C \nANISOU 1274 CB THR A 159 3023 4493 7422 -102 469 -1234 C \nATOM 1275 OG1 THR A 159 -4.130 15.745 -83.820 1.00 37.96 O \nANISOU 1275 OG1 THR A 159 2864 4350 7208 -138 505 -1193 O \nATOM 1276 CG2 THR A 159 -3.050 16.739 -81.967 1.00 36.71 C \nANISOU 1276 CG2 THR A 159 2739 4100 7111 -90 426 -1203 C \nATOM 1277 N ILE A 160 -5.549 18.530 -80.600 1.00 59.82 N \nANISOU 1277 N ILE A 160 5592 7062 10077 -71 422 -1234 N \nATOM 1278 CA ILE A 160 -5.580 19.536 -79.568 1.00 51.68 C \nANISOU 1278 CA ILE A 160 4547 6010 9079 -37 384 -1252 C \nATOM 1279 C ILE A 160 -4.233 19.650 -78.923 1.00 60.84 C \nANISOU 1279 C ILE A 160 5750 7103 10264 -3 338 -1248 C \nATOM 1280 O ILE A 160 -3.610 18.638 -78.600 1.00 68.12 O \nANISOU 1280 O ILE A 160 6720 7986 11176 -23 331 -1205 O \nATOM 1281 CB ILE A 160 -6.606 19.175 -78.501 1.00 46.27 C \nANISOU 1281 CB ILE A 160 3870 5320 8389 -65 386 -1212 C \nATOM 1282 CG1 ILE A 160 -8.036 19.316 -79.095 1.00 43.67 C \nANISOU 1282 CG1 ILE A 160 3501 5059 8033 -104 429 -1224 C \nATOM 1283 CG2 ILE A 160 -6.515 20.102 -77.280 1.00 47.93 C \nANISOU 1283 CG2 ILE A 160 4072 5505 8633 -31 341 -1223 C \nATOM 1284 CD1 ILE A 160 -9.132 18.676 -78.241 1.00 42.86 C \nANISOU 1284 CD1 ILE A 160 3423 4949 7912 -146 442 -1179 C \nATOM 1285 N LYS A 161 -3.796 20.892 -78.718 1.00 59.70 N \nANISOU 1285 N LYS A 161 5589 6948 10148 49 305 -1294 N \nATOM 1286 CA LYS A 161 -2.518 21.182 -78.109 1.00 64.07 C \nANISOU 1286 CA LYS A 161 6190 7431 10723 85 258 -1295 C \nATOM 1287 C LYS A 161 -2.702 22.476 -77.342 1.00 60.12 C \nANISOU 1287 C LYS A 161 5664 6928 10252 139 223 -1326 C \nATOM 1288 O LYS A 161 -2.753 23.551 -77.903 1.00 76.59 O \nANISOU 1288 O LYS A 161 7710 9046 12344 184 222 -1380 O \nATOM 1289 CB LYS A 161 -1.433 21.296 -79.175 1.00 72.61 C \nANISOU 1289 CB LYS A 161 7291 8499 11796 98 260 -1329 C \nATOM 1290 CG LYS A 161 -0.238 20.393 -78.929 1.00 78.94 C \nANISOU 1290 CG LYS A 161 8164 9242 12589 73 241 -1293 C \nATOM 1291 CD LYS A 161 0.694 20.407 -80.132 1.00 81.26 C \nANISOU 1291 CD LYS A 161 8476 9536 12866 72 252 -1326 C \nATOM 1292 CE LYS A 161 1.905 19.506 -79.891 1.00 88.49 C \nANISOU 1292 CE LYS A 161 9459 10401 13763 36 233 -1290 C \nATOM 1293 NZ LYS A 161 2.821 20.073 -78.859 1.00 91.04 N \nANISOU 1293 NZ LYS A 161 9838 10645 14107 65 179 -1290 N \nATOM 1294 N ARG A 162 -2.856 22.338 -76.043 1.00 58.57 N \nANISOU 1294 N ARG A 162 5488 6698 10069 136 196 -1289 N \nATOM 1295 CA ARG A 162 -3.149 23.438 -75.142 1.00 56.09 C \nANISOU 1295 CA ARG A 162 5147 6386 9777 183 162 -1307 C \nATOM 1296 C ARG A 162 -2.281 23.251 -73.915 1.00 52.39 C \nANISOU 1296 C ARG A 162 4742 5836 9327 195 113 -1272 C \nATOM 1297 O ARG A 162 -2.068 22.109 -73.473 1.00 55.95 O \nANISOU 1297 O ARG A 162 5238 6254 9768 148 116 -1221 O \nATOM 1298 CB ARG A 162 -4.653 23.431 -74.708 1.00 53.98 C \nANISOU 1298 CB ARG A 162 4828 6180 9501 148 184 -1293 C \nATOM 1299 CG ARG A 162 -5.632 23.436 -75.860 1.00 58.85 C \nANISOU 1299 CG ARG A 162 5390 6878 10092 117 235 -1319 C \nATOM 1300 CD ARG A 162 -5.762 24.827 -76.500 1.00 64.55 C \nANISOU 1300 CD ARG A 162 6046 7661 10818 171 233 -1386 C \nATOM 1301 NE ARG A 162 -6.375 25.719 -75.527 1.00 67.61 N \nANISOU 1301 NE ARG A 162 6393 8080 11216 195 207 -1394 N \nATOM 1302 CZ ARG A 162 -7.631 26.112 -75.537 1.00 62.70 C \nANISOU 1302 CZ ARG A 162 5707 7542 10575 166 229 -1406 C \nATOM 1303 NH1 ARG A 162 -8.443 25.735 -76.504 1.00 62.02 N \nANISOU 1303 NH1 ARG A 162 5592 7513 10458 111 278 -1413 N \nATOM 1304 NH2 ARG A 162 -8.048 26.905 -74.573 1.00 63.82 N \nANISOU 1304 NH2 ARG A 162 5814 7710 10724 189 201 -1411 N \nATOM 1305 N SER A 163 -1.895 24.361 -73.300 1.00 46.57 N \nANISOU 1305 N SER A 163 4006 5076 8612 258 70 -1297 N \nATOM 1306 CA SER A 163 -1.118 24.284 -72.082 1.00 50.94 C \nANISOU 1306 CA SER A 163 4620 5554 9182 270 22 -1264 C \nATOM 1307 C SER A 163 -1.385 25.453 -71.178 1.00 46.18 C \nANISOU 1307 C SER A 163 3991 4956 8598 329 -16 -1281 C \nATOM 1308 O SER A 163 -1.785 26.491 -71.634 1.00 58.49 O \nANISOU 1308 O SER A 163 5494 6568 10160 380 -13 -1329 O \nATOM 1309 CB SER A 163 0.391 24.174 -72.410 1.00 59.30 C \nANISOU 1309 CB SER A 163 5754 6537 10239 285 -2 -1271 C \nATOM 1310 OG SER A 163 1.012 25.445 -72.453 1.00 64.41 O \nANISOU 1310 OG SER A 163 6414 7157 10901 365 -36 -1317 O \nATOM 1311 N TYR A 164 -1.170 25.259 -69.886 1.00 42.60 N \nANISOU 1311 N TYR A 164 3576 4455 8157 323 -52 -1241 N \nATOM 1312 CA TYR A 164 -1.524 26.222 -68.856 1.00 44.65 C \nANISOU 1312 CA TYR A 164 3809 4724 8432 371 -89 -1246 C \nATOM 1313 C TYR A 164 -0.403 26.381 -67.884 1.00 51.85 C \nANISOU 1313 C TYR A 164 4797 5546 9358 401 -145 -1224 C \nATOM 1314 O TYR A 164 0.052 25.396 -67.288 1.00 54.46 O \nANISOU 1314 O TYR A 164 5184 5823 9684 349 -153 -1176 O \nATOM 1315 CB TYR A 164 -2.778 25.802 -68.098 1.00 41.38 C \nANISOU 1315 CB TYR A 164 3353 4359 8012 318 -72 -1212 C \nATOM 1316 CG TYR A 164 -3.134 26.754 -66.966 1.00 44.08 C \nANISOU 1316 CG TYR A 164 3666 4715 8365 360 -112 -1214 C \nATOM 1317 CD1 TYR A 164 -3.724 27.991 -67.239 1.00 43.32 C \nANISOU 1317 CD1 TYR A 164 3495 4696 8269 415 -114 -1262 C \nATOM 1318 CD2 TYR A 164 -2.846 26.433 -65.614 1.00 38.07 C \nANISOU 1318 CD2 TYR A 164 2952 3899 7614 346 -149 -1168 C \nATOM 1319 CE1 TYR A 164 -4.044 28.874 -66.210 1.00 43.91 C \nANISOU 1319 CE1 TYR A 164 3538 4795 8350 456 -151 -1262 C \nATOM 1320 CE2 TYR A 164 -3.139 27.305 -64.621 1.00 40.67 C \nANISOU 1320 CE2 TYR A 164 3254 4244 7952 385 -186 -1169 C \nATOM 1321 CZ TYR A 164 -3.735 28.547 -64.926 1.00 45.72 C \nANISOU 1321 CZ TYR A 164 3816 4965 8590 443 -188 -1217 C \nATOM 1322 OH TYR A 164 -4.055 29.479 -63.923 1.00 54.81 O \nANISOU 1322 OH TYR A 164 4932 6146 9746 487 -226 -1218 O \nATOM 1323 N ASN A 165 0.038 27.622 -67.726 1.00 58.16 N \nANISOU 1323 N ASN A 165 5599 6331 10170 487 -183 -1260 N \nATOM 1324 CA ASN A 165 1.087 27.935 -66.799 1.00 68.71 C \nANISOU 1324 CA ASN A 165 7012 7579 11517 525 -239 -1243 C \nATOM 1325 C ASN A 165 0.426 28.520 -65.556 1.00 64.12 C \nANISOU 1325 C ASN A 165 6394 7024 10946 550 -270 -1227 C \nATOM 1326 O ASN A 165 -0.069 29.623 -65.584 1.00 71.22 O \nANISOU 1326 O ASN A 165 7233 7980 11848 617 -279 -1263 O \nATOM 1327 CB ASN A 165 2.089 28.906 -67.456 1.00 77.89 C \nANISOU 1327 CB ASN A 165 8216 8697 12680 610 -263 -1292 C \nATOM 1328 CG ASN A 165 3.368 29.083 -66.661 1.00 84.11 C \nANISOU 1328 CG ASN A 165 9110 9375 13472 638 -319 -1273 C \nATOM 1329 OD1 ASN A 165 3.407 28.759 -65.475 1.00 88.32 O \nANISOU 1329 OD1 ASN A 165 9670 9875 14011 611 -348 -1227 O \nATOM 1330 ND2 ASN A 165 4.415 29.617 -67.311 1.00 91.58 N \nANISOU 1330 ND2 ASN A 165 10123 10261 14413 691 -335 -1309 N \nATOM 1331 N ASN A 166 0.421 27.754 -64.471 1.00 55.69 N \nANISOU 1331 N ASN A 166 5360 5921 9880 495 -285 -1172 N \nATOM 1332 CA ASN A 166 -0.038 28.253 -63.194 1.00 57.53 C \nANISOU 1332 CA ASN A 166 5572 6165 10122 515 -319 -1152 C \nATOM 1333 C ASN A 166 0.721 29.559 -62.826 1.00 64.29 C \nANISOU 1333 C ASN A 166 6457 6983 10988 620 -375 -1178 C \nATOM 1334 O ASN A 166 1.852 29.545 -62.363 1.00 60.67 O \nANISOU 1334 O ASN A 166 6088 6431 10533 637 -416 -1161 O \nATOM 1335 CB ASN A 166 0.132 27.187 -62.114 1.00 54.10 C \nANISOU 1335 CB ASN A 166 5189 5681 9685 443 -332 -1089 C \nATOM 1336 CG ASN A 166 -0.490 27.566 -60.769 1.00 51.96 C \nANISOU 1336 CG ASN A 166 4891 5430 9420 448 -362 -1065 C \nATOM 1337 OD1 ASN A 166 -1.092 28.615 -60.626 1.00 60.18 O \nANISOU 1337 OD1 ASN A 166 5870 6530 10465 503 -373 -1093 O \nATOM 1338 ND2 ASN A 166 -0.245 26.747 -59.752 1.00 46.96 N \nANISOU 1338 ND2 ASN A 166 4307 4750 8786 395 -378 -1013 N \nATOM 1339 N THR A 167 0.051 30.687 -63.024 1.00 67.26 N \nANISOU 1339 N THR A 167 6754 7437 11364 689 -376 -1219 N \nATOM 1340 CA THR A 167 0.616 31.984 -62.698 1.00 64.52 C \nANISOU 1340 CA THR A 167 6423 7070 11022 802 -426 -1246 C \nATOM 1341 C THR A 167 0.430 32.367 -61.226 1.00 70.27 C \nANISOU 1341 C THR A 167 7150 7794 11756 821 -472 -1213 C \nATOM 1342 O THR A 167 0.792 33.474 -60.843 1.00 76.53 O \nANISOU 1342 O THR A 167 7949 8579 12550 921 -516 -1231 O \nATOM 1343 CB THR A 167 -0.004 33.072 -63.566 1.00 57.89 C \nANISOU 1343 CB THR A 167 5492 6330 10175 877 -407 -1308 C \nATOM 1344 OG1 THR A 167 -1.421 33.146 -63.361 1.00 61.48 O \nANISOU 1344 OG1 THR A 167 5838 6903 10620 838 -380 -1307 O \nATOM 1345 CG2 THR A 167 0.234 32.811 -65.007 1.00 56.47 C \nANISOU 1345 CG2 THR A 167 5315 6153 9988 867 -365 -1344 C \nATOM 1346 N ASN A 168 -0.127 31.465 -60.415 1.00 67.87 N \nANISOU 1346 N ASN A 168 6840 7497 11453 730 -463 -1164 N \nATOM 1347 CA ASN A 168 -0.490 31.785 -59.029 1.00 66.08 C \nANISOU 1347 CA ASN A 168 6598 7282 11228 737 -501 -1132 C \nATOM 1348 C ASN A 168 0.521 31.242 -58.065 1.00 67.43 C \nANISOU 1348 C ASN A 168 6874 7341 11406 714 -543 -1084 C \nATOM 1349 O ASN A 168 1.455 30.583 -58.495 1.00 74.47 O \nANISOU 1349 O ASN A 168 7846 8153 12298 686 -540 -1075 O \nATOM 1350 CB ASN A 168 -1.853 31.202 -58.708 1.00 68.60 C \nANISOU 1350 CB ASN A 168 6841 7686 11538 650 -464 -1112 C \nATOM 1351 CG ASN A 168 -2.922 31.640 -59.695 1.00 74.53 C \nANISOU 1351 CG ASN A 168 7490 8553 12276 653 -418 -1158 C \nATOM 1352 OD1 ASN A 168 -3.420 32.764 -59.624 1.00 99.43 O \nANISOU 1352 OD1 ASN A 168 10570 11788 15421 717 -432 -1189 O \nATOM 1353 ND2 ASN A 168 -3.301 30.748 -60.606 1.00 65.83 N \nANISOU 1353 ND2 ASN A 168 6380 7465 11167 582 -363 -1160 N \nATOM 1354 N GLN A 169 0.347 31.540 -56.783 1.00 71.45 N \nANISOU 1354 N GLN A 169 7382 7850 11917 723 -583 -1053 N \nATOM 1355 CA GLN A 169 1.290 31.110 -55.740 1.00 80.00 C \nANISOU 1355 CA GLN A 169 8563 8831 13003 702 -627 -1006 C \nATOM 1356 C GLN A 169 0.736 29.949 -54.957 1.00 77.17 C \nANISOU 1356 C GLN A 169 8199 8481 12641 594 -609 -956 C \nATOM 1357 O GLN A 169 1.298 29.556 -53.928 1.00 76.03 O \nANISOU 1357 O GLN A 169 8119 8272 12496 566 -644 -912 O \nATOM 1358 CB GLN A 169 1.654 32.258 -54.768 1.00 84.06 C \nANISOU 1358 CB GLN A 169 9095 9324 13519 793 -692 -1002 C \nATOM 1359 CG GLN A 169 2.724 33.208 -55.267 1.00 87.69 C \nANISOU 1359 CG GLN A 169 9619 9721 13979 902 -727 -1036 C \nATOM 1360 CD GLN A 169 2.164 34.251 -56.197 1.00 90.56 C \nANISOU 1360 CD GLN A 169 9897 10173 14339 991 -708 -1096 C \nATOM 1361 OE1 GLN A 169 1.532 35.217 -55.752 1.00 91.86 O \nANISOU 1361 OE1 GLN A 169 9989 10416 14499 1059 -728 -1110 O \nATOM 1362 NE2 GLN A 169 2.406 34.077 -57.494 1.00 85.41 N \nANISOU 1362 NE2 GLN A 169 9251 9516 13686 992 -671 -1133 N \nATOM 1363 N GLU A 170 -0.359 29.392 -55.454 1.00 73.73 N \nANISOU 1363 N GLU A 170 7692 8122 12199 534 -554 -962 N \nATOM 1364 CA GLU A 170 -0.964 28.242 -54.810 1.00 71.37 C \nANISOU 1364 CA GLU A 170 7392 7832 11892 436 -530 -918 C \nATOM 1365 C GLU A 170 -0.983 27.053 -55.724 1.00 65.72 C \nANISOU 1365 C GLU A 170 6691 7109 11169 368 -477 -914 C \nATOM 1366 O GLU A 170 -1.198 27.170 -56.922 1.00 73.81 O \nANISOU 1366 O GLU A 170 7683 8169 12191 381 -441 -951 O \nATOM 1367 CB GLU A 170 -2.394 28.553 -54.374 1.00 76.45 C \nANISOU 1367 CB GLU A 170 7946 8575 12528 416 -512 -922 C \nATOM 1368 CG GLU A 170 -2.530 29.790 -53.486 1.00 79.79 C \nANISOU 1368 CG GLU A 170 8334 9028 12953 484 -562 -928 C \nATOM 1369 CD GLU A 170 -2.793 31.040 -54.275 1.00 80.74 C \nANISOU 1369 CD GLU A 170 8386 9219 13072 571 -562 -983 C \nATOM 1370 OE1 GLU A 170 -2.455 31.053 -55.470 1.00 85.57 O \nANISOU 1370 OE1 GLU A 170 9003 9824 13687 594 -537 -1016 O \nATOM 1371 OE2 GLU A 170 -3.327 32.008 -53.699 1.00 90.42 O \nANISOU 1371 OE2 GLU A 170 9551 10514 14292 616 -588 -993 O \nATOM 1372 N ASP A 171 -0.765 25.889 -55.140 1.00 58.88 N \nANISOU 1372 N ASP A 171 5875 6203 10295 297 -472 -868 N \nATOM 1373 CA ASP A 171 -1.007 24.642 -55.835 1.00 55.83 C \nANISOU 1373 CA ASP A 171 5493 5827 9894 229 -419 -856 C \nATOM 1374 C ASP A 171 -2.406 24.679 -56.368 1.00 55.95 C \nANISOU 1374 C ASP A 171 5429 5929 9902 209 -369 -877 C \nATOM 1375 O ASP A 171 -3.322 25.103 -55.661 1.00 51.57 O \nANISOU 1375 O ASP A 171 4828 5421 9345 204 -374 -875 O \nATOM 1376 CB ASP A 171 -0.866 23.459 -54.871 1.00 55.63 C \nANISOU 1376 CB ASP A 171 5513 5768 9856 160 -421 -801 C \nATOM 1377 CG ASP A 171 0.536 23.366 -54.250 1.00 62.06 C \nANISOU 1377 CG ASP A 171 6410 6499 10671 165 -471 -775 C \nATOM 1378 OD1 ASP A 171 1.500 23.921 -54.821 1.00 78.24 O \nANISOU 1378 OD1 ASP A 171 8496 8505 12726 209 -493 -798 O \nATOM 1379 OD2 ASP A 171 0.684 22.731 -53.198 1.00 62.22 O \nANISOU 1379 OD2 ASP A 171 6463 6496 10681 122 -488 -732 O \nATOM 1380 N LEU A 172 -2.618 24.249 -57.609 1.00 59.69 N \nANISOU 1380 N LEU A 172 5885 6427 10367 193 -322 -899 N \nATOM 1381 CA LEU A 172 -4.003 24.078 -58.051 1.00 57.72 C \nANISOU 1381 CA LEU A 172 5573 6255 10104 157 -272 -911 C \nATOM 1382 C LEU A 172 -4.355 22.677 -58.570 1.00 54.67 C \nANISOU 1382 C LEU A 172 5207 5869 9696 90 -219 -887 C \nATOM 1383 O LEU A 172 -3.547 21.987 -59.178 1.00 48.71 O \nANISOU 1383 O LEU A 172 4493 5078 8938 83 -209 -880 O \nATOM 1384 CB LEU A 172 -4.443 25.180 -58.998 1.00 59.51 C \nANISOU 1384 CB LEU A 172 5732 6546 10334 205 -260 -966 C \nATOM 1385 CG LEU A 172 -3.761 25.448 -60.306 1.00 62.51 C \nANISOU 1385 CG LEU A 172 6114 6917 10720 246 -248 -1004 C \nATOM 1386 CD1 LEU A 172 -4.442 24.730 -61.435 1.00 69.36 C \nANISOU 1386 CD1 LEU A 172 6957 7828 11569 198 -187 -1014 C \nATOM 1387 CD2 LEU A 172 -3.824 26.941 -60.588 1.00 66.19 C \nANISOU 1387 CD2 LEU A 172 6526 7430 11196 326 -271 -1053 C \nATOM 1388 N LEU A 173 -5.591 22.270 -58.276 1.00 50.63 N \nANISOU 1388 N LEU A 173 4670 5402 9167 40 -186 -875 N \nATOM 1389 CA LEU A 173 -6.033 20.927 -58.547 1.00 45.02 C \nANISOU 1389 CA LEU A 173 3987 4688 8431 -17 -140 -846 C \nATOM 1390 C LEU A 173 -6.771 20.922 -59.847 1.00 45.13 C \nANISOU 1390 C LEU A 173 3963 4754 8431 -28 -89 -877 C \nATOM 1391 O LEU A 173 -7.809 21.539 -59.944 1.00 34.78 O \nANISOU 1391 O LEU A 173 2602 3500 7112 -39 -74 -900 O \nATOM 1392 CB LEU A 173 -6.908 20.429 -57.405 1.00 43.40 C \nANISOU 1392 CB LEU A 173 3794 4488 8209 -65 -134 -812 C \nATOM 1393 CG LEU A 173 -7.851 19.248 -57.701 1.00 43.76 C \nANISOU 1393 CG LEU A 173 3859 4548 8221 -122 -77 -792 C \nATOM 1394 CD1 LEU A 173 -7.038 17.927 -57.847 1.00 40.19 C \nANISOU 1394 CD1 LEU A 173 3464 4052 7756 -130 -66 -756 C \nATOM 1395 CD2 LEU A 173 -8.886 19.149 -56.617 1.00 39.27 C \nANISOU 1395 CD2 LEU A 173 3293 3992 7635 -164 -74 -772 C \nATOM 1396 N ILE A 174 -6.219 20.167 -60.841 1.00 46.52 N \nANISOU 1396 N ILE A 174 4163 4914 8599 -31 -63 -876 N \nATOM 1397 CA ILE A 174 -6.823 20.052 -62.184 1.00 36.24 C \nANISOU 1397 CA ILE A 174 2831 3657 7281 -43 -13 -903 C \nATOM 1398 C ILE A 174 -7.324 18.615 -62.386 1.00 39.09 C \nANISOU 1398 C ILE A 174 3229 4014 7610 -93 33 -866 C \nATOM 1399 O ILE A 174 -6.758 17.687 -61.894 1.00 45.82 O \nANISOU 1399 O ILE A 174 4129 4827 8454 -103 26 -828 O \nATOM 1400 CB ILE A 174 -5.822 20.392 -63.272 1.00 33.26 C \nANISOU 1400 CB ILE A 174 2449 3270 6916 -2 -19 -933 C \nATOM 1401 CG1 ILE A 174 -5.026 21.688 -62.882 1.00 32.31 C \nANISOU 1401 CG1 ILE A 174 2317 3132 6828 60 -74 -961 C \nATOM 1402 CG2 ILE A 174 -6.489 20.547 -64.613 1.00 30.96 C \nANISOU 1402 CG2 ILE A 174 2116 3036 6612 -9 27 -968 C \nATOM 1403 CD1 ILE A 174 -4.004 22.077 -63.929 1.00 31.16 C \nANISOU 1403 CD1 ILE A 174 2179 2969 6692 103 -80 -994 C \nATOM 1404 N LEU A 175 -8.445 18.459 -63.077 1.00 44.03 N \nANISOU 1404 N LEU A 175 3833 4684 8211 -123 79 -878 N \nATOM 1405 CA LEU A 175 -9.059 17.183 -63.316 1.00 42.29 C \nANISOU 1405 CA LEU A 175 3653 4461 7956 -163 125 -846 C \nATOM 1406 C LEU A 175 -9.480 17.066 -64.781 1.00 45.93 C \nANISOU 1406 C LEU A 175 4093 4961 8399 -172 171 -870 C \nATOM 1407 O LEU A 175 -9.985 18.019 -65.368 1.00 53.78 O \nANISOU 1407 O LEU A 175 5036 6001 9397 -171 178 -911 O \nATOM 1408 CB LEU A 175 -10.282 17.004 -62.460 1.00 44.51 C \nANISOU 1408 CB LEU A 175 3947 4750 8214 -207 139 -828 C \nATOM 1409 CG LEU A 175 -10.048 17.041 -60.949 1.00 51.03 C \nANISOU 1409 CG LEU A 175 4794 5541 9052 -207 99 -801 C \nATOM 1410 CD1 LEU A 175 -10.359 18.398 -60.364 1.00 49.90 C \nANISOU 1410 CD1 LEU A 175 4601 5429 8931 -200 66 -830 C \nATOM 1411 CD2 LEU A 175 -10.906 16.001 -60.244 1.00 49.41 C \nANISOU 1411 CD2 LEU A 175 4642 5320 8812 -250 126 -763 C \nATOM 1412 N TRP A 176 -9.251 15.889 -65.361 1.00 43.47 N \nANISOU 1412 N TRP A 176 3819 4636 8063 -179 201 -844 N \nATOM 1413 CA TRP A 176 -9.602 15.611 -66.752 1.00 35.11 C \nANISOU 1413 CA TRP A 176 2749 3611 6982 -188 245 -860 C \nATOM 1414 C TRP A 176 -9.985 14.176 -66.853 1.00 33.09 C \nANISOU 1414 C TRP A 176 2546 3341 6684 -208 283 -817 C \nATOM 1415 O TRP A 176 -9.905 13.420 -65.874 1.00 31.26 O \nANISOU 1415 O TRP A 176 2358 3077 6442 -211 274 -778 O \nATOM 1416 CB TRP A 176 -8.430 15.929 -67.693 1.00 33.33 C \nANISOU 1416 CB TRP A 176 2500 3388 6775 -152 232 -886 C \nATOM 1417 CG TRP A 176 -7.214 15.094 -67.470 1.00 33.58 C \nANISOU 1417 CG TRP A 176 2570 3383 6807 -137 214 -855 C \nATOM 1418 CD1 TRP A 176 -6.875 13.969 -68.119 1.00 31.68 C \nANISOU 1418 CD1 TRP A 176 2354 3146 6537 -142 240 -830 C \nATOM 1419 CD2 TRP A 176 -6.214 15.319 -66.504 1.00 34.36 C \nANISOU 1419 CD2 TRP A 176 2685 3441 6931 -118 164 -844 C \nATOM 1420 NE1 TRP A 176 -5.738 13.477 -67.622 1.00 32.22 N \nANISOU 1420 NE1 TRP A 176 2449 3186 6608 -132 212 -806 N \nATOM 1421 CE2 TRP A 176 -5.301 14.277 -66.614 1.00 32.15 C \nANISOU 1421 CE2 TRP A 176 2439 3145 6631 -120 164 -813 C \nATOM 1422 CE3 TRP A 176 -6.012 16.313 -65.522 1.00 38.50 C \nANISOU 1422 CE3 TRP A 176 3199 3944 7487 -101 118 -856 C \nATOM 1423 CZ2 TRP A 176 -4.180 14.184 -65.834 1.00 35.57 C \nANISOU 1423 CZ2 TRP A 176 2900 3541 7076 -113 122 -795 C \nATOM 1424 CZ3 TRP A 176 -4.877 16.202 -64.687 1.00 39.40 C \nANISOU 1424 CZ3 TRP A 176 3345 4011 7614 -88 74 -835 C \nATOM 1425 CH2 TRP A 176 -3.973 15.159 -64.873 1.00 40.41 C \nANISOU 1425 CH2 TRP A 176 3509 4123 7721 -98 77 -806 C \nATOM 1426 N GLY A 177 -10.397 13.773 -68.028 1.00 29.88 N \nANISOU 1426 N GLY A 177 2139 2961 6251 -218 325 -823 N \nATOM 1427 CA GLY A 177 -10.995 12.467 -68.197 1.00 33.12 C \nANISOU 1427 CA GLY A 177 2605 3365 6616 -233 366 -784 C \nATOM 1428 C GLY A 177 -10.799 11.895 -69.589 1.00 34.66 C \nANISOU 1428 C GLY A 177 2797 3585 6787 -225 400 -786 C \nATOM 1429 O GLY A 177 -10.334 12.590 -70.461 1.00 32.05 O \nANISOU 1429 O GLY A 177 2421 3282 6476 -216 396 -822 O \nATOM 1430 N ILE A 178 -11.225 10.628 -69.760 1.00 35.06 N \nANISOU 1430 N ILE A 178 2900 3629 6791 -227 436 -746 N \nATOM 1431 CA ILE A 178 -11.104 9.930 -71.019 1.00 35.84 C \nANISOU 1431 CA ILE A 178 3003 3754 6859 -217 470 -740 C \nATOM 1432 C ILE A 178 -12.400 9.149 -71.248 1.00 41.55 C \nANISOU 1432 C ILE A 178 3783 4474 7531 -237 517 -715 C \nATOM 1433 O ILE A 178 -13.002 8.665 -70.273 1.00 39.85 O \nANISOU 1433 O ILE A 178 3620 4225 7296 -243 521 -686 O \nATOM 1434 CB ILE A 178 -9.899 8.955 -71.053 1.00 37.25 C \nANISOU 1434 CB ILE A 178 3191 3935 7027 -183 459 -709 C \nATOM 1435 CG1 ILE A 178 -9.821 8.252 -72.390 1.00 38.42 C \nANISOU 1435 CG1 ILE A 178 3339 4119 7139 -174 495 -702 C \nATOM 1436 CG2 ILE A 178 -10.044 7.852 -70.043 1.00 37.21 C \nANISOU 1436 CG2 ILE A 178 3241 3904 6992 -170 462 -659 C \nATOM 1437 CD1 ILE A 178 -8.591 7.404 -72.581 1.00 40.10 C \nANISOU 1437 CD1 ILE A 178 3548 4351 7337 -147 485 -678 C \nATOM 1438 N HIS A 179 -12.856 9.089 -72.517 1.00 38.98 N \nANISOU 1438 N HIS A 179 3452 4178 7180 -249 553 -728 N \nATOM 1439 CA HIS A 179 -14.074 8.383 -72.822 1.00 37.50 C \nANISOU 1439 CA HIS A 179 3328 3982 6939 -269 598 -705 C \nATOM 1440 C HIS A 179 -13.763 7.128 -73.548 1.00 32.82 C \nANISOU 1440 C HIS A 179 2766 3399 6304 -233 625 -670 C \nATOM 1441 O HIS A 179 -13.366 7.168 -74.700 1.00 30.12 O \nANISOU 1441 O HIS A 179 2390 3094 5958 -226 636 -685 O \nATOM 1442 CB HIS A 179 -15.083 9.231 -73.671 1.00 37.13 C \nANISOU 1442 CB HIS A 179 3262 3963 6884 -319 624 -743 C \nATOM 1443 CG HIS A 179 -16.268 8.437 -74.166 1.00 32.78 C \nANISOU 1443 CG HIS A 179 2785 3399 6269 -343 672 -718 C \nATOM 1444 ND1 HIS A 179 -16.602 8.344 -75.501 1.00 38.18 N \nANISOU 1444 ND1 HIS A 179 3466 4116 6925 -356 706 -728 N \nATOM 1445 CD2 HIS A 179 -17.166 7.693 -73.503 1.00 30.68 C \nANISOU 1445 CD2 HIS A 179 2607 3089 5961 -353 692 -683 C \nATOM 1446 CE1 HIS A 179 -17.655 7.552 -75.634 1.00 33.37 C \nANISOU 1446 CE1 HIS A 179 2943 3480 6258 -373 744 -697 C \nATOM 1447 NE2 HIS A 179 -18.030 7.174 -74.431 1.00 37.02 N \nANISOU 1447 NE2 HIS A 179 3463 3893 6710 -372 737 -671 N \nATOM 1448 N HIS A 180 -14.066 6.014 -72.908 1.00 31.51 N \nANISOU 1448 N HIS A 180 2669 3203 6099 -209 638 -624 N \nATOM 1449 CA HIS A 180 -13.964 4.728 -73.551 1.00 29.63 C \nANISOU 1449 CA HIS A 180 2470 2980 5809 -168 667 -585 C \nATOM 1450 C HIS A 180 -15.269 4.509 -74.290 1.00 30.64 C \nANISOU 1450 C HIS A 180 2656 3098 5889 -193 713 -581 C \nATOM 1451 O HIS A 180 -16.292 4.246 -73.652 1.00 32.81 O \nANISOU 1451 O HIS A 180 3004 3328 6135 -209 730 -564 O \nATOM 1452 CB HIS A 180 -13.700 3.628 -72.506 1.00 30.56 C \nANISOU 1452 CB HIS A 180 2636 3075 5901 -124 661 -538 C \nATOM 1453 CG HIS A 180 -12.486 3.846 -71.648 1.00 27.12 C \nANISOU 1453 CG HIS A 180 2153 2645 5507 -110 615 -539 C \nATOM 1454 ND1 HIS A 180 -11.217 3.864 -72.155 1.00 27.17 N \nANISOU 1454 ND1 HIS A 180 2099 2693 5530 -94 594 -547 N \nATOM 1455 CD2 HIS A 180 -12.349 4.092 -70.339 1.00 27.36 C \nANISOU 1455 CD2 HIS A 180 2189 2644 5562 -116 584 -535 C \nATOM 1456 CE1 HIS A 180 -10.325 4.085 -71.204 1.00 25.89 C \nANISOU 1456 CE1 HIS A 180 1913 2524 5401 -91 553 -546 C \nATOM 1457 NE2 HIS A 180 -10.979 4.197 -70.074 1.00 29.56 N \nANISOU 1457 NE2 HIS A 180 2416 2946 5872 -101 546 -538 N \nATOM 1458 N SER A 181 -15.229 4.583 -75.614 1.00 30.78 N \nANISOU 1458 N SER A 181 2646 3154 5894 -198 734 -595 N \nATOM 1459 CA SER A 181 -16.330 4.248 -76.459 1.00 38.45 C \nANISOU 1459 CA SER A 181 3675 4121 6814 -218 778 -587 C \nATOM 1460 C SER A 181 -16.581 2.774 -76.581 1.00 42.55 C \nANISOU 1460 C SER A 181 4274 4625 7266 -165 807 -532 C \nATOM 1461 O SER A 181 -15.786 1.955 -76.078 1.00 53.02 O \nANISOU 1461 O SER A 181 5600 5959 8587 -107 793 -501 O \nATOM 1462 CB SER A 181 -16.088 4.850 -77.866 1.00 45.61 C \nANISOU 1462 CB SER A 181 4517 5081 7730 -240 788 -622 C \nATOM 1463 OG SER A 181 -14.705 4.702 -78.285 1.00 41.07 O \nANISOU 1463 OG SER A 181 3876 4549 7179 -200 767 -625 O \nATOM 1464 N ASN A 182 -17.654 2.402 -77.285 1.00 47.04 N \nANISOU 1464 N ASN A 182 4913 5179 7781 -180 848 -520 N \nATOM 1465 CA ASN A 182 -18.150 0.975 -77.312 1.00 53.62 C \nANISOU 1465 CA ASN A 182 5848 5985 8541 -123 880 -465 C \nATOM 1466 C ASN A 182 -17.730 0.158 -78.521 1.00 55.86 C \nANISOU 1466 C ASN A 182 6122 6317 8784 -75 901 -442 C \nATOM 1467 O ASN A 182 -17.448 -1.035 -78.394 1.00 62.84 O \nANISOU 1467 O ASN A 182 7044 7208 9624 -1 909 -397 O \nATOM 1468 CB ASN A 182 -19.640 0.933 -77.201 1.00 55.20 C \nANISOU 1468 CB ASN A 182 6155 6125 8695 -166 912 -458 C \nATOM 1469 CG ASN A 182 -20.098 1.313 -75.838 1.00 63.34 C \nANISOU 1469 CG ASN A 182 7219 7102 9743 -197 895 -463 C \nATOM 1470 OD1 ASN A 182 -19.489 0.891 -74.822 1.00 64.88 O \nANISOU 1470 OD1 ASN A 182 7410 7287 9954 -150 872 -445 O \nATOM 1471 ND2 ASN A 182 -21.186 2.067 -75.772 1.00 62.11 N \nANISOU 1471 ND2 ASN A 182 7100 6917 9581 -278 908 -488 N \nATOM 1472 N ASP A 183 -17.573 0.827 -79.649 1.00 56.74 N \nANISOU 1472 N ASP A 183 6172 6472 8912 -112 905 -474 N \nATOM 1473 CA ASP A 183 -17.196 0.173 -80.889 1.00 54.82 C \nANISOU 1473 CA ASP A 183 5915 6282 8633 -76 925 -457 C \nATOM 1474 C ASP A 183 -16.616 1.158 -81.892 1.00 56.47 C \nANISOU 1474 C ASP A 183 6024 6546 8884 -120 916 -505 C \nATOM 1475 O ASP A 183 -16.701 2.391 -81.712 1.00 51.94 O \nANISOU 1475 O ASP A 183 5403 5969 8363 -179 899 -553 O \nATOM 1476 CB ASP A 183 -18.427 -0.522 -81.522 1.00 59.41 C \nANISOU 1476 CB ASP A 183 6604 6832 9139 -72 970 -427 C \nATOM 1477 CG ASP A 183 -19.693 0.371 -81.549 1.00 59.81 C \nANISOU 1477 CG ASP A 183 6700 6835 9188 -160 986 -456 C \nATOM 1478 OD1 ASP A 183 -20.648 0.098 -80.824 1.00 64.21 O \nANISOU 1478 OD1 ASP A 183 7357 7327 9714 -171 999 -437 O \nATOM 1479 OD2 ASP A 183 -19.758 1.297 -82.321 1.00 64.51 O \nANISOU 1479 OD2 ASP A 183 7238 7465 9809 -220 987 -496 O \nATOM 1480 N ALA A 184 -16.069 0.612 -82.985 1.00 53.83 N \nANISOU 1480 N ALA A 184 5661 6269 8522 -89 928 -493 N \nATOM 1481 CA ALA A 184 -15.409 1.437 -83.992 1.00 54.24 C \nANISOU 1481 CA ALA A 184 5621 6377 8609 -123 921 -537 C \nATOM 1482 C ALA A 184 -16.365 2.504 -84.542 1.00 59.65 C \nANISOU 1482 C ALA A 184 6305 7052 9305 -198 937 -579 C \nATOM 1483 O ALA A 184 -15.963 3.623 -84.814 1.00 66.33 O \nANISOU 1483 O ALA A 184 7074 7927 10203 -238 919 -630 O \nATOM 1484 CB ALA A 184 -14.845 0.591 -85.118 1.00 45.80 C \nANISOU 1484 CB ALA A 184 4534 5371 7497 -83 937 -513 C \nATOM 1485 N ALA A 185 -17.628 2.136 -84.704 1.00 62.86 N \nANISOU 1485 N ALA A 185 6803 7422 9659 -216 970 -557 N \nATOM 1486 CA ALA A 185 -18.638 3.040 -85.275 1.00 62.59 C \nANISOU 1486 CA ALA A 185 6776 7385 9620 -296 989 -592 C \nATOM 1487 C ALA A 185 -18.842 4.278 -84.394 1.00 60.44 C \nANISOU 1487 C ALA A 185 6465 7095 9404 -350 964 -636 C \nATOM 1488 O ALA A 185 -18.744 5.419 -84.887 1.00 64.47 O \nANISOU 1488 O ALA A 185 6899 7648 9950 -399 957 -689 O \nATOM 1489 CB ALA A 185 -19.955 2.294 -85.499 1.00 63.16 C \nANISOU 1489 CB ALA A 185 6972 7411 9617 -307 1029 -553 C \nATOM 1490 N GLU A 186 -19.127 4.056 -83.109 1.00 54.32 N \nANISOU 1490 N GLU A 186 5741 6264 8633 -340 952 -617 N \nATOM 1491 CA GLU A 186 -19.272 5.158 -82.145 1.00 55.67 C \nANISOU 1491 CA GLU A 186 5875 6421 8855 -385 925 -654 C \nATOM 1492 C GLU A 186 -18.054 5.996 -82.118 1.00 56.18 C \nANISOU 1492 C GLU A 186 5827 6529 8989 -371 888 -694 C \nATOM 1493 O GLU A 186 -18.124 7.222 -82.044 1.00 62.03 O \nANISOU 1493 O GLU A 186 6506 7293 9770 -416 872 -742 O \nATOM 1494 CB GLU A 186 -19.539 4.679 -80.732 1.00 55.90 C \nANISOU 1494 CB GLU A 186 5972 6387 8880 -365 914 -623 C \nATOM 1495 CG GLU A 186 -19.872 5.789 -79.743 1.00 62.12 C \nANISOU 1495 CG GLU A 186 6732 7161 9711 -419 889 -658 C \nATOM 1496 CD GLU A 186 -19.971 5.324 -78.285 1.00 67.56 C \nANISOU 1496 CD GLU A 186 7478 7791 10401 -396 874 -629 C \nATOM 1497 OE1 GLU A 186 -19.725 4.125 -77.999 1.00 76.17 O \nANISOU 1497 OE1 GLU A 186 8628 8852 11462 -332 880 -582 O \nATOM 1498 OE2 GLU A 186 -20.334 6.173 -77.430 1.00 63.52 O \nANISOU 1498 OE2 GLU A 186 6951 7267 9917 -442 855 -653 O \nATOM 1499 N GLN A 187 -16.911 5.339 -82.193 1.00 59.45 N \nANISOU 1499 N GLN A 187 6216 6960 9414 -309 873 -674 N \nATOM 1500 CA GLN A 187 -15.655 6.082 -82.123 1.00 50.88 C \nANISOU 1500 CA GLN A 187 5035 5906 8391 -295 836 -710 C \nATOM 1501 C GLN A 187 -15.608 7.085 -83.249 1.00 49.53 C \nANISOU 1501 C GLN A 187 4795 5788 8237 -333 842 -762 C \nATOM 1502 O GLN A 187 -15.435 8.282 -83.005 1.00 62.90 O \nANISOU 1502 O GLN A 187 6428 7493 9978 -357 819 -809 O \nATOM 1503 CB GLN A 187 -14.456 5.147 -82.157 1.00 43.64 C \nANISOU 1503 CB GLN A 187 4105 5006 7469 -233 823 -679 C \nATOM 1504 CG GLN A 187 -13.102 5.889 -82.221 1.00 37.98 C \nANISOU 1504 CG GLN A 187 3301 4320 6809 -226 786 -716 C \nATOM 1505 CD GLN A 187 -12.768 6.644 -80.929 1.00 38.17 C \nANISOU 1505 CD GLN A 187 3305 4309 6887 -230 746 -735 C \nATOM 1506 OE1 GLN A 187 -13.280 6.349 -79.865 1.00 34.37 O \nANISOU 1506 OE1 GLN A 187 2873 3785 6401 -226 741 -709 O \nATOM 1507 NE2 GLN A 187 -11.854 7.599 -81.026 1.00 42.58 N \nANISOU 1507 NE2 GLN A 187 3797 4886 7497 -233 715 -778 N \nATOM 1508 N THR A 188 -15.791 6.605 -84.480 1.00 45.70 N \nANISOU 1508 N THR A 188 4320 5336 7710 -335 874 -753 N \nATOM 1509 CA THR A 188 -15.769 7.460 -85.681 1.00 44.14 C \nANISOU 1509 CA THR A 188 4058 5193 7520 -371 885 -801 C \nATOM 1510 C THR A 188 -16.806 8.560 -85.654 1.00 49.01 C \nANISOU 1510 C THR A 188 4662 5817 8143 -436 893 -841 C \nATOM 1511 O THR A 188 -16.533 9.677 -86.065 1.00 54.16 O \nANISOU 1511 O THR A 188 5237 6512 8829 -457 882 -895 O \nATOM 1512 CB THR A 188 -15.919 6.640 -86.979 1.00 48.63 C \nANISOU 1512 CB THR A 188 4650 5794 8033 -365 921 -778 C \nATOM 1513 OG1 THR A 188 -16.243 5.271 -86.699 1.00 52.50 O \nANISOU 1513 OG1 THR A 188 5226 6250 8471 -326 938 -714 O \nATOM 1514 CG2 THR A 188 -14.604 6.637 -87.770 1.00 52.58 C \nANISOU 1514 CG2 THR A 188 5080 6345 8553 -335 909 -795 C \nATOM 1515 N LYS A 189 -18.020 8.235 -85.206 1.00 62.38 N \nANISOU 1515 N LYS A 189 6434 7471 9795 -470 914 -815 N \nATOM 1516 CA LYS A 189 -19.126 9.223 -85.182 1.00 61.22 C \nANISOU 1516 CA LYS A 189 6281 7339 9641 -547 925 -849 C \nATOM 1517 C LYS A 189 -18.889 10.326 -84.186 1.00 62.87 C \nANISOU 1517 C LYS A 189 6430 7551 9906 -555 888 -887 C \nATOM 1518 O LYS A 189 -19.264 11.472 -84.429 1.00 59.86 O \nANISOU 1518 O LYS A 189 5989 7217 9537 -602 887 -936 O \nATOM 1519 CB LYS A 189 -20.495 8.598 -84.943 1.00 67.89 C \nANISOU 1519 CB LYS A 189 7236 8138 10422 -590 957 -812 C \nATOM 1520 CG LYS A 189 -20.716 7.873 -83.637 1.00 74.70 C \nANISOU 1520 CG LYS A 189 8178 8926 11277 -565 947 -769 C \nATOM 1521 CD LYS A 189 -22.219 7.816 -83.284 1.00 91.91 C \nANISOU 1521 CD LYS A 189 10453 11067 13402 -636 974 -756 C \nATOM 1522 CE LYS A 189 -22.706 6.408 -82.864 1.00 97.36 C \nANISOU 1522 CE LYS A 189 11277 11681 14036 -601 995 -692 C \nATOM 1523 NZ LYS A 189 -24.182 6.305 -82.628 1.00 92.15 N \nANISOU 1523 NZ LYS A 189 10726 10974 13313 -674 1024 -678 N \nATOM 1524 N LEU A 190 -18.273 9.991 -83.052 1.00 56.26 N \nANISOU 1524 N LEU A 190 5607 6668 9100 -509 858 -865 N \nATOM 1525 CA LEU A 190 -17.996 11.006 -82.068 1.00 53.11 C \nANISOU 1525 CA LEU A 190 5155 6270 8754 -511 821 -897 C \nATOM 1526 C LEU A 190 -16.782 11.811 -82.412 1.00 58.08 C \nANISOU 1526 C LEU A 190 5690 6939 9438 -475 791 -940 C \nATOM 1527 O LEU A 190 -16.763 13.041 -82.223 1.00 60.61 O \nANISOU 1527 O LEU A 190 5943 7292 9792 -489 771 -988 O \nATOM 1528 CB LEU A 190 -17.787 10.387 -80.697 1.00 48.52 C \nANISOU 1528 CB LEU A 190 4625 5626 8185 -479 799 -857 C \nATOM 1529 CG LEU A 190 -19.091 9.943 -80.052 1.00 50.96 C \nANISOU 1529 CG LEU A 190 5025 5891 8447 -523 821 -827 C \nATOM 1530 CD1 LEU A 190 -18.837 9.268 -78.706 1.00 46.91 C \nANISOU 1530 CD1 LEU A 190 4564 5317 7944 -486 800 -788 C \nATOM 1531 CD2 LEU A 190 -20.025 11.135 -79.841 1.00 50.50 C \nANISOU 1531 CD2 LEU A 190 4935 5863 8388 -598 821 -868 C \nATOM 1532 N TYR A 191 -15.755 11.110 -82.885 1.00 61.65 N \nANISOU 1532 N TYR A 191 6140 7388 9896 -425 788 -922 N \nATOM 1533 CA TYR A 191 -14.407 11.690 -82.871 1.00 58.40 C \nANISOU 1533 CA TYR A 191 5662 6990 9537 -383 751 -953 C \nATOM 1534 C TYR A 191 -13.669 11.680 -84.128 1.00 65.60 C \nANISOU 1534 C TYR A 191 6534 7944 10447 -368 761 -973 C \nATOM 1535 O TYR A 191 -12.673 12.370 -84.217 1.00 67.03 O \nANISOU 1535 O TYR A 191 6662 8138 10670 -343 734 -1009 O \nATOM 1536 CB TYR A 191 -13.529 10.941 -81.921 1.00 51.05 C \nANISOU 1536 CB TYR A 191 4761 6013 8624 -337 724 -915 C \nATOM 1537 CG TYR A 191 -14.084 10.773 -80.562 1.00 45.39 C \nANISOU 1537 CG TYR A 191 4090 5247 7910 -343 711 -888 C \nATOM 1538 CD1 TYR A 191 -14.177 11.859 -79.708 1.00 45.35 C \nANISOU 1538 CD1 TYR A 191 4049 5237 7944 -354 681 -919 C \nATOM 1539 CD2 TYR A 191 -14.509 9.556 -80.115 1.00 45.94 C \nANISOU 1539 CD2 TYR A 191 4236 5279 7939 -334 728 -832 C \nATOM 1540 CE1 TYR A 191 -14.710 11.741 -78.427 1.00 42.81 C \nANISOU 1540 CE1 TYR A 191 3769 4874 7624 -365 669 -895 C \nATOM 1541 CE2 TYR A 191 -15.055 9.431 -78.847 1.00 47.08 C \nANISOU 1541 CE2 TYR A 191 4427 5378 8085 -342 718 -810 C \nATOM 1542 CZ TYR A 191 -15.141 10.528 -78.023 1.00 43.77 C \nANISOU 1542 CZ TYR A 191 3969 4955 7706 -361 688 -842 C \nATOM 1543 OH TYR A 191 -15.671 10.378 -76.777 1.00 44.52 O \nANISOU 1543 OH TYR A 191 4109 5007 7798 -372 678 -820 O \nATOM 1544 N GLN A 192 -14.118 10.879 -85.085 1.00 70.75 N \nANISOU 1544 N GLN A 192 7218 8614 11049 -382 799 -950 N \nATOM 1545 CA GLN A 192 -13.493 10.878 -86.376 1.00 67.20 C \nANISOU 1545 CA GLN A 192 6730 8212 10592 -375 812 -970 C \nATOM 1546 C GLN A 192 -12.329 9.898 -86.317 1.00 61.55 C \nANISOU 1546 C GLN A 192 6029 7483 9876 -328 798 -935 C \nATOM 1547 O GLN A 192 -12.440 8.815 -86.873 1.00 57.70 O \nANISOU 1547 O GLN A 192 5577 7004 9340 -319 824 -895 O \nATOM 1548 CB GLN A 192 -13.020 12.263 -86.767 1.00 79.78 C \nANISOU 1548 CB GLN A 192 8242 9843 12227 -378 794 -1039 C \nATOM 1549 CG GLN A 192 -13.434 12.758 -88.166 1.00 93.15 C \nANISOU 1549 CG GLN A 192 9896 11601 13898 -411 825 -1077 C \nATOM 1550 CD GLN A 192 -13.944 11.667 -89.124 1.00 87.75 C \nANISOU 1550 CD GLN A 192 9256 10931 13152 -430 866 -1038 C \nATOM 1551 OE1 GLN A 192 -15.132 11.388 -89.157 1.00 92.08 O \nANISOU 1551 OE1 GLN A 192 9850 11476 13661 -469 894 -1017 O \nATOM 1552 NE2 GLN A 192 -13.052 11.079 -89.918 1.00 76.39 N \nANISOU 1552 NE2 GLN A 192 7809 9512 11704 -404 871 -1029 N \nATOM 1553 N ASN A 193 -11.251 10.225 -85.594 1.00 56.75 N \nANISOU 1553 N ASN A 193 5396 6853 9312 -298 758 -947 N \nATOM 1554 CA ASN A 193 -10.051 9.408 -85.648 1.00 52.85 C \nANISOU 1554 CA ASN A 193 4908 6361 8814 -265 744 -921 C \nATOM 1555 C ASN A 193 -10.261 8.075 -84.915 1.00 48.01 C \nANISOU 1555 C ASN A 193 4357 5720 8165 -244 750 -854 C \nATOM 1556 O ASN A 193 -10.784 8.065 -83.820 1.00 49.53 O \nANISOU 1556 O ASN A 193 4582 5870 8367 -243 740 -836 O \nATOM 1557 CB ASN A 193 -8.863 10.194 -85.065 1.00 60.58 C \nANISOU 1557 CB ASN A 193 5851 7321 9846 -247 699 -954 C \nATOM 1558 CG ASN A 193 -8.990 11.720 -85.290 1.00 52.95 C \nANISOU 1558 CG ASN A 193 4833 6366 8920 -258 687 -1020 C \nATOM 1559 OD1 ASN A 193 -9.232 12.129 -86.371 1.00 47.35 O \nANISOU 1559 OD1 ASN A 193 4092 5698 8199 -274 710 -1053 O \nATOM 1560 ND2 ASN A 193 -8.866 12.528 -84.247 1.00 51.51 N \nANISOU 1560 ND2 ASN A 193 4641 6149 8781 -246 653 -1039 N \nATOM 1561 N PRO A 194 -9.848 6.950 -85.520 1.00 42.76 N \nANISOU 1561 N PRO A 194 3707 5085 7456 -224 767 -816 N \nATOM 1562 CA PRO A 194 -10.032 5.624 -85.009 1.00 42.04 C \nANISOU 1562 CA PRO A 194 3671 4982 7322 -194 777 -754 C \nATOM 1563 C PRO A 194 -9.021 5.238 -83.936 1.00 47.42 C \nANISOU 1563 C PRO A 194 4352 5646 8020 -167 741 -732 C \nATOM 1564 O PRO A 194 -9.325 4.469 -83.024 1.00 44.21 O \nANISOU 1564 O PRO A 194 3992 5214 7594 -143 740 -688 O \nATOM 1565 CB PRO A 194 -9.802 4.737 -86.237 1.00 41.49 C \nANISOU 1565 CB PRO A 194 3597 4969 7198 -182 805 -731 C \nATOM 1566 CG PRO A 194 -8.895 5.513 -87.080 1.00 41.72 C \nANISOU 1566 CG PRO A 194 3562 5034 7254 -202 793 -780 C \nATOM 1567 CD PRO A 194 -9.304 6.926 -86.894 1.00 45.50 C \nANISOU 1567 CD PRO A 194 4016 5487 7784 -231 782 -836 C \nATOM 1568 N THR A 195 -7.821 5.792 -84.047 1.00 51.61 N \nANISOU 1568 N THR A 195 4835 6190 8584 -172 711 -763 N \nATOM 1569 CA THR A 195 -6.773 5.518 -83.051 1.00 51.68 C \nANISOU 1569 CA THR A 195 4845 6184 8608 -157 674 -746 C \nATOM 1570 C THR A 195 -6.352 6.804 -82.394 1.00 53.12 C \nANISOU 1570 C THR A 195 5004 6324 8854 -171 636 -792 C \nATOM 1571 O THR A 195 -5.901 7.751 -83.063 1.00 56.18 O \nANISOU 1571 O THR A 195 5354 6721 9270 -185 628 -842 O \nATOM 1572 CB THR A 195 -5.547 4.831 -83.706 1.00 47.16 C \nANISOU 1572 CB THR A 195 4248 5667 8004 -153 670 -733 C \nATOM 1573 OG1 THR A 195 -6.003 3.766 -84.513 1.00 47.24 O \nANISOU 1573 OG1 THR A 195 4271 5726 7953 -137 707 -697 O \nATOM 1574 CG2 THR A 195 -4.658 4.263 -82.630 1.00 44.97 C \nANISOU 1574 CG2 THR A 195 3981 5383 7723 -140 638 -702 C \nATOM 1575 N THR A 196 -6.514 6.864 -81.091 1.00 54.65 N \nANISOU 1575 N THR A 196 5223 6473 9070 -162 613 -776 N \nATOM 1576 CA THR A 196 -6.417 8.169 -80.388 1.00 57.96 C \nANISOU 1576 CA THR A 196 5624 6849 9549 -171 579 -818 C \nATOM 1577 C THR A 196 -5.727 8.018 -79.036 1.00 51.18 C \nANISOU 1577 C THR A 196 4785 5953 8710 -160 540 -796 C \nATOM 1578 O THR A 196 -5.482 6.906 -78.604 1.00 51.42 O \nANISOU 1578 O THR A 196 4840 5991 8705 -148 542 -749 O \nATOM 1579 CB THR A 196 -7.826 8.815 -80.172 1.00 58.57 C \nANISOU 1579 CB THR A 196 5709 6908 9638 -185 596 -834 C \nATOM 1580 OG1 THR A 196 -8.689 7.916 -79.464 1.00 55.29 O \nANISOU 1580 OG1 THR A 196 5344 6471 9191 -179 613 -785 O \nATOM 1581 CG2 THR A 196 -8.467 9.118 -81.441 1.00 68.02 C \nANISOU 1581 CG2 THR A 196 6884 8142 10818 -203 631 -860 C \nATOM 1582 N TYR A 197 -5.522 9.159 -78.353 1.00 42.85 N \nANISOU 1582 N TYR A 197 3717 4860 7706 -162 505 -830 N \nATOM 1583 CA TYR A 197 -4.728 9.226 -77.134 1.00 39.40 C \nANISOU 1583 CA TYR A 197 3295 4384 7293 -156 462 -817 C \nATOM 1584 C TYR A 197 -4.947 10.536 -76.434 1.00 36.71 C \nANISOU 1584 C TYR A 197 2941 4003 7003 -153 432 -854 C \nATOM 1585 O TYR A 197 -5.130 11.589 -77.105 1.00 35.07 O \nANISOU 1585 O TYR A 197 2701 3805 6820 -153 435 -903 O \nATOM 1586 CB TYR A 197 -3.193 9.084 -77.488 1.00 37.87 C \nANISOU 1586 CB TYR A 197 3093 4202 7094 -160 438 -823 C \nATOM 1587 CG TYR A 197 -2.708 10.214 -78.359 1.00 33.09 C \nANISOU 1587 CG TYR A 197 2459 3597 6517 -163 429 -881 C \nATOM 1588 CD1 TYR A 197 -2.047 11.261 -77.826 1.00 33.39 C \nANISOU 1588 CD1 TYR A 197 2497 3591 6598 -156 388 -914 C \nATOM 1589 CD2 TYR A 197 -2.935 10.232 -79.712 1.00 40.78 C \nANISOU 1589 CD2 TYR A 197 3409 4615 7473 -170 463 -904 C \nATOM 1590 CE1 TYR A 197 -1.653 12.342 -78.573 1.00 33.56 C \nANISOU 1590 CE1 TYR A 197 2498 3611 6644 -149 381 -970 C \nATOM 1591 CE2 TYR A 197 -2.521 11.312 -80.503 1.00 41.78 C \nANISOU 1591 CE2 TYR A 197 3508 4742 7623 -169 456 -961 C \nATOM 1592 CZ TYR A 197 -1.885 12.375 -79.890 1.00 40.43 C \nANISOU 1592 CZ TYR A 197 3341 4524 7496 -155 414 -995 C \nATOM 1593 OH TYR A 197 -1.428 13.449 -80.605 1.00 48.24 O \nANISOU 1593 OH TYR A 197 4310 5511 8508 -144 406 -1052 O \nATOM 1594 N ILE A 198 -4.858 10.520 -75.111 1.00 32.88 N \nANISOU 1594 N ILE A 198 2478 3479 6534 -148 403 -832 N \nATOM 1595 CA ILE A 198 -4.759 11.747 -74.367 1.00 34.73 C \nANISOU 1595 CA ILE A 198 2701 3677 6817 -141 365 -864 C \nATOM 1596 C ILE A 198 -3.365 11.747 -73.782 1.00 44.45 C \nANISOU 1596 C ILE A 198 3950 4879 8062 -135 322 -857 C \nATOM 1597 O ILE A 198 -2.890 10.709 -73.264 1.00 44.15 O \nANISOU 1597 O ILE A 198 3938 4840 7996 -143 317 -813 O \nATOM 1598 CB ILE A 198 -5.744 11.816 -73.196 1.00 40.86 C \nANISOU 1598 CB ILE A 198 3494 4430 7603 -145 361 -845 C \nATOM 1599 CG1 ILE A 198 -7.155 11.965 -73.673 1.00 40.33 C \nANISOU 1599 CG1 ILE A 198 3417 4387 7521 -160 401 -855 C \nATOM 1600 CG2 ILE A 198 -5.422 13.012 -72.277 1.00 39.50 C \nANISOU 1600 CG2 ILE A 198 3310 4222 7478 -132 314 -872 C \nATOM 1601 CD1 ILE A 198 -7.825 10.651 -74.022 1.00 45.52 C \nANISOU 1601 CD1 ILE A 198 4109 5060 8126 -169 444 -813 C \nATOM 1602 N SER A 199 -2.710 12.902 -73.812 1.00 48.47 N \nANISOU 1602 N SER A 199 4445 5364 8608 -122 289 -900 N \nATOM 1603 CA SER A 199 -1.309 13.005 -73.376 1.00 50.68 C \nANISOU 1603 CA SER A 199 4752 5609 8897 -121 246 -898 C \nATOM 1604 C SER A 199 -1.222 14.205 -72.468 1.00 53.02 C \nANISOU 1604 C SER A 199 5051 5858 9238 -98 204 -923 C \nATOM 1605 O SER A 199 -1.492 15.323 -72.874 1.00 56.47 O \nANISOU 1605 O SER A 199 5460 6296 9701 -74 201 -969 O \nATOM 1606 CB SER A 199 -0.385 13.126 -74.592 1.00 55.21 C \nANISOU 1606 CB SER A 199 5320 6198 9458 -127 251 -928 C \nATOM 1607 OG SER A 199 0.750 13.912 -74.292 1.00 56.18 O \nANISOU 1607 OG SER A 199 5467 6273 9604 -118 207 -953 O \nATOM 1608 N VAL A 200 -0.909 13.972 -71.200 1.00 55.55 N \nANISOU 1608 N VAL A 200 5401 6141 9564 -102 172 -890 N \nATOM 1609 CA VAL A 200 -0.895 15.053 -70.200 1.00 49.38 C \nANISOU 1609 CA VAL A 200 4623 5317 8822 -78 129 -907 C \nATOM 1610 C VAL A 200 0.465 15.061 -69.502 1.00 49.21 C \nANISOU 1610 C VAL A 200 4649 5246 8805 -83 82 -893 C \nATOM 1611 O VAL A 200 0.965 13.991 -69.106 1.00 45.25 O \nANISOU 1611 O VAL A 200 4175 4745 8273 -114 80 -851 O \nATOM 1612 CB VAL A 200 -1.924 14.837 -69.126 1.00 44.48 C \nANISOU 1612 CB VAL A 200 4000 4695 8204 -84 132 -878 C \nATOM 1613 CG1 VAL A 200 -2.052 16.074 -68.269 1.00 36.19 C \nANISOU 1613 CG1 VAL A 200 2941 3615 7193 -57 93 -900 C \nATOM 1614 CG2 VAL A 200 -3.226 14.465 -69.729 1.00 51.91 C \nANISOU 1614 CG2 VAL A 200 4914 5683 9127 -96 183 -877 C \nATOM 1615 N GLY A 201 1.061 16.245 -69.376 1.00 45.49 N \nANISOU 1615 N GLY A 201 4188 4733 8363 -52 44 -930 N \nATOM 1616 CA GLY A 201 2.407 16.399 -68.834 1.00 49.12 C \nANISOU 1616 CA GLY A 201 4703 5136 8824 -57 -3 -923 C \nATOM 1617 C GLY A 201 2.604 17.613 -67.956 1.00 51.06 C \nANISOU 1617 C GLY A 201 4966 5328 9106 -16 -51 -942 C \nATOM 1618 O GLY A 201 2.189 18.722 -68.273 1.00 49.41 O \nANISOU 1618 O GLY A 201 4727 5122 8923 31 -54 -986 O \nATOM 1619 N THR A 202 3.234 17.392 -66.812 1.00 51.17 N \nANISOU 1619 N THR A 202 5026 5299 9119 -32 -90 -909 N \nATOM 1620 CA THR A 202 3.733 18.472 -65.981 1.00 47.44 C \nANISOU 1620 CA THR A 202 4587 4765 8674 5 -143 -922 C \nATOM 1621 C THR A 202 5.255 18.250 -65.811 1.00 56.17 C \nANISOU 1621 C THR A 202 5770 5813 9759 -23 -179 -910 C \nATOM 1622 O THR A 202 5.889 17.550 -66.594 1.00 67.41 O \nANISOU 1622 O THR A 202 7211 7251 11152 -63 -161 -907 O \nATOM 1623 CB THR A 202 3.020 18.504 -64.644 1.00 45.05 C \nANISOU 1623 CB THR A 202 4272 4459 8386 8 -161 -892 C \nATOM 1624 OG1 THR A 202 3.458 17.430 -63.796 1.00 40.77 O \nANISOU 1624 OG1 THR A 202 3766 3906 7819 -43 -171 -839 O \nATOM 1625 CG2 THR A 202 1.578 18.346 -64.813 1.00 44.99 C \nANISOU 1625 CG2 THR A 202 4199 4511 8382 10 -119 -893 C \nATOM 1626 N SER A 203 5.845 18.838 -64.784 1.00 59.89 N \nANISOU 1626 N SER A 203 6291 6221 10244 -8 -231 -902 N \nATOM 1627 CA SER A 203 7.208 18.521 -64.424 1.00 57.40 C \nANISOU 1627 CA SER A 203 6056 5851 9902 -50 -266 -881 C \nATOM 1628 C SER A 203 7.319 17.127 -63.801 1.00 55.27 C \nANISOU 1628 C SER A 203 5790 5612 9597 -121 -257 -824 C \nATOM 1629 O SER A 203 8.375 16.471 -63.845 1.00 65.17 O \nANISOU 1629 O SER A 203 7093 6854 10813 -177 -268 -804 O \nATOM 1630 CB SER A 203 7.750 19.546 -63.465 1.00 57.83 C \nANISOU 1630 CB SER A 203 6167 5828 9978 -11 -324 -886 C \nATOM 1631 OG SER A 203 7.100 19.432 -62.235 1.00 61.19 O \nANISOU 1631 OG SER A 203 6571 6261 10417 -11 -339 -852 O \nATOM 1632 N THR A 204 6.233 16.679 -63.220 1.00 48.74 N \nANISOU 1632 N THR A 204 4912 4828 8778 -119 -237 -799 N \nATOM 1633 CA THR A 204 6.222 15.442 -62.423 1.00 46.28 C \nANISOU 1633 CA THR A 204 4604 4545 8436 -172 -232 -744 C \nATOM 1634 C THR A 204 5.426 14.353 -63.102 1.00 48.55 C \nANISOU 1634 C THR A 204 4838 4910 8699 -190 -174 -730 C \nATOM 1635 O THR A 204 5.655 13.193 -62.855 1.00 54.05 O \nANISOU 1635 O THR A 204 5539 5643 9357 -233 -162 -691 O \nATOM 1636 CB THR A 204 5.614 15.751 -61.035 1.00 55.68 C \nANISOU 1636 CB THR A 204 5790 5716 9650 -155 -258 -722 C \nATOM 1637 OG1 THR A 204 6.507 15.266 -60.003 1.00 60.65 O \nANISOU 1637 OG1 THR A 204 6472 6316 10255 -200 -295 -683 O \nATOM 1638 CG2 THR A 204 4.188 15.110 -60.867 1.00 56.02 C \nANISOU 1638 CG2 THR A 204 5773 5819 9694 -153 -214 -705 C \nATOM 1639 N LEU A 205 4.527 14.745 -64.013 1.00 47.42 N \nANISOU 1639 N LEU A 205 4646 4795 8574 -154 -138 -763 N \nATOM 1640 CA LEU A 205 3.565 13.861 -64.601 1.00 43.75 C \nANISOU 1640 CA LEU A 205 4136 4397 8091 -162 -84 -751 C \nATOM 1641 C LEU A 205 3.865 13.682 -66.092 1.00 44.08 C \nANISOU 1641 C LEU A 205 4163 4471 8114 -167 -53 -777 C \nATOM 1642 O LEU A 205 4.167 14.646 -66.791 1.00 42.87 O \nANISOU 1642 O LEU A 205 4013 4294 7983 -142 -61 -822 O \nATOM 1643 CB LEU A 205 2.141 14.448 -64.419 1.00 40.63 C \nANISOU 1643 CB LEU A 205 3697 4014 7728 -125 -66 -767 C \nATOM 1644 CG LEU A 205 1.029 13.567 -64.999 1.00 40.01 C \nANISOU 1644 CG LEU A 205 3581 3995 7626 -133 -9 -754 C \nATOM 1645 CD1 LEU A 205 0.753 12.370 -64.128 1.00 32.98 C \nANISOU 1645 CD1 LEU A 205 2703 3121 6705 -158 1 -701 C \nATOM 1646 CD2 LEU A 205 -0.233 14.436 -65.223 1.00 43.19 C \nANISOU 1646 CD2 LEU A 205 3942 4410 8058 -103 9 -786 C \nATOM 1647 N ASN A 206 3.634 12.459 -66.560 1.00 44.53 N \nANISOU 1647 N ASN A 206 4201 4587 8131 -193 -13 -750 N \nATOM 1648 CA ASN A 206 3.927 12.041 -67.894 1.00 47.04 C \nANISOU 1648 CA ASN A 206 4505 4947 8422 -206 19 -764 C \nATOM 1649 C ASN A 206 3.035 10.836 -68.199 1.00 47.75 C \nANISOU 1649 C ASN A 206 4561 5104 8477 -211 68 -732 C \nATOM 1650 O ASN A 206 3.475 9.695 -68.101 1.00 52.35 O \nANISOU 1650 O ASN A 206 5150 5727 9014 -240 76 -694 O \nATOM 1651 CB ASN A 206 5.428 11.677 -68.035 1.00 42.22 C \nANISOU 1651 CB ASN A 206 3936 4329 7777 -251 -6 -755 C \nATOM 1652 CG ASN A 206 5.839 11.389 -69.465 1.00 43.39 C \nANISOU 1652 CG ASN A 206 4071 4519 7896 -268 23 -776 C \nATOM 1653 OD1 ASN A 206 5.102 11.652 -70.439 1.00 57.03 O \nANISOU 1653 OD1 ASN A 206 5762 6272 9637 -241 58 -804 O \nATOM 1654 ND2 ASN A 206 7.000 10.838 -69.622 1.00 40.90 N \nANISOU 1654 ND2 ASN A 206 3785 4217 7539 -318 10 -762 N \nATOM 1655 N GLN A 207 1.792 11.108 -68.604 1.00 41.08 N \nANISOU 1655 N GLN A 207 3683 4274 7650 -182 101 -748 N \nATOM 1656 CA GLN A 207 0.872 10.058 -68.937 1.00 38.59 C \nANISOU 1656 CA GLN A 207 3349 4012 7303 -182 148 -720 C \nATOM 1657 C GLN A 207 0.454 10.028 -70.428 1.00 40.12 C \nANISOU 1657 C GLN A 207 3512 4248 7485 -175 191 -745 C \nATOM 1658 O GLN A 207 0.592 10.963 -71.166 1.00 37.12 O \nANISOU 1658 O GLN A 207 3118 3856 7129 -165 188 -790 O \nATOM 1659 CB GLN A 207 -0.354 10.101 -68.042 1.00 39.95 C \nANISOU 1659 CB GLN A 207 3520 4171 7490 -165 156 -705 C \nATOM 1660 CG GLN A 207 -1.445 10.991 -68.486 1.00 43.95 C \nANISOU 1660 CG GLN A 207 4000 4673 8027 -146 175 -741 C \nATOM 1661 CD GLN A 207 -2.747 10.858 -67.650 1.00 43.73 C \nANISOU 1661 CD GLN A 207 3975 4639 8001 -142 190 -722 C \nATOM 1662 OE1 GLN A 207 -3.796 11.420 -68.007 1.00 40.75 O \nANISOU 1662 OE1 GLN A 207 3578 4270 7637 -137 212 -746 O \nATOM 1663 NE2 GLN A 207 -2.672 10.157 -66.553 1.00 43.39 N \nANISOU 1663 NE2 GLN A 207 3960 4585 7943 -149 177 -682 N \nATOM 1664 N ARG A 208 0.003 8.878 -70.874 1.00 40.86 N \nANISOU 1664 N ARG A 208 3598 4393 7534 -177 231 -714 N \nATOM 1665 CA ARG A 208 -0.553 8.765 -72.177 1.00 38.51 C \nANISOU 1665 CA ARG A 208 3275 4135 7222 -171 273 -732 C \nATOM 1666 C ARG A 208 -1.653 7.730 -72.091 1.00 46.07 C \nANISOU 1666 C ARG A 208 4237 5123 8144 -158 313 -693 C \nATOM 1667 O ARG A 208 -1.382 6.588 -71.755 1.00 45.66 O \nANISOU 1667 O ARG A 208 4198 5102 8050 -159 319 -650 O \nATOM 1668 CB ARG A 208 0.450 8.336 -73.187 1.00 38.15 C \nANISOU 1668 CB ARG A 208 3221 4130 7144 -189 279 -736 C \nATOM 1669 CG ARG A 208 0.259 9.059 -74.506 1.00 36.59 C \nANISOU 1669 CG ARG A 208 2999 3944 6961 -185 300 -783 C \nATOM 1670 CD ARG A 208 1.181 8.572 -75.548 1.00 36.13 C \nANISOU 1670 CD ARG A 208 2933 3930 6865 -207 310 -786 C \nATOM 1671 NE ARG A 208 0.517 7.629 -76.448 1.00 38.35 N \nANISOU 1671 NE ARG A 208 3193 4275 7103 -202 358 -765 N \nATOM 1672 CZ ARG A 208 0.337 7.801 -77.755 1.00 39.50 C \nANISOU 1672 CZ ARG A 208 3315 4454 7240 -203 386 -792 C \nATOM 1673 NH1 ARG A 208 0.722 8.945 -78.346 1.00 42.19 N \nANISOU 1673 NH1 ARG A 208 3647 4770 7615 -207 374 -847 N \nATOM 1674 NH2 ARG A 208 -0.262 6.835 -78.457 1.00 37.42 N \nANISOU 1674 NH2 ARG A 208 3040 4248 6932 -197 428 -765 N \nATOM 1675 N LEU A 209 -2.904 8.153 -72.361 1.00 49.78 N \nANISOU 1675 N LEU A 209 4700 5587 8629 -147 340 -710 N \nATOM 1676 CA LEU A 209 -4.099 7.311 -72.148 1.00 38.61 C \nANISOU 1676 CA LEU A 209 3304 4183 7182 -136 376 -676 C \nATOM 1677 C LEU A 209 -4.645 6.937 -73.498 1.00 39.18 C \nANISOU 1677 C LEU A 209 3366 4298 7224 -133 422 -681 C \nATOM 1678 O LEU A 209 -4.674 7.725 -74.404 1.00 39.00 O \nANISOU 1678 O LEU A 209 3315 4282 7221 -140 428 -722 O \nATOM 1679 CB LEU A 209 -5.142 8.063 -71.411 1.00 42.78 C \nANISOU 1679 CB LEU A 209 3841 4671 7742 -138 372 -689 C \nATOM 1680 CG LEU A 209 -4.752 8.630 -70.045 1.00 45.17 C \nANISOU 1680 CG LEU A 209 4153 4929 8080 -140 326 -688 C \nATOM 1681 CD1 LEU A 209 -5.772 9.609 -69.493 1.00 40.48 C \nANISOU 1681 CD1 LEU A 209 3556 4307 7520 -145 321 -711 C \nATOM 1682 CD2 LEU A 209 -4.462 7.519 -69.084 1.00 46.37 C \nANISOU 1682 CD2 LEU A 209 4337 5081 8201 -136 319 -638 C \nATOM 1683 N VAL A 210 -4.949 5.656 -73.656 1.00 48.54 N \nANISOU 1683 N VAL A 210 4571 5515 8355 -117 452 -638 N \nATOM 1684 CA VAL A 210 -5.496 5.131 -74.920 1.00 47.03 C \nANISOU 1684 CA VAL A 210 4377 5367 8126 -110 497 -634 C \nATOM 1685 C VAL A 210 -6.831 4.519 -74.583 1.00 42.95 C \nANISOU 1685 C VAL A 210 3905 4835 7580 -94 529 -605 C \nATOM 1686 O VAL A 210 -6.922 3.773 -73.602 1.00 49.04 O \nANISOU 1686 O VAL A 210 4709 5594 8330 -75 525 -567 O \nATOM 1687 CB VAL A 210 -4.589 4.051 -75.538 1.00 46.45 C \nANISOU 1687 CB VAL A 210 4292 5355 8002 -100 505 -606 C \nATOM 1688 CG1 VAL A 210 -5.363 3.326 -76.623 1.00 56.48 C \nANISOU 1688 CG1 VAL A 210 5570 6665 9225 -82 553 -590 C \nATOM 1689 CG2 VAL A 210 -3.378 4.688 -76.167 1.00 49.41 C \nANISOU 1689 CG2 VAL A 210 4630 5747 8399 -125 481 -641 C \nATOM 1690 N PRO A 211 -7.876 4.887 -75.317 1.00 36.74 N \nANISOU 1690 N PRO A 211 3124 4043 6791 -104 561 -624 N \nATOM 1691 CA PRO A 211 -9.239 4.431 -75.016 1.00 35.36 C \nANISOU 1691 CA PRO A 211 3005 3844 6587 -98 592 -600 C \nATOM 1692 C PRO A 211 -9.369 2.973 -75.299 1.00 34.87 C \nANISOU 1692 C PRO A 211 2980 3810 6458 -60 623 -551 C \nATOM 1693 O PRO A 211 -8.869 2.512 -76.357 1.00 35.01 O \nANISOU 1693 O PRO A 211 2973 3880 6448 -48 637 -546 O \nATOM 1694 CB PRO A 211 -10.092 5.246 -75.987 1.00 32.38 C \nANISOU 1694 CB PRO A 211 2615 3469 6219 -128 617 -638 C \nATOM 1695 CG PRO A 211 -9.184 5.669 -77.066 1.00 34.49 C \nANISOU 1695 CG PRO A 211 2825 3778 6500 -134 610 -669 C \nATOM 1696 CD PRO A 211 -7.881 5.909 -76.355 1.00 35.37 C \nANISOU 1696 CD PRO A 211 2909 3883 6645 -127 565 -673 C \nATOM 1697 N LYS A 212 -9.941 2.238 -74.378 1.00 34.95 N \nANISOU 1697 N LYS A 212 3046 3793 6441 -36 630 -514 N \nATOM 1698 CA LYS A 212 -10.228 0.802 -74.535 1.00 37.25 C \nANISOU 1698 CA LYS A 212 3384 4108 6662 14 662 -464 C \nATOM 1699 C LYS A 212 -11.564 0.566 -75.198 1.00 39.21 C \nANISOU 1699 C LYS A 212 3691 4336 6872 16 706 -457 C \nATOM 1700 O LYS A 212 -12.612 0.658 -74.555 1.00 37.70 O \nANISOU 1700 O LYS A 212 3559 4089 6675 5 717 -453 O \nATOM 1701 CB LYS A 212 -10.315 0.150 -73.130 1.00 38.00 C \nANISOU 1701 CB LYS A 212 3522 4175 6741 42 650 -429 C \nATOM 1702 CG LYS A 212 -8.966 -0.296 -72.569 1.00 39.49 C \nANISOU 1702 CG LYS A 212 3669 4407 6930 59 618 -412 C \nATOM 1703 CD LYS A 212 -8.559 0.578 -71.422 1.00 38.10 C \nANISOU 1703 CD LYS A 212 3476 4190 6811 26 575 -433 C \nATOM 1704 CE LYS A 212 -8.203 -0.254 -70.217 1.00 41.59 C \nANISOU 1704 CE LYS A 212 3938 4636 7227 54 560 -395 C \nATOM 1705 NZ LYS A 212 -8.190 0.571 -68.948 1.00 39.97 N \nANISOU 1705 NZ LYS A 212 3737 4376 7073 23 524 -411 N \nATOM 1706 N ILE A 213 -11.535 0.296 -76.484 1.00 44.90 N \nANISOU 1706 N ILE A 213 4396 5099 7564 23 731 -457 N \nATOM 1707 CA ILE A 213 -12.777 0.189 -77.271 1.00 53.75 C \nANISOU 1707 CA ILE A 213 5572 6200 8649 15 772 -455 C \nATOM 1708 C ILE A 213 -13.273 -1.259 -77.070 1.00 61.81 C \nANISOU 1708 C ILE A 213 6672 7218 9596 81 801 -398 C \nATOM 1709 O ILE A 213 -12.704 -2.186 -77.633 1.00 67.48 O \nANISOU 1709 O ILE A 213 7376 7994 10271 130 810 -369 O \nATOM 1710 CB ILE A 213 -12.502 0.400 -78.784 1.00 49.61 C \nANISOU 1710 CB ILE A 213 5001 5729 8118 1 788 -474 C \nATOM 1711 CG1 ILE A 213 -11.623 1.629 -79.045 1.00 52.72 C \nANISOU 1711 CG1 ILE A 213 5309 6144 8580 -43 756 -527 C \nATOM 1712 CG2 ILE A 213 -13.800 0.422 -79.567 1.00 43.96 C \nANISOU 1712 CG2 ILE A 213 4342 4992 7368 -18 828 -475 C \nATOM 1713 CD1 ILE A 213 -12.382 2.941 -79.049 1.00 55.12 C \nANISOU 1713 CD1 ILE A 213 5605 6412 8926 -100 754 -574 C \nATOM 1714 N ALA A 214 -14.335 -1.452 -76.318 1.00 64.24 N \nANISOU 1714 N ALA A 214 7063 7461 9884 83 815 -383 N \nATOM 1715 CA ALA A 214 -14.905 -2.783 -76.180 1.00 68.63 C \nANISOU 1715 CA ALA A 214 7706 8005 10364 151 845 -332 C \nATOM 1716 C ALA A 214 -16.403 -2.766 -75.845 1.00 65.60 C \nANISOU 1716 C ALA A 214 7434 7540 9953 131 873 -326 C \nATOM 1717 O ALA A 214 -16.979 -1.730 -75.548 1.00 62.37 O \nANISOU 1717 O ALA A 214 7027 7087 9582 60 866 -361 O \nATOM 1718 CB ALA A 214 -14.149 -3.528 -75.100 1.00 69.60 C \nANISOU 1718 CB ALA A 214 7820 8146 10478 205 824 -303 C \nATOM 1719 N THR A 215 -17.001 -3.943 -75.870 1.00 71.25 N \nANISOU 1719 N THR A 215 8242 8237 10594 197 904 -282 N \nATOM 1720 CA THR A 215 -18.438 -4.135 -75.541 1.00 75.21 C \nANISOU 1720 CA THR A 215 8872 8653 11052 186 935 -270 C \nATOM 1721 C THR A 215 -18.599 -4.325 -74.031 1.00 75.77 C \nANISOU 1721 C THR A 215 8988 8673 11127 199 920 -259 C \nATOM 1722 O THR A 215 -17.834 -5.053 -73.402 1.00 76.49 O \nANISOU 1722 O THR A 215 9057 8796 11209 265 906 -234 O \nATOM 1723 CB THR A 215 -19.025 -5.374 -76.290 1.00 72.94 C \nANISOU 1723 CB THR A 215 8678 8361 10675 260 976 -224 C \nATOM 1724 OG1 THR A 215 -19.016 -5.131 -77.709 1.00 71.24 O \nANISOU 1724 OG1 THR A 215 8428 8186 10453 237 991 -235 O \nATOM 1725 CG2 THR A 215 -20.455 -5.684 -75.844 1.00 74.93 C \nANISOU 1725 CG2 THR A 215 9081 8515 10874 255 1006 -208 C \nATOM 1726 N ARG A 216 -19.572 -3.656 -73.439 1.00 83.59 N \nANISOU 1726 N ARG A 216 10038 9591 12130 133 924 -279 N \nATOM 1727 CA ARG A 216 -19.769 -3.777 -71.994 1.00 92.17 C \nANISOU 1727 CA ARG A 216 11170 10629 13220 138 911 -272 C \nATOM 1728 C ARG A 216 -21.220 -3.948 -71.626 1.00 87.39 C \nANISOU 1728 C ARG A 216 10706 9933 12564 113 942 -263 C \nATOM 1729 O ARG A 216 -22.113 -3.717 -72.446 1.00 79.92 O \nANISOU 1729 O ARG A 216 9817 8960 11590 68 970 -270 O \nATOM 1730 CB ARG A 216 -19.256 -2.547 -71.263 1.00 97.66 C \nANISOU 1730 CB ARG A 216 11774 11333 13999 68 869 -312 C \nATOM 1731 CG ARG A 216 -17.747 -2.379 -71.272 1.00 96.93 C \nANISOU 1731 CG ARG A 216 11557 11315 13958 91 831 -320 C \nATOM 1732 CD ARG A 216 -17.377 -0.952 -70.897 1.00 83.52 C \nANISOU 1732 CD ARG A 216 9773 9620 12339 15 794 -366 C \nATOM 1733 NE ARG A 216 -16.157 -0.484 -71.515 1.00 74.63 N \nANISOU 1733 NE ARG A 216 8535 8561 11260 14 768 -387 N \nATOM 1734 CZ ARG A 216 -16.105 0.354 -72.546 1.00 77.97 C \nANISOU 1734 CZ ARG A 216 8904 9010 11712 -30 769 -421 C \nATOM 1735 NH1 ARG A 216 -17.207 0.830 -73.112 1.00 84.24 N \nANISOU 1735 NH1 ARG A 216 9737 9778 12491 -79 795 -439 N \nATOM 1736 NH2 ARG A 216 -14.933 0.712 -73.027 1.00 78.28 N \nANISOU 1736 NH2 ARG A 216 8849 9104 11788 -26 744 -439 N \nATOM 1737 N SER A 217 -21.411 -4.365 -70.375 1.00 81.63 N \nANISOU 1737 N SER A 217 10035 9159 11820 138 937 -247 N \nATOM 1738 CA SER A 217 -22.723 -4.419 -69.739 1.00 81.49 C \nANISOU 1738 CA SER A 217 10153 9050 11761 102 960 -244 C \nATOM 1739 C SER A 217 -23.169 -3.006 -69.388 1.00 83.22 C \nANISOU 1739 C SER A 217 10336 9249 12033 -20 942 -289 C \nATOM 1740 O SER A 217 -22.388 -2.172 -68.948 1.00 81.85 O \nANISOU 1740 O SER A 217 10050 9117 11932 -52 904 -316 O \nATOM 1741 CB SER A 217 -22.688 -5.286 -68.471 1.00 81.21 C \nANISOU 1741 CB SER A 217 10182 8980 11695 170 958 -215 C \nATOM 1742 OG SER A 217 -21.523 -5.029 -67.668 1.00 77.25 O \nANISOU 1742 OG SER A 217 9566 8532 11254 182 915 -224 O \nATOM 1743 N LYS A 218 -24.447 -2.731 -69.595 1.00 91.05 N \nANISOU 1743 N LYS A 218 11429 10180 12985 -90 971 -298 N \nATOM 1744 CA LYS A 218 -24.970 -1.382 -69.419 1.00 87.34 C \nANISOU 1744 CA LYS A 218 10923 9706 12555 -211 958 -342 C \nATOM 1745 C LYS A 218 -25.093 -1.104 -67.935 1.00 84.18 C \nANISOU 1745 C LYS A 218 10537 9271 12175 -239 936 -348 C \nATOM 1746 O LYS A 218 -25.799 -1.812 -67.239 1.00 95.58 O \nANISOU 1746 O LYS A 218 12107 10646 13564 -221 956 -325 O \nATOM 1747 CB LYS A 218 -26.312 -1.214 -70.135 1.00 82.15 C \nANISOU 1747 CB LYS A 218 10370 9002 11839 -287 996 -347 C \nATOM 1748 CG LYS A 218 -26.166 -1.276 -71.646 1.00 90.82 C \nANISOU 1748 CG LYS A 218 11437 10145 12926 -275 1014 -347 C \nATOM 1749 CD LYS A 218 -27.481 -1.010 -72.372 1.00 97.53 C \nANISOU 1749 CD LYS A 218 12385 10954 13718 -363 1050 -355 C \nATOM 1750 CE LYS A 218 -27.295 -0.779 -73.866 1.00101.99 C \nANISOU 1750 CE LYS A 218 12891 11575 14284 -373 1062 -364 C \nATOM 1751 NZ LYS A 218 -26.976 -2.044 -74.569 1.00108.32 N \nANISOU 1751 NZ LYS A 218 13743 12375 15039 -262 1083 -321 N \nATOM 1752 N VAL A 219 -24.378 -0.082 -67.471 1.00 81.49 N \nANISOU 1752 N VAL A 219 10072 8980 11912 -277 895 -380 N \nATOM 1753 CA VAL A 219 -24.536 0.507 -66.142 1.00 76.75 C \nANISOU 1753 CA VAL A 219 9465 8357 11339 -327 869 -395 C \nATOM 1754 C VAL A 219 -25.255 1.856 -66.278 1.00 81.85 C \nANISOU 1754 C VAL A 219 10078 9017 12005 -447 864 -438 C \nATOM 1755 O VAL A 219 -24.721 2.773 -66.897 1.00 81.97 O \nANISOU 1755 O VAL A 219 9975 9096 12073 -474 844 -468 O \nATOM 1756 CB VAL A 219 -23.148 0.724 -65.489 1.00 72.57 C \nANISOU 1756 CB VAL A 219 8815 7879 10880 -280 822 -398 C \nATOM 1757 CG1 VAL A 219 -23.274 1.263 -64.068 1.00 71.17 C \nANISOU 1757 CG1 VAL A 219 8633 7679 10728 -324 794 -410 C \nATOM 1758 CG2 VAL A 219 -22.369 -0.569 -65.496 1.00 68.85 C \nANISOU 1758 CG2 VAL A 219 8358 7416 10385 -167 827 -358 C \nATOM 1759 N ASN A 220 -26.424 1.990 -65.641 1.00 98.59 N \nANISOU 1759 N ASN A 220 12298 11081 14081 -520 881 -441 N \nATOM 1760 CA ASN A 220 -27.359 3.135 -65.837 1.00103.14 C \nANISOU 1760 CA ASN A 220 12865 11671 14652 -646 886 -478 C \nATOM 1761 C ASN A 220 -27.840 3.248 -67.283 1.00100.26 C \nANISOU 1761 C ASN A 220 12512 11326 14255 -679 917 -486 C \nATOM 1762 O ASN A 220 -27.933 4.337 -67.841 1.00 99.18 O \nANISOU 1762 O ASN A 220 12289 11250 14146 -750 908 -523 O \nATOM 1763 CB ASN A 220 -26.733 4.467 -65.373 1.00112.72 C \nANISOU 1763 CB ASN A 220 13929 12954 15943 -688 839 -517 C \nATOM 1764 CG ASN A 220 -26.490 4.510 -63.875 1.00119.36 C \nANISOU 1764 CG ASN A 220 14769 13774 16808 -681 810 -511 C \nATOM 1765 OD1 ASN A 220 -27.090 3.739 -63.119 1.00124.55 O \nANISOU 1765 OD1 ASN A 220 15546 14363 17415 -677 828 -486 O \nATOM 1766 ND2 ASN A 220 -25.605 5.411 -63.434 1.00117.49 N \nANISOU 1766 ND2 ASN A 220 14402 13594 16645 -679 764 -534 N \nATOM 1767 N GLY A 221 -28.111 2.101 -67.891 1.00 98.07 N \nANISOU 1767 N GLY A 221 12342 11002 13920 -621 952 -452 N \nATOM 1768 CA GLY A 221 -28.470 2.038 -69.302 1.00 95.97 C \nANISOU 1768 CA GLY A 221 12094 10751 13620 -637 982 -453 C \nATOM 1769 C GLY A 221 -27.397 2.561 -70.239 1.00 93.61 C \nANISOU 1769 C GLY A 221 11641 10540 13385 -606 961 -473 C \nATOM 1770 O GLY A 221 -27.701 2.950 -71.362 1.00106.84 O \nANISOU 1770 O GLY A 221 13297 12249 15047 -649 978 -489 O \nATOM 1771 N GLN A 222 -26.138 2.532 -69.803 1.00 91.96 N \nANISOU 1771 N GLN A 222 11333 10369 13240 -531 925 -471 N \nATOM 1772 CA GLN A 222 -25.010 3.039 -70.611 1.00 90.14 C \nANISOU 1772 CA GLN A 222 10959 10218 13071 -500 902 -492 C \nATOM 1773 C GLN A 222 -23.791 2.084 -70.665 1.00 85.59 C \nANISOU 1773 C GLN A 222 10351 9658 12512 -383 890 -461 C \nATOM 1774 O GLN A 222 -23.144 1.782 -69.659 1.00 80.28 O \nANISOU 1774 O GLN A 222 9661 8976 11863 -336 865 -447 O \nATOM 1775 CB GLN A 222 -24.558 4.395 -70.094 1.00 86.34 C \nANISOU 1775 CB GLN A 222 10355 9788 12663 -551 861 -535 C \nATOM 1776 CG GLN A 222 -23.364 4.972 -70.863 1.00 89.90 C \nANISOU 1776 CG GLN A 222 10667 10314 13177 -518 835 -560 C \nATOM 1777 CD GLN A 222 -23.540 4.943 -72.388 1.00 89.03 C \nANISOU 1777 CD GLN A 222 10548 10238 13043 -527 864 -567 C \nATOM 1778 OE1 GLN A 222 -22.709 4.411 -73.123 1.00 85.21 O \nANISOU 1778 OE1 GLN A 222 10030 9779 12566 -460 865 -554 O \nATOM 1779 NE2 GLN A 222 -24.630 5.517 -72.859 1.00 93.89 N \nANISOU 1779 NE2 GLN A 222 11194 10857 13624 -615 888 -588 N \nATOM 1780 N SER A 223 -23.491 1.620 -71.867 1.00 79.44 N \nANISOU 1780 N SER A 223 9561 8909 11716 -342 908 -450 N \nATOM 1781 CA SER A 223 -22.446 0.628 -72.077 1.00 79.95 C \nANISOU 1781 CA SER A 223 9601 8998 11779 -237 903 -418 C \nATOM 1782 C SER A 223 -21.041 1.250 -72.105 1.00 78.27 C \nANISOU 1782 C SER A 223 9242 8855 11644 -219 861 -442 C \nATOM 1783 O SER A 223 -20.040 0.548 -72.015 1.00 86.57 O \nANISOU 1783 O SER A 223 10259 9932 12700 -144 848 -419 O \nATOM 1784 CB SER A 223 -22.736 -0.138 -73.381 1.00 78.27 C \nANISOU 1784 CB SER A 223 9438 8793 11509 -203 941 -395 C \nATOM 1785 OG SER A 223 -23.315 -1.408 -73.119 1.00 75.15 O \nANISOU 1785 OG SER A 223 9175 8340 11040 -141 970 -349 O \nATOM 1786 N GLY A 224 -20.976 2.567 -72.229 1.00 68.91 N \nANISOU 1786 N GLY A 224 7973 7699 10511 -288 840 -488 N \nATOM 1787 CA GLY A 224 -19.703 3.290 -72.277 1.00 53.20 C \nANISOU 1787 CA GLY A 224 5855 5765 8592 -276 800 -515 C \nATOM 1788 C GLY A 224 -19.151 3.485 -70.917 1.00 46.52 C \nANISOU 1788 C GLY A 224 4985 4905 7787 -264 762 -513 C \nATOM 1789 O GLY A 224 -19.808 3.151 -69.924 1.00 42.72 O \nANISOU 1789 O GLY A 224 4579 4373 7281 -272 767 -496 O \nATOM 1790 N ARG A 225 -17.935 4.027 -70.861 1.00 44.29 N \nANISOU 1790 N ARG A 225 4602 4664 7564 -246 724 -533 N \nATOM 1791 CA ARG A 225 -17.241 4.296 -69.594 1.00 41.24 C \nANISOU 1791 CA ARG A 225 4183 4268 7220 -236 682 -532 C \nATOM 1792 C ARG A 225 -16.499 5.565 -69.703 1.00 36.75 C \nANISOU 1792 C ARG A 225 3513 3735 6718 -260 645 -576 C \nATOM 1793 O ARG A 225 -16.170 6.038 -70.789 1.00 40.05 O \nANISOU 1793 O ARG A 225 3875 4193 7151 -266 648 -601 O \nATOM 1794 CB ARG A 225 -16.248 3.160 -69.217 1.00 49.95 C \nANISOU 1794 CB ARG A 225 5292 5378 8310 -162 672 -493 C \nATOM 1795 CG ARG A 225 -16.745 2.318 -68.081 1.00 67.45 C \nANISOU 1795 CG ARG A 225 7592 7548 10489 -139 680 -458 C \nATOM 1796 CD ARG A 225 -17.285 1.002 -68.536 1.00 77.28 C \nANISOU 1796 CD ARG A 225 8924 8779 11661 -89 723 -418 C \nATOM 1797 NE ARG A 225 -17.837 0.198 -67.432 1.00 82.06 N \nANISOU 1797 NE ARG A 225 9620 9334 12225 -63 733 -387 N \nATOM 1798 CZ ARG A 225 -19.046 -0.359 -67.441 1.00 75.68 C \nANISOU 1798 CZ ARG A 225 8924 8474 11357 -64 771 -369 C \nATOM 1799 NH1 ARG A 225 -19.877 -0.228 -68.471 1.00 66.84 N \nANISOU 1799 NH1 ARG A 225 7844 7344 10209 -95 804 -378 N \nATOM 1800 NH2 ARG A 225 -19.423 -1.074 -66.424 1.00 80.53 N \nANISOU 1800 NH2 ARG A 225 9617 9044 11936 -35 778 -343 N \nATOM 1801 N MET A 226 -16.153 6.122 -68.561 1.00 40.22 N \nANISOU 1801 N MET A 226 3926 4160 7196 -269 607 -584 N \nATOM 1802 CA MET A 226 -15.461 7.418 -68.523 1.00 43.79 C \nANISOU 1802 CA MET A 226 4286 4640 7710 -286 567 -625 C \nATOM 1803 C MET A 226 -14.566 7.456 -67.304 1.00 45.61 C \nANISOU 1803 C MET A 226 4499 4854 7975 -262 523 -613 C \nATOM 1804 O MET A 226 -15.060 7.418 -66.186 1.00 54.95 O \nANISOU 1804 O MET A 226 5720 6005 9153 -278 515 -601 O \nATOM 1805 CB MET A 226 -16.500 8.538 -68.492 1.00 46.12 C \nANISOU 1805 CB MET A 226 4568 4942 8012 -350 572 -661 C \nATOM 1806 CG MET A 226 -15.943 9.895 -68.809 1.00 52.90 C \nANISOU 1806 CG MET A 226 5332 5842 8925 -360 541 -709 C \nATOM 1807 SD MET A 226 -17.272 11.055 -69.180 1.00 57.12 S \nANISOU 1807 SD MET A 226 5844 6411 9448 -435 559 -751 S \nATOM 1808 CE MET A 226 -17.655 10.610 -70.865 1.00 44.87 C \nANISOU 1808 CE MET A 226 4306 4887 7857 -443 607 -756 C \nATOM 1809 N ASP A 227 -13.250 7.507 -67.497 1.00 46.53 N \nANISOU 1809 N ASP A 227 4564 4991 8122 -229 495 -617 N \nATOM 1810 CA ASP A 227 -12.323 7.542 -66.379 1.00 47.22 C \nANISOU 1810 CA ASP A 227 4637 5064 8239 -211 451 -605 C \nATOM 1811 C ASP A 227 -11.815 8.969 -66.157 1.00 46.52 C \nANISOU 1811 C ASP A 227 4483 4982 8209 -226 408 -646 C \nATOM 1812 O ASP A 227 -11.609 9.760 -67.102 1.00 46.09 O \nANISOU 1812 O ASP A 227 4380 4955 8177 -230 407 -682 O \nATOM 1813 CB ASP A 227 -11.144 6.612 -66.630 1.00 55.85 C \nANISOU 1813 CB ASP A 227 5724 6175 9319 -169 445 -578 C \nATOM 1814 CG ASP A 227 -11.561 5.124 -66.756 1.00 61.74 C \nANISOU 1814 CG ASP A 227 6534 6924 10002 -139 484 -533 C \nATOM 1815 OD1 ASP A 227 -12.737 4.763 -66.379 1.00 66.58 O \nANISOU 1815 OD1 ASP A 227 7209 7507 10582 -148 512 -519 O \nATOM 1816 OD2 ASP A 227 -10.692 4.333 -67.209 1.00 55.01 O \nANISOU 1816 OD2 ASP A 227 5668 6104 9128 -106 486 -513 O \nATOM 1817 N PHE A 228 -11.601 9.310 -64.880 1.00 35.82 N \nANISOU 1817 N PHE A 228 3130 3602 6878 -230 372 -640 N \nATOM 1818 CA PHE A 228 -11.103 10.596 -64.580 1.00 33.89 C \nANISOU 1818 CA PHE A 228 2831 3362 6685 -234 330 -674 C \nATOM 1819 C PHE A 228 -9.771 10.584 -63.902 1.00 34.46 C \nANISOU 1819 C PHE A 228 2892 3418 6783 -209 284 -662 C \nATOM 1820 O PHE A 228 -9.419 9.608 -63.284 1.00 46.57 O \nANISOU 1820 O PHE A 228 4462 4937 8295 -199 282 -624 O \nATOM 1821 CB PHE A 228 -12.137 11.352 -63.747 1.00 33.96 C \nANISOU 1821 CB PHE A 228 2842 3363 6700 -270 324 -687 C \nATOM 1822 CG PHE A 228 -13.327 11.745 -64.521 1.00 33.58 C \nANISOU 1822 CG PHE A 228 2789 3340 6631 -306 361 -711 C \nATOM 1823 CD1 PHE A 228 -13.326 12.871 -65.293 1.00 34.04 C \nANISOU 1823 CD1 PHE A 228 2783 3437 6712 -312 355 -756 C \nATOM 1824 CD2 PHE A 228 -14.429 10.929 -64.500 1.00 34.44 C \nANISOU 1824 CD2 PHE A 228 2962 3434 6690 -333 402 -688 C \nATOM 1825 CE1 PHE A 228 -14.427 13.174 -66.070 1.00 38.03 C \nANISOU 1825 CE1 PHE A 228 3284 3975 7193 -351 391 -778 C \nATOM 1826 CE2 PHE A 228 -15.528 11.217 -65.282 1.00 39.50 C \nANISOU 1826 CE2 PHE A 228 3607 4097 7304 -374 439 -708 C \nATOM 1827 CZ PHE A 228 -15.538 12.350 -66.064 1.00 38.48 C \nANISOU 1827 CZ PHE A 228 3408 4015 7198 -387 433 -753 C \nATOM 1828 N PHE A 229 -9.085 11.734 -63.922 1.00 34.85 N \nANISOU 1828 N PHE A 229 2896 3470 6878 -201 245 -695 N \nATOM 1829 CA PHE A 229 -7.723 11.793 -63.412 1.00 38.39 C \nANISOU 1829 CA PHE A 229 3340 3898 7349 -181 201 -686 C \nATOM 1830 C PHE A 229 -7.507 13.173 -62.817 1.00 36.13 C \nANISOU 1830 C PHE A 229 3021 3599 7107 -175 155 -716 C \nATOM 1831 O PHE A 229 -8.211 14.081 -63.143 1.00 32.60 O \nANISOU 1831 O PHE A 229 2540 3172 6672 -180 162 -750 O \nATOM 1832 CB PHE A 229 -6.734 11.569 -64.561 1.00 37.74 C \nANISOU 1832 CB PHE A 229 3242 3833 7263 -164 205 -696 C \nATOM 1833 CG PHE A 229 -6.776 10.212 -65.114 1.00 38.94 C \nANISOU 1833 CG PHE A 229 3420 4005 7369 -162 244 -664 C \nATOM 1834 CD1 PHE A 229 -7.603 9.899 -66.167 1.00 42.78 C \nANISOU 1834 CD1 PHE A 229 3906 4518 7830 -166 291 -671 C \nATOM 1835 CD2 PHE A 229 -5.967 9.233 -64.584 1.00 41.12 C \nANISOU 1835 CD2 PHE A 229 3722 4278 7623 -156 232 -626 C \nATOM 1836 CE1 PHE A 229 -7.599 8.611 -66.715 1.00 42.91 C \nANISOU 1836 CE1 PHE A 229 3948 4556 7799 -156 326 -639 C \nATOM 1837 CE2 PHE A 229 -5.944 7.939 -65.104 1.00 36.75 C \nANISOU 1837 CE2 PHE A 229 3187 3755 7020 -147 267 -594 C \nATOM 1838 CZ PHE A 229 -6.756 7.637 -66.174 1.00 39.67 C \nANISOU 1838 CZ PHE A 229 3557 4149 7366 -143 313 -601 C \nATOM 1839 N TRP A 230 -6.483 13.305 -61.991 1.00 35.27 N \nANISOU 1839 N TRP A 230 2922 3461 7017 -163 110 -704 N \nATOM 1840 CA TRP A 230 -6.220 14.551 -61.343 1.00 37.34 C \nANISOU 1840 CA TRP A 230 3162 3707 7317 -150 64 -727 C \nATOM 1841 C TRP A 230 -4.732 14.675 -61.037 1.00 40.87 C \nANISOU 1841 C TRP A 230 3625 4121 7782 -131 18 -721 C \nATOM 1842 O TRP A 230 -4.029 13.612 -60.865 1.00 37.01 O \nANISOU 1842 O TRP A 230 3170 3621 7269 -142 18 -686 O \nATOM 1843 CB TRP A 230 -6.998 14.630 -60.070 1.00 34.42 C \nANISOU 1843 CB TRP A 230 2804 3328 6946 -169 53 -709 C \nATOM 1844 CG TRP A 230 -6.636 13.626 -59.018 1.00 35.22 C \nANISOU 1844 CG TRP A 230 2951 3402 7029 -181 42 -662 C \nATOM 1845 CD1 TRP A 230 -7.066 12.321 -58.945 1.00 35.60 C \nANISOU 1845 CD1 TRP A 230 3035 3453 7036 -196 79 -627 C \nATOM 1846 CD2 TRP A 230 -5.767 13.836 -57.868 1.00 34.97 C \nANISOU 1846 CD2 TRP A 230 2936 3338 7015 -176 -9 -644 C \nATOM 1847 NE1 TRP A 230 -6.518 11.706 -57.785 1.00 40.51 N \nANISOU 1847 NE1 TRP A 230 3690 4053 7650 -201 54 -590 N \nATOM 1848 CE2 TRP A 230 -5.728 12.613 -57.123 1.00 34.46 C \nANISOU 1848 CE2 TRP A 230 2911 3263 6918 -194 0 -599 C \nATOM 1849 CE3 TRP A 230 -4.946 14.917 -57.450 1.00 33.72 C \nANISOU 1849 CE3 TRP A 230 2764 3155 6892 -155 -63 -661 C \nATOM 1850 CZ2 TRP A 230 -4.957 12.454 -56.014 1.00 30.11 C \nANISOU 1850 CZ2 TRP A 230 2384 2688 6370 -199 -40 -573 C \nATOM 1851 CZ3 TRP A 230 -4.219 14.814 -56.263 1.00 29.67 C \nANISOU 1851 CZ3 TRP A 230 2281 2609 6384 -160 -106 -633 C \nATOM 1852 CH2 TRP A 230 -4.209 13.570 -55.572 1.00 31.67 C \nANISOU 1852 CH2 TRP A 230 2570 2858 6604 -186 -94 -589 C \nATOM 1853 N THR A 231 -4.269 15.933 -60.942 1.00 33.64 N \nANISOU 1853 N THR A 231 2689 3191 6901 -104 -22 -753 N \nATOM 1854 CA THR A 231 -2.925 16.204 -60.453 1.00 37.51 C \nANISOU 1854 CA THR A 231 3207 3637 7406 -89 -72 -747 C \nATOM 1855 C THR A 231 -2.888 17.533 -59.767 1.00 40.20 C \nANISOU 1855 C THR A 231 3533 3961 7781 -58 -117 -769 C \nATOM 1856 O THR A 231 -3.803 18.360 -59.912 1.00 43.98 O \nANISOU 1856 O THR A 231 3968 4473 8272 -44 -108 -798 O \nATOM 1857 CB THR A 231 -1.873 16.160 -61.563 1.00 38.54 C \nANISOU 1857 CB THR A 231 3347 3762 7535 -77 -71 -765 C \nATOM 1858 OG1 THR A 231 -0.580 16.394 -61.023 1.00 52.41 O \nANISOU 1858 OG1 THR A 231 5143 5470 9300 -71 -120 -757 O \nATOM 1859 CG2 THR A 231 -2.141 17.208 -62.593 1.00 38.26 C \nANISOU 1859 CG2 THR A 231 3271 3748 7519 -45 -61 -817 C \nATOM 1860 N ILE A 232 -1.853 17.745 -58.977 1.00 41.75 N \nANISOU 1860 N ILE A 232 3765 4110 7988 -49 -166 -754 N \nATOM 1861 CA ILE A 232 -1.602 19.083 -58.367 1.00 38.35 C \nANISOU 1861 CA ILE A 232 3328 3656 7588 -7 -216 -776 C \nATOM 1862 C ILE A 232 -0.589 19.798 -59.237 1.00 39.17 C \nANISOU 1862 C ILE A 232 3443 3734 7704 34 -235 -811 C \nATOM 1863 O ILE A 232 0.438 19.212 -59.623 1.00 37.10 O \nANISOU 1863 O ILE A 232 3225 3442 7429 17 -238 -800 O \nATOM 1864 CB ILE A 232 -1.081 18.941 -56.950 1.00 32.72 C \nANISOU 1864 CB ILE A 232 2656 2900 6876 -20 -261 -738 C \nATOM 1865 CG1 ILE A 232 -2.082 18.131 -56.090 1.00 30.43 C \nANISOU 1865 CG1 ILE A 232 2360 2634 6568 -62 -238 -703 C \nATOM 1866 CG2 ILE A 232 -0.831 20.241 -56.322 1.00 30.69 C \nANISOU 1866 CG2 ILE A 232 2396 2620 6645 27 -311 -755 C \nATOM 1867 CD1 ILE A 232 -3.492 18.578 -56.129 1.00 30.00 C \nANISOU 1867 CD1 ILE A 232 2256 2628 6517 -63 -211 -722 C \nATOM 1868 N LEU A 233 -0.881 21.037 -59.589 1.00 41.02 N \nANISOU 1868 N LEU A 233 3640 3986 7960 85 -245 -854 N \nATOM 1869 CA LEU A 233 0.030 21.818 -60.404 1.00 46.24 C \nANISOU 1869 CA LEU A 233 4316 4621 8633 133 -263 -892 C \nATOM 1870 C LEU A 233 0.676 22.856 -59.568 1.00 47.91 C \nANISOU 1870 C LEU A 233 4555 4785 8863 185 -323 -898 C \nATOM 1871 O LEU A 233 0.005 23.782 -59.125 1.00 58.04 O \nANISOU 1871 O LEU A 233 5794 6099 10160 223 -338 -914 O \nATOM 1872 CB LEU A 233 -0.685 22.444 -61.548 1.00 51.00 C \nANISOU 1872 CB LEU A 233 4857 5282 9241 163 -229 -940 C \nATOM 1873 CG LEU A 233 0.179 23.152 -62.570 1.00 54.23 C \nANISOU 1873 CG LEU A 233 5279 5670 9656 213 -238 -984 C \nATOM 1874 CD1 LEU A 233 1.110 22.167 -63.262 1.00 58.68 C \nANISOU 1874 CD1 LEU A 233 5895 6200 10201 173 -223 -970 C \nATOM 1875 CD2 LEU A 233 -0.701 23.858 -63.592 1.00 52.06 C \nANISOU 1875 CD2 LEU A 233 4930 5466 9384 243 -204 -1033 C \nATOM 1876 N LYS A 234 1.981 22.697 -59.322 1.00 50.07 N \nANISOU 1876 N LYS A 234 4904 4988 9132 182 -359 -882 N \nATOM 1877 CA LYS A 234 2.738 23.602 -58.434 1.00 51.88 C \nANISOU 1877 CA LYS A 234 5181 5156 9374 228 -421 -880 C \nATOM 1878 C LYS A 234 2.818 25.021 -59.033 1.00 52.72 C \nANISOU 1878 C LYS A 234 5267 5265 9497 318 -437 -934 C \nATOM 1879 O LYS A 234 2.687 25.200 -60.256 1.00 41.80 O \nANISOU 1879 O LYS A 234 3855 3912 8114 337 -404 -974 O \nATOM 1880 CB LYS A 234 4.152 23.095 -58.268 1.00 56.93 C \nANISOU 1880 CB LYS A 234 5914 5719 9998 198 -449 -857 C \nATOM 1881 CG LYS A 234 4.327 21.687 -57.739 1.00 57.51 C \nANISOU 1881 CG LYS A 234 6012 5793 10047 113 -437 -805 C \nATOM 1882 CD LYS A 234 4.275 21.645 -56.225 1.00 64.40 C \nANISOU 1882 CD LYS A 234 6905 6644 10922 99 -475 -764 C \nATOM 1883 CE LYS A 234 4.725 20.275 -55.719 1.00 71.43 C \nANISOU 1883 CE LYS A 234 7831 7528 11781 18 -469 -715 C \nATOM 1884 NZ LYS A 234 4.372 20.055 -54.281 1.00 86.13 N \nANISOU 1884 NZ LYS A 234 9695 9389 13642 -4 -492 -675 N \nATOM 1885 N PRO A 235 3.020 26.047 -58.169 1.00 65.80 N \nANISOU 1885 N PRO A 235 6939 6894 11168 379 -488 -937 N \nATOM 1886 CA PRO A 235 3.064 27.462 -58.534 1.00 62.23 C \nANISOU 1886 CA PRO A 235 6467 6450 10728 479 -510 -985 C \nATOM 1887 C PRO A 235 3.596 27.760 -59.916 1.00 65.71 C \nANISOU 1887 C PRO A 235 6921 6879 11165 514 -491 -1032 C \nATOM 1888 O PRO A 235 2.784 28.046 -60.791 1.00 66.57 O \nANISOU 1888 O PRO A 235 6954 7064 11277 532 -452 -1068 O \nATOM 1889 CB PRO A 235 3.915 28.026 -57.451 1.00 66.64 C \nANISOU 1889 CB PRO A 235 7098 6932 11290 518 -575 -965 C \nATOM 1890 CG PRO A 235 3.410 27.283 -56.228 1.00 68.25 C \nANISOU 1890 CG PRO A 235 7292 7149 11492 450 -580 -912 C \nATOM 1891 CD PRO A 235 3.019 25.912 -56.697 1.00 68.27 C \nANISOU 1891 CD PRO A 235 7275 7182 11481 358 -526 -892 C \nATOM 1892 N ASN A 236 4.895 27.652 -60.178 1.00 66.24 N \nANISOU 1892 N ASN A 236 7085 6860 11223 515 -513 -1032 N \nATOM 1893 CA ASN A 236 5.370 28.031 -61.533 1.00 70.64 C \nANISOU 1893 CA ASN A 236 7656 7408 11775 553 -494 -1082 C \nATOM 1894 C ASN A 236 5.564 26.905 -62.536 1.00 66.68 C \nANISOU 1894 C ASN A 236 7162 6918 11258 474 -447 -1079 C \nATOM 1895 O ASN A 236 6.390 27.007 -63.450 1.00 81.00 O \nANISOU 1895 O ASN A 236 9025 8692 13059 484 -442 -1108 O \nATOM 1896 CB ASN A 236 6.627 28.924 -61.451 1.00 78.46 C \nANISOU 1896 CB ASN A 236 8748 8302 12762 624 -546 -1102 C \nATOM 1897 CG ASN A 236 6.273 30.375 -61.196 1.00 79.28 C \nANISOU 1897 CG ASN A 236 8817 8428 12880 743 -575 -1136 C \nATOM 1898 OD1 ASN A 236 6.673 30.949 -60.189 1.00 86.90 O \nANISOU 1898 OD1 ASN A 236 9830 9341 13846 789 -627 -1118 O \nATOM 1899 ND2 ASN A 236 5.467 30.956 -62.078 1.00 76.88 N \nANISOU 1899 ND2 ASN A 236 8422 8209 12581 793 -541 -1183 N \nATOM 1900 N ASP A 237 4.780 25.854 -62.409 1.00 61.70 N \nANISOU 1900 N ASP A 237 6480 6342 10622 398 -410 -1047 N \nATOM 1901 CA ASP A 237 4.855 24.734 -63.356 1.00 55.44 C \nANISOU 1901 CA ASP A 237 5684 5572 9810 328 -362 -1041 C \nATOM 1902 C ASP A 237 3.750 24.928 -64.375 1.00 55.60 C \nANISOU 1902 C ASP A 237 5612 5680 9835 344 -312 -1077 C \nATOM 1903 O ASP A 237 2.737 25.554 -64.094 1.00 68.74 O \nANISOU 1903 O ASP A 237 7206 7398 11513 379 -307 -1090 O \nATOM 1904 CB ASP A 237 4.702 23.418 -62.594 1.00 55.39 C \nANISOU 1904 CB ASP A 237 5685 5572 9788 242 -353 -982 C \nATOM 1905 CG ASP A 237 5.148 22.188 -63.398 1.00 53.65 C \nANISOU 1905 CG ASP A 237 5485 5361 9539 171 -317 -966 C \nATOM 1906 OD1 ASP A 237 5.273 22.232 -64.633 1.00 51.68 O \nANISOU 1906 OD1 ASP A 237 5223 5131 9283 178 -288 -1001 O \nATOM 1907 OD2 ASP A 237 5.267 21.114 -62.757 1.00 51.65 O \nANISOU 1907 OD2 ASP A 237 5250 5107 9267 107 -315 -918 O \nATOM 1908 N ALA A 238 3.948 24.392 -65.561 1.00 54.10 N \nANISOU 1908 N ALA A 238 5420 5506 9629 315 -273 -1094 N \nATOM 1909 CA ALA A 238 2.919 24.364 -66.601 1.00 49.75 C \nANISOU 1909 CA ALA A 238 4786 5039 9077 313 -220 -1122 C \nATOM 1910 C ALA A 238 2.432 22.938 -66.885 1.00 51.02 C \nANISOU 1910 C ALA A 238 4929 5240 9217 230 -174 -1085 C \nATOM 1911 O ALA A 238 3.204 21.962 -66.714 1.00 45.36 O \nANISOU 1911 O ALA A 238 4267 4487 8481 178 -178 -1050 O \nATOM 1912 CB ALA A 238 3.477 24.939 -67.864 1.00 51.14 C \nANISOU 1912 CB ALA A 238 4972 5211 9249 353 -209 -1175 C \nATOM 1913 N ILE A 239 1.150 22.811 -67.296 1.00 45.63 N \nANISOU 1913 N ILE A 239 4171 4634 8534 218 -130 -1093 N \nATOM 1914 CA ILE A 239 0.581 21.512 -67.641 1.00 39.85 C \nANISOU 1914 CA ILE A 239 3423 3939 7777 151 -84 -1060 C \nATOM 1915 C ILE A 239 0.255 21.503 -69.089 1.00 43.78 C \nANISOU 1915 C ILE A 239 3882 4488 8264 150 -39 -1096 C \nATOM 1916 O ILE A 239 -0.296 22.479 -69.550 1.00 46.63 O \nANISOU 1916 O ILE A 239 4193 4887 8637 192 -32 -1139 O \nATOM 1917 CB ILE A 239 -0.627 21.141 -66.795 1.00 43.12 C \nANISOU 1917 CB ILE A 239 3803 4389 8192 124 -70 -1029 C \nATOM 1918 CG1 ILE A 239 -1.249 19.809 -67.317 1.00 46.00 C \nANISOU 1918 CG1 ILE A 239 4158 4792 8527 65 -18 -999 C \nATOM 1919 CG2 ILE A 239 -1.660 22.221 -66.830 1.00 44.21 C \nANISOU 1919 CG2 ILE A 239 3874 4579 8344 160 -65 -1065 C \nATOM 1920 CD1 ILE A 239 -2.212 19.182 -66.367 1.00 44.54 C \nANISOU 1920 CD1 ILE A 239 3967 4622 8334 31 -6 -959 C \nATOM 1921 N ASN A 240 0.623 20.407 -69.819 1.00 45.25 N \nANISOU 1921 N ASN A 240 4089 4680 8424 103 -9 -1077 N \nATOM 1922 CA ASN A 240 0.414 20.325 -71.278 1.00 49.64 C \nANISOU 1922 CA ASN A 240 4613 5283 8966 99 34 -1109 C \nATOM 1923 C ASN A 240 -0.573 19.198 -71.643 1.00 48.70 C \nANISOU 1923 C ASN A 240 4465 5219 8821 48 85 -1078 C \nATOM 1924 O ASN A 240 -0.473 18.094 -71.161 1.00 50.16 O \nANISOU 1924 O ASN A 240 4678 5395 8987 10 90 -1030 O \nATOM 1925 CB ASN A 240 1.727 20.061 -72.008 1.00 58.76 C \nANISOU 1925 CB ASN A 240 5818 6404 10106 89 28 -1119 C \nATOM 1926 CG ASN A 240 2.837 21.042 -71.635 1.00 62.31 C \nANISOU 1926 CG ASN A 240 6319 6784 10573 134 -24 -1145 C \nATOM 1927 OD1 ASN A 240 3.036 22.071 -72.301 1.00 61.47 O \nANISOU 1927 OD1 ASN A 240 6204 6675 10477 186 -29 -1198 O \nATOM 1928 ND2 ASN A 240 3.557 20.724 -70.565 1.00 65.22 N \nANISOU 1928 ND2 ASN A 240 6746 7095 10941 117 -63 -1108 N \nATOM 1929 N PHE A 241 -1.544 19.492 -72.475 1.00 46.56 N \nANISOU 1929 N PHE A 241 4140 5006 8546 51 123 -1106 N \nATOM 1930 CA PHE A 241 -2.496 18.497 -72.916 1.00 38.07 C \nANISOU 1930 CA PHE A 241 3046 3977 7443 7 172 -1080 C \nATOM 1931 C PHE A 241 -2.332 18.332 -74.400 1.00 41.17 C \nANISOU 1931 C PHE A 241 3421 4405 7816 0 207 -1106 C \nATOM 1932 O PHE A 241 -2.202 19.336 -75.121 1.00 44.17 O \nANISOU 1932 O PHE A 241 3773 4801 8209 33 205 -1159 O \nATOM 1933 CB PHE A 241 -3.948 18.952 -72.633 1.00 37.59 C \nANISOU 1933 CB PHE A 241 2939 3959 7385 3 190 -1087 C \nATOM 1934 CG PHE A 241 -4.313 19.025 -71.167 1.00 37.37 C \nANISOU 1934 CG PHE A 241 2923 3905 7370 1 162 -1058 C \nATOM 1935 CD1 PHE A 241 -4.687 17.871 -70.493 1.00 36.71 C \nANISOU 1935 CD1 PHE A 241 2873 3808 7267 -37 174 -1005 C \nATOM 1936 CD2 PHE A 241 -4.305 20.194 -70.489 1.00 36.04 C \nANISOU 1936 CD2 PHE A 241 2735 3729 7229 39 125 -1083 C \nATOM 1937 CE1 PHE A 241 -4.948 17.891 -69.165 1.00 35.93 C \nANISOU 1937 CE1 PHE A 241 2789 3684 7178 -41 149 -978 C \nATOM 1938 CE2 PHE A 241 -4.652 20.246 -69.130 1.00 36.46 C \nANISOU 1938 CE2 PHE A 241 2799 3762 7293 33 99 -1055 C \nATOM 1939 CZ PHE A 241 -4.947 19.100 -68.465 1.00 36.15 C \nANISOU 1939 CZ PHE A 241 2794 3704 7235 -9 110 -1003 C \nATOM 1940 N GLU A 242 -2.453 17.090 -74.866 1.00 39.06 N \nANISOU 1940 N GLU A 242 3168 4158 7516 -38 240 -1071 N \nATOM 1941 CA GLU A 242 -2.498 16.819 -76.259 1.00 42.07 C \nANISOU 1941 CA GLU A 242 3529 4582 7873 -51 279 -1090 C \nATOM 1942 C GLU A 242 -3.423 15.624 -76.518 1.00 46.74 C \nANISOU 1942 C GLU A 242 4120 5210 8428 -87 323 -1048 C \nATOM 1943 O GLU A 242 -3.302 14.567 -75.908 1.00 59.79 O \nANISOU 1943 O GLU A 242 5806 6849 10062 -104 323 -998 O \nATOM 1944 CB GLU A 242 -1.067 16.522 -76.785 1.00 44.99 C \nANISOU 1944 CB GLU A 242 3932 4930 8232 -54 264 -1095 C \nATOM 1945 CG GLU A 242 -0.965 16.599 -78.316 1.00 46.39 C \nANISOU 1945 CG GLU A 242 4085 5151 8392 -59 298 -1130 C \nATOM 1946 CD GLU A 242 0.235 15.924 -78.911 1.00 49.27 C \nANISOU 1946 CD GLU A 242 4482 5509 8730 -82 296 -1122 C \nATOM 1947 OE1 GLU A 242 0.108 15.485 -80.046 1.00 49.46 O \nANISOU 1947 OE1 GLU A 242 4486 5580 8726 -100 332 -1128 O \nATOM 1948 OE2 GLU A 242 1.284 15.840 -78.247 1.00 61.52 O \nANISOU 1948 OE2 GLU A 242 6078 7013 10285 -85 259 -1108 O \nATOM 1949 N SER A 243 -4.305 15.753 -77.486 1.00 42.13 N \nANISOU 1949 N SER A 243 3502 4676 7830 -97 363 -1069 N \nATOM 1950 CA SER A 243 -5.198 14.668 -77.807 1.00 38.21 C \nANISOU 1950 CA SER A 243 3014 4209 7295 -127 406 -1031 C \nATOM 1951 C SER A 243 -5.862 14.884 -79.121 1.00 43.25 C \nANISOU 1951 C SER A 243 3617 4901 7915 -140 447 -1061 C \nATOM 1952 O SER A 243 -6.063 16.070 -79.571 1.00 51.24 O \nANISOU 1952 O SER A 243 4587 5936 8947 -127 444 -1115 O \nATOM 1953 CB SER A 243 -6.287 14.553 -76.769 1.00 35.93 C \nANISOU 1953 CB SER A 243 2737 3908 7007 -139 408 -1004 C \nATOM 1954 OG SER A 243 -7.230 13.521 -77.110 1.00 32.44 O \nANISOU 1954 OG SER A 243 2315 3488 6522 -165 452 -969 O \nATOM 1955 N ASN A 244 -6.251 13.739 -79.714 1.00 35.25 N \nANISOU 1955 N ASN A 244 2622 3911 6859 -162 484 -1026 N \nATOM 1956 CA ASN A 244 -6.942 13.749 -80.976 1.00 38.02 C \nANISOU 1956 CA ASN A 244 2949 4313 7184 -180 527 -1045 C \nATOM 1957 C ASN A 244 -8.190 12.966 -80.887 1.00 38.19 C \nANISOU 1957 C ASN A 244 2996 4344 7169 -206 562 -1006 C \nATOM 1958 O ASN A 244 -8.750 12.486 -81.879 1.00 35.10 O \nANISOU 1958 O ASN A 244 2605 3988 6741 -224 601 -1000 O \nATOM 1959 CB ASN A 244 -6.033 13.232 -82.064 1.00 38.34 C \nANISOU 1959 CB ASN A 244 2987 4378 7204 -180 538 -1048 C \nATOM 1960 CG ASN A 244 -5.775 11.796 -81.932 1.00 32.83 C \nANISOU 1960 CG ASN A 244 2327 3678 6468 -185 549 -989 C \nATOM 1961 OD1 ASN A 244 -5.753 11.246 -80.861 1.00 36.73 O \nANISOU 1961 OD1 ASN A 244 2853 4141 6962 -179 533 -949 O \nATOM 1962 ND2 ASN A 244 -5.616 11.159 -83.050 1.00 33.11 N \nANISOU 1962 ND2 ASN A 244 2357 3755 6467 -195 578 -982 N \nATOM 1963 N GLY A 245 -8.649 12.839 -79.660 1.00 41.56 N \nANISOU 1963 N GLY A 245 3451 4736 7605 -207 547 -980 N \nATOM 1964 CA GLY A 245 -9.885 12.129 -79.450 1.00 53.88 C \nANISOU 1964 CA GLY A 245 5049 6295 9129 -231 580 -943 C \nATOM 1965 C GLY A 245 -10.061 11.632 -78.032 1.00 53.82 C \nANISOU 1965 C GLY A 245 5086 6240 9124 -226 561 -902 C \nATOM 1966 O GLY A 245 -9.126 11.433 -77.245 1.00 65.22 O \nANISOU 1966 O GLY A 245 6539 7655 10588 -203 527 -886 O \nATOM 1967 N ASN A 246 -11.320 11.412 -77.752 1.00 50.95 N \nANISOU 1967 N ASN A 246 4754 5871 8735 -253 586 -886 N \nATOM 1968 CA ASN A 246 -11.826 10.986 -76.467 1.00 43.44 C \nANISOU 1968 CA ASN A 246 3850 4877 7777 -257 578 -850 C \nATOM 1969 C ASN A 246 -11.386 11.709 -75.260 1.00 38.67 C \nANISOU 1969 C ASN A 246 3229 4245 7218 -247 533 -861 C \nATOM 1970 O ASN A 246 -11.404 11.149 -74.186 1.00 42.74 O \nANISOU 1970 O ASN A 246 3785 4724 7730 -240 520 -825 O \nATOM 1971 CB ASN A 246 -11.660 9.478 -76.240 1.00 45.22 C \nANISOU 1971 CB ASN A 246 4136 5082 7964 -235 592 -792 C \nATOM 1972 CG ASN A 246 -11.839 8.693 -77.490 1.00 47.18 C \nANISOU 1972 CG ASN A 246 4397 5361 8167 -232 632 -778 C \nATOM 1973 OD1 ASN A 246 -11.453 9.147 -78.534 1.00 46.91 O \nANISOU 1973 OD1 ASN A 246 4319 5364 8141 -236 637 -809 O \nATOM 1974 ND2 ASN A 246 -12.534 7.570 -77.403 1.00 49.47 N \nANISOU 1974 ND2 ASN A 246 4753 5637 8407 -226 662 -732 N \nATOM 1975 N PHE A 247 -11.065 12.978 -75.399 1.00 42.85 N \nANISOU 1975 N PHE A 247 3701 4794 7787 -243 509 -910 N \nATOM 1976 CA PHE A 247 -10.553 13.799 -74.322 1.00 44.25 C \nANISOU 1976 CA PHE A 247 3858 4947 8007 -226 462 -924 C \nATOM 1977 C PHE A 247 -11.708 14.524 -73.626 1.00 49.11 C \nANISOU 1977 C PHE A 247 4464 5570 8624 -257 461 -937 C \nATOM 1978 O PHE A 247 -12.603 15.103 -74.269 1.00 59.38 O \nANISOU 1978 O PHE A 247 5737 6915 9911 -288 486 -966 O \nATOM 1979 CB PHE A 247 -9.657 14.844 -74.911 1.00 48.32 C \nANISOU 1979 CB PHE A 247 4320 5482 8558 -199 438 -974 C \nATOM 1980 CG PHE A 247 -8.992 15.740 -73.882 1.00 52.93 C \nANISOU 1980 CG PHE A 247 4887 6038 9185 -171 386 -990 C \nATOM 1981 CD1 PHE A 247 -8.736 15.291 -72.610 1.00 52.39 C \nANISOU 1981 CD1 PHE A 247 4857 5924 9126 -167 359 -952 C \nATOM 1982 CD2 PHE A 247 -8.613 17.023 -74.208 1.00 49.30 C \nANISOU 1982 CD2 PHE A 247 4376 5600 8756 -144 364 -1042 C \nATOM 1983 CE1 PHE A 247 -8.088 16.093 -71.705 1.00 53.39 C \nANISOU 1983 CE1 PHE A 247 4972 6024 9289 -140 311 -964 C \nATOM 1984 CE2 PHE A 247 -8.004 17.827 -73.288 1.00 49.55 C \nANISOU 1984 CE2 PHE A 247 4399 5603 8823 -112 316 -1055 C \nATOM 1985 CZ PHE A 247 -7.729 17.364 -72.039 1.00 50.46 C \nANISOU 1985 CZ PHE A 247 4555 5670 8947 -112 289 -1015 C \nATOM 1986 N ILE A 248 -11.701 14.468 -72.311 1.00 41.62 N \nANISOU 1986 N ILE A 248 3540 4585 7689 -254 434 -914 N \nATOM 1987 CA ILE A 248 -12.669 15.139 -71.522 1.00 39.00 C \nANISOU 1987 CA ILE A 248 3199 4261 7358 -285 429 -924 C \nATOM 1988 C ILE A 248 -11.843 16.244 -70.881 1.00 39.66 C \nANISOU 1988 C ILE A 248 3237 4343 7491 -249 377 -952 C \nATOM 1989 O ILE A 248 -11.279 16.078 -69.804 1.00 34.43 O \nANISOU 1989 O ILE A 248 2597 3638 6848 -231 343 -928 O \nATOM 1990 CB ILE A 248 -13.303 14.246 -70.457 1.00 41.97 C \nANISOU 1990 CB ILE A 248 3642 4595 7709 -308 436 -876 C \nATOM 1991 CG1 ILE A 248 -13.804 12.922 -71.016 1.00 48.08 C \nANISOU 1991 CG1 ILE A 248 4479 5355 8433 -321 482 -839 C \nATOM 1992 CG2 ILE A 248 -14.471 14.945 -69.852 1.00 42.16 C \nANISOU 1992 CG2 ILE A 248 3658 4638 7724 -355 439 -890 C \nATOM 1993 CD1 ILE A 248 -14.809 13.070 -72.144 1.00 52.08 C \nANISOU 1993 CD1 ILE A 248 4981 5901 8905 -361 525 -859 C \nATOM 1994 N ALA A 249 -11.829 17.425 -71.549 1.00 41.78 N \nANISOU 1994 N ALA A 249 3439 4660 7776 -238 371 -1004 N \nATOM 1995 CA ALA A 249 -10.979 18.543 -71.147 1.00 36.26 C \nANISOU 1995 CA ALA A 249 2697 3961 7120 -191 324 -1036 C \nATOM 1996 C ALA A 249 -11.505 19.304 -69.948 1.00 41.65 C \nANISOU 1996 C ALA A 249 3361 4652 7814 -197 295 -1039 C \nATOM 1997 O ALA A 249 -12.703 19.378 -69.725 1.00 42.35 O \nANISOU 1997 O ALA A 249 3444 4772 7875 -246 317 -1037 O \nATOM 1998 CB ALA A 249 -10.830 19.511 -72.300 1.00 42.13 C \nANISOU 1998 CB ALA A 249 3378 4758 7869 -169 330 -1091 C \nATOM 1999 N PRO A 250 -10.598 19.897 -69.174 1.00 39.14 N \nANISOU 1999 N PRO A 250 3035 4305 7532 -150 246 -1044 N \nATOM 2000 CA PRO A 250 -10.936 20.754 -68.080 1.00 42.07 C \nANISOU 2000 CA PRO A 250 3379 4688 7916 -145 213 -1051 C \nATOM 2001 C PRO A 250 -11.302 22.145 -68.522 1.00 49.15 C \nANISOU 2001 C PRO A 250 4197 5661 8818 -125 206 -1106 C \nATOM 2002 O PRO A 250 -10.939 22.554 -69.597 1.00 46.91 O \nANISOU 2002 O PRO A 250 3881 5405 8537 -97 216 -1142 O \nATOM 2003 CB PRO A 250 -9.646 20.817 -67.267 1.00 39.60 C \nANISOU 2003 CB PRO A 250 3095 4313 7639 -95 161 -1036 C \nATOM 2004 CG PRO A 250 -8.571 20.480 -68.180 1.00 36.69 C \nANISOU 2004 CG PRO A 250 2744 3918 7279 -65 164 -1043 C \nATOM 2005 CD PRO A 250 -9.156 19.698 -69.314 1.00 37.61 C \nANISOU 2005 CD PRO A 250 2865 4062 7364 -103 219 -1040 C \nATOM 2006 N GLU A 251 -12.137 22.814 -67.727 1.00 62.69 N \nANISOU 2006 N GLU A 251 5877 7418 10524 -146 195 -1112 N \nATOM 2007 CA GLU A 251 -12.462 24.221 -67.902 1.00 59.71 C \nANISOU 2007 CA GLU A 251 5415 7124 10148 -121 181 -1162 C \nATOM 2008 C GLU A 251 -12.102 24.886 -66.620 1.00 56.47 C \nANISOU 2008 C GLU A 251 4996 6700 9762 -82 129 -1155 C \nATOM 2009 O GLU A 251 -11.469 25.914 -66.627 1.00 60.79 O \nANISOU 2009 O GLU A 251 5500 7266 10330 -11 94 -1188 O \nATOM 2010 CB GLU A 251 -13.941 24.424 -68.173 1.00 68.00 C \nANISOU 2010 CB GLU A 251 6425 8258 11153 -195 220 -1175 C \nATOM 2011 CG GLU A 251 -14.304 25.894 -68.408 1.00 75.39 C \nANISOU 2011 CG GLU A 251 7261 9300 12082 -170 207 -1229 C \nATOM 2012 CD GLU A 251 -15.725 26.121 -68.894 1.00 68.45 C \nANISOU 2012 CD GLU A 251 6338 8518 11151 -252 249 -1248 C \nATOM 2013 OE1 GLU A 251 -16.487 25.145 -69.015 1.00 70.72 O \nANISOU 2013 OE1 GLU A 251 6682 8782 11408 -331 288 -1218 O \nATOM 2014 OE2 GLU A 251 -16.051 27.277 -69.189 1.00 68.94 O \nANISOU 2014 OE2 GLU A 251 6313 8682 11201 -236 243 -1293 O \nATOM 2015 N TYR A 252 -12.486 24.275 -65.508 1.00 51.10 N \nANISOU 2015 N TYR A 252 4358 5983 9074 -125 122 -1113 N \nATOM 2016 CA TYR A 252 -12.259 24.825 -64.193 1.00 57.67 C \nANISOU 2016 CA TYR A 252 5185 6803 9924 -99 74 -1101 C \nATOM 2017 C TYR A 252 -11.293 23.986 -63.343 1.00 59.95 C \nANISOU 2017 C TYR A 252 5551 6989 10237 -82 46 -1055 C \nATOM 2018 O TYR A 252 -11.317 22.764 -63.379 1.00 66.96 O \nANISOU 2018 O TYR A 252 6501 7828 11115 -121 72 -1019 O \nATOM 2019 CB TYR A 252 -13.582 24.913 -63.436 1.00 57.87 C \nANISOU 2019 CB TYR A 252 5191 6880 9916 -171 86 -1090 C \nATOM 2020 CG TYR A 252 -14.547 25.870 -63.997 1.00 57.88 C \nANISOU 2020 CG TYR A 252 5110 6994 9887 -195 105 -1134 C \nATOM 2021 CD1 TYR A 252 -14.350 27.258 -63.868 1.00 65.71 C \nANISOU 2021 CD1 TYR A 252 6020 8059 10890 -134 69 -1173 C \nATOM 2022 CD2 TYR A 252 -15.668 25.428 -64.666 1.00 60.00 C \nANISOU 2022 CD2 TYR A 252 5381 7305 10113 -277 157 -1137 C \nATOM 2023 CE1 TYR A 252 -15.249 28.164 -64.390 1.00 65.07 C \nANISOU 2023 CE1 TYR A 252 5851 8098 10774 -156 87 -1215 C \nATOM 2024 CE2 TYR A 252 -16.564 26.330 -65.191 1.00 65.66 C \nANISOU 2024 CE2 TYR A 252 6018 8135 10796 -308 175 -1178 C \nATOM 2025 CZ TYR A 252 -16.342 27.685 -65.051 1.00 68.28 C \nANISOU 2025 CZ TYR A 252 6259 8546 11137 -248 140 -1217 C \nATOM 2026 OH TYR A 252 -17.266 28.537 -65.592 1.00 90.51 O \nANISOU 2026 OH TYR A 252 8990 11487 13912 -283 160 -1257 O \nATOM 2027 N ALA A 253 -10.443 24.670 -62.595 1.00 58.13 N \nANISOU 2027 N ALA A 253 5317 6734 10037 -21 -7 -1056 N \nATOM 2028 CA ALA A 253 -9.498 24.020 -61.712 1.00 57.79 C \nANISOU 2028 CA ALA A 253 5342 6601 10014 -7 -40 -1015 C \nATOM 2029 C ALA A 253 -9.750 24.605 -60.361 1.00 52.62 C \nANISOU 2029 C ALA A 253 4673 5956 9364 -4 -79 -1002 C \nATOM 2030 O ALA A 253 -10.487 25.534 -60.256 1.00 56.22 O \nANISOU 2030 O ALA A 253 5065 6487 9809 -2 -83 -1029 O \nATOM 2031 CB ALA A 253 -8.066 24.280 -62.176 1.00 59.01 C \nANISOU 2031 CB ALA A 253 5519 6705 10197 63 -69 -1029 C \nATOM 2032 N TYR A 254 -9.092 24.093 -59.352 1.00 51.59 N \nANISOU 2032 N TYR A 254 4600 5755 9247 -2 -110 -963 N \nATOM 2033 CA TYR A 254 -9.304 24.507 -57.991 1.00 56.12 C \nANISOU 2033 CA TYR A 254 5169 6332 9823 -4 -148 -944 C \nATOM 2034 C TYR A 254 -7.999 24.953 -57.354 1.00 62.18 C \nANISOU 2034 C TYR A 254 5965 7039 10621 62 -207 -935 C \nATOM 2035 O TYR A 254 -7.076 24.164 -57.202 1.00 65.79 O \nANISOU 2035 O TYR A 254 6488 7421 11088 62 -217 -907 O \nATOM 2036 CB TYR A 254 -9.866 23.339 -57.199 1.00 59.43 C \nANISOU 2036 CB TYR A 254 5639 6719 10222 -77 -127 -898 C \nATOM 2037 CG TYR A 254 -11.253 22.945 -57.621 1.00 61.71 C \nANISOU 2037 CG TYR A 254 5912 7061 10474 -147 -73 -903 C \nATOM 2038 CD1 TYR A 254 -11.456 21.939 -58.558 1.00 63.42 C \nANISOU 2038 CD1 TYR A 254 6163 7261 10674 -178 -23 -896 C \nATOM 2039 CD2 TYR A 254 -12.366 23.575 -57.081 1.00 62.98 C \nANISOU 2039 CD2 TYR A 254 6029 7288 10613 -186 -71 -914 C \nATOM 2040 CE1 TYR A 254 -12.727 21.584 -58.964 1.00 65.59 C \nANISOU 2040 CE1 TYR A 254 6435 7576 10911 -242 26 -900 C \nATOM 2041 CE2 TYR A 254 -13.639 23.227 -57.466 1.00 63.16 C \nANISOU 2041 CE2 TYR A 254 6047 7354 10596 -259 -22 -918 C \nATOM 2042 CZ TYR A 254 -13.818 22.233 -58.403 1.00 65.72 C \nANISOU 2042 CZ TYR A 254 6413 7653 10904 -286 27 -911 C \nATOM 2043 OH TYR A 254 -15.074 21.865 -58.791 1.00 62.16 O \nANISOU 2043 OH TYR A 254 5971 7237 10410 -359 76 -914 O \nATOM 2044 N LYS A 255 -7.937 26.217 -56.961 1.00 67.86 N \nANISOU 2044 N LYS A 255 6637 7795 11350 118 -247 -959 N \nATOM 2045 CA LYS A 255 -6.793 26.758 -56.268 1.00 63.46 C \nANISOU 2045 CA LYS A 255 6113 7182 10818 184 -306 -950 C \nATOM 2046 C LYS A 255 -6.865 26.377 -54.836 1.00 57.48 C \nANISOU 2046 C LYS A 255 5388 6393 10058 149 -333 -905 C \nATOM 2047 O LYS A 255 -7.898 26.511 -54.240 1.00 61.55 O \nANISOU 2047 O LYS A 255 5866 6965 10557 109 -325 -900 O \nATOM 2048 CB LYS A 255 -6.890 28.256 -56.297 1.00 68.69 C \nANISOU 2048 CB LYS A 255 6707 7908 11484 259 -337 -990 C \nATOM 2049 CG LYS A 255 -5.739 28.943 -56.980 1.00 75.70 C \nANISOU 2049 CG LYS A 255 7613 8758 12392 351 -363 -1021 C \nATOM 2050 CD LYS A 255 -5.607 30.393 -56.528 1.00 73.06 C \nANISOU 2050 CD LYS A 255 7233 8466 12062 442 -411 -1046 C \nATOM 2051 CE LYS A 255 -6.443 31.343 -57.361 1.00 69.76 C \nANISOU 2051 CE LYS A 255 6715 8165 11627 473 -388 -1098 C \nATOM 2052 NZ LYS A 255 -6.382 32.712 -56.789 1.00 67.71 N \nANISOU 2052 NZ LYS A 255 6405 7957 11364 564 -436 -1118 N \nATOM 2053 N ILE A 256 -5.773 25.950 -54.247 1.00 57.07 N \nANISOU 2053 N ILE A 256 5407 6256 10021 162 -367 -874 N \nATOM 2054 CA ILE A 256 -5.872 25.605 -52.850 1.00 61.63 C \nANISOU 2054 CA ILE A 256 6013 6809 10594 127 -393 -832 C \nATOM 2055 C ILE A 256 -5.464 26.726 -51.872 1.00 71.73 C \nANISOU 2055 C ILE A 256 7282 8087 11886 187 -456 -831 C \nATOM 2056 O ILE A 256 -4.291 27.042 -51.678 1.00 77.82 O \nANISOU 2056 O ILE A 256 8101 8794 12674 240 -500 -825 O \nATOM 2057 CB ILE A 256 -5.251 24.241 -52.512 1.00 57.40 C \nANISOU 2057 CB ILE A 256 5556 6199 10056 79 -386 -787 C \nATOM 2058 CG1 ILE A 256 -4.230 24.349 -51.404 1.00 57.83 C \nANISOU 2058 CG1 ILE A 256 5664 6189 10121 99 -444 -756 C \nATOM 2059 CG2 ILE A 256 -4.720 23.567 -53.749 1.00 57.15 C \nANISOU 2059 CG2 ILE A 256 5549 6142 10023 76 -352 -798 C \nATOM 2060 CD1 ILE A 256 -4.853 24.244 -50.044 1.00 57.48 C \nANISOU 2060 CD1 ILE A 256 5615 6158 10066 61 -460 -725 C \nATOM 2061 N VAL A 257 -6.479 27.264 -51.222 1.00 80.33 N \nANISOU 2061 N VAL A 257 8314 9248 12962 171 -459 -834 N \nATOM 2062 CA VAL A 257 -6.302 28.207 -50.130 1.00 83.26 C \nANISOU 2062 CA VAL A 257 8669 9629 13337 215 -516 -826 C \nATOM 2063 C VAL A 257 -7.510 28.068 -49.221 1.00 88.38 C \nANISOU 2063 C VAL A 257 9280 10339 13961 146 -505 -808 C \nATOM 2064 O VAL A 257 -8.607 28.481 -49.603 1.00104.19 O \nANISOU 2064 O VAL A 257 11211 12433 15944 123 -475 -836 O \nATOM 2065 CB VAL A 257 -6.107 29.649 -50.648 1.00 80.34 C \nANISOU 2065 CB VAL A 257 8242 9310 12974 314 -543 -870 C \nATOM 2066 CG1 VAL A 257 -7.302 30.166 -51.477 1.00 68.45 C \nANISOU 2066 CG1 VAL A 257 6641 7921 11448 303 -501 -913 C \nATOM 2067 CG2 VAL A 257 -5.744 30.558 -49.477 1.00 79.74 C \nANISOU 2067 CG2 VAL A 257 8164 9233 12901 372 -607 -856 C \nATOM 2068 N LYS A 258 -7.356 27.479 -48.038 1.00 87.02 N \nANISOU 2068 N LYS A 258 9156 10120 13786 106 -525 -765 N \nATOM 2069 CA LYS A 258 -6.082 27.234 -47.395 1.00 86.21 C \nANISOU 2069 CA LYS A 258 9129 9925 13702 134 -571 -733 C \nATOM 2070 C LYS A 258 -5.873 25.770 -47.013 1.00 81.73 C \nANISOU 2070 C LYS A 258 8632 9294 13129 61 -549 -691 C \nATOM 2071 O LYS A 258 -6.767 24.933 -47.171 1.00 71.80 O \nANISOU 2071 O LYS A 258 7369 8061 11852 -7 -499 -686 O \nATOM 2072 CB LYS A 258 -6.020 28.058 -46.127 1.00103.83 C \nANISOU 2072 CB LYS A 258 11347 12170 15933 163 -628 -716 C \nATOM 2073 CG LYS A 258 -6.974 27.553 -45.058 1.00117.47 C \nANISOU 2073 CG LYS A 258 13065 13930 17638 81 -617 -687 C \nATOM 2074 CD LYS A 258 -7.148 28.536 -43.920 1.00130.63 C \nANISOU 2074 CD LYS A 258 14696 15638 19298 109 -668 -678 C \nATOM 2075 CE LYS A 258 -8.086 29.665 -44.323 1.00136.65 C \nANISOU 2075 CE LYS A 258 15358 16517 20046 137 -661 -719 C \nATOM 2076 NZ LYS A 258 -8.332 30.627 -43.210 1.00137.33 N \nANISOU 2076 NZ LYS A 258 15400 16660 20119 163 -710 -710 N \nATOM 2077 N LYS A 259 -4.666 25.475 -46.523 1.00 82.94 N \nANISOU 2077 N LYS A 259 8854 9366 13293 77 -588 -663 N \nATOM 2078 CA LYS A 259 -4.312 24.143 -45.998 1.00 79.36 C \nANISOU 2078 CA LYS A 259 8466 8858 12829 14 -576 -620 C \nATOM 2079 C LYS A 259 -4.318 24.093 -44.461 1.00 82.10 C \nANISOU 2079 C LYS A 259 8835 9193 13168 -13 -615 -582 C \nATOM 2080 O LYS A 259 -3.511 24.764 -43.822 1.00 74.71 O \nANISOU 2080 O LYS A 259 7922 8222 12243 29 -672 -571 O \nATOM 2081 CB LYS A 259 -2.947 23.682 -46.500 1.00 73.13 C \nANISOU 2081 CB LYS A 259 7743 7995 12049 31 -589 -611 C \nATOM 2082 CG LYS A 259 -2.950 23.089 -47.880 1.00 75.57 C \nANISOU 2082 CG LYS A 259 8048 8308 12355 23 -538 -633 C \nATOM 2083 CD LYS A 259 -1.979 21.925 -48.020 1.00 77.04 C \nANISOU 2083 CD LYS A 259 8302 8438 12532 -11 -531 -605 C \nATOM 2084 CE LYS A 259 -1.928 21.372 -49.428 1.00 79.83 C \nANISOU 2084 CE LYS A 259 8650 8800 12880 -14 -483 -626 C \nATOM 2085 NZ LYS A 259 -1.283 22.336 -50.377 1.00 89.80 N \nANISOU 2085 NZ LYS A 259 9907 10049 14162 49 -500 -665 N \nATOM 2086 N GLY A 260 -5.219 23.287 -43.884 1.00 78.45 N \nANISOU 2086 N GLY A 260 8369 8754 12684 -83 -583 -562 N \nATOM 2087 CA GLY A 260 -5.275 23.090 -42.431 1.00 78.02 C \nANISOU 2087 CA GLY A 260 8337 8688 12618 -117 -613 -525 C \nATOM 2088 C GLY A 260 -5.755 21.703 -42.049 1.00 84.27 C \nANISOU 2088 C GLY A 260 9163 9471 13384 -192 -571 -497 C \nATOM 2089 O GLY A 260 -5.423 20.727 -42.699 1.00 98.23 O \nANISOU 2089 O GLY A 260 10965 11213 15146 -207 -538 -491 O \nATOM 2090 N ASP A 261 -6.532 21.611 -40.985 1.00 79.78 N \nANISOU 2090 N ASP A 261 8588 8928 12797 -235 -573 -480 N \nATOM 2091 CA ASP A 261 -6.998 20.332 -40.519 1.00 79.06 C \nANISOU 2091 CA ASP A 261 8535 8827 12678 -299 -536 -454 C \nATOM 2092 C ASP A 261 -8.393 20.123 -41.068 1.00 76.98 C \nANISOU 2092 C ASP A 261 8244 8612 12394 -336 -478 -477 C \nATOM 2093 O ASP A 261 -9.148 21.075 -41.257 1.00 80.79 O \nANISOU 2093 O ASP A 261 8670 9148 12877 -331 -478 -505 O \nATOM 2094 CB ASP A 261 -6.995 20.262 -38.981 1.00 83.16 C \nANISOU 2094 CB ASP A 261 9075 9338 13184 -331 -571 -420 C \nATOM 2095 CG ASP A 261 -5.602 19.974 -38.382 1.00 87.72 C \nANISOU 2095 CG ASP A 261 9703 9857 13769 -318 -617 -387 C \nATOM 2096 OD1 ASP A 261 -4.791 19.245 -39.013 1.00100.06 O \nANISOU 2096 OD1 ASP A 261 11302 11384 15333 -311 -605 -380 O \nATOM 2097 OD2 ASP A 261 -5.323 20.454 -37.260 1.00 78.78 O \nANISOU 2097 OD2 ASP A 261 8578 8718 12638 -319 -666 -367 O \nATOM 2098 N SER A 262 -8.732 18.868 -41.315 1.00 78.08 N \nANISOU 2098 N SER A 262 8423 8735 12509 -372 -428 -465 N \nATOM 2099 CA SER A 262 -10.054 18.486 -41.746 1.00 76.25 C \nANISOU 2099 CA SER A 262 8186 8537 12250 -415 -370 -480 C \nATOM 2100 C SER A 262 -10.141 16.954 -41.717 1.00 86.09 C \nANISOU 2100 C SER A 262 9495 9749 13465 -443 -327 -455 C \nATOM 2101 O SER A 262 -9.137 16.253 -41.407 1.00 86.25 O \nANISOU 2101 O SER A 262 9551 9732 13487 -429 -343 -427 O \nATOM 2102 CB SER A 262 -10.292 18.996 -43.179 1.00 75.29 C \nANISOU 2102 CB SER A 262 8023 8444 12140 -388 -344 -519 C \nATOM 2103 OG SER A 262 -11.360 18.290 -43.798 1.00 92.70 O \nANISOU 2103 OG SER A 262 10244 10664 14314 -428 -281 -528 O \nATOM 2104 N ALA A 263 -11.332 16.432 -42.028 1.00 76.62 N \nANISOU 2104 N ALA A 263 8313 8566 12234 -482 -272 -464 N \nATOM 2105 CA ALA A 263 -11.451 15.046 -42.462 1.00 74.92 C \nANISOU 2105 CA ALA A 263 8152 8324 11990 -489 -222 -448 C \nATOM 2106 C ALA A 263 -12.719 14.909 -43.245 1.00 65.56 C \nANISOU 2106 C ALA A 263 6972 7160 10777 -519 -166 -471 C \nATOM 2107 O ALA A 263 -13.321 15.883 -43.614 1.00 57.73 O \nANISOU 2107 O ALA A 263 5934 6206 9793 -531 -167 -500 O \nATOM 2108 CB ALA A 263 -11.397 14.072 -41.283 1.00 83.95 C \nANISOU 2108 CB ALA A 263 9350 9442 13105 -513 -223 -412 C \nATOM 2109 N ILE A 264 -13.116 13.680 -43.512 1.00 70.16 N \nANISOU 2109 N ILE A 264 7613 7720 11325 -528 -117 -457 N \nATOM 2110 CA ILE A 264 -14.305 13.446 -44.271 1.00 60.51 C \nANISOU 2110 CA ILE A 264 6412 6508 10071 -558 -62 -475 C \nATOM 2111 C ILE A 264 -15.166 12.463 -43.475 1.00 63.34 C \nANISOU 2111 C ILE A 264 6847 6840 10379 -597 -28 -455 C \nATOM 2112 O ILE A 264 -14.915 11.260 -43.444 1.00 80.47 O \nANISOU 2112 O ILE A 264 9071 8979 12524 -575 -4 -430 O \nATOM 2113 CB ILE A 264 -13.967 12.922 -45.672 1.00 59.50 C \nANISOU 2113 CB ILE A 264 6286 6375 9946 -520 -29 -482 C \nATOM 2114 CG1 ILE A 264 -13.364 14.043 -46.500 1.00 60.08 C \nANISOU 2114 CG1 ILE A 264 6286 6477 10064 -489 -57 -511 C \nATOM 2115 CG2 ILE A 264 -15.218 12.362 -46.337 1.00 63.29 C \nANISOU 2115 CG2 ILE A 264 6812 6853 10381 -552 33 -491 C \nATOM 2116 CD1 ILE A 264 -12.756 13.596 -47.808 1.00 56.13 C \nANISOU 2116 CD1 ILE A 264 5782 5973 9573 -448 -36 -516 C \nATOM 2117 N VAL A 265 -16.194 13.008 -42.844 1.00 62.30 N \nANISOU 2117 N VAL A 265 6719 6726 10227 -655 -26 -466 N \nATOM 2118 CA VAL A 265 -17.105 12.257 -42.000 1.00 57.68 C \nANISOU 2118 CA VAL A 265 6210 6116 9591 -702 3 -451 C \nATOM 2119 C VAL A 265 -18.187 11.619 -42.842 1.00 55.21 C \nANISOU 2119 C VAL A 265 5959 5787 9232 -726 67 -461 C \nATOM 2120 O VAL A 265 -18.704 12.241 -43.751 1.00 61.26 O \nANISOU 2120 O VAL A 265 6695 6581 10001 -746 83 -488 O \nATOM 2121 CB VAL A 265 -17.724 13.184 -40.960 1.00 61.76 C \nANISOU 2121 CB VAL A 265 6703 6661 10102 -761 -25 -460 C \nATOM 2122 CG1 VAL A 265 -18.689 12.430 -40.049 1.00 78.71 C \nANISOU 2122 CG1 VAL A 265 8936 8779 12193 -815 6 -447 C \nATOM 2123 CG2 VAL A 265 -16.632 13.826 -40.128 1.00 46.03 C \nANISOU 2123 CG2 VAL A 265 4655 4682 8154 -732 -90 -448 C \nATOM 2124 N LYS A 266 -18.540 10.392 -42.501 1.00 58.51 N \nANISOU 2124 N LYS A 266 6466 6160 9605 -724 103 -440 N \nATOM 2125 CA LYS A 266 -19.594 9.636 -43.166 1.00 62.41 C \nANISOU 2125 CA LYS A 266 7041 6626 10046 -743 165 -444 C \nATOM 2126 C LYS A 266 -20.802 9.643 -42.282 1.00 67.29 C \nANISOU 2126 C LYS A 266 7725 7228 10615 -819 183 -447 C \nATOM 2127 O LYS A 266 -21.204 8.592 -41.777 1.00 80.18 O \nANISOU 2127 O LYS A 266 9451 8814 12200 -816 213 -429 O \nATOM 2128 CB LYS A 266 -19.165 8.170 -43.408 1.00 61.07 C \nANISOU 2128 CB LYS A 266 6937 6416 9851 -678 195 -416 C \nATOM 2129 CG LYS A 266 -17.882 7.995 -44.234 1.00 59.69 C \nANISOU 2129 CG LYS A 266 6703 6259 9717 -605 179 -409 C \nATOM 2130 CD LYS A 266 -18.010 8.646 -45.593 1.00 63.14 C \nANISOU 2130 CD LYS A 266 7094 6721 10176 -606 190 -435 C \nATOM 2131 CE LYS A 266 -17.348 7.847 -46.703 1.00 64.12 C \nANISOU 2131 CE LYS A 266 7219 6843 10301 -541 212 -425 C \nATOM 2132 NZ LYS A 266 -18.144 8.037 -47.983 1.00 72.18 N \nANISOU 2132 NZ LYS A 266 8249 7869 11306 -559 252 -448 N \nATOM 2133 N SER A 267 -21.415 10.819 -42.135 1.00 68.18 N \nANISOU 2133 N SER A 267 7790 7383 10733 -886 166 -472 N \nATOM 2134 CA SER A 267 -22.628 10.972 -41.307 1.00 70.62 C \nANISOU 2134 CA SER A 267 8156 7687 10990 -975 182 -480 C \nATOM 2135 C SER A 267 -23.887 11.037 -42.134 1.00 64.09 C \nANISOU 2135 C SER A 267 7379 6860 10114 -1040 231 -502 C \nATOM 2136 O SER A 267 -23.853 11.477 -43.259 1.00 62.87 O \nANISOU 2136 O SER A 267 7177 6735 9978 -1030 239 -519 O \nATOM 2137 CB SER A 267 -22.518 12.232 -40.446 1.00 77.06 C \nANISOU 2137 CB SER A 267 8886 8562 11833 -1017 129 -490 C \nATOM 2138 OG SER A 267 -23.693 12.410 -39.656 1.00 75.65 O \nANISOU 2138 OG SER A 267 8757 8387 11601 -1111 144 -498 O \nATOM 2139 N GLU A 268 -24.996 10.602 -41.554 1.00 76.69 N \nANISOU 2139 N GLU A 268 9075 8420 11645 -1108 264 -501 N \nATOM 2140 CA GLU A 268 -26.361 10.859 -42.102 1.00 78.90 C \nANISOU 2140 CA GLU A 268 9408 8704 11867 -1201 306 -524 C \nATOM 2141 C GLU A 268 -27.077 11.976 -41.313 1.00 65.46 C \nANISOU 2141 C GLU A 268 7663 7062 10146 -1306 283 -544 C \nATOM 2142 O GLU A 268 -28.100 12.480 -41.701 1.00 76.23 O \nANISOU 2142 O GLU A 268 9041 8457 11468 -1394 306 -567 O \nATOM 2143 CB GLU A 268 -27.196 9.569 -42.077 1.00 80.32 C \nANISOU 2143 CB GLU A 268 9747 8796 11974 -1213 364 -510 C \nATOM 2144 CG GLU A 268 -28.467 9.641 -42.923 1.00 93.52 C \nANISOU 2144 CG GLU A 268 11490 10458 13585 -1294 413 -530 C \nATOM 2145 CD GLU A 268 -29.474 8.523 -42.666 1.00104.33 C \nANISOU 2145 CD GLU A 268 13034 11736 14871 -1325 467 -519 C \nATOM 2146 OE1 GLU A 268 -29.392 7.484 -43.356 1.00115.65 O \nANISOU 2146 OE1 GLU A 268 14545 13110 16286 -1255 502 -503 O \nATOM 2147 OE2 GLU A 268 -30.383 8.687 -41.814 1.00101.80 O \nANISOU 2147 OE2 GLU A 268 12777 11403 14497 -1419 475 -526 O \nATOM 2148 N VAL A 269 -26.501 12.329 -40.188 1.00 58.68 N \nANISOU 2148 N VAL A 269 6754 6225 9317 -1295 237 -534 N \nATOM 2149 CA VAL A 269 -27.041 13.300 -39.267 1.00 52.79 C \nANISOU 2149 CA VAL A 269 5966 5539 8555 -1382 210 -547 C \nATOM 2150 C VAL A 269 -27.018 14.680 -39.906 1.00 58.31 C \nANISOU 2150 C VAL A 269 6536 6337 9282 -1404 183 -575 C \nATOM 2151 O VAL A 269 -26.140 15.026 -40.733 1.00 54.87 O \nANISOU 2151 O VAL A 269 6018 5926 8904 -1327 163 -579 O \nATOM 2152 CB VAL A 269 -26.193 13.324 -37.975 1.00 53.26 C \nANISOU 2152 CB VAL A 269 5991 5597 8648 -1344 161 -525 C \nATOM 2153 CG1 VAL A 269 -26.570 14.468 -37.069 1.00 53.55 C \nANISOU 2153 CG1 VAL A 269 5960 5710 8677 -1421 123 -537 C \nATOM 2154 CG2 VAL A 269 -26.325 11.985 -37.244 1.00 50.33 C \nANISOU 2154 CG2 VAL A 269 5747 5137 8238 -1330 189 -500 C \nATOM 2155 N GLU A 270 -28.001 15.484 -39.525 1.00 63.12 N \nANISOU 2155 N GLU A 270 7128 7010 9846 -1511 182 -595 N \nATOM 2156 CA GLU A 270 -28.142 16.819 -40.080 1.00 64.78 C \nANISOU 2156 CA GLU A 270 7215 7329 10069 -1541 160 -624 C \nATOM 2157 C GLU A 270 -27.397 17.871 -39.248 1.00 59.43 C \nANISOU 2157 C GLU A 270 6415 6726 9438 -1510 94 -623 C \nATOM 2158 O GLU A 270 -26.980 17.627 -38.147 1.00 52.61 O \nANISOU 2158 O GLU A 270 5568 5834 8586 -1492 66 -601 O \nATOM 2159 CB GLU A 270 -29.607 17.173 -40.197 1.00 78.85 C \nANISOU 2159 CB GLU A 270 9034 9155 11770 -1678 196 -648 C \nATOM 2160 CG GLU A 270 -30.376 17.093 -38.885 1.00 88.96 C \nANISOU 2160 CG GLU A 270 10377 10430 12993 -1774 196 -642 C \nATOM 2161 CD GLU A 270 -31.822 17.547 -39.032 1.00 96.21 C \nANISOU 2161 CD GLU A 270 11326 11404 13825 -1923 229 -668 C \nATOM 2162 OE1 GLU A 270 -32.181 18.039 -40.133 1.00 98.45 O \nANISOU 2162 OE1 GLU A 270 11566 11743 14097 -1950 246 -691 O \nATOM 2163 OE2 GLU A 270 -32.582 17.418 -38.043 1.00 97.59 O \nANISOU 2163 OE2 GLU A 270 11569 11570 13941 -2017 236 -665 O \nATOM 2164 N TYR A 271 -27.248 19.047 -39.823 1.00 59.73 N \nANISOU 2164 N TYR A 271 6332 6862 9500 -1501 68 -648 N \nATOM 2165 CA TYR A 271 -26.595 20.163 -39.163 1.00 64.96 C \nANISOU 2165 CA TYR A 271 6876 7605 10202 -1465 5 -650 C \nATOM 2166 C TYR A 271 -27.525 20.666 -38.077 1.00 69.85 C \nANISOU 2166 C TYR A 271 7492 8286 10764 -1573 -4 -654 C \nATOM 2167 O TYR A 271 -28.723 20.393 -38.108 1.00 84.65 O \nANISOU 2167 O TYR A 271 9436 10161 12566 -1684 40 -665 O \nATOM 2168 CB TYR A 271 -26.329 21.253 -40.201 1.00 66.52 C \nANISOU 2168 CB TYR A 271 6953 7894 10428 -1425 -12 -679 C \nATOM 2169 CG TYR A 271 -25.558 22.434 -39.708 1.00 68.43 C \nANISOU 2169 CG TYR A 271 7071 8216 10713 -1365 -77 -682 C \nATOM 2170 CD1 TYR A 271 -24.315 22.290 -39.168 1.00 66.17 C \nANISOU 2170 CD1 TYR A 271 6776 7878 10488 -1267 -121 -657 C \nATOM 2171 CD2 TYR A 271 -26.092 23.726 -39.801 1.00 81.40 C \nANISOU 2171 CD2 TYR A 271 8605 9993 12331 -1406 -95 -711 C \nATOM 2172 CE1 TYR A 271 -23.596 23.389 -38.731 1.00 72.58 C \nANISOU 2172 CE1 TYR A 271 7484 8757 11337 -1206 -183 -659 C \nATOM 2173 CE2 TYR A 271 -25.384 24.841 -39.353 1.00 81.95 C \nANISOU 2173 CE2 TYR A 271 8562 10140 12436 -1338 -157 -714 C \nATOM 2174 CZ TYR A 271 -24.132 24.668 -38.826 1.00 78.09 C \nANISOU 2174 CZ TYR A 271 8076 9585 12010 -1236 -201 -687 C \nATOM 2175 OH TYR A 271 -23.450 25.776 -38.384 1.00 79.93 O \nANISOU 2175 OH TYR A 271 8208 9887 12273 -1167 -262 -689 O \nATOM 2176 N GLY A 272 -26.988 21.392 -37.114 1.00 73.80 N \nANISOU 2176 N GLY A 272 7915 8836 11289 -1547 -61 -645 N \nATOM 2177 CA GLY A 272 -27.755 21.800 -35.928 1.00 69.27 C \nANISOU 2177 CA GLY A 272 7339 8318 10662 -1645 -74 -644 C \nATOM 2178 C GLY A 272 -27.463 23.192 -35.412 1.00 70.02 C \nANISOU 2178 C GLY A 272 7296 8536 10773 -1628 -134 -653 C \nATOM 2179 O GLY A 272 -27.846 23.523 -34.299 1.00 74.35 O \nANISOU 2179 O GLY A 272 7834 9129 11287 -1690 -156 -646 O \nATOM 2180 N ASN A 273 -26.733 23.988 -36.187 1.00 70.57 N \nANISOU 2180 N ASN A 273 7262 8659 10892 -1538 -163 -666 N \nATOM 2181 CA ASN A 273 -26.269 25.316 -35.748 1.00 75.95 C \nANISOU 2181 CA ASN A 273 7811 9451 11594 -1491 -225 -672 C \nATOM 2182 C ASN A 273 -25.618 25.363 -34.350 1.00 84.47 C \nANISOU 2182 C ASN A 273 8891 10509 12697 -1459 -277 -640 C \nATOM 2183 O ASN A 273 -25.945 26.225 -33.554 1.00 94.16 O \nANISOU 2183 O ASN A 273 10048 11833 13894 -1497 -311 -643 O \nATOM 2184 CB ASN A 273 -27.409 26.304 -35.818 1.00 65.80 C \nANISOU 2184 CB ASN A 273 6448 8312 10241 -1592 -218 -703 C \nATOM 2185 CG ASN A 273 -28.063 26.310 -37.182 1.00 69.52 C \nANISOU 2185 CG ASN A 273 6916 8814 10685 -1631 -168 -734 C \nATOM 2186 OD1 ASN A 273 -27.700 27.085 -38.055 1.00 63.25 O \nANISOU 2186 OD1 ASN A 273 6026 8089 9917 -1565 -181 -756 O \nATOM 2187 ND2 ASN A 273 -29.052 25.431 -37.373 1.00 73.34 N \nANISOU 2187 ND2 ASN A 273 7511 9243 11113 -1739 -109 -736 N \nATOM 2188 N CYS A 274 -24.670 24.464 -34.095 1.00 95.11 N \nANISOU 2188 N CYS A 274 10309 11736 14093 -1387 -285 -611 N \nATOM 2189 CA CYS A 274 -24.010 24.368 -32.787 1.00101.08 C \nANISOU 2189 CA CYS A 274 11078 12458 14869 -1360 -331 -578 C \nATOM 2190 C CYS A 274 -22.511 24.607 -32.936 1.00100.52 C \nANISOU 2190 C CYS A 274 10968 12349 14875 -1224 -381 -563 C \nATOM 2191 O CYS A 274 -22.052 24.953 -34.021 1.00 99.77 O \nANISOU 2191 O CYS A 274 10830 12264 14815 -1155 -380 -580 O \nATOM 2192 CB CYS A 274 -24.292 23.012 -32.135 1.00 97.78 C \nANISOU 2192 CB CYS A 274 10791 11934 14426 -1413 -296 -555 C \nATOM 2193 SG CYS A 274 -24.764 21.719 -33.293 1.00106.16 S \nANISOU 2193 SG CYS A 274 11964 12900 15472 -1433 -218 -564 S \nATOM 2194 N ASN A 275 -21.779 24.448 -31.835 1.00105.51 N \nANISOU 2194 N ASN A 275 11619 12940 15529 -1192 -423 -530 N \nATOM 2195 CA ASN A 275 -20.326 24.524 -31.834 1.00106.99 C \nANISOU 2195 CA ASN A 275 11794 13075 15782 -1076 -470 -510 C \nATOM 2196 C ASN A 275 -19.711 23.459 -30.963 1.00110.59 C \nANISOU 2196 C ASN A 275 12338 13429 16250 -1071 -476 -473 C \nATOM 2197 O ASN A 275 -20.318 23.042 -29.983 1.00115.54 O \nANISOU 2197 O ASN A 275 13011 14053 16838 -1147 -467 -460 O \nATOM 2198 CB ASN A 275 -19.892 25.882 -31.285 1.00106.75 C \nANISOU 2198 CB ASN A 275 11664 13131 15766 -1026 -538 -509 C \nATOM 2199 CG ASN A 275 -19.921 26.965 -32.332 1.00106.72 C \nANISOU 2199 CG ASN A 275 11563 13212 15773 -974 -545 -543 C \nATOM 2200 OD1 ASN A 275 -19.911 26.688 -33.517 1.00114.55 O \nANISOU 2200 OD1 ASN A 275 12565 14181 16779 -953 -509 -563 O \nATOM 2201 ND2 ASN A 275 -19.965 28.210 -31.895 1.00111.26 N \nANISOU 2201 ND2 ASN A 275 12044 13893 16337 -951 -592 -550 N \nATOM 2202 N THR A 276 -18.483 23.081 -31.301 1.00106.71 N \nANISOU 2202 N THR A 276 11869 12865 15812 -982 -495 -457 N \nATOM 2203 CA THR A 276 -17.726 22.088 -30.554 1.00110.92 C \nANISOU 2203 CA THR A 276 12477 13309 16358 -968 -504 -421 C \nATOM 2204 C THR A 276 -16.254 22.162 -30.965 1.00119.45 C \nANISOU 2204 C THR A 276 13549 14341 17497 -865 -542 -407 C \nATOM 2205 O THR A 276 -15.931 22.745 -31.991 1.00132.29 O \nANISOU 2205 O THR A 276 15128 15985 19151 -809 -546 -429 O \nATOM 2206 CB THR A 276 -18.279 20.672 -30.790 1.00118.49 C \nANISOU 2206 CB THR A 276 13533 14202 17288 -1017 -438 -418 C \nATOM 2207 OG1 THR A 276 -17.486 19.711 -30.086 1.00119.36 O \nANISOU 2207 OG1 THR A 276 13707 14237 17408 -996 -448 -384 O \nATOM 2208 CG2 THR A 276 -18.256 20.315 -32.239 1.00121.37 C \nANISOU 2208 CG2 THR A 276 13906 14542 17667 -984 -396 -438 C \nATOM 2209 N LYS A 277 -15.368 21.610 -30.146 1.00116.22 N \nANISOU 2209 N LYS A 277 13185 13872 17102 -846 -571 -373 N \nATOM 2210 CA LYS A 277 -13.989 21.373 -30.548 1.00120.38 C \nANISOU 2210 CA LYS A 277 13728 14337 17674 -767 -596 -357 C \nATOM 2211 C LYS A 277 -13.834 19.886 -30.814 1.00122.37 C \nANISOU 2211 C LYS A 277 14061 14518 17916 -780 -549 -344 C \nATOM 2212 O LYS A 277 -12.766 19.419 -31.269 1.00141.67 O \nANISOU 2212 O LYS A 277 16529 16911 20389 -728 -557 -332 O \nATOM 2213 CB LYS A 277 -13.011 21.826 -29.459 1.00131.30 C \nANISOU 2213 CB LYS A 277 15107 15708 19075 -735 -666 -326 C \nATOM 2214 CG LYS A 277 -11.544 21.841 -29.894 1.00136.08 C \nANISOU 2214 CG LYS A 277 15725 16255 19723 -655 -701 -313 C \nATOM 2215 CD LYS A 277 -10.540 22.323 -28.853 1.00134.46 C \nANISOU 2215 CD LYS A 277 15525 16032 19533 -625 -771 -281 C \nATOM 2216 CE LYS A 277 -9.113 22.206 -29.362 1.00132.75 C \nANISOU 2216 CE LYS A 277 15339 15749 19350 -559 -799 -269 C \nATOM 2217 NZ LYS A 277 -8.898 22.700 -30.756 1.00129.72 N \nANISOU 2217 NZ LYS A 277 14924 15369 18995 -499 -787 -301 N \nATOM 2218 N CYS A 278 -14.900 19.140 -30.526 1.00102.99 N \nANISOU 2218 N CYS A 278 11650 12063 15417 -851 -500 -347 N \nATOM 2219 CA CYS A 278 -14.902 17.727 -30.763 1.00110.57 C \nANISOU 2219 CA CYS A 278 12687 12965 16360 -859 -451 -336 C \nATOM 2220 C CYS A 278 -16.204 17.290 -31.419 1.00106.15 C \nANISOU 2220 C CYS A 278 12158 12414 15762 -909 -384 -361 C \nATOM 2221 O CYS A 278 -17.271 17.487 -30.845 1.00 96.51 O \nANISOU 2221 O CYS A 278 10943 11224 14501 -979 -370 -370 O \nATOM 2222 CB CYS A 278 -14.703 16.975 -29.451 1.00112.60 C \nANISOU 2222 CB CYS A 278 12996 13192 16593 -889 -462 -304 C \nATOM 2223 SG CYS A 278 -14.639 15.203 -29.757 1.00128.76 S \nANISOU 2223 SG CYS A 278 15133 15177 18613 -884 -403 -290 S \nATOM 2224 N GLN A 279 -16.084 16.647 -32.590 1.00 90.49 N \nANISOU 2224 N GLN A 279 10197 10399 13785 -877 -343 -370 N \nATOM 2225 CA GLN A 279 -17.234 16.178 -33.345 1.00 70.16 C \nANISOU 2225 CA GLN A 279 7660 7824 11173 -917 -279 -392 C \nATOM 2226 C GLN A 279 -17.090 14.712 -33.716 1.00 70.50 C \nANISOU 2226 C GLN A 279 7784 7805 11198 -896 -232 -377 C \nATOM 2227 O GLN A 279 -15.985 14.254 -34.005 1.00 70.87 O \nANISOU 2227 O GLN A 279 7831 7824 11274 -836 -246 -361 O \nATOM 2228 CB GLN A 279 -17.366 17.016 -34.588 1.00 61.06 C \nANISOU 2228 CB GLN A 279 6446 6712 10044 -895 -274 -423 C \nATOM 2229 CG GLN A 279 -18.466 16.566 -35.520 1.00 66.10 C \nANISOU 2229 CG GLN A 279 7122 7348 10645 -935 -208 -445 C \nATOM 2230 CD GLN A 279 -19.865 16.917 -35.020 1.00 67.46 C \nANISOU 2230 CD GLN A 279 7307 7559 10765 -1030 -187 -461 C \nATOM 2231 OE1 GLN A 279 -20.215 18.106 -34.897 1.00 57.52 O \nANISOU 2231 OE1 GLN A 279 5974 6374 9507 -1057 -214 -479 O \nATOM 2232 NE2 GLN A 279 -20.683 15.898 -34.774 1.00 63.36 N \nANISOU 2232 NE2 GLN A 279 6883 6997 10195 -1080 -138 -455 N \nATOM 2233 N THR A 280 -18.208 13.982 -33.708 1.00 67.94 N \nANISOU 2233 N THR A 280 7530 7461 10821 -947 -177 -384 N \nATOM 2234 CA THR A 280 -18.214 12.571 -34.148 1.00 66.21 C \nANISOU 2234 CA THR A 280 7393 7188 10576 -920 -127 -372 C \nATOM 2235 C THR A 280 -19.258 12.467 -35.223 1.00 65.95 C \nANISOU 2235 C THR A 280 7390 7153 10516 -946 -72 -397 C \nATOM 2236 O THR A 280 -20.032 13.410 -35.410 1.00 68.56 O \nANISOU 2236 O THR A 280 7684 7527 10840 -998 -72 -422 O \nATOM 2237 CB THR A 280 -18.466 11.562 -33.005 1.00 68.45 C \nANISOU 2237 CB THR A 280 7757 7435 10815 -942 -111 -349 C \nATOM 2238 OG1 THR A 280 -19.774 11.003 -33.103 1.00 78.64 O \nANISOU 2238 OG1 THR A 280 9130 8702 12047 -993 -54 -362 O \nATOM 2239 CG2 THR A 280 -18.305 12.206 -31.644 1.00 67.25 C \nANISOU 2239 CG2 THR A 280 7575 7308 10668 -978 -162 -338 C \nATOM 2240 N PRO A 281 -19.299 11.345 -35.946 1.00 67.43 N \nANISOU 2240 N PRO A 281 7641 7298 10682 -911 -24 -391 N \nATOM 2241 CA PRO A 281 -20.322 11.175 -36.982 1.00 76.31 C \nANISOU 2241 CA PRO A 281 8805 8413 11774 -937 30 -413 C \nATOM 2242 C PRO A 281 -21.772 11.186 -36.500 1.00 72.67 C \nANISOU 2242 C PRO A 281 8412 7946 11252 -1027 63 -426 C \nATOM 2243 O PRO A 281 -22.658 11.644 -37.230 1.00 77.93 O \nANISOU 2243 O PRO A 281 9080 8632 11899 -1076 90 -450 O \nATOM 2244 CB PRO A 281 -20.007 9.783 -37.555 1.00 79.36 C \nANISOU 2244 CB PRO A 281 9260 8750 12142 -875 71 -395 C \nATOM 2245 CG PRO A 281 -18.555 9.604 -37.314 1.00 75.33 C \nANISOU 2245 CG PRO A 281 8702 8246 11676 -807 29 -372 C \nATOM 2246 CD PRO A 281 -18.355 10.228 -35.953 1.00 72.37 C \nANISOU 2246 CD PRO A 281 8296 7888 11312 -843 -20 -364 C \nATOM 2247 N ILE A 282 -21.994 10.685 -35.290 1.00 62.42 N \nANISOU 2247 N ILE A 282 7172 6623 9922 -1053 62 -410 N \nATOM 2248 CA ILE A 282 -23.319 10.609 -34.740 1.00 59.39 C \nANISOU 2248 CA ILE A 282 6865 6225 9474 -1142 94 -421 C \nATOM 2249 C ILE A 282 -23.702 11.792 -33.816 1.00 66.02 C \nANISOU 2249 C ILE A 282 7647 7124 10315 -1221 54 -432 C \nATOM 2250 O ILE A 282 -24.832 11.847 -33.293 1.00 73.08 O \nANISOU 2250 O ILE A 282 8600 8016 11152 -1309 77 -443 O \nATOM 2251 CB ILE A 282 -23.525 9.291 -34.008 1.00 54.62 C \nANISOU 2251 CB ILE A 282 6375 5556 8821 -1129 126 -400 C \nATOM 2252 CG1 ILE A 282 -22.695 9.213 -32.753 1.00 58.19 C \nANISOU 2252 CG1 ILE A 282 6800 6016 9293 -1108 81 -378 C \nATOM 2253 CG2 ILE A 282 -23.205 8.150 -34.928 1.00 47.31 C \nANISOU 2253 CG2 ILE A 282 5503 4585 7888 -1048 165 -389 C \nATOM 2254 CD1 ILE A 282 -23.127 8.075 -31.842 1.00 59.57 C \nANISOU 2254 CD1 ILE A 282 7087 6138 9409 -1114 112 -363 C \nATOM 2255 N GLY A 283 -22.773 12.721 -33.615 1.00 59.19 N \nANISOU 2255 N GLY A 283 6671 6311 9508 -1189 -5 -429 N \nATOM 2256 CA GLY A 283 -23.064 13.924 -32.861 1.00 63.79 C \nANISOU 2256 CA GLY A 283 7184 6960 10093 -1250 -46 -439 C \nATOM 2257 C GLY A 283 -21.844 14.593 -32.271 1.00 60.97 C \nANISOU 2257 C GLY A 283 6737 6635 9795 -1197 -114 -423 C \nATOM 2258 O GLY A 283 -20.865 13.947 -31.994 1.00 58.10 O \nANISOU 2258 O GLY A 283 6387 6232 9456 -1134 -130 -398 O \nATOM 2259 N ALA A 284 -21.948 15.897 -32.044 1.00 58.75 N \nANISOU 2259 N ALA A 284 6367 6429 9528 -1225 -155 -437 N \nATOM 2260 CA ALA A 284 -20.937 16.655 -31.356 1.00 62.80 C \nANISOU 2260 CA ALA A 284 6801 6974 10087 -1183 -222 -421 C \nATOM 2261 C ALA A 284 -20.895 16.364 -29.840 1.00 68.65 C \nANISOU 2261 C ALA A 284 7576 7701 10806 -1216 -245 -397 C \nATOM 2262 O ALA A 284 -21.858 15.879 -29.249 1.00 75.20 O \nANISOU 2262 O ALA A 284 8475 8516 11579 -1290 -213 -399 O \nATOM 2263 CB ALA A 284 -21.168 18.131 -31.562 1.00 62.75 C \nANISOU 2263 CB ALA A 284 6691 7059 10094 -1199 -256 -444 C \nATOM 2264 N ILE A 285 -19.757 16.650 -29.224 1.00 68.08 N \nANISOU 2264 N ILE A 285 7461 7630 10776 -1163 -302 -374 N \nATOM 2265 CA ILE A 285 -19.668 16.626 -27.784 1.00 63.19 C \nANISOU 2265 CA ILE A 285 6856 7015 10141 -1196 -334 -352 C \nATOM 2266 C ILE A 285 -18.930 17.810 -27.195 1.00 70.26 C \nANISOU 2266 C ILE A 285 7661 7962 11073 -1169 -406 -342 C \nATOM 2267 O ILE A 285 -17.732 17.927 -27.334 1.00 75.74 O \nANISOU 2267 O ILE A 285 8327 8636 11813 -1095 -444 -326 O \nATOM 2268 CB ILE A 285 -19.142 15.265 -27.213 1.00 61.11 C \nANISOU 2268 CB ILE A 285 6675 6678 9865 -1173 -318 -324 C \nATOM 2269 CG1 ILE A 285 -19.066 15.357 -25.692 1.00 67.84 C \nANISOU 2269 CG1 ILE A 285 7533 7542 10700 -1212 -354 -303 C \nATOM 2270 CG2 ILE A 285 -17.818 14.806 -27.756 1.00 53.13 C \nANISOU 2270 CG2 ILE A 285 5655 5630 8901 -1084 -334 -307 C \nATOM 2271 CD1 ILE A 285 -20.396 15.751 -25.041 1.00 61.94 C \nANISOU 2271 CD1 ILE A 285 6802 6835 9899 -1311 -338 -320 C \nATOM 2272 N ASN A 286 -19.683 18.660 -26.491 1.00 86.29 N \nANISOU 2272 N ASN A 286 9654 10059 13075 -1234 -425 -351 N \nATOM 2273 CA ASN A 286 -19.152 19.741 -25.627 1.00 85.04 C \nANISOU 2273 CA ASN A 286 9420 9956 12936 -1219 -495 -337 C \nATOM 2274 C ASN A 286 -18.955 19.284 -24.176 1.00 87.73 C \nANISOU 2274 C ASN A 286 9803 10274 13256 -1251 -518 -307 C \nATOM 2275 O ASN A 286 -19.807 19.509 -23.334 1.00 85.43 O \nANISOU 2275 O ASN A 286 9515 10023 12920 -1330 -516 -310 O \nATOM 2276 CB ASN A 286 -20.098 20.941 -25.654 1.00 87.31 C \nANISOU 2276 CB ASN A 286 9632 10344 13197 -1272 -504 -363 C \nATOM 2277 CG ASN A 286 -19.634 22.079 -24.765 1.00 91.48 C \nANISOU 2277 CG ASN A 286 10082 10939 13739 -1253 -575 -349 C \nATOM 2278 OD1 ASN A 286 -18.478 22.135 -24.337 1.00 99.33 O \nANISOU 2278 OD1 ASN A 286 11069 11899 14772 -1185 -623 -322 O \nATOM 2279 ND2 ASN A 286 -20.546 22.992 -24.472 1.00 92.66 N \nANISOU 2279 ND2 ASN A 286 10171 11185 13849 -1314 -583 -366 N \nATOM 2280 N SER A 287 -17.824 18.637 -23.899 1.00 97.61 N \nANISOU 2280 N SER A 287 11085 11464 14537 -1195 -538 -279 N \nATOM 2281 CA SER A 287 -17.500 18.179 -22.542 1.00 98.51 C \nANISOU 2281 CA SER A 287 11237 11558 14633 -1219 -563 -249 C \nATOM 2282 C SER A 287 -16.071 18.469 -22.147 1.00 93.21 C \nANISOU 2282 C SER A 287 10537 10870 14007 -1152 -627 -218 C \nATOM 2283 O SER A 287 -15.354 19.172 -22.866 1.00 97.32 O \nANISOU 2283 O SER A 287 11007 11399 14573 -1086 -657 -222 O \nATOM 2284 CB SER A 287 -17.798 16.690 -22.395 1.00100.23 C \nANISOU 2284 CB SER A 287 11554 11712 14816 -1244 -506 -243 C \nATOM 2285 OG SER A 287 -19.201 16.465 -22.489 1.00102.60 O \nANISOU 2285 OG SER A 287 11895 12023 15064 -1320 -452 -268 O \nATOM 2286 N SER A 288 -15.688 17.979 -20.970 1.00 90.86 N \nANISOU 2286 N SER A 288 10276 10553 13694 -1173 -648 -189 N \nATOM 2287 CA SER A 288 -14.319 18.124 -20.477 1.00 90.14 C \nANISOU 2287 CA SER A 288 10173 10439 13636 -1121 -708 -157 C \nATOM 2288 C SER A 288 -13.966 16.965 -19.569 1.00 86.64 C \nANISOU 2288 C SER A 288 9798 9955 13168 -1146 -699 -130 C \nATOM 2289 O SER A 288 -14.183 17.044 -18.358 1.00 78.42 O \nANISOU 2289 O SER A 288 8765 8934 12099 -1194 -721 -114 O \nATOM 2290 CB SER A 288 -14.146 19.439 -19.730 1.00 86.88 C \nANISOU 2290 CB SER A 288 9696 10081 13234 -1120 -775 -146 C \nATOM 2291 OG SER A 288 -12.790 19.616 -19.380 1.00 90.75 O \nANISOU 2291 OG SER A 288 10185 10541 13756 -1066 -833 -115 O \nATOM 2292 N MET A 289 -13.427 15.906 -20.178 1.00 84.63 N \nANISOU 2292 N MET A 289 9587 9649 12918 -1111 -667 -125 N \nATOM 2293 CA MET A 289 -13.148 14.663 -19.488 1.00 92.29 C \nANISOU 2293 CA MET A 289 10621 10588 13857 -1127 -648 -105 C \nATOM 2294 C MET A 289 -12.107 13.835 -20.245 1.00 88.04 C \nANISOU 2294 C MET A 289 10103 10010 13338 -1069 -637 -94 C \nATOM 2295 O MET A 289 -12.076 13.814 -21.460 1.00 93.71 O \nANISOU 2295 O MET A 289 10810 10716 14078 -1029 -612 -111 O \nATOM 2296 CB MET A 289 -14.454 13.862 -19.323 1.00 97.16 C \nANISOU 2296 CB MET A 289 11295 11201 14421 -1181 -581 -124 C \nATOM 2297 CG MET A 289 -15.310 14.227 -18.111 1.00104.53 C \nANISOU 2297 CG MET A 289 12234 12167 15315 -1257 -591 -124 C \nATOM 2298 SD MET A 289 -16.631 13.023 -17.759 1.00118.37 S \nANISOU 2298 SD MET A 289 14083 13896 16996 -1317 -513 -141 S \nATOM 2299 CE MET A 289 -17.592 13.966 -16.592 1.00 84.04 C \nANISOU 2299 CE MET A 289 9715 9603 12615 -1410 -538 -147 C \nATOM 2300 N PRO A 290 -11.278 13.094 -19.531 1.00 99.58 N \nANISOU 2300 N PRO A 290 11593 11457 14785 -1068 -653 -64 N \nATOM 2301 CA PRO A 290 -10.197 12.360 -20.202 1.00101.79 C \nANISOU 2301 CA PRO A 290 11886 11712 15079 -1020 -648 -52 C \nATOM 2302 C PRO A 290 -10.665 11.222 -21.091 1.00 93.72 C \nANISOU 2302 C PRO A 290 10902 10675 14034 -999 -576 -69 C \nATOM 2303 O PRO A 290 -9.883 10.734 -21.936 1.00 90.07 O \nANISOU 2303 O PRO A 290 10439 10200 13585 -954 -567 -65 O \nATOM 2304 CB PRO A 290 -9.369 11.802 -19.036 1.00 97.35 C \nANISOU 2304 CB PRO A 290 11347 11151 14493 -1040 -680 -17 C \nATOM 2305 CG PRO A 290 -10.323 11.707 -17.914 1.00101.27 C \nANISOU 2305 CG PRO A 290 11864 11664 14949 -1097 -669 -18 C \nATOM 2306 CD PRO A 290 -11.303 12.841 -18.085 1.00105.64 C \nANISOU 2306 CD PRO A 290 12383 12236 15518 -1117 -673 -42 C \nATOM 2307 N PHE A 291 -11.912 10.796 -20.925 1.00 83.82 N \nANISOU 2307 N PHE A 291 9684 9422 12741 -1031 -525 -87 N \nATOM 2308 CA PHE A 291 -12.407 9.675 -21.727 1.00 92.82 C \nANISOU 2308 CA PHE A 291 10872 10543 13853 -1006 -456 -101 C \nATOM 2309 C PHE A 291 -13.847 9.825 -22.224 1.00 86.76 C \nANISOU 2309 C PHE A 291 10129 9770 13068 -1032 -406 -134 C \nATOM 2310 O PHE A 291 -14.619 10.637 -21.712 1.00 79.72 O \nANISOU 2310 O PHE A 291 9225 8895 12171 -1084 -418 -145 O \nATOM 2311 CB PHE A 291 -12.255 8.379 -20.945 1.00 95.55 C \nANISOU 2311 CB PHE A 291 11271 10886 14148 -1009 -432 -83 C \nATOM 2312 CG PHE A 291 -10.862 8.157 -20.410 1.00100.24 C \nANISOU 2312 CG PHE A 291 11844 11494 14750 -996 -479 -51 C \nATOM 2313 CD1 PHE A 291 -10.531 8.527 -19.120 1.00102.24 C \nANISOU 2313 CD1 PHE A 291 12088 11761 14996 -1037 -527 -30 C \nATOM 2314 CD2 PHE A 291 -9.888 7.601 -21.203 1.00 98.70 C \nANISOU 2314 CD2 PHE A 291 11638 11299 14564 -948 -476 -41 C \nATOM 2315 CE1 PHE A 291 -9.264 8.320 -18.611 1.00 99.30 C \nANISOU 2315 CE1 PHE A 291 11703 11401 14625 -1033 -571 1 C \nATOM 2316 CE2 PHE A 291 -8.614 7.389 -20.709 1.00104.21 C \nANISOU 2316 CE2 PHE A 291 12321 12013 15262 -947 -519 -11 C \nATOM 2317 CZ PHE A 291 -8.299 7.748 -19.411 1.00103.12 C \nANISOU 2317 CZ PHE A 291 12180 11886 15117 -991 -566 11 C \nATOM 2318 N HIS A 292 -14.165 9.056 -23.269 1.00 85.13 N \nANISOU 2318 N HIS A 292 9955 9541 12848 -997 -350 -148 N \nATOM 2319 CA HIS A 292 -15.523 8.935 -23.794 1.00 74.70 C \nANISOU 2319 CA HIS A 292 8679 8206 11499 -1021 -293 -176 C \nATOM 2320 C HIS A 292 -15.687 7.582 -24.458 1.00 74.99 C \nANISOU 2320 C HIS A 292 8779 8213 11499 -975 -232 -178 C \nATOM 2321 O HIS A 292 -14.699 6.894 -24.731 1.00 92.07 O \nANISOU 2321 O HIS A 292 10933 10379 13669 -921 -235 -160 O \nATOM 2322 CB HIS A 292 -15.857 10.079 -24.758 1.00 71.57 C \nANISOU 2322 CB HIS A 292 8227 7824 11141 -1026 -302 -200 C \nATOM 2323 CG HIS A 292 -15.292 9.912 -26.137 1.00 80.33 C \nANISOU 2323 CG HIS A 292 9315 8925 12283 -963 -288 -206 C \nATOM 2324 ND1 HIS A 292 -15.792 9.009 -27.049 1.00 88.30 N \nANISOU 2324 ND1 HIS A 292 10376 9908 13266 -937 -227 -217 N \nATOM 2325 CD2 HIS A 292 -14.303 10.574 -26.778 1.00 78.67 C \nANISOU 2325 CD2 HIS A 292 9040 8726 12126 -922 -328 -203 C \nATOM 2326 CE1 HIS A 292 -15.117 9.092 -28.178 1.00 86.13 C \nANISOU 2326 CE1 HIS A 292 10063 9634 13027 -886 -229 -220 C \nATOM 2327 NE2 HIS A 292 -14.205 10.035 -28.038 1.00 84.23 N \nANISOU 2327 NE2 HIS A 292 9753 9415 12835 -877 -289 -213 N \nATOM 2328 N ASN A 293 -16.932 7.217 -24.730 1.00 78.46 N \nANISOU 2328 N ASN A 293 9285 8629 11898 -999 -176 -199 N \nATOM 2329 CA ASN A 293 -17.267 5.963 -25.425 1.00 73.95 C \nANISOU 2329 CA ASN A 293 8786 8026 11287 -951 -113 -202 C \nATOM 2330 C ASN A 293 -18.319 6.150 -26.507 1.00 71.88 C \nANISOU 2330 C ASN A 293 8555 7741 11015 -963 -67 -230 C \nATOM 2331 O ASN A 293 -19.107 5.254 -26.781 1.00 76.37 O \nANISOU 2331 O ASN A 293 9211 8273 11532 -952 -10 -238 O \nATOM 2332 CB ASN A 293 -17.769 4.947 -24.431 1.00 78.74 C \nANISOU 2332 CB ASN A 293 9478 8613 11828 -961 -81 -196 C \nATOM 2333 CG ASN A 293 -19.031 5.397 -23.731 1.00 78.89 C \nANISOU 2333 CG ASN A 293 9546 8617 11812 -1043 -68 -214 C \nATOM 2334 OD1 ASN A 293 -19.349 6.592 -23.679 1.00 74.57 O \nANISOU 2334 OD1 ASN A 293 8950 8091 11293 -1101 -98 -226 O \nATOM 2335 ND2 ASN A 293 -19.752 4.435 -23.184 1.00 78.67 N \nANISOU 2335 ND2 ASN A 293 9617 8556 11718 -1049 -23 -217 N \nATOM 2336 N ILE A 294 -18.315 7.329 -27.115 1.00 66.79 N \nANISOU 2336 N ILE A 294 7841 7120 10418 -985 -94 -245 N \nATOM 2337 CA ILE A 294 -19.326 7.740 -28.065 1.00 67.29 C \nANISOU 2337 CA ILE A 294 7921 7174 10474 -1013 -59 -272 C \nATOM 2338 C ILE A 294 -19.180 7.023 -29.396 1.00 71.44 C \nANISOU 2338 C ILE A 294 8467 7678 11000 -948 -18 -275 C \nATOM 2339 O ILE A 294 -20.072 6.307 -29.835 1.00 75.26 O \nANISOU 2339 O ILE A 294 9034 8124 11436 -948 39 -285 O \nATOM 2340 CB ILE A 294 -19.245 9.251 -28.343 1.00 59.91 C \nANISOU 2340 CB ILE A 294 6890 6284 9589 -1045 -104 -287 C \nATOM 2341 CG1 ILE A 294 -19.257 10.076 -27.051 1.00 63.39 C \nANISOU 2341 CG1 ILE A 294 7295 6758 10034 -1102 -153 -281 C \nATOM 2342 CG2 ILE A 294 -20.405 9.657 -29.237 1.00 57.16 C \nANISOU 2342 CG2 ILE A 294 6560 5935 9222 -1088 -65 -317 C \nATOM 2343 CD1 ILE A 294 -20.506 9.909 -26.198 1.00 67.08 C \nANISOU 2343 CD1 ILE A 294 7835 7215 10439 -1183 -124 -291 C \nATOM 2344 N HIS A 295 -18.029 7.236 -30.023 1.00 75.43 N \nANISOU 2344 N HIS A 295 8899 8204 11557 -892 -49 -266 N \nATOM 2345 CA HIS A 295 -17.753 6.709 -31.358 1.00 75.63 C \nANISOU 2345 CA HIS A 295 8926 8219 11590 -832 -18 -269 C \nATOM 2346 C HIS A 295 -16.225 6.702 -31.618 1.00 65.51 C \nANISOU 2346 C HIS A 295 7573 6962 10355 -773 -59 -250 C \nATOM 2347 O HIS A 295 -15.536 7.620 -31.206 1.00 68.56 O \nANISOU 2347 O HIS A 295 7892 7372 10785 -787 -115 -245 O \nATOM 2348 CB HIS A 295 -18.480 7.581 -32.381 1.00 80.31 C \nANISOU 2348 CB HIS A 295 9495 8819 12200 -861 -4 -298 C \nATOM 2349 CG HIS A 295 -18.544 6.980 -33.753 1.00 81.22 C \nANISOU 2349 CG HIS A 295 9632 8917 12309 -812 40 -304 C \nATOM 2350 ND1 HIS A 295 -17.590 7.232 -34.715 1.00 79.21 N \nANISOU 2350 ND1 HIS A 295 9311 8684 12103 -761 21 -303 N \nATOM 2351 CD2 HIS A 295 -19.430 6.123 -34.310 1.00 83.84 C \nANISOU 2351 CD2 HIS A 295 10052 9212 12590 -804 101 -310 C \nATOM 2352 CE1 HIS A 295 -17.894 6.557 -35.808 1.00 85.33 C \nANISOU 2352 CE1 HIS A 295 10123 9440 12857 -726 69 -308 C \nATOM 2353 NE2 HIS A 295 -19.003 5.871 -35.588 1.00 83.03 N \nANISOU 2353 NE2 HIS A 295 9927 9113 12506 -749 118 -312 N \nATOM 2354 N PRO A 296 -15.704 5.658 -32.268 1.00 63.53 N \nANISOU 2354 N PRO A 296 7342 6706 10090 -710 -32 -237 N \nATOM 2355 CA PRO A 296 -14.265 5.563 -32.544 1.00 59.63 C \nANISOU 2355 CA PRO A 296 6789 6238 9631 -663 -67 -219 C \nATOM 2356 C PRO A 296 -13.783 6.667 -33.425 1.00 72.71 C \nANISOU 2356 C PRO A 296 8372 7907 11346 -661 -98 -234 C \nATOM 2357 O PRO A 296 -12.838 7.367 -33.079 1.00 63.59 O \nANISOU 2357 O PRO A 296 7161 6769 10232 -663 -153 -226 O \nATOM 2358 CB PRO A 296 -14.111 4.214 -33.263 1.00 59.87 C \nANISOU 2358 CB PRO A 296 6860 6267 9623 -600 -19 -209 C \nATOM 2359 CG PRO A 296 -15.500 3.759 -33.640 1.00 68.13 C \nANISOU 2359 CG PRO A 296 7985 7278 10623 -606 42 -225 C \nATOM 2360 CD PRO A 296 -16.439 4.424 -32.650 1.00 71.68 C \nANISOU 2360 CD PRO A 296 8462 7711 11064 -679 34 -237 C \nATOM 2361 N LEU A 297 -14.438 6.801 -34.577 1.00 93.56 N \nANISOU 2361 N LEU A 297 11019 10540 13989 -653 -62 -256 N \nATOM 2362 CA LEU A 297 -14.075 7.810 -35.584 1.00100.88 C \nANISOU 2362 CA LEU A 297 11880 11483 14969 -645 -83 -275 C \nATOM 2363 C LEU A 297 -14.407 9.204 -35.115 1.00 95.42 C \nANISOU 2363 C LEU A 297 11142 10806 14308 -693 -123 -292 C \nATOM 2364 O LEU A 297 -15.468 9.723 -35.391 1.00108.01 O \nANISOU 2364 O LEU A 297 12742 12404 15894 -730 -101 -315 O \nATOM 2365 CB LEU A 297 -14.776 7.543 -36.921 1.00106.16 C \nANISOU 2365 CB LEU A 297 12570 12143 15625 -629 -30 -294 C \nATOM 2366 CG LEU A 297 -14.523 6.173 -37.548 1.00104.81 C \nANISOU 2366 CG LEU A 297 12442 11962 15418 -573 12 -279 C \nATOM 2367 CD1 LEU A 297 -15.524 5.854 -38.656 1.00105.53 C \nANISOU 2367 CD1 LEU A 297 12577 12037 15484 -567 70 -297 C \nATOM 2368 CD2 LEU A 297 -13.102 6.115 -38.084 1.00105.71 C \nANISOU 2368 CD2 LEU A 297 12499 12100 15566 -527 -18 -267 C \nATOM 2369 N THR A 298 -13.490 9.815 -34.399 1.00 88.42 N \nANISOU 2369 N THR A 298 10211 9932 13454 -692 -181 -279 N \nATOM 2370 CA THR A 298 -13.733 11.120 -33.822 1.00 84.66 C \nANISOU 2370 CA THR A 298 9688 9476 13003 -729 -224 -291 C \nATOM 2371 C THR A 298 -12.841 12.098 -34.520 1.00 76.19 C \nANISOU 2371 C THR A 298 8547 8418 11984 -694 -265 -300 C \nATOM 2372 O THR A 298 -11.866 11.686 -35.129 1.00 92.79 O \nANISOU 2372 O THR A 298 10643 10509 14102 -649 -269 -291 O \nATOM 2373 CB THR A 298 -13.418 11.049 -32.320 1.00 94.88 C \nANISOU 2373 CB THR A 298 10995 10770 14286 -755 -261 -266 C \nATOM 2374 OG1 THR A 298 -14.122 9.924 -31.740 1.00 99.05 O \nANISOU 2374 OG1 THR A 298 11596 11280 14759 -776 -217 -256 O \nATOM 2375 CG2 THR A 298 -13.819 12.315 -31.603 1.00 92.25 C \nANISOU 2375 CG2 THR A 298 10620 10463 13968 -796 -301 -275 C \nATOM 2376 N ILE A 299 -13.160 13.386 -34.451 1.00 67.57 N \nANISOU 2376 N ILE A 299 7402 7354 10916 -711 -295 -319 N \nATOM 2377 CA ILE A 299 -12.372 14.412 -35.125 1.00 67.16 C \nANISOU 2377 CA ILE A 299 7288 7316 10913 -670 -334 -332 C \nATOM 2378 C ILE A 299 -12.250 15.673 -34.307 1.00 70.03 C \nANISOU 2378 C ILE A 299 7603 7708 11299 -679 -392 -334 C \nATOM 2379 O ILE A 299 -13.228 16.179 -33.790 1.00 86.74 O \nANISOU 2379 O ILE A 299 9707 9856 13396 -724 -389 -345 O \nATOM 2380 CB ILE A 299 -12.891 14.729 -36.571 1.00 79.67 C \nANISOU 2380 CB ILE A 299 8847 8918 12507 -655 -297 -366 C \nATOM 2381 CG1 ILE A 299 -13.791 16.009 -36.656 1.00 80.81 C \nANISOU 2381 CG1 ILE A 299 8936 9111 12655 -683 -306 -396 C \nATOM 2382 CG2 ILE A 299 -13.577 13.502 -37.209 1.00 80.12 C \nANISOU 2382 CG2 ILE A 299 8963 8954 12526 -665 -229 -367 C \nATOM 2383 CD1 ILE A 299 -13.105 17.199 -37.288 1.00 79.81 C \nANISOU 2383 CD1 ILE A 299 8739 9011 12575 -634 -346 -415 C \nATOM 2384 N GLY A 300 -11.043 16.194 -34.195 1.00 92.30 N \nANISOU 2384 N GLY A 300 10399 10518 14155 -636 -446 -322 N \nATOM 2385 CA GLY A 300 -10.757 17.405 -33.409 1.00109.03 C \nANISOU 2385 CA GLY A 300 12474 12658 16293 -630 -508 -320 C \nATOM 2386 C GLY A 300 -9.831 17.080 -32.240 1.00120.05 C \nANISOU 2386 C GLY A 300 13901 14024 17687 -634 -552 -282 C \nATOM 2387 O GLY A 300 -8.964 16.205 -32.362 1.00112.54 O \nANISOU 2387 O GLY A 300 12986 13037 16735 -619 -548 -262 O \nATOM 2388 N GLU A 301 -10.005 17.799 -31.126 1.00128.77 N \nANISOU 2388 N GLU A 301 14987 15151 18788 -655 -594 -272 N \nATOM 2389 CA GLU A 301 -9.343 17.455 -29.854 1.00132.29 C \nANISOU 2389 CA GLU A 301 15466 15575 19224 -673 -632 -235 C \nATOM 2390 C GLU A 301 -10.402 16.881 -28.911 1.00125.49 C \nANISOU 2390 C GLU A 301 14630 14731 18320 -739 -603 -229 C \nATOM 2391 O GLU A 301 -11.243 17.583 -28.325 1.00 86.51 O \nANISOU 2391 O GLU A 301 9666 9834 13371 -773 -612 -237 O \nATOM 2392 CB GLU A 301 -8.569 18.611 -29.202 1.00138.67 C \nANISOU 2392 CB GLU A 301 16245 16387 20057 -644 -706 -222 C \nATOM 2393 CG GLU A 301 -7.056 18.538 -29.384 1.00129.17 C \nANISOU 2393 CG GLU A 301 15067 15135 18878 -601 -746 -202 C \nATOM 2394 CD GLU A 301 -6.313 19.666 -28.681 1.00128.17 C \nANISOU 2394 CD GLU A 301 14926 15002 18770 -571 -821 -187 C \nATOM 2395 OE1 GLU A 301 -6.954 20.528 -28.055 1.00126.39 O \nANISOU 2395 OE1 GLU A 301 14663 14818 18541 -578 -844 -192 O \nATOM 2396 OE2 GLU A 301 -5.072 19.701 -28.755 1.00129.33 O \nANISOU 2396 OE2 GLU A 301 15104 15105 18932 -541 -858 -170 O \nATOM 2397 N CYS A 302 -10.322 15.570 -28.783 1.00131.49 N \nANISOU 2397 N CYS A 302 15445 15463 19053 -755 -567 -213 N \nATOM 2398 CA CYS A 302 -11.350 14.783 -28.159 1.00128.08 C \nANISOU 2398 CA CYS A 302 15053 15036 18575 -808 -524 -211 C \nATOM 2399 C CYS A 302 -10.749 13.814 -27.158 1.00126.63 C \nANISOU 2399 C CYS A 302 14916 14832 18367 -822 -533 -178 C \nATOM 2400 O CYS A 302 -9.683 13.226 -27.387 1.00138.89 O \nANISOU 2400 O CYS A 302 16483 16364 19927 -791 -542 -160 O \nATOM 2401 CB CYS A 302 -12.086 13.982 -29.229 1.00123.06 C \nANISOU 2401 CB CYS A 302 14446 14391 17920 -805 -454 -232 C \nATOM 2402 SG CYS A 302 -12.750 15.052 -30.492 1.00111.20 S \nANISOU 2402 SG CYS A 302 12889 12919 16444 -792 -440 -272 S \nATOM 2403 N PRO A 303 -11.442 13.631 -26.041 1.00111.50 N \nANISOU 2403 N PRO A 303 13022 12926 16415 -873 -529 -170 N \nATOM 2404 CA PRO A 303 -11.116 12.579 -25.102 1.00103.03 C \nANISOU 2404 CA PRO A 303 11997 11840 15308 -892 -525 -143 C \nATOM 2405 C PRO A 303 -10.779 11.248 -25.754 1.00 91.01 C \nANISOU 2405 C PRO A 303 10515 10298 13766 -861 -479 -138 C \nATOM 2406 O PRO A 303 -11.247 10.938 -26.846 1.00100.17 O \nANISOU 2406 O PRO A 303 11683 11451 14925 -839 -432 -158 O \nATOM 2407 CB PRO A 303 -12.416 12.441 -24.280 1.00107.86 C \nANISOU 2407 CB PRO A 303 12639 12465 15877 -952 -497 -152 C \nATOM 2408 CG PRO A 303 -13.327 13.552 -24.705 1.00101.31 C \nANISOU 2408 CG PRO A 303 11770 11663 15061 -972 -496 -180 C \nATOM 2409 CD PRO A 303 -12.529 14.490 -25.548 1.00102.14 C \nANISOU 2409 CD PRO A 303 11815 11775 15220 -920 -534 -187 C \nATOM 2410 N LYS A 304 -10.014 10.441 -25.055 1.00 95.49 N \nANISOU 2410 N LYS A 304 11108 10863 14312 -861 -491 -110 N \nATOM 2411 CA LYS A 304 -9.680 9.134 -25.572 1.00101.37 C \nANISOU 2411 CA LYS A 304 11884 11602 15029 -830 -448 -102 C \nATOM 2412 C LYS A 304 -10.925 8.284 -25.657 1.00 92.08 C \nANISOU 2412 C LYS A 304 10759 10420 13807 -838 -380 -118 C \nATOM 2413 O LYS A 304 -11.524 7.950 -24.651 1.00 98.42 O \nANISOU 2413 O LYS A 304 11597 11224 14573 -873 -370 -113 O \nATOM 2414 CB LYS A 304 -8.675 8.437 -24.655 1.00112.03 C \nANISOU 2414 CB LYS A 304 13247 12963 16355 -838 -475 -69 C \nATOM 2415 CG LYS A 304 -7.321 9.110 -24.547 1.00119.17 C \nANISOU 2415 CG LYS A 304 14119 13867 17295 -833 -541 -49 C \nATOM 2416 CD LYS A 304 -6.267 8.089 -24.157 1.00111.34 C \nANISOU 2416 CD LYS A 304 13142 12891 16269 -834 -548 -20 C \nATOM 2417 CE LYS A 304 -6.067 7.065 -25.242 1.00108.28 C \nANISOU 2417 CE LYS A 304 12762 12515 15863 -793 -499 -26 C \nATOM 2418 NZ LYS A 304 -5.994 7.608 -26.631 1.00103.98 N \nANISOU 2418 NZ LYS A 304 12193 11954 15361 -758 -492 -47 N \nATOM 2419 N TYR A 305 -11.303 7.926 -26.865 1.00 89.80 N \nANISOU 2419 N TYR A 305 10480 10122 13519 -805 -334 -136 N \nATOM 2420 CA TYR A 305 -12.325 6.925 -27.036 1.00 90.75 C \nANISOU 2420 CA TYR A 305 10662 10229 13588 -801 -268 -146 C \nATOM 2421 C TYR A 305 -11.919 5.624 -26.317 1.00 88.28 C \nANISOU 2421 C TYR A 305 10391 9927 13226 -784 -252 -123 C \nATOM 2422 O TYR A 305 -10.815 5.090 -26.508 1.00 70.95 O \nANISOU 2422 O TYR A 305 8175 7751 11032 -751 -265 -103 O \nATOM 2423 CB TYR A 305 -12.594 6.651 -28.514 1.00 83.42 C \nANISOU 2423 CB TYR A 305 9739 9291 12667 -759 -224 -165 C \nATOM 2424 CG TYR A 305 -13.640 5.573 -28.743 1.00 94.26 C \nANISOU 2424 CG TYR A 305 11188 10644 13983 -747 -154 -173 C \nATOM 2425 CD1 TYR A 305 -14.972 5.793 -28.461 1.00 94.59 C \nANISOU 2425 CD1 TYR A 305 11276 10665 13999 -793 -125 -193 C \nATOM 2426 CD2 TYR A 305 -13.289 4.319 -29.221 1.00 93.00 C \nANISOU 2426 CD2 TYR A 305 11057 10488 13790 -691 -117 -162 C \nATOM 2427 CE1 TYR A 305 -15.917 4.803 -28.657 1.00 95.03 C \nANISOU 2427 CE1 TYR A 305 11416 10693 13998 -780 -62 -200 C \nATOM 2428 CE2 TYR A 305 -14.242 3.338 -29.424 1.00 93.58 C \nANISOU 2428 CE2 TYR A 305 11208 10540 13808 -670 -55 -169 C \nATOM 2429 CZ TYR A 305 -15.556 3.588 -29.135 1.00 91.25 C \nANISOU 2429 CZ TYR A 305 10969 10213 13489 -715 -27 -188 C \nATOM 2430 OH TYR A 305 -16.507 2.613 -29.328 1.00 98.63 O \nANISOU 2430 OH TYR A 305 11994 11116 14364 -693 35 -195 O \nATOM 2431 N VAL A 306 -12.829 5.111 -25.502 1.00 83.77 N \nANISOU 2431 N VAL A 306 9876 9344 12606 -809 -222 -125 N \nATOM 2432 CA VAL A 306 -12.610 3.819 -24.832 1.00 86.02 C \nANISOU 2432 CA VAL A 306 10205 9642 12835 -787 -199 -107 C \nATOM 2433 C VAL A 306 -13.875 3.014 -24.898 1.00 78.09 C \nANISOU 2433 C VAL A 306 9284 8610 11776 -778 -132 -123 C \nATOM 2434 O VAL A 306 -14.913 3.600 -25.029 1.00 70.10 O \nANISOU 2434 O VAL A 306 8298 7571 10767 -816 -117 -145 O \nATOM 2435 CB VAL A 306 -12.192 4.014 -23.373 1.00 82.01 C \nANISOU 2435 CB VAL A 306 9688 9153 12319 -831 -244 -87 C \nATOM 2436 CG1 VAL A 306 -10.682 3.918 -23.287 1.00 82.21 C \nANISOU 2436 CG1 VAL A 306 9661 9211 12362 -814 -290 -60 C \nATOM 2437 CG2 VAL A 306 -12.682 5.359 -22.857 1.00 74.92 C \nANISOU 2437 CG2 VAL A 306 8766 8244 11455 -893 -282 -98 C \nATOM 2438 N LYS A 307 -13.780 1.687 -24.826 1.00 85.48 N \nANISOU 2438 N LYS A 307 10265 9556 12658 -728 -94 -113 N \nATOM 2439 CA LYS A 307 -14.978 0.846 -24.882 1.00109.72 C \nANISOU 2439 CA LYS A 307 13429 12591 15668 -709 -28 -127 C \nATOM 2440 C LYS A 307 -15.486 0.333 -23.524 1.00115.46 C \nANISOU 2440 C LYS A 307 14217 13312 16339 -734 -17 -124 C \nATOM 2441 O LYS A 307 -16.131 -0.712 -23.450 1.00128.40 O \nANISOU 2441 O LYS A 307 15938 14932 17916 -696 36 -129 O \nATOM 2442 CB LYS A 307 -14.790 -0.290 -25.878 1.00119.75 C \nANISOU 2442 CB LYS A 307 14723 13870 16907 -624 18 -123 C \nATOM 2443 CG LYS A 307 -13.811 -1.384 -25.491 1.00125.41 C \nANISOU 2443 CG LYS A 307 15424 14641 17587 -570 17 -98 C \nATOM 2444 CD LYS A 307 -13.746 -2.434 -26.613 1.00128.83 C \nANISOU 2444 CD LYS A 307 15875 15087 17986 -483 65 -96 C \nATOM 2445 CE LYS A 307 -14.096 -1.858 -27.993 1.00128.34 C \nANISOU 2445 CE LYS A 307 15804 14994 17966 -477 79 -113 C \nATOM 2446 NZ LYS A 307 -14.029 -2.845 -29.097 1.00133.54 N \nANISOU 2446 NZ LYS A 307 16480 15667 18592 -393 124 -109 N \nATOM 2447 N SER A 308 -15.211 1.091 -22.466 1.00119.82 N \nANISOU 2447 N SER A 308 14733 13879 16913 -797 -68 -117 N \nATOM 2448 CA SER A 308 -15.764 0.822 -21.134 1.00118.98 C \nANISOU 2448 CA SER A 308 14681 13766 16760 -837 -63 -117 C \nATOM 2449 C SER A 308 -17.128 1.476 -21.012 1.00114.54 C \nANISOU 2449 C SER A 308 14173 13159 16190 -901 -43 -143 C \nATOM 2450 O SER A 308 -17.402 2.457 -21.699 1.00102.28 O \nANISOU 2450 O SER A 308 12584 11596 14681 -932 -56 -156 O \nATOM 2451 CB SER A 308 -14.866 1.406 -20.032 1.00116.36 C \nANISOU 2451 CB SER A 308 14284 13473 16453 -883 -129 -95 C \nATOM 2452 OG SER A 308 -13.575 0.814 -19.989 1.00113.72 O \nANISOU 2452 OG SER A 308 13905 13186 16119 -840 -151 -70 O \nATOM 2453 N ASN A 309 -17.967 0.934 -20.132 1.00111.05 N \nANISOU 2453 N ASN A 309 13815 12693 15686 -925 -12 -151 N \nATOM 2454 CA ASN A 309 -19.252 1.550 -19.804 1.00108.84 C \nANISOU 2454 CA ASN A 309 13591 12375 15387 -1004 4 -175 C \nATOM 2455 C ASN A 309 -19.166 2.482 -18.609 1.00106.84 C \nANISOU 2455 C ASN A 309 13293 12149 15152 -1086 -50 -169 C \nATOM 2456 O ASN A 309 -20.010 3.351 -18.442 1.00102.13 O \nANISOU 2456 O ASN A 309 12704 11542 14557 -1162 -55 -187 O \nATOM 2457 CB ASN A 309 -20.310 0.485 -19.538 1.00112.47 C \nANISOU 2457 CB ASN A 309 14182 12786 15766 -990 70 -189 C \nATOM 2458 CG ASN A 309 -20.745 -0.220 -20.808 1.00117.97 C \nANISOU 2458 CG ASN A 309 14937 13444 16441 -922 126 -200 C \nATOM 2459 OD1 ASN A 309 -20.850 0.399 -21.868 1.00114.97 O \nANISOU 2459 OD1 ASN A 309 14524 13059 16103 -928 125 -209 O \nATOM 2460 ND2 ASN A 309 -20.997 -1.517 -20.708 1.00119.27 N \nANISOU 2460 ND2 ASN A 309 15193 13585 16539 -854 176 -199 N \nATOM 2461 N LYS A 310 -18.131 2.297 -17.792 1.00106.86 N \nANISOU 2461 N LYS A 310 13248 12192 15163 -1073 -90 -144 N \nATOM 2462 CA LYS A 310 -18.000 3.011 -16.533 1.00 96.59 C \nANISOU 2462 CA LYS A 310 11914 10918 13868 -1144 -139 -135 C \nATOM 2463 C LYS A 310 -16.533 3.302 -16.201 1.00 92.84 C \nANISOU 2463 C LYS A 310 11347 10491 13438 -1127 -203 -104 C \nATOM 2464 O LYS A 310 -15.702 2.388 -16.123 1.00 99.10 O \nANISOU 2464 O LYS A 310 12136 11304 14214 -1073 -199 -86 O \nATOM 2465 CB LYS A 310 -18.637 2.169 -15.425 1.00 92.66 C \nANISOU 2465 CB LYS A 310 11506 10406 13297 -1164 -107 -139 C \nATOM 2466 CG LYS A 310 -18.678 2.844 -14.065 1.00 92.37 C \nANISOU 2466 CG LYS A 310 11447 10393 13255 -1246 -151 -132 C \nATOM 2467 CD LYS A 310 -18.948 1.837 -12.964 1.00 90.73 C \nANISOU 2467 CD LYS A 310 11315 10180 12976 -1247 -123 -132 C \nATOM 2468 CE LYS A 310 -18.919 2.504 -11.599 1.00 92.94 C \nANISOU 2468 CE LYS A 310 11569 10490 13252 -1330 -170 -122 C \nATOM 2469 NZ LYS A 310 -19.565 1.637 -10.577 1.00 99.72 N \nANISOU 2469 NZ LYS A 310 12521 11333 14033 -1347 -132 -132 N \nATOM 2470 N LEU A 311 -16.222 4.579 -16.008 1.00 82.10 N \nANISOU 2470 N LEU A 311 9914 9150 12129 -1174 -262 -98 N \nATOM 2471 CA LEU A 311 -14.952 4.974 -15.394 1.00 89.21 C \nANISOU 2471 CA LEU A 311 10745 10089 13063 -1176 -328 -68 C \nATOM 2472 C LEU A 311 -15.223 6.004 -14.318 1.00 83.57 C \nANISOU 2472 C LEU A 311 10006 9392 12356 -1253 -375 -64 C \nATOM 2473 O LEU A 311 -15.348 7.205 -14.621 1.00 80.67 O \nANISOU 2473 O LEU A 311 9586 9031 12032 -1278 -408 -70 O \nATOM 2474 CB LEU A 311 -13.956 5.557 -16.420 1.00 91.12 C \nANISOU 2474 CB LEU A 311 10913 10339 13369 -1134 -363 -58 C \nATOM 2475 CG LEU A 311 -13.430 4.580 -17.487 1.00 97.61 C \nANISOU 2475 CG LEU A 311 11744 11157 14188 -1058 -327 -56 C \nATOM 2476 CD1 LEU A 311 -12.520 5.302 -18.476 1.00 95.96 C \nANISOU 2476 CD1 LEU A 311 11466 10954 14043 -1029 -364 -50 C \nATOM 2477 CD2 LEU A 311 -12.708 3.380 -16.883 1.00 98.30 C \nANISOU 2477 CD2 LEU A 311 11849 11271 14229 -1029 -319 -35 C \nATOM 2478 N VAL A 312 -15.264 5.537 -13.066 1.00 77.68 N \nANISOU 2478 N VAL A 312 9291 8659 11565 -1286 -379 -53 N \nATOM 2479 CA VAL A 312 -15.532 6.421 -11.906 1.00 74.76 C \nANISOU 2479 CA VAL A 312 8902 8310 11193 -1362 -423 -47 C \nATOM 2480 C VAL A 312 -14.457 6.346 -10.799 1.00 73.97 C \nANISOU 2480 C VAL A 312 8771 8243 11090 -1374 -476 -13 C \nATOM 2481 O VAL A 312 -14.202 5.293 -10.218 1.00 75.48 O \nANISOU 2481 O VAL A 312 9000 8443 11237 -1361 -455 -4 O \nATOM 2482 CB VAL A 312 -16.910 6.123 -11.296 1.00 64.21 C \nANISOU 2482 CB VAL A 312 7644 6957 9796 -1418 -376 -71 C \nATOM 2483 CG1 VAL A 312 -17.184 7.045 -10.130 1.00 58.70 C \nANISOU 2483 CG1 VAL A 312 6920 6289 9094 -1500 -422 -65 C \nATOM 2484 CG2 VAL A 312 -17.985 6.295 -12.355 1.00 58.96 C \nANISOU 2484 CG2 VAL A 312 7013 6260 9130 -1420 -328 -104 C \nATOM 2485 N LEU A 313 -13.857 7.484 -10.505 1.00 69.16 N \nANISOU 2485 N LEU A 313 8095 7657 10526 -1397 -544 6 N \nATOM 2486 CA LEU A 313 -12.799 7.534 -9.512 1.00 75.20 C \nANISOU 2486 CA LEU A 313 8833 8450 11291 -1412 -600 40 C \nATOM 2487 C LEU A 313 -13.397 7.865 -8.155 1.00 82.79 C \nANISOU 2487 C LEU A 313 9808 9431 12217 -1486 -617 43 C \nATOM 2488 O LEU A 313 -14.075 8.888 -7.992 1.00 82.38 O \nANISOU 2488 O LEU A 313 9734 9387 12178 -1530 -636 33 O \nATOM 2489 CB LEU A 313 -11.746 8.603 -9.866 1.00 67.87 C \nANISOU 2489 CB LEU A 313 7833 7527 10425 -1394 -669 62 C \nATOM 2490 CG LEU A 313 -10.903 8.340 -11.108 1.00 68.02 C \nANISOU 2490 CG LEU A 313 7833 7530 10480 -1327 -664 65 C \nATOM 2491 CD1 LEU A 313 -10.317 9.649 -11.626 1.00 61.81 C \nANISOU 2491 CD1 LEU A 313 6988 6740 9756 -1311 -722 72 C \nATOM 2492 CD2 LEU A 313 -9.813 7.302 -10.811 1.00 69.84 C \nANISOU 2492 CD2 LEU A 313 8075 7775 10684 -1307 -667 90 C \nATOM 2493 N ALA A 314 -13.124 7.024 -7.167 1.00 79.97 N \nANISOU 2493 N ALA A 314 9482 9088 11812 -1503 -613 57 N \nATOM 2494 CA ALA A 314 -13.484 7.360 -5.805 1.00 80.29 C \nANISOU 2494 CA ALA A 314 9530 9153 11822 -1574 -639 65 C \nATOM 2495 C ALA A 314 -12.607 8.516 -5.364 1.00 73.20 C \nANISOU 2495 C ALA A 314 8565 8280 10968 -1594 -722 97 C \nATOM 2496 O ALA A 314 -11.400 8.493 -5.557 1.00 78.31 O \nANISOU 2496 O ALA A 314 9183 8930 11642 -1560 -760 123 O \nATOM 2497 CB ALA A 314 -13.267 6.171 -4.898 1.00 87.59 C \nANISOU 2497 CB ALA A 314 10501 10093 12687 -1580 -616 74 C \nATOM 2498 N THR A 315 -13.222 9.522 -4.767 1.00 65.04 N \nANISOU 2498 N THR A 315 7511 7266 9937 -1649 -752 94 N \nATOM 2499 CA THR A 315 -12.499 10.629 -4.143 1.00 66.47 C \nANISOU 2499 CA THR A 315 7634 7473 10148 -1669 -833 126 C \nATOM 2500 C THR A 315 -12.721 10.656 -2.617 1.00 75.21 C \nANISOU 2500 C THR A 315 8754 8613 11208 -1741 -857 141 C \nATOM 2501 O THR A 315 -11.812 10.934 -1.844 1.00 81.53 O \nANISOU 2501 O THR A 315 9532 9432 12013 -1754 -915 176 O \nATOM 2502 CB THR A 315 -12.944 11.977 -4.749 1.00 66.01 C \nANISOU 2502 CB THR A 315 7523 7424 10133 -1666 -859 114 C \nATOM 2503 OG1 THR A 315 -14.378 12.174 -4.607 1.00 58.20 O \nANISOU 2503 OG1 THR A 315 6553 6449 9111 -1720 -819 82 O \nATOM 2504 CG2 THR A 315 -12.560 12.014 -6.233 1.00 62.63 C \nANISOU 2504 CG2 THR A 315 7078 6965 9753 -1593 -844 103 C \nATOM 2505 N GLY A 316 -13.941 10.371 -2.195 1.00 76.41 N \nANISOU 2505 N GLY A 316 8947 8770 11313 -1792 -810 114 N \nATOM 2506 CA GLY A 316 -14.278 10.369 -0.792 1.00 75.02 C \nANISOU 2506 CA GLY A 316 8789 8626 11090 -1864 -826 123 C \nATOM 2507 C GLY A 316 -14.116 9.004 -0.148 1.00 76.34 C \nANISOU 2507 C GLY A 316 9017 8788 11203 -1868 -788 124 C \nATOM 2508 O GLY A 316 -13.344 8.164 -0.639 1.00 72.64 O \nANISOU 2508 O GLY A 316 8557 8302 10738 -1810 -772 132 O \nATOM 2509 N LEU A 317 -14.910 8.779 0.909 1.00 71.69 N \nANISOU 2509 N LEU A 317 8467 8215 10556 -1935 -770 113 N \nATOM 2510 CA LEU A 317 -14.769 7.642 1.809 1.00 77.13 C \nANISOU 2510 CA LEU A 317 9208 8912 11186 -1949 -745 117 C \nATOM 2511 C LEU A 317 -15.818 6.552 1.629 1.00 73.94 C \nANISOU 2511 C LEU A 317 8891 8476 10726 -1943 -659 77 C \nATOM 2512 O LEU A 317 -16.913 6.819 1.209 1.00 84.65 O \nANISOU 2512 O LEU A 317 10277 9810 12074 -1966 -623 47 O \nATOM 2513 CB LEU A 317 -14.843 8.131 3.252 1.00 79.26 C \nANISOU 2513 CB LEU A 317 9466 9224 11425 -2030 -789 135 C \nATOM 2514 CG LEU A 317 -13.984 9.360 3.554 1.00 86.56 C \nANISOU 2514 CG LEU A 317 10313 10180 12398 -2042 -878 175 C \nATOM 2515 CD1 LEU A 317 -14.821 10.638 3.610 1.00 83.12 C \nANISOU 2515 CD1 LEU A 317 9841 9765 11976 -2089 -903 165 C \nATOM 2516 CD2 LEU A 317 -13.219 9.160 4.853 1.00 87.19 C \nANISOU 2516 CD2 LEU A 317 10387 10294 12446 -2080 -922 209 C \nATOM 2517 N ARG A 318 -15.472 5.327 1.986 1.00 69.22 N \nANISOU 2517 N ARG A 318 8335 7881 10084 -1914 -627 78 N \nATOM 2518 CA ARG A 318 -16.450 4.258 2.092 1.00 72.83 C \nANISOU 2518 CA ARG A 318 8886 8310 10475 -1909 -549 43 C \nATOM 2519 C ARG A 318 -17.648 4.748 2.889 1.00 81.37 C \nANISOU 2519 C ARG A 318 10009 9391 11518 -2000 -540 22 C \nATOM 2520 O ARG A 318 -17.493 5.205 4.013 1.00 79.30 O \nANISOU 2520 O ARG A 318 9722 9168 11240 -2065 -584 40 O \nATOM 2521 CB ARG A 318 -15.856 3.031 2.787 1.00 65.19 C \nANISOU 2521 CB ARG A 318 7947 7369 9455 -1881 -531 52 C \nATOM 2522 CG ARG A 318 -14.926 2.213 1.915 1.00 62.76 C \nANISOU 2522 CG ARG A 318 7621 7064 9162 -1788 -516 63 C \nATOM 2523 CD ARG A 318 -14.389 1.019 2.686 1.00 69.89 C \nANISOU 2523 CD ARG A 318 8544 8007 10002 -1766 -498 71 C \nATOM 2524 NE ARG A 318 -13.280 0.340 2.031 1.00 74.20 N \nANISOU 2524 NE ARG A 318 9053 8581 10560 -1693 -499 89 N \nATOM 2525 CZ ARG A 318 -13.395 -0.684 1.199 1.00 78.41 C \nANISOU 2525 CZ ARG A 318 9620 9102 11069 -1610 -440 71 C \nATOM 2526 NH1 ARG A 318 -14.575 -1.195 0.909 1.00 86.92 N \nANISOU 2526 NH1 ARG A 318 10781 10134 12111 -1583 -372 34 N \nATOM 2527 NH2 ARG A 318 -12.316 -1.218 0.670 1.00 84.42 N \nANISOU 2527 NH2 ARG A 318 10336 9901 11838 -1554 -448 91 N \nATOM 2528 N ASN A 319 -18.844 4.634 2.319 1.00 92.31 N \nANISOU 2528 N ASN A 319 11460 10732 12881 -2009 -482 -16 N \nATOM 2529 CA ASN A 319 -20.056 5.167 2.963 1.00 94.55 C \nANISOU 2529 CA ASN A 319 11785 11015 13124 -2106 -471 -39 C \nATOM 2530 C ASN A 319 -21.201 4.165 2.984 1.00 97.22 C \nANISOU 2530 C ASN A 319 12251 11301 13388 -2112 -388 -79 C \nATOM 2531 O ASN A 319 -22.102 4.204 2.152 1.00 92.62 O \nANISOU 2531 O ASN A 319 11720 10673 12799 -2114 -344 -108 O \nATOM 2532 CB ASN A 319 -20.482 6.440 2.248 1.00 92.53 C \nANISOU 2532 CB ASN A 319 11476 10765 12917 -2139 -497 -43 C \nATOM 2533 CG ASN A 319 -21.762 7.011 2.794 1.00 85.87 C \nANISOU 2533 CG ASN A 319 10671 9930 12027 -2245 -484 -68 C \nATOM 2534 OD1 ASN A 319 -22.029 6.939 3.987 1.00 96.72 O \nANISOU 2534 OD1 ASN A 319 12071 11328 13352 -2312 -491 -67 O \nATOM 2535 ND2 ASN A 319 -22.579 7.563 1.910 1.00 80.13 N \nANISOU 2535 ND2 ASN A 319 9949 9185 11311 -2266 -462 -92 N \nATOM 2536 N SER A 320 -21.121 3.223 3.914 1.00111.03 N \nANISOU 2536 N SER A 320 14055 13055 15077 -2109 -367 -81 N \nATOM 2537 CA SER A 320 -22.247 2.332 4.189 1.00120.46 C \nANISOU 2537 CA SER A 320 15380 14200 16190 -2123 -292 -120 C \nATOM 2538 C SER A 320 -22.992 2.825 5.439 1.00121.97 C \nANISOU 2538 C SER A 320 15600 14413 16331 -2242 -305 -130 C \nATOM 2539 O SER A 320 -22.351 3.272 6.405 1.00113.15 O \nANISOU 2539 O SER A 320 14414 13355 15222 -2284 -362 -102 O \nATOM 2540 CB SER A 320 -21.778 0.885 4.371 1.00119.85 C \nANISOU 2540 CB SER A 320 15355 14115 16067 -2034 -251 -122 C \nATOM 2541 OG SER A 320 -22.811 0.090 4.931 1.00122.59 O \nANISOU 2541 OG SER A 320 15831 14421 16328 -2055 -188 -158 O \nATOM 2542 N PRO A 321 -24.342 2.787 5.405 1.00123.58 N \nANISOU 2542 N PRO A 321 15906 14569 16480 -2302 -253 -168 N \nATOM 2543 CA PRO A 321 -25.162 2.980 6.617 1.00129.03 C \nANISOU 2543 CA PRO A 321 16652 15272 17103 -2414 -249 -184 C \nATOM 2544 C PRO A 321 -25.296 1.679 7.424 1.00120.80 C \nANISOU 2544 C PRO A 321 15713 14204 15981 -2386 -200 -201 C \nATOM 2545 O PRO A 321 -26.394 1.296 7.823 1.00121.71 O \nANISOU 2545 O PRO A 321 15948 14274 16020 -2439 -149 -237 O \nATOM 2546 CB PRO A 321 -26.523 3.465 6.065 1.00127.10 C \nANISOU 2546 CB PRO A 321 16476 14983 16831 -2489 -211 -220 C \nATOM 2547 CG PRO A 321 -26.294 3.745 4.611 1.00132.97 C \nANISOU 2547 CG PRO A 321 17175 15706 17642 -2421 -210 -216 C \nATOM 2548 CD PRO A 321 -25.169 2.844 4.191 1.00127.32 C \nANISOU 2548 CD PRO A 321 16434 14983 16960 -2289 -207 -196 C \nTER 2549 PRO A 321 \nATOM 2550 N ILE B 10 -14.693 3.451 12.775 1.00 98.50 N \nANISOU 2550 N ILE B 10 12185 11944 13298 -1318 -779 -14 N \nATOM 2551 CA ILE B 10 -14.439 1.974 12.661 1.00 96.54 C \nANISOU 2551 CA ILE B 10 11963 11743 12975 -1172 -805 -52 C \nATOM 2552 C ILE B 10 -15.745 1.157 12.671 1.00109.89 C \nANISOU 2552 C ILE B 10 13864 13327 14561 -1085 -863 -78 C \nATOM 2553 O ILE B 10 -15.880 0.170 11.945 1.00131.03 O \nANISOU 2553 O ILE B 10 16628 15995 17163 -964 -896 -111 O \nATOM 2554 CB ILE B 10 -13.431 1.452 13.718 1.00 86.39 C \nANISOU 2554 CB ILE B 10 10547 10605 11672 -1118 -796 -66 C \nATOM 2555 CG1 ILE B 10 -13.873 0.097 14.305 1.00 81.91 C \nANISOU 2555 CG1 ILE B 10 10043 10096 10984 -945 -840 -116 C \nATOM 2556 CG2 ILE B 10 -13.224 2.483 14.809 1.00 85.96 C \nANISOU 2556 CG2 ILE B 10 10433 10548 11681 -1221 -777 -37 C \nATOM 2557 CD1 ILE B 10 -12.797 -0.649 15.069 1.00 79.19 C \nANISOU 2557 CD1 ILE B 10 9534 9975 10580 -884 -831 -139 C \nATOM 2558 N GLU B 11 -16.709 1.578 13.476 1.00107.55 N \nANISOU 2558 N GLU B 11 13676 12945 14246 -1145 -886 -66 N \nATOM 2559 CA GLU B 11 -18.035 0.967 13.460 1.00105.55 C \nANISOU 2559 CA GLU B 11 13687 12545 13872 -1103 -959 -81 C \nATOM 2560 C GLU B 11 -18.867 1.492 12.287 1.00101.41 C \nANISOU 2560 C GLU B 11 13298 11908 13326 -1248 -973 -50 C \nATOM 2561 O GLU B 11 -20.010 1.066 12.091 1.00110.87 O \nANISOU 2561 O GLU B 11 14765 12958 14403 -1261 -1046 -53 O \nATOM 2562 CB GLU B 11 -18.741 1.232 14.793 1.00112.40 C \nANISOU 2562 CB GLU B 11 14632 13365 14709 -1143 -984 -74 C \nATOM 2563 CG GLU B 11 -18.014 0.694 16.020 1.00119.89 C \nANISOU 2563 CG GLU B 11 15457 14435 15661 -1007 -975 -105 C \nATOM 2564 CD GLU B 11 -17.750 -0.807 15.979 1.00121.49 C \nANISOU 2564 CD GLU B 11 15705 14707 15749 -756 -1022 -170 C \nATOM 2565 OE1 GLU B 11 -18.664 -1.581 16.363 1.00120.68 O \nANISOU 2565 OE1 GLU B 11 15834 14507 15512 -621 -1103 -207 O \nATOM 2566 OE2 GLU B 11 -16.623 -1.218 15.595 1.00120.50 O \nANISOU 2566 OE2 GLU B 11 15391 14749 15644 -689 -985 -187 O \nATOM 2567 N GLY B 12 -18.281 2.398 11.500 1.00 97.18 N \nANISOU 2567 N GLY B 12 12595 11444 12886 -1357 -912 -23 N \nATOM 2568 CA GLY B 12 -18.970 3.093 10.420 1.00 99.41 C \nANISOU 2568 CA GLY B 12 12943 11679 13147 -1518 -912 9 C \nATOM 2569 C GLY B 12 -18.678 4.584 10.483 1.00103.90 C \nANISOU 2569 C GLY B 12 13316 12364 13799 -1663 -851 39 C \nATOM 2570 O GLY B 12 -18.029 5.058 11.421 1.00 99.47 O \nANISOU 2570 O GLY B 12 12609 11878 13306 -1637 -820 38 O \nATOM 2571 N GLY B 13 -19.163 5.319 9.483 1.00102.21 N \nANISOU 2571 N GLY B 13 13101 12177 13557 -1803 -842 62 N \nATOM 2572 CA GLY B 13 -18.952 6.772 9.397 1.00100.43 C \nANISOU 2572 CA GLY B 13 12684 12103 13371 -1906 -793 78 C \nATOM 2573 C GLY B 13 -19.957 7.608 10.187 1.00 94.76 C \nANISOU 2573 C GLY B 13 11978 11448 12580 -2069 -802 100 C \nATOM 2574 O GLY B 13 -21.015 7.124 10.572 1.00 90.46 O \nANISOU 2574 O GLY B 13 11632 10804 11936 -2161 -852 116 O \nATOM 2575 N TRP B 14 -19.607 8.868 10.437 1.00 97.22 N \nANISOU 2575 N TRP B 14 12091 11928 12921 -2096 -762 99 N \nATOM 2576 CA TRP B 14 -20.455 9.790 11.225 1.00 87.73 C \nANISOU 2576 CA TRP B 14 10848 10846 11641 -2243 -763 115 C \nATOM 2577 C TRP B 14 -21.377 10.557 10.289 1.00 87.49 C \nANISOU 2577 C TRP B 14 10791 10971 11479 -2447 -763 135 C \nATOM 2578 O TRP B 14 -20.989 11.603 9.735 1.00 80.42 O \nANISOU 2578 O TRP B 14 9697 10281 10577 -2430 -728 118 O \nATOM 2579 CB TRP B 14 -19.649 10.864 11.988 1.00 81.86 C \nANISOU 2579 CB TRP B 14 9895 10246 10961 -2150 -727 93 C \nATOM 2580 CG TRP B 14 -18.673 10.518 13.070 1.00 79.70 C \nANISOU 2580 CG TRP B 14 9600 9887 10794 -1993 -724 78 C \nATOM 2581 CD1 TRP B 14 -17.569 11.286 13.474 1.00 78.23 C \nANISOU 2581 CD1 TRP B 14 9278 9772 10674 -1870 -706 56 C \nATOM 2582 CD2 TRP B 14 -18.688 9.373 13.919 1.00 81.77 C \nANISOU 2582 CD2 TRP B 14 9989 9994 11085 -1943 -746 81 C \nATOM 2583 NE1 TRP B 14 -16.923 10.664 14.511 1.00 80.69 N \nANISOU 2583 NE1 TRP B 14 9625 9981 11055 -1787 -713 54 N \nATOM 2584 CE2 TRP B 14 -17.569 9.484 14.792 1.00 85.22 C \nANISOU 2584 CE2 TRP B 14 10334 10436 11608 -1820 -732 66 C \nATOM 2585 CE3 TRP B 14 -19.509 8.239 14.010 1.00 79.31 C \nANISOU 2585 CE3 TRP B 14 9877 9541 10714 -1975 -787 89 C \nATOM 2586 CZ2 TRP B 14 -17.266 8.506 15.739 1.00 83.85 C \nANISOU 2586 CZ2 TRP B 14 10221 10173 11464 -1746 -746 61 C \nATOM 2587 CZ3 TRP B 14 -19.201 7.271 14.949 1.00 81.65 C \nANISOU 2587 CZ3 TRP B 14 10241 9743 11038 -1857 -807 75 C \nATOM 2588 CH2 TRP B 14 -18.098 7.409 15.809 1.00 82.52 C \nANISOU 2588 CH2 TRP B 14 10216 9902 11237 -1753 -781 62 C \nATOM 2589 N GLN B 15 -22.604 10.070 10.134 1.00 88.03 N \nANISOU 2589 N GLN B 15 11071 10959 11417 -2642 -811 168 N \nATOM 2590 CA GLN B 15 -23.610 10.806 9.387 1.00 90.13 C \nANISOU 2590 CA GLN B 15 11323 11404 11517 -2903 -818 197 C \nATOM 2591 C GLN B 15 -23.663 12.271 9.849 1.00 89.56 C \nANISOU 2591 C GLN B 15 10983 11654 11393 -2968 -777 187 C \nATOM 2592 O GLN B 15 -24.011 13.173 9.069 1.00 83.33 O \nANISOU 2592 O GLN B 15 10044 11131 10485 -3100 -758 189 O \nATOM 2593 CB GLN B 15 -24.971 10.148 9.556 1.00 98.24 C \nANISOU 2593 CB GLN B 15 12663 12281 12381 -3140 -894 242 C \nATOM 2594 CG GLN B 15 -26.043 10.707 8.617 1.00101.74 C \nANISOU 2594 CG GLN B 15 13147 12892 12620 -3465 -915 284 C \nATOM 2595 CD GLN B 15 -25.784 10.475 7.119 1.00108.69 C \nANISOU 2595 CD GLN B 15 14031 13764 13501 -3450 -908 281 C \nATOM 2596 OE1 GLN B 15 -25.041 9.572 6.701 1.00100.38 O \nANISOU 2596 OE1 GLN B 15 13057 12505 12577 -3225 -910 256 O \nATOM 2597 NE2 GLN B 15 -26.402 11.316 6.298 1.00115.48 N \nANISOU 2597 NE2 GLN B 15 14788 14886 14201 -3699 -898 305 N \nATOM 2598 N GLY B 16 -23.307 12.489 11.118 1.00 86.77 N \nANISOU 2598 N GLY B 16 10563 11294 11110 -2860 -766 172 N \nATOM 2599 CA GLY B 16 -23.379 13.786 11.746 1.00 85.33 C \nANISOU 2599 CA GLY B 16 10153 11398 10869 -2889 -737 155 C \nATOM 2600 C GLY B 16 -22.191 14.702 11.534 1.00 93.01 C \nANISOU 2600 C GLY B 16 10879 12538 11923 -2648 -696 102 C \nATOM 2601 O GLY B 16 -22.260 15.863 11.924 1.00 94.95 O \nANISOU 2601 O GLY B 16 10929 13059 12089 -2638 -681 76 O \nATOM 2602 N MET B 17 -21.101 14.221 10.931 1.00 96.92 N \nANISOU 2602 N MET B 17 11393 12880 12553 -2447 -688 81 N \nATOM 2603 CA MET B 17 -19.946 15.087 10.731 1.00 91.64 C \nANISOU 2603 CA MET B 17 10551 12332 11938 -2218 -669 30 C \nATOM 2604 C MET B 17 -19.953 15.711 9.353 1.00 89.71 C \nANISOU 2604 C MET B 17 10190 12290 11608 -2222 -657 10 C \nATOM 2605 O MET B 17 -19.530 15.107 8.374 1.00 95.64 O \nANISOU 2605 O MET B 17 11010 12910 12418 -2179 -656 14 O \nATOM 2606 CB MET B 17 -18.619 14.383 10.959 1.00 94.86 C \nANISOU 2606 CB MET B 17 11038 12489 12515 -2008 -673 18 C \nATOM 2607 CG MET B 17 -17.464 15.380 10.827 1.00 94.43 C \nANISOU 2607 CG MET B 17 10862 12537 12479 -1789 -676 -31 C \nATOM 2608 SD MET B 17 -15.932 14.854 11.545 1.00 83.59 S \nANISOU 2608 SD MET B 17 9588 10917 11254 -1601 -696 -39 S \nATOM 2609 CE MET B 17 -15.721 13.332 10.611 1.00 93.12 C \nANISOU 2609 CE MET B 17 10926 11911 12545 -1650 -688 -7 C \nATOM 2610 N VAL B 18 -20.422 16.940 9.302 1.00 97.10 N \nANISOU 2610 N VAL B 18 10932 13572 12390 -2262 -649 -16 N \nATOM 2611 CA VAL B 18 -20.580 17.692 8.063 1.00106.11 C \nANISOU 2611 CA VAL B 18 11920 14997 13402 -2276 -639 -43 C \nATOM 2612 C VAL B 18 -19.382 18.623 7.841 1.00111.64 C \nANISOU 2612 C VAL B 18 12485 15813 14118 -1952 -645 -117 C \nATOM 2613 O VAL B 18 -19.214 19.183 6.761 1.00127.41 O \nANISOU 2613 O VAL B 18 14372 18007 16033 -1879 -643 -152 O \nATOM 2614 CB VAL B 18 -21.891 18.535 8.102 1.00108.80 C \nANISOU 2614 CB VAL B 18 12103 15731 13505 -2530 -632 -34 C \nATOM 2615 CG1 VAL B 18 -23.084 17.647 8.462 1.00106.16 C \nANISOU 2615 CG1 VAL B 18 11966 15242 13126 -2865 -647 43 C \nATOM 2616 CG2 VAL B 18 -21.787 19.703 9.085 1.00105.72 C \nANISOU 2616 CG2 VAL B 18 11517 15620 13030 -2402 -632 -85 C \nATOM 2617 N ASP B 19 -18.565 18.784 8.874 1.00110.47 N \nANISOU 2617 N ASP B 19 12373 15538 14062 -1757 -663 -141 N \nATOM 2618 CA ASP B 19 -17.473 19.763 8.898 1.00114.42 C \nANISOU 2618 CA ASP B 19 12803 16131 14542 -1443 -693 -215 C \nATOM 2619 C ASP B 19 -16.223 19.344 8.078 1.00119.32 C \nANISOU 2619 C ASP B 19 13552 16509 15276 -1263 -715 -227 C \nATOM 2620 O ASP B 19 -15.383 20.181 7.719 1.00110.14 O \nANISOU 2620 O ASP B 19 12363 15431 14057 -1011 -754 -290 O \nATOM 2621 CB ASP B 19 -17.050 20.006 10.361 1.00121.88 C \nANISOU 2621 CB ASP B 19 13789 16984 15534 -1331 -716 -227 C \nATOM 2622 CG ASP B 19 -18.175 20.586 11.213 1.00123.38 C \nANISOU 2622 CG ASP B 19 13839 17442 15596 -1476 -700 -225 C \nATOM 2623 OD1 ASP B 19 -19.182 21.057 10.636 1.00130.80 O \nANISOU 2623 OD1 ASP B 19 14620 18708 16371 -1638 -679 -226 O \nATOM 2624 OD2 ASP B 19 -18.039 20.571 12.458 1.00120.99 O \nANISOU 2624 OD2 ASP B 19 13585 17038 15346 -1445 -711 -220 O \nATOM 2625 N GLY B 20 -16.085 18.048 7.799 1.00112.74 N \nANISOU 2625 N GLY B 20 12872 15379 14584 -1381 -699 -171 N \nATOM 2626 CA GLY B 20 -14.885 17.539 7.132 1.00101.22 C \nANISOU 2626 CA GLY B 20 11538 13690 13230 -1246 -719 -174 C \nATOM 2627 C GLY B 20 -14.919 16.054 6.824 1.00 94.23 C \nANISOU 2627 C GLY B 20 10789 12545 12471 -1390 -697 -116 C \nATOM 2628 O GLY B 20 -15.965 15.409 6.932 1.00 93.10 O \nANISOU 2628 O GLY B 20 10665 12389 12322 -1586 -673 -75 O \nATOM 2629 N TRP B 21 -13.758 15.510 6.469 1.00 85.18 N \nANISOU 2629 N TRP B 21 9754 11194 11418 -1287 -716 -114 N \nATOM 2630 CA TRP B 21 -13.651 14.084 6.121 1.00 88.66 C \nANISOU 2630 CA TRP B 21 10304 11423 11959 -1383 -700 -70 C \nATOM 2631 C TRP B 21 -13.315 13.217 7.309 1.00 77.47 C \nANISOU 2631 C TRP B 21 8977 9832 10625 -1408 -704 -44 C \nATOM 2632 O TRP B 21 -13.862 12.135 7.458 1.00 69.48 O \nANISOU 2632 O TRP B 21 8023 8728 9648 -1510 -689 -14 O \nATOM 2633 CB TRP B 21 -12.603 13.867 5.027 1.00100.63 C \nANISOU 2633 CB TRP B 21 11875 12850 13511 -1288 -714 -80 C \nATOM 2634 CG TRP B 21 -13.110 14.108 3.627 1.00111.53 C \nANISOU 2634 CG TRP B 21 13189 14353 14832 -1316 -698 -90 C \nATOM 2635 CD1 TRP B 21 -14.348 14.539 3.259 1.00116.05 C \nANISOU 2635 CD1 TRP B 21 13660 15126 15309 -1432 -674 -90 C \nATOM 2636 CD2 TRP B 21 -12.367 13.956 2.421 1.00114.58 C \nANISOU 2636 CD2 TRP B 21 13612 14687 15237 -1244 -707 -100 C \nATOM 2637 NE1 TRP B 21 -14.428 14.644 1.902 1.00118.04 N \nANISOU 2637 NE1 TRP B 21 13874 15456 15519 -1436 -666 -99 N \nATOM 2638 CE2 TRP B 21 -13.220 14.298 1.361 1.00114.79 C \nANISOU 2638 CE2 TRP B 21 13546 14885 15185 -1307 -685 -108 C \nATOM 2639 CE3 TRP B 21 -11.055 13.560 2.132 1.00119.86 C \nANISOU 2639 CE3 TRP B 21 14388 15188 15967 -1153 -735 -99 C \nATOM 2640 CZ2 TRP B 21 -12.809 14.260 0.029 1.00123.21 C \nANISOU 2640 CZ2 TRP B 21 14616 15951 16247 -1257 -686 -119 C \nATOM 2641 CZ3 TRP B 21 -10.645 13.518 0.801 1.00123.94 C \nANISOU 2641 CZ3 TRP B 21 14918 15698 16476 -1110 -739 -109 C \nATOM 2642 CH2 TRP B 21 -11.523 13.864 -0.232 1.00120.36 C \nANISOU 2642 CH2 TRP B 21 14364 15408 15959 -1149 -713 -121 C \nATOM 2643 N TYR B 22 -12.394 13.696 8.133 1.00 75.47 N \nANISOU 2643 N TYR B 22 8751 9539 10385 -1302 -735 -59 N \nATOM 2644 CA TYR B 22 -12.060 13.013 9.368 1.00 74.67 C \nANISOU 2644 CA TYR B 22 8714 9315 10341 -1333 -740 -36 C \nATOM 2645 C TYR B 22 -12.213 13.956 10.537 1.00 73.58 C \nANISOU 2645 C TYR B 22 8540 9254 10165 -1290 -757 -53 C \nATOM 2646 O TYR B 22 -12.095 15.178 10.380 1.00 77.57 O \nANISOU 2646 O TYR B 22 8996 9882 10595 -1179 -781 -92 O \nATOM 2647 CB TYR B 22 -10.625 12.525 9.346 1.00 80.65 C \nANISOU 2647 CB TYR B 22 9571 9932 11140 -1286 -771 -27 C \nATOM 2648 CG TYR B 22 -10.120 12.101 7.993 1.00 78.65 C \nANISOU 2648 CG TYR B 22 9348 9639 10897 -1276 -770 -25 C \nATOM 2649 CD1 TYR B 22 -9.127 12.822 7.348 1.00 72.31 C \nANISOU 2649 CD1 TYR B 22 8605 8812 10056 -1176 -814 -45 C \nATOM 2650 CD2 TYR B 22 -10.617 10.951 7.378 1.00 72.99 C \nANISOU 2650 CD2 TYR B 22 8623 8896 10215 -1354 -736 -5 C \nATOM 2651 CE1 TYR B 22 -8.644 12.419 6.122 1.00 71.02 C \nANISOU 2651 CE1 TYR B 22 8475 8607 9902 -1174 -815 -42 C \nATOM 2652 CE2 TYR B 22 -10.130 10.532 6.157 1.00 69.17 C \nANISOU 2652 CE2 TYR B 22 8163 8378 9740 -1343 -736 -4 C \nATOM 2653 CZ TYR B 22 -9.149 11.274 5.526 1.00 68.58 C \nANISOU 2653 CZ TYR B 22 8129 8288 9639 -1263 -770 -20 C \nATOM 2654 OH TYR B 22 -8.699 10.871 4.287 1.00 58.31 O \nANISOU 2654 OH TYR B 22 6854 6956 8346 -1259 -770 -18 O \nATOM 2655 N GLY B 23 -12.469 13.386 11.710 1.00 67.41 N \nANISOU 2655 N GLY B 23 7780 8411 9421 -1357 -749 -30 N \nATOM 2656 CA GLY B 23 -12.593 14.190 12.916 1.00 67.35 C \nANISOU 2656 CA GLY B 23 7745 8463 9383 -1322 -764 -43 C \nATOM 2657 C GLY B 23 -12.979 13.432 14.149 1.00 65.58 C \nANISOU 2657 C GLY B 23 7545 8172 9202 -1407 -751 -16 C \nATOM 2658 O GLY B 23 -12.780 12.216 14.238 1.00 57.40 O \nANISOU 2658 O GLY B 23 6565 7026 8217 -1456 -742 8 O \nATOM 2659 N TYR B 24 -13.579 14.144 15.095 1.00 72.70 N \nANISOU 2659 N TYR B 24 8394 9163 10065 -1413 -751 -25 N \nATOM 2660 CA TYR B 24 -13.827 13.585 16.436 1.00 73.56 C \nANISOU 2660 CA TYR B 24 8533 9208 10209 -1471 -747 -5 C \nATOM 2661 C TYR B 24 -15.279 13.669 16.846 1.00 71.66 C \nANISOU 2661 C TYR B 24 8249 9057 9923 -1583 -726 5 C \nATOM 2662 O TYR B 24 -16.073 14.385 16.234 1.00 85.61 O \nANISOU 2662 O TYR B 24 9940 10976 11612 -1631 -717 -6 O \nATOM 2663 CB TYR B 24 -12.998 14.331 17.464 1.00 73.51 C \nANISOU 2663 CB TYR B 24 8543 9190 10196 -1381 -781 -19 C \nATOM 2664 CG TYR B 24 -11.543 14.517 17.077 1.00 78.55 C \nANISOU 2664 CG TYR B 24 9273 9737 10835 -1286 -825 -28 C \nATOM 2665 CD1 TYR B 24 -11.132 15.637 16.349 1.00 77.93 C \nANISOU 2665 CD1 TYR B 24 9201 9721 10689 -1155 -860 -66 C \nATOM 2666 CD2 TYR B 24 -10.576 13.576 17.443 1.00 78.26 C \nANISOU 2666 CD2 TYR B 24 9326 9569 10840 -1333 -839 1 C \nATOM 2667 CE1 TYR B 24 -9.798 15.827 16.014 1.00 75.74 C \nANISOU 2667 CE1 TYR B 24 9061 9327 10389 -1072 -919 -73 C \nATOM 2668 CE2 TYR B 24 -9.245 13.752 17.113 1.00 80.81 C \nANISOU 2668 CE2 TYR B 24 9765 9802 11136 -1292 -890 2 C \nATOM 2669 CZ TYR B 24 -8.860 14.886 16.397 1.00 84.60 C \nANISOU 2669 CZ TYR B 24 10295 10298 11553 -1161 -935 -34 C \nATOM 2670 OH TYR B 24 -7.545 15.092 16.046 1.00 95.24 O \nANISOU 2670 OH TYR B 24 11810 11527 12851 -1121 -1004 -33 O \nATOM 2671 N HIS B 25 -15.623 12.909 17.870 1.00 64.47 N \nANISOU 2671 N HIS B 25 7391 8063 9041 -1638 -725 25 N \nATOM 2672 CA HIS B 25 -16.871 13.060 18.552 1.00 62.42 C \nANISOU 2672 CA HIS B 25 7125 7863 8727 -1747 -720 36 C \nATOM 2673 C HIS B 25 -16.634 12.862 20.019 1.00 64.92 C \nANISOU 2673 C HIS B 25 7464 8121 9081 -1722 -728 40 C \nATOM 2674 O HIS B 25 -16.244 11.772 20.446 1.00 67.87 O \nANISOU 2674 O HIS B 25 7910 8374 9504 -1700 -734 51 O \nATOM 2675 CB HIS B 25 -17.927 12.067 18.103 1.00 66.88 C \nANISOU 2675 CB HIS B 25 7797 8357 9259 -1867 -722 60 C \nATOM 2676 CG HIS B 25 -19.219 12.218 18.854 1.00 79.24 C \nANISOU 2676 CG HIS B 25 9403 9961 10744 -2008 -732 77 C \nATOM 2677 ND1 HIS B 25 -19.958 13.384 18.851 1.00 89.42 N \nANISOU 2677 ND1 HIS B 25 10590 11448 11935 -2114 -724 76 N \nATOM 2678 CD2 HIS B 25 -19.878 11.359 19.667 1.00 82.86 C \nANISOU 2678 CD2 HIS B 25 9997 10300 11186 -2060 -755 93 C \nATOM 2679 CE1 HIS B 25 -21.030 13.226 19.605 1.00 93.90 C \nANISOU 2679 CE1 HIS B 25 11237 12008 12433 -2259 -741 100 C \nATOM 2680 NE2 HIS B 25 -21.007 12.001 20.106 1.00 91.00 N \nANISOU 2680 NE2 HIS B 25 11031 11428 12116 -2220 -763 110 N \nATOM 2681 N HIS B 26 -16.885 13.908 20.799 1.00 65.45 N \nANISOU 2681 N HIS B 26 7457 8302 9108 -1721 -731 29 N \nATOM 2682 CA HIS B 26 -16.762 13.824 22.247 1.00 67.88 C \nANISOU 2682 CA HIS B 26 7783 8565 9444 -1708 -739 34 C \nATOM 2683 C HIS B 26 -18.127 13.751 22.938 1.00 71.61 C \nANISOU 2683 C HIS B 26 8273 9077 9860 -1841 -736 51 C \nATOM 2684 O HIS B 26 -19.148 14.185 22.421 1.00 72.38 O \nANISOU 2684 O HIS B 26 8344 9289 9869 -1957 -731 56 O \nATOM 2685 CB HIS B 26 -15.947 15.016 22.777 1.00 71.12 C \nANISOU 2685 CB HIS B 26 8130 9049 9843 -1591 -757 6 C \nATOM 2686 CG HIS B 26 -16.709 16.301 22.834 1.00 77.58 C \nANISOU 2686 CG HIS B 26 8833 10081 10562 -1597 -755 -19 C \nATOM 2687 ND1 HIS B 26 -16.903 17.098 21.730 1.00 78.30 N \nANISOU 2687 ND1 HIS B 26 8836 10342 10574 -1567 -752 -45 N \nATOM 2688 CD2 HIS B 26 -17.328 16.931 23.865 1.00 82.42 C \nANISOU 2688 CD2 HIS B 26 9386 10805 11124 -1628 -755 -24 C \nATOM 2689 CE1 HIS B 26 -17.620 18.158 22.071 1.00 85.02 C \nANISOU 2689 CE1 HIS B 26 9563 11427 11315 -1581 -750 -69 C \nATOM 2690 NE2 HIS B 26 -17.883 18.086 23.364 1.00 80.88 N \nANISOU 2690 NE2 HIS B 26 9056 10867 10809 -1621 -752 -56 N \nATOM 2691 N SER B 27 -18.121 13.196 24.127 1.00 73.46 N \nANISOU 2691 N SER B 27 8561 9222 10128 -1837 -743 60 N \nATOM 2692 CA SER B 27 -19.262 13.283 24.991 1.00 74.30 C \nANISOU 2692 CA SER B 27 8696 9359 10176 -1949 -749 74 C \nATOM 2693 C SER B 27 -18.746 13.419 26.426 1.00 71.58 C \nANISOU 2693 C SER B 27 8329 8990 9878 -1882 -754 69 C \nATOM 2694 O SER B 27 -17.864 12.674 26.849 1.00 68.20 O \nANISOU 2694 O SER B 27 7938 8458 9517 -1799 -759 68 O \nATOM 2695 CB SER B 27 -20.182 12.074 24.815 1.00 71.04 C \nANISOU 2695 CB SER B 27 8449 8816 9727 -2036 -770 95 C \nATOM 2696 OG SER B 27 -19.594 10.905 25.348 1.00 78.57 O \nANISOU 2696 OG SER B 27 9479 9633 10740 -1929 -782 89 O \nATOM 2697 N ASN B 28 -19.291 14.394 27.151 1.00 70.71 N \nANISOU 2697 N ASN B 28 8148 9004 9715 -1928 -752 65 N \nATOM 2698 CA ASN B 28 -18.909 14.648 28.539 1.00 69.33 C \nANISOU 2698 CA ASN B 28 7953 8817 9573 -1874 -759 60 C \nATOM 2699 C ASN B 28 -20.059 15.292 29.317 1.00 67.05 C \nANISOU 2699 C ASN B 28 7628 8647 9202 -1989 -759 66 C \nATOM 2700 O ASN B 28 -21.157 15.395 28.795 1.00 68.41 O \nANISOU 2700 O ASN B 28 7811 8898 9282 -2137 -758 81 O \nATOM 2701 CB ASN B 28 -17.640 15.510 28.601 1.00 71.75 C \nANISOU 2701 CB ASN B 28 8192 9161 9907 -1726 -768 33 C \nATOM 2702 CG ASN B 28 -17.825 16.879 27.966 1.00 72.41 C \nANISOU 2702 CG ASN B 28 8162 9447 9905 -1684 -770 1 C \nATOM 2703 OD1 ASN B 28 -18.878 17.187 27.414 1.00 72.76 O \nANISOU 2703 OD1 ASN B 28 8144 9635 9865 -1794 -754 4 O \nATOM 2704 ND2 ASN B 28 -16.788 17.702 28.028 1.00 67.60 N \nANISOU 2704 ND2 ASN B 28 7535 8860 9288 -1524 -797 -32 N \nATOM 2705 N GLU B 29 -19.808 15.682 30.570 1.00 62.94 N \nANISOU 2705 N GLU B 29 7075 8139 8701 -1941 -764 59 N \nATOM 2706 CA GLU B 29 -20.812 16.336 31.435 1.00 69.03 C \nANISOU 2706 CA GLU B 29 7800 9037 9392 -2046 -764 64 C \nATOM 2707 C GLU B 29 -21.392 17.637 30.793 1.00 69.58 C \nANISOU 2707 C GLU B 29 7718 9385 9333 -2101 -755 44 C \nATOM 2708 O GLU B 29 -22.570 17.910 30.936 1.00 70.89 O \nANISOU 2708 O GLU B 29 7863 9683 9388 -2281 -754 61 O \nATOM 2709 CB GLU B 29 -20.251 16.586 32.862 1.00 67.89 C \nANISOU 2709 CB GLU B 29 7639 8861 9296 -1956 -772 54 C \nATOM 2710 CG GLU B 29 -18.945 17.408 32.875 1.00 80.65 C \nANISOU 2710 CG GLU B 29 9193 10510 10942 -1773 -784 20 C \nATOM 2711 CD GLU B 29 -17.614 16.615 32.601 1.00 84.08 C \nANISOU 2711 CD GLU B 29 9717 10759 11470 -1679 -796 25 C \nATOM 2712 OE1 GLU B 29 -17.512 15.371 32.757 1.00 70.69 O \nANISOU 2712 OE1 GLU B 29 8101 8927 9831 -1720 -791 49 O \nATOM 2713 OE2 GLU B 29 -16.619 17.260 32.220 1.00 90.59 O \nANISOU 2713 OE2 GLU B 29 10539 11592 12288 -1558 -819 2 O \nATOM 2714 N GLN B 30 -20.572 18.361 30.030 1.00 70.60 N \nANISOU 2714 N GLN B 30 7755 9612 9459 -1954 -755 8 N \nATOM 2715 CA GLN B 30 -20.998 19.556 29.304 1.00 71.80 C \nANISOU 2715 CA GLN B 30 7742 10069 9470 -1960 -749 -25 C \nATOM 2716 C GLN B 30 -21.800 19.219 28.023 1.00 82.63 C \nANISOU 2716 C GLN B 30 9119 11506 10772 -2133 -736 -1 C \nATOM 2717 O GLN B 30 -22.223 20.135 27.290 1.00 79.12 O \nANISOU 2717 O GLN B 30 8522 11352 10189 -2168 -728 -25 O \nATOM 2718 CB GLN B 30 -19.804 20.460 28.952 1.00 74.22 C \nANISOU 2718 CB GLN B 30 7979 10448 9773 -1699 -770 -82 C \nATOM 2719 CG GLN B 30 -19.085 21.059 30.154 1.00 88.27 C \nANISOU 2719 CG GLN B 30 9765 12205 11570 -1530 -800 -112 C \nATOM 2720 CD GLN B 30 -17.965 20.178 30.704 1.00101.23 C \nANISOU 2720 CD GLN B 30 11579 13524 13360 -1460 -819 -90 C \nATOM 2721 OE1 GLN B 30 -17.818 19.008 30.329 1.00113.12 O \nANISOU 2721 OE1 GLN B 30 13183 14838 14959 -1543 -804 -51 O \nATOM 2722 NE2 GLN B 30 -17.167 20.739 31.599 1.00106.08 N \nANISOU 2722 NE2 GLN B 30 12232 14098 13974 -1310 -857 -115 N \nATOM 2723 N GLY B 31 -22.070 17.932 27.774 1.00 88.84 N \nANISOU 2723 N GLY B 31 10080 12048 11627 -2241 -738 43 N \nATOM 2724 CA GLY B 31 -22.785 17.500 26.557 1.00 88.40 C \nANISOU 2724 CA GLY B 31 10080 12004 11504 -2403 -737 68 C \nATOM 2725 C GLY B 31 -21.863 16.836 25.534 1.00 85.79 C \nANISOU 2725 C GLY B 31 9810 11508 11278 -2272 -733 61 C \nATOM 2726 O GLY B 31 -20.919 16.162 25.891 1.00 87.55 O \nANISOU 2726 O GLY B 31 10107 11527 11629 -2129 -738 57 O \nATOM 2727 N SER B 32 -22.165 17.031 24.255 1.00 84.37 N \nANISOU 2727 N SER B 32 9591 11441 11026 -2342 -727 61 N \nATOM 2728 CA SER B 32 -21.536 16.300 23.181 1.00 75.56 C \nANISOU 2728 CA SER B 32 8550 10170 9989 -2266 -725 62 C \nATOM 2729 C SER B 32 -21.352 17.169 21.943 1.00 79.42 C \nANISOU 2729 C SER B 32 8895 10876 10404 -2228 -712 33 C \nATOM 2730 O SER B 32 -21.825 18.307 21.893 1.00 73.28 O \nANISOU 2730 O SER B 32 7951 10400 9492 -2271 -706 11 O \nATOM 2731 CB SER B 32 -22.366 15.067 22.833 1.00 70.82 C \nANISOU 2731 CB SER B 32 8154 9381 9372 -2427 -744 105 C \nATOM 2732 OG SER B 32 -23.477 15.386 22.062 1.00 71.92 O \nANISOU 2732 OG SER B 32 8297 9670 9359 -2650 -751 127 O \nATOM 2733 N GLY B 33 -20.623 16.638 20.962 1.00 81.60 N \nANISOU 2733 N GLY B 33 9224 11023 10759 -2134 -710 29 N \nATOM 2734 CA GLY B 33 -20.382 17.361 19.716 1.00 82.94 C \nANISOU 2734 CA GLY B 33 9275 11376 10865 -2079 -702 -1 C \nATOM 2735 C GLY B 33 -19.398 16.717 18.750 1.00 81.83 C \nANISOU 2735 C GLY B 33 9208 11055 10828 -1955 -703 -5 C \nATOM 2736 O GLY B 33 -18.559 15.923 19.150 1.00 82.18 O \nANISOU 2736 O GLY B 33 9359 10869 10997 -1860 -711 2 O \nATOM 2737 N TYR B 34 -19.523 17.061 17.468 1.00 83.49 N \nANISOU 2737 N TYR B 34 9352 11400 10971 -1972 -695 -17 N \nATOM 2738 CA TYR B 34 -18.569 16.652 16.433 1.00 82.30 C \nANISOU 2738 CA TYR B 34 9248 11121 10900 -1847 -697 -28 C \nATOM 2739 C TYR B 34 -17.540 17.746 16.168 1.00 82.13 C \nANISOU 2739 C TYR B 34 9130 11222 10855 -1617 -715 -85 C \nATOM 2740 O TYR B 34 -17.763 18.908 16.462 1.00 80.65 O \nANISOU 2740 O TYR B 34 8806 11283 10553 -1552 -723 -125 O \nATOM 2741 CB TYR B 34 -19.277 16.331 15.125 1.00 80.80 C \nANISOU 2741 CB TYR B 34 9068 10984 10647 -1992 -685 -8 C \nATOM 2742 CG TYR B 34 -20.266 15.181 15.189 1.00 80.54 C \nANISOU 2742 CG TYR B 34 9202 10790 10611 -2200 -691 44 C \nATOM 2743 CD1 TYR B 34 -21.630 15.416 15.395 1.00 71.48 C \nANISOU 2743 CD1 TYR B 34 8061 9777 9319 -2441 -697 73 C \nATOM 2744 CD2 TYR B 34 -19.848 13.855 15.025 1.00 74.21 C \nANISOU 2744 CD2 TYR B 34 8567 9710 9918 -2155 -701 62 C \nATOM 2745 CE1 TYR B 34 -22.533 14.366 15.465 1.00 71.56 C \nANISOU 2745 CE1 TYR B 34 8289 9602 9300 -2621 -725 119 C \nATOM 2746 CE2 TYR B 34 -20.757 12.806 15.090 1.00 73.18 C \nANISOU 2746 CE2 TYR B 34 8624 9426 9756 -2297 -724 98 C \nATOM 2747 CZ TYR B 34 -22.091 13.067 15.315 1.00 74.34 C \nANISOU 2747 CZ TYR B 34 8821 9662 9762 -2525 -742 126 C \nATOM 2748 OH TYR B 34 -22.977 12.025 15.374 1.00 80.30 O \nANISOU 2748 OH TYR B 34 9823 10227 10461 -2654 -786 160 O \nATOM 2749 N ALA B 35 -16.402 17.349 15.619 1.00 86.51 N \nANISOU 2749 N ALA B 35 9772 11600 11498 -1485 -730 -92 N \nATOM 2750 CA ALA B 35 -15.310 18.273 15.350 1.00 91.39 C \nANISOU 2750 CA ALA B 35 10376 12266 12084 -1253 -768 -145 C \nATOM 2751 C ALA B 35 -14.340 17.650 14.355 1.00 90.70 C \nANISOU 2751 C ALA B 35 10397 11995 12070 -1193 -781 -138 C \nATOM 2752 O ALA B 35 -13.709 16.653 14.651 1.00 88.12 O \nANISOU 2752 O ALA B 35 10194 11438 11850 -1226 -783 -104 O \nATOM 2753 CB ALA B 35 -14.590 18.623 16.643 1.00 93.20 C \nANISOU 2753 CB ALA B 35 10669 12408 12336 -1134 -805 -159 C \nATOM 2754 N ALA B 36 -14.252 18.229 13.166 1.00100.81 N \nANISOU 2754 N ALA B 36 11617 13408 13277 -1112 -787 -171 N \nATOM 2755 CA ALA B 36 -13.396 17.689 12.109 1.00104.68 C \nANISOU 2755 CA ALA B 36 12204 13743 13825 -1064 -799 -165 C \nATOM 2756 C ALA B 36 -11.953 18.142 12.271 1.00104.40 C \nANISOU 2756 C ALA B 36 12305 13577 13787 -863 -867 -196 C \nATOM 2757 O ALA B 36 -11.697 19.236 12.773 1.00106.63 O \nANISOU 2757 O ALA B 36 12581 13959 13973 -695 -914 -245 O \nATOM 2758 CB ALA B 36 -13.925 18.101 10.744 1.00109.00 C \nANISOU 2758 CB ALA B 36 12640 14486 14288 -1069 -781 -187 C \nATOM 2759 N ASP B 37 -11.014 17.300 11.850 1.00101.55 N \nANISOU 2759 N ASP B 37 12085 12995 13506 -884 -881 -167 N \nATOM 2760 CA ASP B 37 -9.613 17.681 11.858 1.00105.12 C \nANISOU 2760 CA ASP B 37 12714 13300 13925 -736 -960 -186 C \nATOM 2761 C ASP B 37 -9.310 18.487 10.594 1.00111.68 C \nANISOU 2761 C ASP B 37 13549 14222 14663 -567 -997 -238 C \nATOM 2762 O ASP B 37 -9.511 18.010 9.479 1.00120.49 O \nANISOU 2762 O ASP B 37 14617 15354 15809 -629 -961 -225 O \nATOM 2763 CB ASP B 37 -8.730 16.451 11.942 1.00104.54 C \nANISOU 2763 CB ASP B 37 12779 12995 13945 -863 -964 -130 C \nATOM 2764 CG ASP B 37 -7.324 16.777 12.347 1.00107.99 C \nANISOU 2764 CG ASP B 37 13439 13262 14330 -786 -1056 -134 C \nATOM 2765 OD1 ASP B 37 -6.843 17.892 12.056 1.00113.31 O \nANISOU 2765 OD1 ASP B 37 14211 13949 14894 -590 -1131 -186 O \nATOM 2766 OD2 ASP B 37 -6.691 15.904 12.959 1.00114.80 O \nANISOU 2766 OD2 ASP B 37 14393 13988 15238 -922 -1061 -86 O \nATOM 2767 N LYS B 38 -8.812 19.704 10.779 1.00104.59 N \nANISOU 2767 N LYS B 38 12720 13381 13637 -335 -1076 -302 N \nATOM 2768 CA LYS B 38 -8.579 20.617 9.671 1.00102.36 C \nANISOU 2768 CA LYS B 38 12436 13227 13230 -119 -1123 -369 C \nATOM 2769 C LYS B 38 -7.423 20.171 8.811 1.00100.41 C \nANISOU 2769 C LYS B 38 12400 12746 13003 -100 -1174 -352 C \nATOM 2770 O LYS B 38 -7.525 20.148 7.585 1.00 92.28 O \nANISOU 2770 O LYS B 38 11315 11788 11960 -74 -1157 -366 O \nATOM 2771 CB LYS B 38 -8.285 22.017 10.204 1.00108.44 C \nANISOU 2771 CB LYS B 38 13260 14113 13829 172 -1214 -453 C \nATOM 2772 CG LYS B 38 -8.071 23.074 9.133 1.00112.09 C \nANISOU 2772 CG LYS B 38 13716 14754 14121 457 -1277 -542 C \nATOM 2773 CD LYS B 38 -7.996 24.467 9.711 1.00110.79 C \nANISOU 2773 CD LYS B 38 13564 14775 13757 778 -1364 -640 C \nATOM 2774 CE LYS B 38 -8.152 25.504 8.629 1.00112.25 C \nANISOU 2774 CE LYS B 38 13636 15264 13748 1061 -1403 -740 C \nATOM 2775 NZ LYS B 38 -7.988 26.890 9.134 1.00115.45 N \nANISOU 2775 NZ LYS B 38 14070 15874 13922 1440 -1506 -853 N \nATOM 2776 N GLU B 39 -6.316 19.838 9.470 1.00100.43 N \nANISOU 2776 N GLU B 39 12654 12482 13025 -131 -1241 -321 N \nATOM 2777 CA GLU B 39 -5.095 19.455 8.775 1.00 97.99 C \nANISOU 2777 CA GLU B 39 12586 11941 12703 -142 -1308 -299 C \nATOM 2778 C GLU B 39 -5.318 18.158 8.009 1.00 98.02 C \nANISOU 2778 C GLU B 39 12485 11915 12843 -371 -1218 -237 C \nATOM 2779 O GLU B 39 -5.045 18.081 6.815 1.00 96.72 O \nANISOU 2779 O GLU B 39 12346 11738 12664 -337 -1225 -246 O \nATOM 2780 CB GLU B 39 -3.921 19.300 9.755 1.00 96.52 C \nANISOU 2780 CB GLU B 39 12692 11497 12484 -197 -1399 -266 C \nATOM 2781 CG GLU B 39 -2.618 18.886 9.079 1.00103.45 C \nANISOU 2781 CG GLU B 39 13848 12140 13319 -261 -1479 -234 C \nATOM 2782 CD GLU B 39 -1.403 18.906 9.993 1.00105.10 C \nANISOU 2782 CD GLU B 39 14394 12102 13438 -330 -1595 -202 C \nATOM 2783 OE1 GLU B 39 -1.484 19.480 11.099 1.00112.11 O \nANISOU 2783 OE1 GLU B 39 15335 12984 14276 -254 -1634 -221 O \nATOM 2784 OE2 GLU B 39 -0.353 18.338 9.602 1.00101.29 O \nANISOU 2784 OE2 GLU B 39 14132 11435 12919 -481 -1651 -153 O \nATOM 2785 N SER B 40 -5.840 17.154 8.706 1.00 96.83 N \nANISOU 2785 N SER B 40 12220 11760 12810 -583 -1139 -181 N \nATOM 2786 CA SER B 40 -6.004 15.822 8.148 1.00 93.02 C \nANISOU 2786 CA SER B 40 11664 11243 12438 -777 -1066 -127 C \nATOM 2787 C SER B 40 -6.943 15.832 6.932 1.00 87.78 C \nANISOU 2787 C SER B 40 10828 10733 11793 -758 -1004 -147 C \nATOM 2788 O SER B 40 -6.626 15.268 5.884 1.00 97.28 O \nANISOU 2788 O SER B 40 12054 11887 13022 -800 -993 -132 O \nATOM 2789 CB SER B 40 -6.529 14.867 9.230 1.00 91.12 C \nANISOU 2789 CB SER B 40 11333 11002 12285 -949 -1005 -82 C \nATOM 2790 OG SER B 40 -5.768 13.673 9.249 1.00 90.50 O \nANISOU 2790 OG SER B 40 11327 10810 12248 -1102 -1002 -32 O \nATOM 2791 N THR B 41 -8.093 16.471 7.075 1.00 90.53 N \nANISOU 2791 N THR B 41 11006 11280 12112 -714 -966 -177 N \nATOM 2792 CA THR B 41 -9.063 16.597 5.980 1.00 87.82 C \nANISOU 2792 CA THR B 41 10499 11118 11751 -727 -913 -194 C \nATOM 2793 C THR B 41 -8.419 17.308 4.785 1.00 93.01 C \nANISOU 2793 C THR B 41 11210 11804 12324 -555 -963 -240 C \nATOM 2794 O THR B 41 -8.598 16.899 3.640 1.00102.18 O \nANISOU 2794 O THR B 41 12327 12988 13509 -602 -931 -231 O \nATOM 2795 CB THR B 41 -10.326 17.354 6.444 1.00 86.57 C \nANISOU 2795 CB THR B 41 10157 11211 11526 -728 -879 -220 C \nATOM 2796 OG1 THR B 41 -10.999 16.596 7.459 1.00 85.62 O \nANISOU 2796 OG1 THR B 41 10007 11043 11481 -900 -835 -174 O \nATOM 2797 CG2 THR B 41 -11.291 17.571 5.286 1.00 92.59 C \nANISOU 2797 CG2 THR B 41 10760 12191 12231 -774 -835 -234 C \nATOM 2798 N GLN B 42 -7.660 18.365 5.053 1.00 93.97 N \nANISOU 2798 N GLN B 42 11450 11917 12337 -340 -1050 -293 N \nATOM 2799 CA GLN B 42 -6.974 19.111 3.997 1.00 89.64 C \nANISOU 2799 CA GLN B 42 10996 11384 11681 -131 -1120 -348 C \nATOM 2800 C GLN B 42 -5.982 18.255 3.227 1.00 86.90 C \nANISOU 2800 C GLN B 42 10825 10798 11396 -213 -1141 -306 C \nATOM 2801 O GLN B 42 -6.030 18.190 2.001 1.00 92.46 O \nANISOU 2801 O GLN B 42 11486 11551 12092 -189 -1126 -317 O \nATOM 2802 CB GLN B 42 -6.251 20.334 4.571 1.00 85.13 C \nANISOU 2802 CB GLN B 42 10590 10799 10958 141 -1235 -416 C \nATOM 2803 CG GLN B 42 -5.791 21.318 3.515 1.00 86.34 C \nANISOU 2803 CG GLN B 42 10816 11036 10954 423 -1315 -496 C \nATOM 2804 CD GLN B 42 -6.934 21.737 2.597 1.00 87.32 C \nANISOU 2804 CD GLN B 42 10634 11520 11025 460 -1242 -538 C \nATOM 2805 OE1 GLN B 42 -8.038 22.041 3.058 1.00 88.50 O \nANISOU 2805 OE1 GLN B 42 10540 11936 11150 408 -1179 -549 O \nATOM 2806 NE2 GLN B 42 -6.671 21.764 1.292 1.00 88.52 N \nANISOU 2806 NE2 GLN B 42 10799 11691 11142 531 -1253 -559 N \nATOM 2807 N LYS B 43 -5.078 17.616 3.965 1.00 86.52 N \nANISOU 2807 N LYS B 43 10966 10513 11393 -322 -1178 -257 N \nATOM 2808 CA LYS B 43 -4.061 16.716 3.393 1.00 81.92 C \nANISOU 2808 CA LYS B 43 10550 9725 10850 -448 -1202 -208 C \nATOM 2809 C LYS B 43 -4.683 15.663 2.456 1.00 84.55 C \nANISOU 2809 C LYS B 43 10710 10121 11293 -601 -1103 -173 C \nATOM 2810 O LYS B 43 -4.129 15.333 1.417 1.00 89.98 O \nANISOU 2810 O LYS B 43 11468 10741 11979 -614 -1117 -165 O \nATOM 2811 CB LYS B 43 -3.294 16.021 4.510 1.00 85.23 C \nANISOU 2811 CB LYS B 43 11118 9970 11295 -615 -1230 -151 C \nATOM 2812 CG LYS B 43 -2.073 16.759 5.015 1.00102.70 C \nANISOU 2812 CG LYS B 43 13648 12000 13372 -521 -1366 -164 C \nATOM 2813 CD LYS B 43 -2.386 18.182 5.468 1.00114.88 C \nANISOU 2813 CD LYS B 43 15218 13626 14804 -248 -1428 -242 C \nATOM 2814 CE LYS B 43 -1.127 18.968 5.838 1.00124.34 C \nANISOU 2814 CE LYS B 43 16802 14608 15835 -112 -1591 -265 C \nATOM 2815 NZ LYS B 43 -1.341 20.355 6.355 1.00129.14 N \nANISOU 2815 NZ LYS B 43 17466 15298 16305 197 -1669 -351 N \nATOM 2816 N ALA B 44 -5.854 15.168 2.825 1.00 85.66 N \nANISOU 2816 N ALA B 44 10646 10385 11514 -709 -1012 -155 N \nATOM 2817 CA ALA B 44 -6.544 14.166 2.039 1.00 82.73 C \nANISOU 2817 CA ALA B 44 10148 10059 11228 -841 -932 -125 C \nATOM 2818 C ALA B 44 -7.089 14.721 0.746 1.00 82.88 C \nANISOU 2818 C ALA B 44 10070 10217 11204 -756 -915 -162 C \nATOM 2819 O ALA B 44 -7.104 14.035 -0.261 1.00 92.30 O \nANISOU 2819 O ALA B 44 11247 11385 12438 -821 -886 -143 O \nATOM 2820 CB ALA B 44 -7.654 13.525 2.852 1.00 75.78 C \nANISOU 2820 CB ALA B 44 9137 9243 10413 -970 -864 -99 C \nATOM 2821 N ILE B 45 -7.549 15.956 0.777 1.00 86.15 N \nANISOU 2821 N ILE B 45 10407 10805 11520 -608 -934 -216 N \nATOM 2822 CA ILE B 45 -8.121 16.603 -0.402 1.00 86.75 C \nANISOU 2822 CA ILE B 45 10359 11082 11522 -525 -919 -258 C \nATOM 2823 C ILE B 45 -7.005 16.991 -1.359 1.00 81.51 C \nANISOU 2823 C ILE B 45 9842 10328 10799 -362 -989 -290 C \nATOM 2824 O ILE B 45 -7.119 16.777 -2.558 1.00 83.89 O \nANISOU 2824 O ILE B 45 10098 10670 11105 -375 -966 -292 O \nATOM 2825 CB ILE B 45 -8.920 17.880 -0.001 1.00 92.42 C \nANISOU 2825 CB ILE B 45 10922 12084 12111 -402 -924 -317 C \nATOM 2826 CG1 ILE B 45 -10.109 17.542 0.898 1.00 93.92 C \nANISOU 2826 CG1 ILE B 45 10975 12371 12338 -589 -859 -282 C \nATOM 2827 CG2 ILE B 45 -9.417 18.641 -1.221 1.00 94.88 C \nANISOU 2827 CG2 ILE B 45 11085 12660 12303 -304 -916 -369 C \nATOM 2828 CD1 ILE B 45 -10.574 18.719 1.738 1.00100.16 C \nANISOU 2828 CD1 ILE B 45 11656 13393 13007 -474 -879 -333 C \nATOM 2829 N ASP B 46 -5.954 17.602 -0.828 1.00 84.25 N \nANISOU 2829 N ASP B 46 10387 10549 11075 -206 -1084 -318 N \nATOM 2830 CA ASP B 46 -4.752 17.904 -1.608 1.00 84.76 C \nANISOU 2830 CA ASP B 46 10672 10464 11067 -65 -1175 -342 C \nATOM 2831 C ASP B 46 -4.228 16.658 -2.308 1.00 90.05 C \nANISOU 2831 C ASP B 46 11414 10959 11844 -257 -1146 -277 C \nATOM 2832 O ASP B 46 -3.942 16.689 -3.510 1.00 95.59 O \nANISOU 2832 O ASP B 46 12144 11657 12520 -201 -1159 -292 O \nATOM 2833 CB ASP B 46 -3.676 18.517 -0.719 1.00 85.98 C \nANISOU 2833 CB ASP B 46 11100 10441 11125 69 -1295 -362 C \nATOM 2834 CG ASP B 46 -3.965 19.983 -0.394 1.00101.62 C \nANISOU 2834 CG ASP B 46 13054 12611 12944 367 -1357 -455 C \nATOM 2835 OD1 ASP B 46 -4.865 20.576 -1.033 1.00108.06 O \nANISOU 2835 OD1 ASP B 46 13634 13722 13701 477 -1312 -508 O \nATOM 2836 OD2 ASP B 46 -3.321 20.548 0.520 1.00108.95 O \nANISOU 2836 OD2 ASP B 46 14190 13421 13784 489 -1453 -477 O \nATOM 2837 N GLY B 47 -4.150 15.550 -1.572 1.00 85.08 N \nANISOU 2837 N GLY B 47 10791 10216 11321 -475 -1104 -210 N \nATOM 2838 CA GLY B 47 -3.688 14.300 -2.135 1.00 78.88 C \nANISOU 2838 CA GLY B 47 10040 9314 10615 -653 -1074 -155 C \nATOM 2839 C GLY B 47 -4.637 13.752 -3.186 1.00 80.48 C \nANISOU 2839 C GLY B 47 10052 9640 10887 -710 -987 -150 C \nATOM 2840 O GLY B 47 -4.241 13.462 -4.331 1.00 86.49 O \nANISOU 2840 O GLY B 47 10850 10362 11649 -711 -991 -147 O \nATOM 2841 N VAL B 48 -5.895 13.591 -2.810 1.00 77.15 N \nANISOU 2841 N VAL B 48 9448 9354 10510 -772 -915 -146 N \nATOM 2842 CA VAL B 48 -6.872 12.931 -3.695 1.00 83.17 C \nANISOU 2842 CA VAL B 48 10073 10204 11323 -867 -841 -132 C \nATOM 2843 C VAL B 48 -7.122 13.726 -4.973 1.00 86.50 C \nANISOU 2843 C VAL B 48 10433 10757 11676 -757 -845 -174 C \nATOM 2844 O VAL B 48 -7.292 13.153 -6.046 1.00 95.56 O \nANISOU 2844 O VAL B 48 11553 11902 12854 -814 -815 -160 O \nATOM 2845 CB VAL B 48 -8.195 12.626 -2.947 1.00 80.95 C \nANISOU 2845 CB VAL B 48 9665 10019 11073 -977 -783 -115 C \nATOM 2846 CG1 VAL B 48 -9.401 12.743 -3.860 1.00 81.04 C \nANISOU 2846 CG1 VAL B 48 9551 10188 11054 -1030 -737 -122 C \nATOM 2847 CG2 VAL B 48 -8.129 11.231 -2.308 1.00 76.62 C \nANISOU 2847 CG2 VAL B 48 9157 9346 10608 -1109 -758 -69 C \nATOM 2848 N THR B 49 -7.129 15.045 -4.871 1.00 91.80 N \nANISOU 2848 N THR B 49 11080 11560 12239 -585 -888 -230 N \nATOM 2849 CA THR B 49 -7.455 15.873 -6.035 1.00 91.64 C \nANISOU 2849 CA THR B 49 10965 11731 12122 -463 -891 -280 C \nATOM 2850 C THR B 49 -6.352 15.817 -7.087 1.00 96.99 C \nANISOU 2850 C THR B 49 11791 12273 12787 -366 -942 -291 C \nATOM 2851 O THR B 49 -6.638 15.702 -8.274 1.00105.14 O \nANISOU 2851 O THR B 49 12752 13384 13813 -377 -914 -297 O \nATOM 2852 CB THR B 49 -7.715 17.344 -5.678 1.00 91.32 C \nANISOU 2852 CB THR B 49 10843 11924 11930 -258 -932 -354 C \nATOM 2853 OG1 THR B 49 -6.820 17.725 -4.637 1.00 99.60 O \nANISOU 2853 OG1 THR B 49 12064 12823 12955 -138 -1007 -368 O \nATOM 2854 CG2 THR B 49 -9.154 17.555 -5.205 1.00 94.73 C \nANISOU 2854 CG2 THR B 49 11051 12611 12329 -382 -866 -350 C \nATOM 2855 N ASN B 50 -5.093 15.880 -6.665 1.00 88.19 N \nANISOU 2855 N ASN B 50 10902 10950 11657 -291 -1023 -290 N \nATOM 2856 CA ASN B 50 -3.983 15.837 -7.620 1.00 84.54 C \nANISOU 2856 CA ASN B 50 10622 10337 11161 -220 -1086 -296 C \nATOM 2857 C ASN B 50 -3.819 14.452 -8.224 1.00 79.00 C \nANISOU 2857 C ASN B 50 9919 9519 10578 -431 -1031 -232 C \nATOM 2858 O ASN B 50 -3.333 14.312 -9.347 1.00 83.21 O \nANISOU 2858 O ASN B 50 10514 10005 11099 -405 -1048 -235 O \nATOM 2859 CB ASN B 50 -2.680 16.242 -6.936 1.00 87.27 C \nANISOU 2859 CB ASN B 50 11258 10472 11428 -128 -1203 -303 C \nATOM 2860 CG ASN B 50 -2.823 17.483 -6.082 1.00 90.02 C \nANISOU 2860 CG ASN B 50 11632 10915 11658 85 -1265 -366 C \nATOM 2861 OD1 ASN B 50 -3.854 18.157 -6.103 1.00 91.61 O \nANISOU 2861 OD1 ASN B 50 11610 11379 11817 185 -1221 -413 O \nATOM 2862 ND2 ASN B 50 -1.783 17.791 -5.317 1.00 89.21 N \nANISOU 2862 ND2 ASN B 50 11808 10608 11480 145 -1372 -367 N \nATOM 2863 N LYS B 51 -4.237 13.440 -7.482 1.00 72.37 N \nANISOU 2863 N LYS B 51 9008 8649 9839 -619 -970 -179 N \nATOM 2864 CA LYS B 51 -4.353 12.111 -8.035 1.00 71.25 C \nANISOU 2864 CA LYS B 51 8820 8461 9791 -786 -910 -132 C \nATOM 2865 C LYS B 51 -5.269 12.112 -9.236 1.00 80.68 C \nANISOU 2865 C LYS B 51 9874 9786 10995 -777 -857 -147 C \nATOM 2866 O LYS B 51 -4.891 11.654 -10.323 1.00 89.43 O \nANISOU 2866 O LYS B 51 11013 10848 12118 -794 -854 -139 O \nATOM 2867 CB LYS B 51 -4.917 11.166 -7.009 1.00 70.19 C \nANISOU 2867 CB LYS B 51 8612 8325 9732 -932 -858 -93 C \nATOM 2868 CG LYS B 51 -4.999 9.736 -7.486 1.00 69.38 C \nANISOU 2868 CG LYS B 51 8475 8189 9697 -1062 -810 -56 C \nATOM 2869 CD LYS B 51 -5.774 8.852 -6.523 1.00 67.45 C \nANISOU 2869 CD LYS B 51 8156 7970 9502 -1157 -764 -33 C \nATOM 2870 CE LYS B 51 -4.821 8.046 -5.684 1.00 68.71 C \nANISOU 2870 CE LYS B 51 8380 8066 9663 -1236 -785 -5 C \nATOM 2871 NZ LYS B 51 -5.417 7.218 -4.619 1.00 76.38 N \nANISOU 2871 NZ LYS B 51 9288 9071 10660 -1296 -753 9 N \nATOM 2872 N VAL B 52 -6.465 12.652 -9.047 1.00 83.77 N \nANISOU 2872 N VAL B 52 10116 10352 11361 -768 -818 -168 N \nATOM 2873 CA VAL B 52 -7.403 12.826 -10.148 1.00 83.34 C \nANISOU 2873 CA VAL B 52 9932 10458 11277 -785 -776 -182 C \nATOM 2874 C VAL B 52 -6.778 13.617 -11.319 1.00 82.64 C \nANISOU 2874 C VAL B 52 9871 10418 11111 -623 -818 -227 C \nATOM 2875 O VAL B 52 -6.919 13.237 -12.485 1.00 93.75 O \nANISOU 2875 O VAL B 52 11250 11840 12532 -661 -793 -220 O \nATOM 2876 CB VAL B 52 -8.694 13.541 -9.670 1.00 81.08 C \nANISOU 2876 CB VAL B 52 9487 10397 10922 -816 -745 -199 C \nATOM 2877 CG1 VAL B 52 -9.528 14.027 -10.852 1.00 74.10 C \nANISOU 2877 CG1 VAL B 52 8467 9736 9953 -831 -718 -222 C \nATOM 2878 CG2 VAL B 52 -9.518 12.602 -8.801 1.00 82.69 C \nANISOU 2878 CG2 VAL B 52 9680 10542 11195 -999 -702 -151 C \nATOM 2879 N ASN B 53 -6.140 14.741 -11.019 1.00 70.87 N \nANISOU 2879 N ASN B 53 8447 8958 9523 -426 -889 -278 N \nATOM 2880 CA ASN B 53 -5.607 15.586 -12.078 1.00 74.63 C \nANISOU 2880 CA ASN B 53 8964 9497 9895 -228 -943 -335 C \nATOM 2881 C ASN B 53 -4.461 14.874 -12.785 1.00 83.81 C \nANISOU 2881 C ASN B 53 10316 10420 11109 -253 -978 -306 C \nATOM 2882 O ASN B 53 -4.366 14.883 -14.008 1.00 85.93 O \nANISOU 2882 O ASN B 53 10571 10721 11357 -212 -976 -320 O \nATOM 2883 CB ASN B 53 -5.163 16.959 -11.548 1.00 75.56 C \nANISOU 2883 CB ASN B 53 9149 9695 9865 36 -1031 -408 C \nATOM 2884 CG ASN B 53 -6.291 17.717 -10.862 1.00 82.70 C \nANISOU 2884 CG ASN B 53 9840 10888 10695 63 -996 -442 C \nATOM 2885 OD1 ASN B 53 -7.465 17.566 -11.209 1.00 82.39 O \nANISOU 2885 OD1 ASN B 53 9585 11062 10659 -79 -916 -428 O \nATOM 2886 ND2 ASN B 53 -5.938 18.525 -9.869 1.00 84.10 N \nANISOU 2886 ND2 ASN B 53 10093 11074 10789 229 -1062 -484 N \nATOM 2887 N SER B 54 -3.577 14.256 -12.014 1.00 89.55 N \nANISOU 2887 N SER B 54 11215 10924 11887 -337 -1012 -264 N \nATOM 2888 CA SER B 54 -2.454 13.546 -12.609 1.00 89.20 C \nANISOU 2888 CA SER B 54 11347 10678 11865 -404 -1049 -230 C \nATOM 2889 C SER B 54 -2.944 12.526 -13.632 1.00 91.64 C \nANISOU 2889 C SER B 54 11531 11023 12265 -540 -968 -198 C \nATOM 2890 O SER B 54 -2.408 12.434 -14.731 1.00 99.67 O \nANISOU 2890 O SER B 54 12614 11991 13264 -510 -990 -203 O \nATOM 2891 CB SER B 54 -1.621 12.871 -11.524 1.00 93.46 C \nANISOU 2891 CB SER B 54 12038 11039 12433 -545 -1081 -179 C \nATOM 2892 OG SER B 54 -0.935 13.849 -10.742 1.00 86.50 O \nANISOU 2892 OG SER B 54 11349 10075 11443 -412 -1182 -209 O \nATOM 2893 N ILE B 55 -3.980 11.769 -13.277 1.00 92.37 N \nANISOU 2893 N ILE B 55 11463 11192 12442 -680 -885 -168 N \nATOM 2894 CA ILE B 55 -4.601 10.820 -14.212 1.00 86.80 C \nANISOU 2894 CA ILE B 55 10659 10518 11802 -789 -818 -143 C \nATOM 2895 C ILE B 55 -5.118 11.535 -15.451 1.00 95.11 C \nANISOU 2895 C ILE B 55 11627 11712 12800 -699 -808 -181 C \nATOM 2896 O ILE B 55 -4.868 11.096 -16.565 1.00108.47 O \nANISOU 2896 O ILE B 55 13336 13368 14509 -716 -799 -174 O \nATOM 2897 CB ILE B 55 -5.779 10.068 -13.538 1.00 82.84 C \nANISOU 2897 CB ILE B 55 10045 10070 11360 -922 -752 -115 C \nATOM 2898 CG1 ILE B 55 -5.254 9.054 -12.511 1.00 82.60 C \nANISOU 2898 CG1 ILE B 55 10078 9923 11383 -1015 -754 -78 C \nATOM 2899 CG2 ILE B 55 -6.693 9.365 -14.538 1.00 80.28 C \nANISOU 2899 CG2 ILE B 55 9646 9794 11062 -1006 -699 -102 C \nATOM 2900 CD1 ILE B 55 -6.278 8.631 -11.481 1.00 75.84 C \nANISOU 2900 CD1 ILE B 55 9151 9108 10556 -1090 -716 -64 C \nATOM 2901 N ILE B 56 -5.834 12.637 -15.234 1.00100.49 N \nANISOU 2901 N ILE B 56 12202 12579 13400 -608 -808 -223 N \nATOM 2902 CA ILE B 56 -6.401 13.438 -16.321 1.00 99.19 C \nANISOU 2902 CA ILE B 56 11917 12624 13145 -524 -799 -266 C \nATOM 2903 C ILE B 56 -5.337 14.164 -17.151 1.00 97.85 C \nANISOU 2903 C ILE B 56 11857 12424 12896 -316 -871 -315 C \nATOM 2904 O ILE B 56 -5.413 14.157 -18.376 1.00102.20 O \nANISOU 2904 O ILE B 56 12368 13037 13427 -296 -859 -327 O \nATOM 2905 CB ILE B 56 -7.412 14.490 -15.791 1.00100.04 C \nANISOU 2905 CB ILE B 56 11858 13007 13146 -481 -786 -305 C \nATOM 2906 CG1 ILE B 56 -8.645 13.797 -15.221 1.00 98.42 C \nANISOU 2906 CG1 ILE B 56 11559 12845 12992 -713 -719 -255 C \nATOM 2907 CG2 ILE B 56 -7.846 15.456 -16.897 1.00 95.87 C \nANISOU 2907 CG2 ILE B 56 11186 12759 12479 -371 -787 -361 C \nATOM 2908 CD1 ILE B 56 -9.552 14.701 -14.419 1.00 99.84 C \nANISOU 2908 CD1 ILE B 56 11595 13270 13069 -718 -710 -280 C \nATOM 2909 N ASP B 57 -4.393 14.822 -16.488 1.00 98.22 N \nANISOU 2909 N ASP B 57 12062 12375 12883 -157 -955 -345 N \nATOM 2910 CA ASP B 57 -3.396 15.674 -17.170 1.00106.07 C \nANISOU 2910 CA ASP B 57 13215 13327 13759 81 -1051 -402 C \nATOM 2911 C ASP B 57 -2.348 14.890 -17.970 1.00101.96 C \nANISOU 2911 C ASP B 57 12882 12568 13291 15 -1081 -365 C \nATOM 2912 O ASP B 57 -1.995 15.280 -19.081 1.00104.31 O \nANISOU 2912 O ASP B 57 13225 12887 13520 144 -1117 -402 O \nATOM 2913 CB ASP B 57 -2.683 16.598 -16.170 1.00113.19 C \nANISOU 2913 CB ASP B 57 14293 14160 14553 275 -1154 -446 C \nATOM 2914 CG ASP B 57 -3.629 17.542 -15.466 1.00114.08 C \nANISOU 2914 CG ASP B 57 14216 14548 14579 386 -1136 -498 C \nATOM 2915 OD1 ASP B 57 -4.630 17.956 -16.088 1.00119.04 O \nANISOU 2915 OD1 ASP B 57 14601 15477 15152 408 -1080 -531 O \nATOM 2916 OD2 ASP B 57 -3.373 17.844 -14.282 1.00113.72 O \nANISOU 2916 OD2 ASP B 57 14264 14432 14511 430 -1180 -503 O \nATOM 2917 N LYS B 58 -1.850 13.795 -17.407 1.00100.64 N \nANISOU 2917 N LYS B 58 12812 12201 13227 -185 -1067 -296 N \nATOM 2918 CA LYS B 58 -0.920 12.909 -18.135 1.00102.71 C \nANISOU 2918 CA LYS B 58 13216 12282 13529 -296 -1085 -254 C \nATOM 2919 C LYS B 58 -1.470 12.441 -19.474 1.00111.24 C \nANISOU 2919 C LYS B 58 14153 13455 14659 -336 -1017 -251 C \nATOM 2920 O LYS B 58 -0.715 12.109 -20.387 1.00115.64 O \nANISOU 2920 O LYS B 58 14821 13908 15209 -348 -1046 -240 O \nATOM 2921 CB LYS B 58 -0.558 11.691 -17.295 1.00 99.74 C \nANISOU 2921 CB LYS B 58 12878 11779 13240 -527 -1058 -183 C \nATOM 2922 CG LYS B 58 0.339 12.029 -16.121 1.00102.72 C \nANISOU 2922 CG LYS B 58 13462 12017 13550 -528 -1144 -174 C \nATOM 2923 CD LYS B 58 1.800 12.128 -16.559 1.00108.12 C \nANISOU 2923 CD LYS B 58 14448 12501 14132 -532 -1256 -163 C \nATOM 2924 CE LYS B 58 2.609 13.060 -15.663 1.00104.24 C \nANISOU 2924 CE LYS B 58 14232 11867 13505 -429 -1383 -183 C \nATOM 2925 NZ LYS B 58 2.516 14.481 -16.112 1.00102.02 N \nANISOU 2925 NZ LYS B 58 14033 11625 13102 -106 -1459 -270 N \nATOM 2926 N MET B 59 -2.789 12.464 -19.600 1.00111.88 N \nANISOU 2926 N MET B 59 14005 13733 14773 -367 -936 -259 N \nATOM 2927 CA MET B 59 -3.429 12.096 -20.836 1.00117.65 C \nANISOU 2927 CA MET B 59 14610 14561 15532 -417 -877 -256 C \nATOM 2928 C MET B 59 -3.178 13.099 -21.971 1.00119.25 C \nANISOU 2928 C MET B 59 14821 14864 15624 -220 -922 -316 C \nATOM 2929 O MET B 59 -3.586 12.835 -23.095 1.00118.27 O \nANISOU 2929 O MET B 59 14608 14816 15513 -257 -881 -315 O \nATOM 2930 CB MET B 59 -4.936 11.901 -20.622 1.00126.47 C \nANISOU 2930 CB MET B 59 15522 15853 16676 -535 -795 -243 C \nATOM 2931 CG MET B 59 -5.544 10.887 -21.571 1.00134.19 C \nANISOU 2931 CG MET B 59 16440 16828 17718 -682 -734 -208 C \nATOM 2932 SD MET B 59 -4.851 9.237 -21.303 1.00148.53 S \nANISOU 2932 SD MET B 59 18371 18410 19652 -818 -723 -149 S \nATOM 2933 CE MET B 59 -3.681 9.176 -22.668 1.00152.07 C \nANISOU 2933 CE MET B 59 18924 18770 20087 -749 -761 -158 C \nATOM 2934 N ASN B 60 -2.484 14.208 -21.695 1.00124.29 N \nANISOU 2934 N ASN B 60 15585 15498 16142 1 -1014 -373 N \nATOM 2935 CA ASN B 60 -2.141 15.248 -22.708 1.00137.08 C \nANISOU 2935 CA ASN B 60 17243 17219 17622 250 -1078 -447 C \nATOM 2936 C ASN B 60 -1.743 14.768 -24.131 1.00141.67 C \nANISOU 2936 C ASN B 60 17867 17732 18227 226 -1073 -435 C \nATOM 2937 O ASN B 60 -1.522 15.594 -25.040 1.00133.99 O \nANISOU 2937 O ASN B 60 16914 16860 17135 438 -1124 -499 O \nATOM 2938 CB ASN B 60 -0.981 16.115 -22.162 1.00144.94 C \nANISOU 2938 CB ASN B 60 18516 18064 18490 478 -1214 -494 C \nATOM 2939 CG ASN B 60 -1.449 17.371 -21.449 1.00148.59 C \nANISOU 2939 CG ASN B 60 18898 18746 18814 708 -1252 -571 C \nATOM 2940 OD1 ASN B 60 -2.468 17.975 -21.802 1.00151.06 O \nANISOU 2940 OD1 ASN B 60 18948 19390 19058 784 -1200 -618 O \nATOM 2941 ND2 ASN B 60 -0.676 17.799 -20.456 1.00150.01 N \nANISOU 2941 ND2 ASN B 60 19312 18759 18927 817 -1349 -586 N \nATOM 2942 N THR B 61 -1.660 13.447 -24.312 1.00142.65 N \nANISOU 2942 N THR B 61 18000 17707 18492 -13 -1016 -361 N \nATOM 2943 CA THR B 61 -1.134 12.830 -25.537 1.00149.85 C \nANISOU 2943 CA THR B 61 18979 18520 19439 -60 -1015 -341 C \nATOM 2944 C THR B 61 -1.885 13.155 -26.842 1.00162.71 C \nANISOU 2944 C THR B 61 20436 20355 21032 1 -971 -375 C \nATOM 2945 O THR B 61 -1.274 13.654 -27.791 1.00175.62 O \nANISOU 2945 O THR B 61 22161 21978 22586 156 -1028 -415 O \nATOM 2946 CB THR B 61 -1.031 11.298 -25.384 1.00141.18 C \nANISOU 2946 CB THR B 61 17883 17281 18480 -317 -957 -262 C \nATOM 2947 OG1 THR B 61 -2.318 10.748 -25.083 1.00134.67 O \nANISOU 2947 OG1 THR B 61 16854 16582 17732 -448 -863 -238 O \nATOM 2948 CG2 THR B 61 -0.059 10.930 -24.282 1.00132.67 C \nANISOU 2948 CG2 THR B 61 16986 16015 17406 -396 -1010 -226 C \nATOM 2949 N GLN B 62 -3.184 12.844 -26.893 1.00166.71 N \nANISOU 2949 N GLN B 62 20718 21040 21583 -134 -879 -357 N \nATOM 2950 CA GLN B 62 -4.017 13.052 -28.101 1.00160.50 C \nANISOU 2950 CA GLN B 62 19762 20467 20752 -140 -832 -377 C \nATOM 2951 C GLN B 62 -4.049 14.508 -28.637 1.00149.69 C \nANISOU 2951 C GLN B 62 18317 19354 19205 116 -880 -465 C \nATOM 2952 O GLN B 62 -4.127 15.469 -27.859 1.00143.95 O \nANISOU 2952 O GLN B 62 17558 18762 18373 267 -919 -515 O \nATOM 2953 CB GLN B 62 -5.454 12.511 -27.900 1.00162.16 C \nANISOU 2953 CB GLN B 62 19794 20814 21005 -364 -743 -336 C \nATOM 2954 CG GLN B 62 -6.371 13.312 -26.981 1.00164.99 C \nANISOU 2954 CG GLN B 62 20009 21401 21277 -366 -729 -358 C \nATOM 2955 CD GLN B 62 -5.955 13.256 -25.523 1.00176.48 C \nANISOU 2955 CD GLN B 62 21559 22712 22781 -349 -756 -346 C \nATOM 2956 OE1 GLN B 62 -5.000 12.571 -25.163 1.00176.66 O \nANISOU 2956 OE1 GLN B 62 21753 22472 22896 -359 -784 -316 O \nATOM 2957 NE2 GLN B 62 -6.665 13.986 -24.674 1.00195.70 N \nANISOU 2957 NE2 GLN B 62 23876 25342 25138 -335 -750 -369 N \nATOM 2958 N PHE B 63 -3.934 14.646 -29.963 1.00141.25 N \nANISOU 2958 N PHE B 63 17223 18357 18090 183 -883 -489 N \nATOM 2959 CA PHE B 63 -4.171 15.919 -30.672 1.00148.24 C \nANISOU 2959 CA PHE B 63 17979 19559 18786 415 -915 -578 C \nATOM 2960 C PHE B 63 -4.933 15.750 -32.008 1.00140.16 C \nANISOU 2960 C PHE B 63 16778 18739 17736 311 -852 -573 C \nATOM 2961 O PHE B 63 -6.013 16.309 -32.201 1.00126.47 O \nANISOU 2961 O PHE B 63 14805 17363 15886 264 -808 -597 O \nATOM 2962 CB PHE B 63 -2.851 16.641 -30.986 1.00153.49 C \nANISOU 2962 CB PHE B 63 18871 20098 19349 728 -1034 -645 C \nATOM 2963 CG PHE B 63 -1.944 16.854 -29.800 1.00156.68 C \nANISOU 2963 CG PHE B 63 19517 20267 19748 835 -1121 -650 C \nATOM 2964 CD1 PHE B 63 -2.144 17.924 -28.925 1.00151.18 C \nANISOU 2964 CD1 PHE B 63 18777 19751 18912 1038 -1169 -717 C \nATOM 2965 CD2 PHE B 63 -0.861 16.013 -29.586 1.00156.27 C \nANISOU 2965 CD2 PHE B 63 19738 19833 19803 731 -1163 -591 C \nATOM 2966 CE1 PHE B 63 -1.301 18.132 -27.843 1.00147.02 C \nANISOU 2966 CE1 PHE B 63 18500 18992 18368 1135 -1258 -722 C \nATOM 2967 CE2 PHE B 63 -0.015 16.215 -28.503 1.00159.63 C \nANISOU 2967 CE2 PHE B 63 20406 20047 20200 795 -1250 -590 C \nATOM 2968 CZ PHE B 63 -0.236 17.275 -27.631 1.00151.50 C \nANISOU 2968 CZ PHE B 63 19355 19163 19043 1001 -1300 -655 C \nATOM 2969 N GLU B 64 -4.348 14.971 -32.921 1.00141.10 N \nANISOU 2969 N GLU B 64 17020 18642 17951 258 -851 -539 N \nATOM 2970 CA GLU B 64 -4.880 14.786 -34.281 1.00136.96 C \nANISOU 2970 CA GLU B 64 16371 18266 17403 180 -804 -536 C \nATOM 2971 C GLU B 64 -5.935 13.701 -34.256 1.00130.56 C \nANISOU 2971 C GLU B 64 15477 17428 16701 -151 -714 -454 C \nATOM 2972 O GLU B 64 -5.942 12.898 -33.334 1.00145.37 O \nANISOU 2972 O GLU B 64 17441 19097 18698 -287 -697 -400 O \nATOM 2973 CB GLU B 64 -3.778 14.341 -35.257 1.00136.37 C \nANISOU 2973 CB GLU B 64 16482 17947 17385 259 -845 -532 C \nATOM 2974 CG GLU B 64 -2.783 15.426 -35.659 1.00142.33 C \nANISOU 2974 CG GLU B 64 17358 18728 17993 600 -949 -619 C \nATOM 2975 CD GLU B 64 -3.377 16.517 -36.560 1.00143.58 C \nANISOU 2975 CD GLU B 64 17303 19295 17957 779 -951 -703 C \nATOM 2976 OE1 GLU B 64 -3.657 16.275 -37.765 1.00138.82 O \nANISOU 2976 OE1 GLU B 64 16611 18783 17350 715 -913 -696 O \nATOM 2977 OE2 GLU B 64 -3.557 17.649 -36.057 1.00146.01 O \nANISOU 2977 OE2 GLU B 64 17521 19860 18095 996 -994 -780 O \nATOM 2978 N ALA B 65 -6.784 13.643 -35.282 1.00112.18 N \nANISOU 2978 N ALA B 65 13009 15297 14317 -275 -667 -446 N \nATOM 2979 CA ALA B 65 -7.778 12.574 -35.393 1.00102.36 C \nANISOU 2979 CA ALA B 65 11751 13991 13151 -583 -603 -369 C \nATOM 2980 C ALA B 65 -8.048 12.241 -36.860 1.00 99.78 C \nANISOU 2980 C ALA B 65 11393 13716 12803 -664 -579 -358 C \nATOM 2981 O ALA B 65 -7.967 13.131 -37.712 1.00105.79 O \nANISOU 2981 O ALA B 65 12038 14721 13434 -530 -593 -414 O \nATOM 2982 CB ALA B 65 -9.058 12.963 -34.666 1.00 93.85 C \nANISOU 2982 CB ALA B 65 10526 13163 11972 -754 -572 -357 C \nATOM 2983 N VAL B 66 -8.309 10.963 -37.172 1.00 91.56 N \nANISOU 2983 N VAL B 66 10462 12448 11878 -855 -550 -293 N \nATOM 2984 CA VAL B 66 -8.546 10.541 -38.579 1.00 92.46 C \nANISOU 2984 CA VAL B 66 10573 12577 11980 -937 -531 -278 C \nATOM 2985 C VAL B 66 -9.243 9.167 -38.626 1.00 90.61 C \nANISOU 2985 C VAL B 66 10464 12136 11828 -1174 -505 -207 C \nATOM 2986 O VAL B 66 -9.124 8.388 -37.681 1.00 87.82 O \nANISOU 2986 O VAL B 66 10224 11567 11575 -1206 -509 -177 O \nATOM 2987 CB VAL B 66 -7.240 10.632 -39.478 1.00 85.72 C \nANISOU 2987 CB VAL B 66 9787 11611 11171 -716 -563 -315 C \nATOM 2988 CG1 VAL B 66 -5.947 10.637 -38.635 1.00 81.17 C \nANISOU 2988 CG1 VAL B 66 9351 10812 10680 -536 -612 -331 C \nATOM 2989 CG2 VAL B 66 -7.189 9.503 -40.508 1.00 82.59 C \nANISOU 2989 CG2 VAL B 66 9485 11032 10863 -824 -543 -273 C \nATOM 2990 N GLY B 67 -10.024 8.934 -39.693 1.00 93.25 N \nANISOU 2990 N GLY B 67 10781 12558 12093 -1332 -487 -185 N \nATOM 2991 CA GLY B 67 -10.537 7.603 -40.065 1.00 89.04 C \nANISOU 2991 CA GLY B 67 10414 11802 11617 -1503 -482 -129 C \nATOM 2992 C GLY B 67 -9.585 6.938 -41.042 1.00 85.97 C \nANISOU 2992 C GLY B 67 10102 11234 11330 -1382 -486 -135 C \nATOM 2993 O GLY B 67 -8.499 6.570 -40.627 1.00 85.11 O \nANISOU 2993 O GLY B 67 10053 10948 11337 -1231 -498 -146 O \nATOM 2994 N ARG B 68 -10.013 6.785 -42.314 1.00 83.64 N \nANISOU 2994 N ARG B 68 9805 10997 10976 -1472 -478 -125 N \nATOM 2995 CA ARG B 68 -9.166 6.457 -43.526 1.00 71.04 C \nANISOU 2995 CA ARG B 68 8236 9314 9441 -1357 -479 -140 C \nATOM 2996 C ARG B 68 -9.917 5.600 -44.556 1.00 70.84 C \nANISOU 2996 C ARG B 68 8313 9219 9385 -1522 -475 -103 C \nATOM 2997 O ARG B 68 -10.783 4.799 -44.195 1.00 80.30 O \nANISOU 2997 O ARG B 68 9648 10298 10562 -1681 -487 -63 O \nATOM 2998 CB ARG B 68 -7.853 5.800 -43.183 1.00 73.05 C \nANISOU 2998 CB ARG B 68 8584 9329 9844 -1189 -493 -147 C \nATOM 2999 CG ARG B 68 -6.791 5.871 -44.284 1.00 77.98 C \nANISOU 2999 CG ARG B 68 9208 9917 10504 -1047 -501 -173 C \nATOM 3000 CD ARG B 68 -5.432 6.347 -43.754 1.00 74.19 C \nANISOU 3000 CD ARG B 68 8749 9371 10071 -856 -533 -204 C \nATOM 3001 NE ARG B 68 -5.195 5.827 -42.416 1.00 80.30 N \nANISOU 3001 NE ARG B 68 9589 10008 10913 -873 -541 -184 N \nATOM 3002 CZ ARG B 68 -4.742 6.548 -41.392 1.00 93.23 C \nANISOU 3002 CZ ARG B 68 11218 11666 12538 -784 -566 -205 C \nATOM 3003 NH1 ARG B 68 -4.446 7.833 -41.562 1.00102.62 N \nANISOU 3003 NH1 ARG B 68 12347 13004 13640 -640 -594 -253 N \nATOM 3004 NH2 ARG B 68 -4.593 5.978 -40.207 1.00 84.68 N \nANISOU 3004 NH2 ARG B 68 10193 10466 11516 -823 -568 -182 N \nATOM 3005 N GLU B 69 -9.592 5.774 -45.840 1.00 64.11 N \nANISOU 3005 N GLU B 69 7415 8430 8514 -1477 -469 -118 N \nATOM 3006 CA GLU B 69 -10.420 5.254 -46.928 1.00 63.27 C \nANISOU 3006 CA GLU B 69 7382 8321 8337 -1652 -468 -87 C \nATOM 3007 C GLU B 69 -9.640 4.418 -47.935 1.00 59.87 C \nANISOU 3007 C GLU B 69 7038 7706 8004 -1547 -471 -90 C \nATOM 3008 O GLU B 69 -8.593 4.830 -48.397 1.00 62.48 O \nANISOU 3008 O GLU B 69 7290 8064 8387 -1372 -466 -125 O \nATOM 3009 CB GLU B 69 -11.094 6.422 -47.633 1.00 72.77 C \nANISOU 3009 CB GLU B 69 8410 9874 9366 -1759 -455 -100 C \nATOM 3010 CG GLU B 69 -12.386 6.097 -48.385 1.00 79.80 C \nANISOU 3010 CG GLU B 69 9382 10826 10113 -2054 -463 -52 C \nATOM 3011 CD GLU B 69 -13.467 7.180 -48.241 1.00 85.01 C \nANISOU 3011 CD GLU B 69 9883 11863 10553 -2275 -456 -45 C \nATOM 3012 OE1 GLU B 69 -13.237 8.209 -47.546 1.00 80.19 O \nANISOU 3012 OE1 GLU B 69 9078 11487 9902 -2168 -442 -86 O \nATOM 3013 OE2 GLU B 69 -14.559 7.011 -48.842 1.00 93.98 O \nANISOU 3013 OE2 GLU B 69 11094 13080 11533 -2566 -470 2 O \nATOM 3014 N PHE B 70 -10.194 3.268 -48.324 1.00 59.85 N \nANISOU 3014 N PHE B 70 7213 7524 8003 -1655 -487 -55 N \nATOM 3015 CA PHE B 70 -9.505 2.266 -49.151 1.00 53.11 C \nANISOU 3015 CA PHE B 70 6455 6486 7237 -1553 -493 -58 C \nATOM 3016 C PHE B 70 -10.420 1.656 -50.168 1.00 50.44 C \nANISOU 3016 C PHE B 70 6256 6098 6812 -1706 -512 -30 C \nATOM 3017 O PHE B 70 -11.579 1.520 -49.911 1.00 64.43 O \nANISOU 3017 O PHE B 70 8144 7864 8473 -1894 -537 2 O \nATOM 3018 CB PHE B 70 -8.978 1.138 -48.279 1.00 53.80 C \nANISOU 3018 CB PHE B 70 6659 6355 7427 -1447 -509 -58 C \nATOM 3019 CG PHE B 70 -7.982 1.587 -47.229 1.00 50.17 C \nANISOU 3019 CG PHE B 70 6099 5911 7051 -1314 -498 -79 C \nATOM 3020 CD1 PHE B 70 -8.362 1.714 -45.945 1.00 46.68 C \nANISOU 3020 CD1 PHE B 70 5665 5469 6602 -1348 -504 -72 C \nATOM 3021 CD2 PHE B 70 -6.692 1.933 -47.589 1.00 45.99 C \nANISOU 3021 CD2 PHE B 70 5492 5394 6590 -1170 -492 -105 C \nATOM 3022 CE1 PHE B 70 -7.463 2.136 -44.999 1.00 46.28 C \nANISOU 3022 CE1 PHE B 70 5540 5427 6616 -1237 -501 -90 C \nATOM 3023 CE2 PHE B 70 -5.799 2.401 -46.685 1.00 43.67 C \nANISOU 3023 CE2 PHE B 70 5150 5101 6343 -1071 -498 -121 C \nATOM 3024 CZ PHE B 70 -6.181 2.496 -45.363 1.00 45.50 C \nANISOU 3024 CZ PHE B 70 5384 5332 6573 -1103 -501 -113 C \nATOM 3025 N ASN B 71 -9.892 1.246 -51.311 1.00 47.65 N \nANISOU 3025 N ASN B 71 5917 5690 6498 -1633 -507 -39 N \nATOM 3026 CA ASN B 71 -10.702 0.676 -52.354 1.00 48.28 C \nANISOU 3026 CA ASN B 71 6142 5713 6489 -1769 -531 -14 C \nATOM 3027 C ASN B 71 -10.863 -0.852 -52.200 1.00 47.27 C \nANISOU 3027 C ASN B 71 6262 5316 6384 -1719 -576 -5 C \nATOM 3028 O ASN B 71 -10.656 -1.391 -51.144 1.00 54.32 O \nANISOU 3028 O ASN B 71 7207 6105 7327 -1628 -589 -13 O \nATOM 3029 CB ASN B 71 -10.178 1.087 -53.745 1.00 49.15 C \nANISOU 3029 CB ASN B 71 6141 5929 6605 -1724 -506 -30 C \nATOM 3030 CG ASN B 71 -8.988 0.303 -54.186 1.00 50.04 C \nANISOU 3030 CG ASN B 71 6274 5890 6851 -1523 -502 -53 C \nATOM 3031 OD1 ASN B 71 -8.591 -0.672 -53.557 1.00 66.48 O \nANISOU 3031 OD1 ASN B 71 8452 7804 9005 -1425 -518 -57 O \nATOM 3032 ND2 ASN B 71 -8.386 0.732 -55.242 1.00 52.51 N \nANISOU 3032 ND2 ASN B 71 6486 6286 7180 -1461 -482 -71 N \nATOM 3033 N ASN B 72 -11.316 -1.520 -53.227 1.00 48.16 N \nANISOU 3033 N ASN B 72 6532 5334 6433 -1774 -606 7 N \nATOM 3034 CA ASN B 72 -11.666 -2.905 -53.126 1.00 51.60 C \nANISOU 3034 CA ASN B 72 7232 5536 6838 -1715 -667 7 C \nATOM 3035 C ASN B 72 -10.439 -3.815 -53.267 1.00 51.80 C \nANISOU 3035 C ASN B 72 7211 5482 6987 -1457 -655 -33 C \nATOM 3036 O ASN B 72 -10.471 -4.934 -52.785 1.00 53.02 O \nANISOU 3036 O ASN B 72 7518 5499 7127 -1334 -698 -51 O \nATOM 3037 CB ASN B 72 -12.668 -3.247 -54.210 1.00 55.67 C \nANISOU 3037 CB ASN B 72 7968 5975 7208 -1879 -718 35 C \nATOM 3038 CG ASN B 72 -13.437 -4.495 -53.909 1.00 60.21 C \nANISOU 3038 CG ASN B 72 8897 6302 7679 -1856 -811 37 C \nATOM 3039 OD1 ASN B 72 -13.757 -4.776 -52.742 1.00 68.46 O \nANISOU 3039 OD1 ASN B 72 10042 7269 8702 -1829 -844 35 O \nATOM 3040 ND2 ASN B 72 -13.808 -5.231 -54.955 1.00 59.49 N \nANISOU 3040 ND2 ASN B 72 9023 6079 7503 -1862 -865 40 N \nATOM 3041 N LEU B 73 -9.399 -3.355 -53.975 1.00 49.39 N \nANISOU 3041 N LEU B 73 6709 5280 6776 -1380 -604 -48 N \nATOM 3042 CA LEU B 73 -8.155 -4.059 -54.084 1.00 44.71 C \nANISOU 3042 CA LEU B 73 6048 4656 6285 -1185 -589 -79 C \nATOM 3043 C LEU B 73 -7.111 -3.600 -53.093 1.00 42.70 C \nANISOU 3043 C LEU B 73 5623 4475 6127 -1102 -556 -92 C \nATOM 3044 O LEU B 73 -5.928 -3.837 -53.313 1.00 47.11 O \nANISOU 3044 O LEU B 73 6092 5053 6756 -995 -539 -108 O \nATOM 3045 CB LEU B 73 -7.622 -3.987 -55.499 1.00 42.88 C \nANISOU 3045 CB LEU B 73 5758 4457 6076 -1162 -570 -84 C \nATOM 3046 CG LEU B 73 -8.495 -4.724 -56.448 1.00 44.95 C \nANISOU 3046 CG LEU B 73 6219 4617 6243 -1213 -612 -75 C \nATOM 3047 CD1 LEU B 73 -7.936 -4.612 -57.862 1.00 43.26 C \nANISOU 3047 CD1 LEU B 73 5933 4446 6060 -1190 -588 -81 C \nATOM 3048 CD2 LEU B 73 -8.699 -6.206 -56.020 1.00 47.87 C \nANISOU 3048 CD2 LEU B 73 6786 4836 6566 -1077 -670 -98 C \nATOM 3049 N GLU B 74 -7.577 -3.013 -51.994 1.00 45.15 N \nANISOU 3049 N GLU B 74 5914 4818 6422 -1167 -556 -81 N \nATOM 3050 CA GLU B 74 -6.709 -2.615 -50.862 1.00 42.72 C \nANISOU 3050 CA GLU B 74 5483 4558 6190 -1097 -536 -91 C \nATOM 3051 C GLU B 74 -7.275 -3.134 -49.555 1.00 43.41 C \nANISOU 3051 C GLU B 74 5657 4586 6250 -1099 -560 -89 C \nATOM 3052 O GLU B 74 -7.225 -2.460 -48.550 1.00 42.94 O \nANISOU 3052 O GLU B 74 5526 4577 6212 -1123 -549 -85 O \nATOM 3053 CB GLU B 74 -6.575 -1.095 -50.800 1.00 42.75 C \nANISOU 3053 CB GLU B 74 5344 4698 6200 -1147 -510 -90 C \nATOM 3054 CG GLU B 74 -5.948 -0.477 -52.071 1.00 42.78 C \nANISOU 3054 CG GLU B 74 5263 4776 6217 -1112 -493 -102 C \nATOM 3055 CD GLU B 74 -5.895 1.043 -51.982 1.00 44.59 C \nANISOU 3055 CD GLU B 74 5358 5172 6414 -1115 -480 -115 C \nATOM 3056 OE1 GLU B 74 -6.951 1.640 -51.688 1.00 46.47 O \nANISOU 3056 OE1 GLU B 74 5568 5520 6569 -1230 -477 -106 O \nATOM 3057 OE2 GLU B 74 -4.810 1.636 -52.241 1.00 40.17 O \nANISOU 3057 OE2 GLU B 74 4732 4643 5887 -999 -482 -139 O \nATOM 3058 N ARG B 75 -7.719 -4.387 -49.546 1.00 43.13 N \nANISOU 3058 N ARG B 75 5782 4443 6162 -1041 -601 -98 N \nATOM 3059 CA ARG B 75 -8.254 -5.006 -48.346 1.00 42.90 C \nANISOU 3059 CA ARG B 75 5862 4349 6088 -1007 -636 -105 C \nATOM 3060 C ARG B 75 -7.175 -5.373 -47.301 1.00 40.36 C \nANISOU 3060 C ARG B 75 5416 4086 5831 -884 -620 -126 C \nATOM 3061 O ARG B 75 -7.433 -5.380 -46.104 1.00 39.02 O \nANISOU 3061 O ARG B 75 5262 3912 5653 -881 -630 -127 O \nATOM 3062 CB ARG B 75 -9.082 -6.231 -48.737 1.00 46.85 C \nANISOU 3062 CB ARG B 75 6609 4715 6475 -946 -703 -119 C \nATOM 3063 CG ARG B 75 -10.251 -5.917 -49.654 1.00 48.10 C \nANISOU 3063 CG ARG B 75 6942 4798 6537 -1112 -735 -89 C \nATOM 3064 CD ARG B 75 -11.072 -4.833 -49.016 1.00 56.81 C \nANISOU 3064 CD ARG B 75 8037 5944 7604 -1315 -728 -52 C \nATOM 3065 NE ARG B 75 -12.348 -4.603 -49.664 1.00 69.04 N \nANISOU 3065 NE ARG B 75 9783 7437 9011 -1527 -773 -16 N \nATOM 3066 CZ ARG B 75 -13.132 -3.548 -49.394 1.00 80.78 C \nANISOU 3066 CZ ARG B 75 11241 9022 10431 -1760 -764 22 C \nATOM 3067 NH1 ARG B 75 -12.741 -2.630 -48.508 1.00 85.19 N \nANISOU 3067 NH1 ARG B 75 11578 9728 11063 -1769 -711 21 N \nATOM 3068 NH2 ARG B 75 -14.301 -3.393 -50.020 1.00 77.42 N \nANISOU 3068 NH2 ARG B 75 11008 8565 9843 -1996 -811 62 N \nATOM 3069 N ARG B 76 -5.963 -5.661 -47.748 1.00 40.97 N \nANISOU 3069 N ARG B 76 5375 4230 5961 -805 -597 -141 N \nATOM 3070 CA ARG B 76 -4.865 -5.962 -46.749 1.00 40.00 C \nANISOU 3070 CA ARG B 76 5132 4193 5873 -739 -585 -153 C \nATOM 3071 C ARG B 76 -4.506 -4.760 -45.962 1.00 36.20 C \nANISOU 3071 C ARG B 76 4558 3744 5454 -821 -560 -132 C \nATOM 3072 O ARG B 76 -4.582 -4.752 -44.737 1.00 32.64 O \nANISOU 3072 O ARG B 76 4094 3305 5001 -819 -565 -132 O \nATOM 3073 CB ARG B 76 -3.641 -6.475 -47.470 1.00 37.81 C \nANISOU 3073 CB ARG B 76 4763 3995 5609 -688 -572 -164 C \nATOM 3074 CG ARG B 76 -3.837 -7.827 -48.148 1.00 37.48 C \nANISOU 3074 CG ARG B 76 4791 3964 5488 -565 -600 -198 C \nATOM 3075 CD ARG B 76 -2.670 -8.152 -49.032 1.00 36.11 C \nANISOU 3075 CD ARG B 76 4514 3883 5324 -550 -583 -203 C \nATOM 3076 NE ARG B 76 -2.598 -7.170 -50.094 1.00 38.47 N \nANISOU 3076 NE ARG B 76 4813 4117 5687 -639 -562 -177 N \nATOM 3077 CZ ARG B 76 -1.481 -6.892 -50.737 1.00 42.96 C \nANISOU 3077 CZ ARG B 76 5298 4735 6288 -676 -545 -167 C \nATOM 3078 NH1 ARG B 76 -0.326 -7.499 -50.397 1.00 47.66 N \nANISOU 3078 NH1 ARG B 76 5805 5452 6853 -673 -546 -173 N \nATOM 3079 NH2 ARG B 76 -1.494 -6.042 -51.708 1.00 43.40 N \nANISOU 3079 NH2 ARG B 76 5365 4737 6386 -725 -533 -153 N \nATOM 3080 N ILE B 77 -4.277 -3.661 -46.689 1.00 37.08 N \nANISOU 3080 N ILE B 77 4618 3868 5604 -882 -540 -118 N \nATOM 3081 CA ILE B 77 -4.028 -2.361 -46.031 1.00 39.07 C \nANISOU 3081 CA ILE B 77 4798 4157 5890 -928 -529 -108 C \nATOM 3082 C ILE B 77 -5.172 -1.939 -45.154 1.00 37.94 C \nANISOU 3082 C ILE B 77 4686 4010 5718 -987 -532 -100 C \nATOM 3083 O ILE B 77 -4.976 -1.417 -44.042 1.00 47.77 O \nANISOU 3083 O ILE B 77 5888 5281 6981 -992 -530 -98 O \nATOM 3084 CB ILE B 77 -3.795 -1.269 -47.104 1.00 46.75 C \nANISOU 3084 CB ILE B 77 5725 5167 6870 -943 -518 -109 C \nATOM 3085 CG1 ILE B 77 -2.557 -1.553 -47.921 1.00 47.63 C \nANISOU 3085 CG1 ILE B 77 5822 5269 7006 -895 -522 -114 C \nATOM 3086 CG2 ILE B 77 -3.555 0.084 -46.440 1.00 56.98 C \nANISOU 3086 CG2 ILE B 77 6959 6522 8171 -940 -519 -113 C \nATOM 3087 CD1 ILE B 77 -1.331 -1.804 -47.054 1.00 48.16 C \nANISOU 3087 CD1 ILE B 77 5875 5334 7087 -882 -537 -110 C \nATOM 3088 N GLU B 78 -6.391 -2.113 -45.624 1.00 38.79 N \nANISOU 3088 N GLU B 78 4886 4087 5766 -1051 -542 -92 N \nATOM 3089 CA GLU B 78 -7.562 -1.670 -44.846 1.00 43.94 C \nANISOU 3089 CA GLU B 78 5588 4742 6363 -1151 -552 -77 C \nATOM 3090 C GLU B 78 -7.680 -2.420 -43.557 1.00 42.56 C \nANISOU 3090 C GLU B 78 5476 4508 6186 -1103 -573 -82 C \nATOM 3091 O GLU B 78 -7.961 -1.864 -42.521 1.00 55.79 O \nANISOU 3091 O GLU B 78 7123 6212 7862 -1146 -570 -75 O \nATOM 3092 CB GLU B 78 -8.807 -1.868 -45.714 1.00 53.36 C \nANISOU 3092 CB GLU B 78 6919 5895 7461 -1263 -575 -61 C \nATOM 3093 CG GLU B 78 -10.112 -1.439 -45.054 1.00 65.60 C \nANISOU 3093 CG GLU B 78 8554 7453 8916 -1422 -596 -36 C \nATOM 3094 CD GLU B 78 -11.309 -1.694 -45.952 1.00 76.54 C \nANISOU 3094 CD GLU B 78 10121 8785 10175 -1574 -634 -12 C \nATOM 3095 OE1 GLU B 78 -12.113 -0.760 -46.167 1.00 96.28 O \nANISOU 3095 OE1 GLU B 78 12591 11406 12586 -1766 -628 14 O \nATOM 3096 OE2 GLU B 78 -11.452 -2.828 -46.467 1.00 79.47 O \nANISOU 3096 OE2 GLU B 78 10670 9009 10514 -1507 -675 -20 O \nATOM 3097 N ASN B 79 -7.416 -3.702 -43.620 1.00 46.13 N \nANISOU 3097 N ASN B 79 6000 4900 6625 -996 -595 -101 N \nATOM 3098 CA ASN B 79 -7.499 -4.570 -42.458 1.00 52.11 C \nANISOU 3098 CA ASN B 79 6813 5630 7355 -914 -621 -117 C \nATOM 3099 C ASN B 79 -6.377 -4.184 -41.515 1.00 48.89 C \nANISOU 3099 C ASN B 79 6246 5310 7020 -890 -592 -118 C \nATOM 3100 O ASN B 79 -6.558 -4.196 -40.292 1.00 41.92 O \nANISOU 3100 O ASN B 79 5364 4432 6132 -886 -599 -119 O \nATOM 3101 CB ASN B 79 -7.356 -6.044 -42.876 1.00 55.19 C \nANISOU 3101 CB ASN B 79 7289 5994 7685 -764 -655 -151 C \nATOM 3102 CG ASN B 79 -7.710 -6.993 -41.764 1.00 62.44 C \nANISOU 3102 CG ASN B 79 8297 6897 8531 -649 -698 -179 C \nATOM 3103 OD1 ASN B 79 -6.868 -7.711 -41.292 1.00 63.10 O \nANISOU 3103 OD1 ASN B 79 8280 7086 8607 -532 -694 -208 O \nATOM 3104 ND2 ASN B 79 -8.977 -6.993 -41.339 1.00 70.89 N \nANISOU 3104 ND2 ASN B 79 9562 7847 9525 -691 -744 -172 N \nATOM 3105 N LEU B 80 -5.206 -3.897 -42.099 1.00 44.48 N \nANISOU 3105 N LEU B 80 5576 4809 6514 -881 -568 -117 N \nATOM 3106 CA LEU B 80 -4.052 -3.416 -41.322 1.00 44.89 C \nANISOU 3106 CA LEU B 80 5521 4922 6613 -890 -555 -112 C \nATOM 3107 C LEU B 80 -4.405 -2.147 -40.576 1.00 42.77 C \nANISOU 3107 C LEU B 80 5230 4652 6369 -951 -548 -98 C \nATOM 3108 O LEU B 80 -4.171 -2.024 -39.370 1.00 40.42 O \nANISOU 3108 O LEU B 80 4907 4371 6081 -954 -552 -96 O \nATOM 3109 CB LEU B 80 -2.857 -3.180 -42.271 1.00 46.13 C \nANISOU 3109 CB LEU B 80 5624 5107 6795 -894 -548 -108 C \nATOM 3110 CG LEU B 80 -1.601 -2.549 -41.713 1.00 48.20 C \nANISOU 3110 CG LEU B 80 5841 5395 7077 -928 -555 -97 C \nATOM 3111 CD1 LEU B 80 -1.220 -3.128 -40.383 1.00 56.08 C \nANISOU 3111 CD1 LEU B 80 6811 6445 8052 -939 -564 -95 C \nATOM 3112 CD2 LEU B 80 -0.459 -2.743 -42.631 1.00 49.46 C \nANISOU 3112 CD2 LEU B 80 5995 5571 7227 -940 -564 -93 C \nATOM 3113 N ASN B 81 -4.986 -1.181 -41.297 1.00 44.52 N \nANISOU 3113 N ASN B 81 5449 4881 6587 -998 -539 -93 N \nATOM 3114 CA ASN B 81 -5.519 0.021 -40.636 1.00 50.36 C \nANISOU 3114 CA ASN B 81 6149 5669 7317 -1048 -534 -88 C \nATOM 3115 C ASN B 81 -6.542 -0.327 -39.534 1.00 53.38 C \nANISOU 3115 C ASN B 81 6589 6024 7668 -1095 -543 -79 C \nATOM 3116 O ASN B 81 -6.475 0.190 -38.435 1.00 51.79 O \nANISOU 3116 O ASN B 81 6349 5850 7479 -1101 -542 -78 O \nATOM 3117 CB ASN B 81 -6.235 0.903 -41.651 1.00 55.20 C \nANISOU 3117 CB ASN B 81 6736 6352 7886 -1105 -524 -87 C \nATOM 3118 CG ASN B 81 -6.507 2.293 -41.124 1.00 59.04 C \nANISOU 3118 CG ASN B 81 7134 6960 8340 -1126 -518 -95 C \nATOM 3119 OD1 ASN B 81 -5.599 3.109 -41.027 1.00 61.43 O \nANISOU 3119 OD1 ASN B 81 7377 7305 8657 -1039 -525 -114 O \nATOM 3120 ND2 ASN B 81 -7.729 2.545 -40.729 1.00 58.60 N \nANISOU 3120 ND2 ASN B 81 7085 6961 8218 -1237 -515 -82 N \nATOM 3121 N LYS B 82 -7.515 -1.175 -39.849 1.00 51.21 N \nANISOU 3121 N LYS B 82 6433 5684 7339 -1125 -561 -75 N \nATOM 3122 CA LYS B 82 -8.506 -1.535 -38.851 1.00 64.17 C \nANISOU 3122 CA LYS B 82 8177 7275 8929 -1166 -585 -68 C \nATOM 3123 C LYS B 82 -7.861 -2.123 -37.591 1.00 72.57 C \nANISOU 3123 C LYS B 82 9213 8332 10027 -1073 -590 -81 C \nATOM 3124 O LYS B 82 -8.259 -1.795 -36.474 1.00 73.38 O \nANISOU 3124 O LYS B 82 9318 8438 10123 -1107 -594 -75 O \nATOM 3125 CB LYS B 82 -9.474 -2.531 -39.431 1.00 75.20 C \nANISOU 3125 CB LYS B 82 9767 8566 10240 -1177 -626 -68 C \nATOM 3126 CG LYS B 82 -10.489 -3.060 -38.445 1.00 81.84 C \nANISOU 3126 CG LYS B 82 10777 9318 11001 -1198 -673 -65 C \nATOM 3127 CD LYS B 82 -11.508 -1.995 -38.076 1.00 93.67 C \nANISOU 3127 CD LYS B 82 12293 10853 12444 -1390 -673 -32 C \nATOM 3128 CE LYS B 82 -12.711 -2.618 -37.380 1.00100.12 C \nANISOU 3128 CE LYS B 82 13357 11539 13145 -1446 -739 -22 C \nATOM 3129 NZ LYS B 82 -12.374 -3.528 -36.240 1.00101.87 N \nANISOU 3129 NZ LYS B 82 13621 11699 13384 -1274 -763 -52 N \nATOM 3130 N LYS B 83 -6.872 -3.006 -37.756 1.00 76.67 N \nANISOU 3130 N LYS B 83 9697 8865 10568 -968 -590 -99 N \nATOM 3131 CA LYS B 83 -6.254 -3.682 -36.602 1.00 71.27 C \nANISOU 3131 CA LYS B 83 8973 8222 9886 -896 -597 -113 C \nATOM 3132 C LYS B 83 -5.373 -2.786 -35.767 1.00 60.54 C \nANISOU 3132 C LYS B 83 7501 6918 8584 -939 -577 -100 C \nATOM 3133 O LYS B 83 -5.309 -2.927 -34.526 1.00 57.23 O \nANISOU 3133 O LYS B 83 7064 6520 8160 -930 -582 -101 O \nATOM 3134 CB LYS B 83 -5.446 -4.883 -37.034 1.00 82.26 C \nANISOU 3134 CB LYS B 83 10335 9675 11246 -794 -604 -138 C \nATOM 3135 CG LYS B 83 -6.302 -6.044 -37.564 1.00 94.74 C \nANISOU 3135 CG LYS B 83 12057 11204 12737 -688 -643 -167 C \nATOM 3136 CD LYS B 83 -7.778 -6.001 -37.114 1.00 97.08 C \nANISOU 3136 CD LYS B 83 12536 11374 12974 -709 -682 -163 C \nATOM 3137 CE LYS B 83 -8.612 -7.219 -37.518 1.00 95.45 C \nANISOU 3137 CE LYS B 83 12540 11083 12645 -579 -747 -198 C \nATOM 3138 NZ LYS B 83 -10.031 -6.870 -37.811 1.00 91.38 N \nANISOU 3138 NZ LYS B 83 12253 10403 12064 -688 -791 -174 N \nATOM 3139 N MET B 84 -4.730 -1.835 -36.416 1.00 53.44 N \nANISOU 3139 N MET B 84 6547 6033 7726 -976 -562 -90 N \nATOM 3140 CA MET B 84 -4.069 -0.750 -35.680 1.00 50.19 C \nANISOU 3140 CA MET B 84 6081 5642 7345 -1004 -562 -81 C \nATOM 3141 C MET B 84 -5.007 -0.020 -34.747 1.00 51.61 C \nANISOU 3141 C MET B 84 6263 5825 7521 -1038 -559 -77 C \nATOM 3142 O MET B 84 -4.675 0.238 -33.579 1.00 55.99 O \nANISOU 3142 O MET B 84 6797 6391 8087 -1040 -565 -74 O \nATOM 3143 CB MET B 84 -3.462 0.279 -36.618 1.00 52.10 C \nANISOU 3143 CB MET B 84 6305 5890 7602 -1000 -563 -82 C \nATOM 3144 CG MET B 84 -2.501 1.189 -35.880 1.00 54.89 C \nANISOU 3144 CG MET B 84 6656 6242 7959 -992 -586 -80 C \nATOM 3145 SD MET B 84 -1.807 2.393 -36.917 1.00 68.56 S \nANISOU 3145 SD MET B 84 8410 7968 9673 -936 -610 -95 S \nATOM 3146 CE MET B 84 -3.224 3.510 -37.023 1.00 49.19 C \nANISOU 3146 CE MET B 84 5884 5615 7192 -917 -588 -114 C \nATOM 3147 N GLU B 85 -6.197 0.325 -35.229 1.00 56.11 N \nANISOU 3147 N GLU B 85 6862 6397 8059 -1085 -553 -74 N \nATOM 3148 CA GLU B 85 -7.192 1.029 -34.358 1.00 58.78 C \nANISOU 3148 CA GLU B 85 7199 6767 8368 -1151 -553 -67 C \nATOM 3149 C GLU B 85 -7.752 0.175 -33.264 1.00 56.66 C \nANISOU 3149 C GLU B 85 7006 6442 8082 -1155 -568 -63 C \nATOM 3150 O GLU B 85 -7.780 0.595 -32.118 1.00 65.16 O \nANISOU 3150 O GLU B 85 8051 7539 9168 -1166 -568 -61 O \nATOM 3151 CB GLU B 85 -8.332 1.629 -35.166 1.00 71.20 C \nANISOU 3151 CB GLU B 85 8784 8393 9874 -1250 -548 -59 C \nATOM 3152 CG GLU B 85 -7.906 2.572 -36.297 1.00 78.95 C \nANISOU 3152 CG GLU B 85 9675 9471 10849 -1231 -534 -70 C \nATOM 3153 CD GLU B 85 -6.982 3.707 -35.856 1.00 86.77 C \nANISOU 3153 CD GLU B 85 10568 10539 11860 -1143 -535 -92 C \nATOM 3154 OE1 GLU B 85 -6.787 3.942 -34.635 1.00 91.61 O \nANISOU 3154 OE1 GLU B 85 11171 11146 12490 -1123 -543 -93 O \nATOM 3155 OE2 GLU B 85 -6.451 4.388 -36.763 1.00 96.31 O \nANISOU 3155 OE2 GLU B 85 11728 11810 13054 -1080 -537 -111 O \nATOM 3156 N ASP B 86 -8.173 -1.030 -33.577 1.00 63.95 N \nANISOU 3156 N ASP B 86 8036 7293 8967 -1123 -589 -69 N \nATOM 3157 CA ASP B 86 -8.579 -1.984 -32.517 1.00 69.94 C \nANISOU 3157 CA ASP B 86 8882 8004 9690 -1073 -616 -78 C \nATOM 3158 C ASP B 86 -7.415 -2.230 -31.568 1.00 73.52 C \nANISOU 3158 C ASP B 86 9228 8519 10188 -1003 -605 -89 C \nATOM 3159 O ASP B 86 -7.612 -2.334 -30.373 1.00 80.98 O \nANISOU 3159 O ASP B 86 10178 9467 11123 -994 -614 -90 O \nATOM 3160 CB ASP B 86 -9.015 -3.334 -33.104 1.00 78.80 C \nANISOU 3160 CB ASP B 86 10148 9053 10738 -986 -655 -99 C \nATOM 3161 CG ASP B 86 -10.231 -3.218 -34.002 1.00 91.79 C \nANISOU 3161 CG ASP B 86 11955 10611 12310 -1080 -682 -83 C \nATOM 3162 OD1 ASP B 86 -10.999 -2.241 -33.853 1.00105.51 O \nANISOU 3162 OD1 ASP B 86 13704 12359 14026 -1232 -677 -55 O \nATOM 3163 OD2 ASP B 86 -10.432 -4.104 -34.867 1.00 99.79 O \nANISOU 3163 OD2 ASP B 86 13089 11560 13267 -1013 -714 -99 O \nATOM 3164 N GLY B 87 -6.209 -2.339 -32.120 1.00 71.49 N \nANISOU 3164 N GLY B 87 8885 8313 9964 -973 -591 -92 N \nATOM 3165 CA GLY B 87 -5.011 -2.571 -31.319 1.00 70.78 C \nANISOU 3165 CA GLY B 87 8708 8298 9888 -956 -588 -94 C \nATOM 3166 C GLY B 87 -4.830 -1.528 -30.229 1.00 64.61 C \nANISOU 3166 C GLY B 87 7890 7516 9141 -1011 -584 -78 C \nATOM 3167 O GLY B 87 -4.748 -1.889 -29.055 1.00 74.70 O \nANISOU 3167 O GLY B 87 9152 8827 10405 -1002 -591 -80 O \nATOM 3168 N PHE B 88 -4.773 -0.252 -30.607 1.00 46.50 N \nANISOU 3168 N PHE B 88 5584 5204 6880 -1050 -578 -68 N \nATOM 3169 CA PHE B 88 -4.585 0.823 -29.638 1.00 49.54 C \nANISOU 3169 CA PHE B 88 5943 5597 7281 -1072 -583 -62 C \nATOM 3170 C PHE B 88 -5.761 1.057 -28.733 1.00 55.89 C \nANISOU 3170 C PHE B 88 6759 6403 8074 -1098 -578 -61 C \nATOM 3171 O PHE B 88 -5.609 1.433 -27.555 1.00 60.19 O \nANISOU 3171 O PHE B 88 7284 6958 8626 -1105 -583 -58 O \nATOM 3172 CB PHE B 88 -4.244 2.134 -30.334 1.00 47.37 C \nANISOU 3172 CB PHE B 88 5655 5332 7010 -1058 -588 -68 C \nATOM 3173 CG PHE B 88 -2.858 2.181 -30.876 1.00 40.60 C \nANISOU 3173 CG PHE B 88 4826 4450 6152 -1041 -612 -66 C \nATOM 3174 CD1 PHE B 88 -1.760 2.016 -30.037 1.00 43.85 C \nANISOU 3174 CD1 PHE B 88 5270 4841 6549 -1071 -640 -53 C \nATOM 3175 CD2 PHE B 88 -2.650 2.424 -32.161 1.00 40.44 C \nANISOU 3175 CD2 PHE B 88 4815 4425 6127 -1015 -613 -73 C \nATOM 3176 CE1 PHE B 88 -0.449 2.078 -30.513 1.00 44.49 C \nANISOU 3176 CE1 PHE B 88 5418 4887 6600 -1095 -676 -44 C \nATOM 3177 CE2 PHE B 88 -1.336 2.499 -32.660 1.00 44.54 C \nANISOU 3177 CE2 PHE B 88 5392 4903 6629 -1010 -646 -69 C \nATOM 3178 CZ PHE B 88 -0.247 2.296 -31.843 1.00 42.13 C \nANISOU 3178 CZ PHE B 88 5142 4568 6298 -1061 -680 -52 C \nATOM 3179 N LEU B 89 -6.939 0.752 -29.245 1.00 68.36 N \nANISOU 3179 N LEU B 89 8390 7962 9621 -1125 -575 -61 N \nATOM 3180 CA LEU B 89 -8.166 0.870 -28.456 1.00 76.68 C \nANISOU 3180 CA LEU B 89 9493 9004 10638 -1182 -581 -54 C \nATOM 3181 C LEU B 89 -8.157 -0.126 -27.308 1.00 77.95 C \nANISOU 3181 C LEU B 89 9697 9130 10790 -1133 -598 -60 C \nATOM 3182 O LEU B 89 -8.477 0.223 -26.171 1.00 88.60 O \nANISOU 3182 O LEU B 89 11040 10487 12139 -1159 -600 -55 O \nATOM 3183 CB LEU B 89 -9.365 0.624 -29.360 1.00 89.00 C \nANISOU 3183 CB LEU B 89 11154 10529 12133 -1250 -592 -46 C \nATOM 3184 CG LEU B 89 -10.751 0.586 -28.717 1.00 99.12 C \nANISOU 3184 CG LEU B 89 12550 11773 13338 -1347 -616 -32 C \nATOM 3185 CD1 LEU B 89 -11.839 0.991 -29.697 1.00 93.64 C \nANISOU 3185 CD1 LEU B 89 11928 11096 12557 -1491 -626 -12 C \nATOM 3186 CD2 LEU B 89 -11.018 -0.823 -28.218 1.00104.81 C \nANISOU 3186 CD2 LEU B 89 13420 12382 14022 -1263 -656 -45 C \nATOM 3187 N ASP B 90 -7.796 -1.372 -27.615 1.00 78.85 N \nANISOU 3187 N ASP B 90 9845 9230 10884 -1051 -610 -76 N \nATOM 3188 CA ASP B 90 -7.688 -2.432 -26.607 1.00 83.84 C \nANISOU 3188 CA ASP B 90 10495 9882 11479 -969 -629 -95 C \nATOM 3189 C ASP B 90 -6.729 -1.999 -25.500 1.00 79.05 C \nANISOU 3189 C ASP B 90 9777 9346 10913 -992 -615 -86 C \nATOM 3190 O ASP B 90 -7.071 -2.048 -24.332 1.00 85.98 O \nANISOU 3190 O ASP B 90 10664 10226 11777 -987 -623 -88 O \nATOM 3191 CB ASP B 90 -7.217 -3.745 -27.234 1.00 95.93 C \nANISOU 3191 CB ASP B 90 12030 11458 12959 -858 -644 -123 C \nATOM 3192 CG ASP B 90 -8.322 -4.464 -28.014 1.00111.70 C \nANISOU 3192 CG ASP B 90 14198 13363 14882 -796 -681 -141 C \nATOM 3193 OD1 ASP B 90 -9.411 -3.875 -28.258 1.00115.01 O \nANISOU 3193 OD1 ASP B 90 14736 13676 15287 -886 -694 -121 O \nATOM 3194 OD2 ASP B 90 -8.082 -5.640 -28.390 1.00135.78 O \nANISOU 3194 OD2 ASP B 90 17269 16458 17862 -662 -704 -176 O \nATOM 3195 N VAL B 91 -5.540 -1.551 -25.888 1.00 71.83 N \nANISOU 3195 N VAL B 91 8784 8474 10035 -1024 -602 -76 N \nATOM 3196 CA VAL B 91 -4.496 -1.139 -24.957 1.00 64.95 C \nANISOU 3196 CA VAL B 91 7852 7649 9178 -1067 -604 -63 C \nATOM 3197 C VAL B 91 -4.974 0.007 -24.099 1.00 69.51 C \nANISOU 3197 C VAL B 91 8439 8186 9788 -1102 -603 -53 C \nATOM 3198 O VAL B 91 -4.911 -0.065 -22.873 1.00 74.62 O \nANISOU 3198 O VAL B 91 9070 8855 10428 -1111 -609 -50 O \nATOM 3199 CB VAL B 91 -3.261 -0.698 -25.715 1.00 62.75 C \nANISOU 3199 CB VAL B 91 7557 7376 8909 -1110 -609 -50 C \nATOM 3200 CG1 VAL B 91 -2.246 -0.061 -24.783 1.00 67.71 C \nANISOU 3200 CG1 VAL B 91 8188 8009 9531 -1175 -631 -31 C \nATOM 3201 CG2 VAL B 91 -2.637 -1.890 -26.414 1.00 64.07 C \nANISOU 3201 CG2 VAL B 91 7692 7624 9028 -1096 -610 -58 C \nATOM 3202 N TRP B 92 -5.500 1.052 -24.732 1.00 69.44 N \nANISOU 3202 N TRP B 92 8442 8144 9798 -1117 -596 -51 N \nATOM 3203 CA TRP B 92 -6.020 2.229 -23.978 1.00 69.01 C \nANISOU 3203 CA TRP B 92 8372 8098 9750 -1141 -596 -48 C \nATOM 3204 C TRP B 92 -7.232 1.974 -23.109 1.00 74.33 C \nANISOU 3204 C TRP B 92 9074 8765 10404 -1170 -593 -46 C \nATOM 3205 O TRP B 92 -7.358 2.534 -22.022 1.00 85.43 O \nANISOU 3205 O TRP B 92 10459 10188 11814 -1186 -596 -43 O \nATOM 3206 CB TRP B 92 -6.330 3.400 -24.918 1.00 64.65 C \nANISOU 3206 CB TRP B 92 7795 7581 9186 -1141 -591 -56 C \nATOM 3207 CG TRP B 92 -5.073 4.078 -25.370 1.00 60.85 C \nANISOU 3207 CG TRP B 92 7314 7095 8710 -1087 -612 -64 C \nATOM 3208 CD1 TRP B 92 -4.575 4.150 -26.638 1.00 58.73 C \nANISOU 3208 CD1 TRP B 92 7058 6819 8438 -1058 -616 -70 C \nATOM 3209 CD2 TRP B 92 -4.128 4.739 -24.531 1.00 53.48 C \nANISOU 3209 CD2 TRP B 92 6409 6142 7770 -1056 -644 -66 C \nATOM 3210 NE1 TRP B 92 -3.380 4.843 -26.638 1.00 58.47 N \nANISOU 3210 NE1 TRP B 92 7074 6755 8388 -1008 -656 -77 N \nATOM 3211 CE2 TRP B 92 -3.085 5.209 -25.352 1.00 57.97 C \nANISOU 3211 CE2 TRP B 92 7034 6676 8317 -1008 -678 -74 C \nATOM 3212 CE3 TRP B 92 -4.071 4.990 -23.173 1.00 58.23 C \nANISOU 3212 CE3 TRP B 92 7016 6739 8371 -1066 -656 -62 C \nATOM 3213 CZ2 TRP B 92 -1.988 5.925 -24.850 1.00 64.52 C \nANISOU 3213 CZ2 TRP B 92 7959 7447 9107 -969 -735 -78 C \nATOM 3214 CZ3 TRP B 92 -2.962 5.692 -22.651 1.00 66.74 C \nANISOU 3214 CZ3 TRP B 92 8167 7771 9420 -1031 -706 -64 C \nATOM 3215 CH2 TRP B 92 -1.943 6.157 -23.496 1.00 66.79 C \nANISOU 3215 CH2 TRP B 92 8262 7725 9389 -984 -750 -73 C \nATOM 3216 N THR B 93 -8.116 1.104 -23.562 1.00 80.46 N \nANISOU 3216 N THR B 93 9922 9504 11145 -1174 -598 -48 N \nATOM 3217 CA THR B 93 -9.243 0.661 -22.720 1.00 78.03 C \nANISOU 3217 CA THR B 93 9699 9156 10791 -1197 -615 -46 C \nATOM 3218 C THR B 93 -8.670 -0.047 -21.496 1.00 72.93 C \nANISOU 3218 C THR B 93 9032 8524 10153 -1131 -623 -56 C \nATOM 3219 O THR B 93 -8.964 0.307 -20.368 1.00 74.98 O \nANISOU 3219 O THR B 93 9285 8788 10414 -1156 -625 -51 O \nATOM 3220 CB THR B 93 -10.207 -0.281 -23.498 1.00 83.06 C \nANISOU 3220 CB THR B 93 10484 9716 11359 -1192 -642 -51 C \nATOM 3221 OG1 THR B 93 -10.984 0.476 -24.428 1.00 76.17 O \nANISOU 3221 OG1 THR B 93 9641 8847 10455 -1303 -638 -34 O \nATOM 3222 CG2 THR B 93 -11.145 -1.039 -22.554 1.00 82.89 C \nANISOU 3222 CG2 THR B 93 10605 9623 11267 -1170 -682 -58 C \nATOM 3223 N TYR B 94 -7.849 -1.058 -21.740 1.00 73.71 N \nANISOU 3223 N TYR B 94 9107 8657 10241 -1054 -627 -72 N \nATOM 3224 CA TYR B 94 -7.203 -1.818 -20.679 1.00 72.02 C \nANISOU 3224 CA TYR B 94 8842 8517 10004 -1001 -634 -84 C \nATOM 3225 C TYR B 94 -6.519 -0.945 -19.640 1.00 68.40 C \nANISOU 3225 C TYR B 94 8310 8090 9588 -1067 -624 -65 C \nATOM 3226 O TYR B 94 -6.655 -1.192 -18.445 1.00 58.01 O \nANISOU 3226 O TYR B 94 6986 6802 8254 -1055 -631 -69 O \nATOM 3227 CB TYR B 94 -6.169 -2.755 -21.274 1.00 75.37 C \nANISOU 3227 CB TYR B 94 9202 9040 10394 -951 -634 -99 C \nATOM 3228 CG TYR B 94 -5.385 -3.517 -20.243 1.00 82.19 C \nANISOU 3228 CG TYR B 94 9978 10048 11203 -925 -639 -111 C \nATOM 3229 CD1 TYR B 94 -5.789 -4.787 -19.843 1.00 80.71 C \nANISOU 3229 CD1 TYR B 94 9799 9950 10919 -790 -662 -153 C \nATOM 3230 CD2 TYR B 94 -4.236 -2.962 -19.674 1.00 76.99 C \nANISOU 3230 CD2 TYR B 94 9240 9448 10563 -1033 -632 -84 C \nATOM 3231 CE1 TYR B 94 -5.067 -5.478 -18.912 1.00 86.45 C \nANISOU 3231 CE1 TYR B 94 10414 10863 11571 -768 -665 -168 C \nATOM 3232 CE2 TYR B 94 -3.513 -3.649 -18.750 1.00 84.83 C \nANISOU 3232 CE2 TYR B 94 10147 10602 11483 -1048 -638 -90 C \nATOM 3233 CZ TYR B 94 -3.936 -4.903 -18.381 1.00 90.36 C \nANISOU 3233 CZ TYR B 94 10812 11430 12089 -917 -649 -133 C \nATOM 3234 OH TYR B 94 -3.193 -5.595 -17.463 1.00132.97 O \nANISOU 3234 OH TYR B 94 16091 17043 17389 -934 -654 -143 O \nATOM 3235 N ASN B 95 -5.751 0.042 -20.089 1.00 66.19 N \nANISOU 3235 N ASN B 95 7997 7802 9352 -1122 -616 -48 N \nATOM 3236 CA ASN B 95 -5.029 0.888 -19.151 1.00 63.99 C \nANISOU 3236 CA ASN B 95 7692 7530 9091 -1168 -624 -34 C \nATOM 3237 C ASN B 95 -5.998 1.644 -18.268 1.00 69.69 C \nANISOU 3237 C ASN B 95 8426 8224 9829 -1176 -620 -33 C \nATOM 3238 O ASN B 95 -5.953 1.528 -17.022 1.00 74.23 O \nANISOU 3238 O ASN B 95 8988 8817 10398 -1185 -626 -30 O \nATOM 3239 CB ASN B 95 -4.112 1.880 -19.872 1.00 65.51 C \nANISOU 3239 CB ASN B 95 7900 7691 9298 -1190 -637 -25 C \nATOM 3240 CG ASN B 95 -2.877 1.212 -20.481 1.00 66.87 C \nANISOU 3240 CG ASN B 95 8076 7895 9439 -1224 -650 -16 C \nATOM 3241 OD1 ASN B 95 -2.396 0.157 -20.019 1.00 73.12 O \nANISOU 3241 OD1 ASN B 95 8825 8772 10184 -1255 -651 -13 O \nATOM 3242 ND2 ASN B 95 -2.357 1.826 -21.511 1.00 67.53 N \nANISOU 3242 ND2 ASN B 95 8199 7932 9526 -1222 -663 -14 N \nATOM 3243 N ALA B 96 -6.896 2.392 -18.890 1.00 64.41 N \nANISOU 3243 N ALA B 96 7771 7536 9165 -1187 -612 -35 N \nATOM 3244 CA ALA B 96 -7.819 3.230 -18.119 1.00 75.22 C \nANISOU 3244 CA ALA B 96 9134 8918 10526 -1221 -609 -33 C \nATOM 3245 C ALA B 96 -8.593 2.440 -17.036 1.00 84.92 C \nANISOU 3245 C ALA B 96 10407 10123 11734 -1230 -615 -32 C \nATOM 3246 O ALA B 96 -8.728 2.886 -15.893 1.00 82.79 O \nANISOU 3246 O ALA B 96 10120 9867 11470 -1247 -617 -28 O \nATOM 3247 CB ALA B 96 -8.786 3.908 -19.057 1.00 79.77 C \nANISOU 3247 CB ALA B 96 9710 9528 11073 -1264 -599 -34 C \nATOM 3248 N GLU B 97 -9.065 1.244 -17.385 1.00 92.75 N \nANISOU 3248 N GLU B 97 11472 11077 12691 -1198 -626 -40 N \nATOM 3249 CA GLU B 97 -9.800 0.411 -16.430 1.00 92.19 C \nANISOU 3249 CA GLU B 97 11479 10974 12574 -1168 -648 -48 C \nATOM 3250 C GLU B 97 -8.937 -0.084 -15.275 1.00 88.97 C \nANISOU 3250 C GLU B 97 11003 10626 12174 -1115 -649 -57 C \nATOM 3251 O GLU B 97 -9.380 -0.079 -14.136 1.00 79.21 O \nANISOU 3251 O GLU B 97 9787 9385 10924 -1117 -658 -58 O \nATOM 3252 CB GLU B 97 -10.442 -0.776 -17.123 1.00 97.24 C \nANISOU 3252 CB GLU B 97 12246 11556 13144 -1102 -678 -67 C \nATOM 3253 CG GLU B 97 -11.406 -0.382 -18.227 1.00 98.95 C \nANISOU 3253 CG GLU B 97 12562 11706 13327 -1186 -687 -52 C \nATOM 3254 CD GLU B 97 -12.685 -1.177 -18.180 1.00 98.95 C \nANISOU 3254 CD GLU B 97 12785 11592 13220 -1179 -743 -59 C \nATOM 3255 OE1 GLU B 97 -13.175 -1.446 -17.070 1.00107.38 O \nANISOU 3255 OE1 GLU B 97 13927 12625 14247 -1158 -771 -64 O \nATOM 3256 OE2 GLU B 97 -13.210 -1.506 -19.246 1.00 97.81 O \nANISOU 3256 OE2 GLU B 97 12763 11381 13020 -1196 -768 -58 O \nATOM 3257 N LEU B 98 -7.717 -0.532 -15.562 1.00 85.26 N \nANISOU 3257 N LEU B 98 10457 10229 11709 -1087 -642 -62 N \nATOM 3258 CA LEU B 98 -6.816 -0.985 -14.475 1.00 80.87 C \nANISOU 3258 CA LEU B 98 9825 9771 11132 -1080 -645 -64 C \nATOM 3259 C LEU B 98 -6.193 0.154 -13.721 1.00 66.03 C \nANISOU 3259 C LEU B 98 7908 7881 9299 -1164 -640 -39 C \nATOM 3260 O LEU B 98 -5.899 0.029 -12.541 1.00 62.69 O \nANISOU 3260 O LEU B 98 7454 7506 8859 -1180 -646 -36 O \nATOM 3261 CB LEU B 98 -5.720 -1.918 -14.974 1.00 89.12 C \nANISOU 3261 CB LEU B 98 10798 10937 12126 -1060 -646 -74 C \nATOM 3262 CG LEU B 98 -6.194 -3.328 -15.377 1.00 96.70 C \nANISOU 3262 CG LEU B 98 11776 11964 13000 -923 -661 -115 C \nATOM 3263 CD1 LEU B 98 -4.994 -4.255 -15.399 1.00104.89 C \nANISOU 3263 CD1 LEU B 98 12687 13211 13954 -917 -661 -128 C \nATOM 3264 CD2 LEU B 98 -7.241 -3.921 -14.451 1.00 97.24 C \nANISOU 3264 CD2 LEU B 98 11918 12017 13013 -816 -687 -145 C \nATOM 3265 N LEU B 99 -6.086 1.289 -14.367 1.00 63.60 N \nANISOU 3265 N LEU B 99 7617 7515 9035 -1202 -636 -27 N \nATOM 3266 CA LEU B 99 -5.684 2.475 -13.640 1.00 65.42 C \nANISOU 3266 CA LEU B 99 7845 7724 9288 -1239 -646 -14 C \nATOM 3267 C LEU B 99 -6.701 2.829 -12.573 1.00 74.28 C \nANISOU 3267 C LEU B 99 8968 8837 10417 -1240 -641 -16 C \nATOM 3268 O LEU B 99 -6.333 3.146 -11.459 1.00 91.07 O \nANISOU 3268 O LEU B 99 11084 10974 12545 -1258 -651 -10 O \nATOM 3269 CB LEU B 99 -5.516 3.657 -14.578 1.00 62.35 C \nANISOU 3269 CB LEU B 99 7474 7301 8916 -1229 -652 -16 C \nATOM 3270 CG LEU B 99 -5.071 4.941 -13.870 1.00 70.61 C \nANISOU 3270 CG LEU B 99 8541 8331 9958 -1219 -678 -16 C \nATOM 3271 CD1 LEU B 99 -3.777 4.719 -13.105 1.00 65.83 C \nANISOU 3271 CD1 LEU B 99 7984 7704 9326 -1266 -712 1 C \nATOM 3272 CD2 LEU B 99 -4.891 6.094 -14.860 1.00 75.56 C \nANISOU 3272 CD2 LEU B 99 9187 8953 10569 -1159 -694 -33 C \nATOM 3273 N VAL B 100 -7.986 2.780 -12.916 1.00 81.29 N \nANISOU 3273 N VAL B 100 9887 9704 11297 -1237 -631 -22 N \nATOM 3274 CA VAL B 100 -9.056 3.160 -11.980 1.00 71.14 C \nANISOU 3274 CA VAL B 100 8620 8410 9998 -1268 -632 -20 C \nATOM 3275 C VAL B 100 -9.169 2.185 -10.817 1.00 71.93 C \nANISOU 3275 C VAL B 100 8744 8509 10079 -1238 -643 -25 C \nATOM 3276 O VAL B 100 -9.167 2.599 -9.663 1.00 84.90 O \nANISOU 3276 O VAL B 100 10363 10164 11730 -1256 -645 -20 O \nATOM 3277 CB VAL B 100 -10.400 3.279 -12.702 1.00 67.44 C \nANISOU 3277 CB VAL B 100 8213 7921 9490 -1319 -631 -17 C \nATOM 3278 CG1 VAL B 100 -11.559 3.245 -11.731 1.00 67.42 C \nANISOU 3278 CG1 VAL B 100 8277 7896 9445 -1372 -645 -11 C \nATOM 3279 CG2 VAL B 100 -10.441 4.581 -13.493 1.00 70.56 C \nANISOU 3279 CG2 VAL B 100 8544 8383 9884 -1358 -618 -16 C \nATOM 3280 N LEU B 101 -9.264 0.901 -11.117 1.00 68.89 N \nANISOU 3280 N LEU B 101 8400 8122 9652 -1174 -655 -41 N \nATOM 3281 CA LEU B 101 -9.376 -0.132 -10.067 1.00 73.38 C \nANISOU 3281 CA LEU B 101 8986 8726 10171 -1103 -673 -60 C \nATOM 3282 C LEU B 101 -8.239 -0.026 -9.069 1.00 75.13 C \nANISOU 3282 C LEU B 101 9100 9038 10407 -1125 -664 -53 C \nATOM 3283 O LEU B 101 -8.463 0.052 -7.880 1.00 77.99 O \nANISOU 3283 O LEU B 101 9458 9412 10764 -1129 -670 -52 O \nATOM 3284 CB LEU B 101 -9.396 -1.559 -10.670 1.00 73.24 C \nANISOU 3284 CB LEU B 101 9007 8742 10077 -983 -695 -93 C \nATOM 3285 CG LEU B 101 -10.547 -1.901 -11.640 1.00 75.17 C \nANISOU 3285 CG LEU B 101 9413 8874 10275 -949 -723 -104 C \nATOM 3286 CD1 LEU B 101 -10.420 -3.301 -12.210 1.00 70.03 C \nANISOU 3286 CD1 LEU B 101 8804 8270 9535 -792 -752 -146 C \nATOM 3287 CD2 LEU B 101 -11.885 -1.740 -10.943 1.00 80.59 C \nANISOU 3287 CD2 LEU B 101 10252 9451 10916 -976 -756 -100 C \nATOM 3288 N MET B 102 -7.013 -0.012 -9.574 1.00 78.16 N \nANISOU 3288 N MET B 102 9417 9482 10798 -1159 -657 -43 N \nATOM 3289 CA MET B 102 -5.831 0.027 -8.720 1.00 75.38 C \nANISOU 3289 CA MET B 102 8997 9218 10428 -1223 -662 -29 C \nATOM 3290 C MET B 102 -5.862 1.268 -7.864 1.00 79.94 C \nANISOU 3290 C MET B 102 9597 9723 11054 -1280 -665 -9 C \nATOM 3291 O MET B 102 -5.663 1.206 -6.659 1.00 77.43 O \nANISOU 3291 O MET B 102 9255 9448 10718 -1305 -672 -4 O \nATOM 3292 CB MET B 102 -4.561 0.005 -9.577 1.00 73.44 C \nANISOU 3292 CB MET B 102 8725 9016 10163 -1290 -666 -13 C \nATOM 3293 CG MET B 102 -4.181 -1.390 -10.079 1.00 76.01 C \nANISOU 3293 CG MET B 102 8982 9494 10404 -1249 -665 -34 C \nATOM 3294 SD MET B 102 -2.943 -1.359 -11.373 1.00 79.55 S \nANISOU 3294 SD MET B 102 9423 9971 10830 -1339 -670 -14 S \nATOM 3295 CE MET B 102 -1.951 0.047 -10.917 1.00 72.27 C \nANISOU 3295 CE MET B 102 8586 8939 9934 -1484 -699 30 C \nATOM 3296 N GLU B 103 -6.150 2.400 -8.497 1.00 81.30 N \nANISOU 3296 N GLU B 103 9808 9807 11274 -1289 -663 -3 N \nATOM 3297 CA GLU B 103 -6.031 3.690 -7.838 1.00 71.14 C \nANISOU 3297 CA GLU B 103 8539 8479 10011 -1312 -675 7 C \nATOM 3298 C GLU B 103 -7.192 3.962 -6.905 1.00 66.51 C \nANISOU 3298 C GLU B 103 7947 7887 9436 -1302 -665 1 C \nATOM 3299 O GLU B 103 -7.050 4.669 -5.896 1.00 60.55 O \nANISOU 3299 O GLU B 103 7191 7130 8687 -1317 -675 6 O \nATOM 3300 CB GLU B 103 -5.920 4.796 -8.887 1.00 69.09 C \nANISOU 3300 CB GLU B 103 8306 8180 9767 -1290 -682 2 C \nATOM 3301 CG GLU B 103 -4.876 5.838 -8.534 1.00 81.75 C \nANISOU 3301 CG GLU B 103 9966 9744 11349 -1289 -723 6 C \nATOM 3302 CD GLU B 103 -3.459 5.288 -8.449 1.00 87.92 C \nANISOU 3302 CD GLU B 103 10807 10511 12089 -1362 -756 29 C \nATOM 3303 OE1 GLU B 103 -2.596 5.991 -7.887 1.00 89.68 O \nANISOU 3303 OE1 GLU B 103 11125 10678 12270 -1386 -806 38 O \nATOM 3304 OE2 GLU B 103 -3.207 4.160 -8.916 1.00 99.70 O \nANISOU 3304 OE2 GLU B 103 12260 12056 13567 -1404 -740 36 O \nATOM 3305 N ASN B 104 -8.360 3.428 -7.243 1.00 66.22 N \nANISOU 3305 N ASN B 104 7932 7839 9390 -1284 -653 -8 N \nATOM 3306 CA ASN B 104 -9.505 3.561 -6.357 1.00 70.64 C \nANISOU 3306 CA ASN B 104 8519 8385 9938 -1300 -653 -9 C \nATOM 3307 C ASN B 104 -9.234 2.810 -5.068 1.00 73.75 C \nANISOU 3307 C ASN B 104 8903 8804 10316 -1276 -662 -12 C \nATOM 3308 O ASN B 104 -9.507 3.322 -3.982 1.00 84.87 O \nANISOU 3308 O ASN B 104 10304 10212 11732 -1299 -664 -7 O \nATOM 3309 CB ASN B 104 -10.764 2.996 -7.006 1.00 75.47 C \nANISOU 3309 CB ASN B 104 9217 8950 10507 -1304 -659 -14 C \nATOM 3310 CG ASN B 104 -11.494 4.015 -7.853 1.00 66.80 C \nANISOU 3310 CG ASN B 104 8122 7861 9398 -1379 -650 -5 C \nATOM 3311 OD1 ASN B 104 -11.177 5.213 -7.842 1.00 68.59 O \nANISOU 3311 OD1 ASN B 104 8269 8149 9643 -1397 -639 -4 O \nATOM 3312 ND2 ASN B 104 -12.522 3.552 -8.534 1.00 59.22 N \nANISOU 3312 ND2 ASN B 104 7264 6853 8383 -1419 -664 -2 N \nATOM 3313 N GLU B 105 -8.697 1.599 -5.167 1.00 70.10 N \nANISOU 3313 N GLU B 105 8425 8393 9816 -1225 -668 -25 N \nATOM 3314 CA GLU B 105 -8.266 0.886 -3.976 1.00 76.73 C \nANISOU 3314 CA GLU B 105 9220 9316 10616 -1202 -676 -33 C \nATOM 3315 C GLU B 105 -7.278 1.684 -3.101 1.00 82.84 C \nANISOU 3315 C GLU B 105 9945 10115 11414 -1286 -677 -9 C \nATOM 3316 O GLU B 105 -7.443 1.782 -1.881 1.00 82.66 O \nANISOU 3316 O GLU B 105 9912 10108 11386 -1295 -681 -7 O \nATOM 3317 CB GLU B 105 -7.612 -0.427 -4.329 1.00 77.80 C \nANISOU 3317 CB GLU B 105 9304 9576 10680 -1142 -682 -54 C \nATOM 3318 CG GLU B 105 -7.441 -1.279 -3.085 1.00 94.57 C \nANISOU 3318 CG GLU B 105 11370 11833 12729 -1095 -693 -74 C \nATOM 3319 CD GLU B 105 -6.240 -2.179 -3.143 1.00108.23 C \nANISOU 3319 CD GLU B 105 12979 13773 14370 -1109 -693 -82 C \nATOM 3320 OE1 GLU B 105 -6.468 -3.396 -3.056 1.00115.97 O \nANISOU 3320 OE1 GLU B 105 13920 14896 15247 -975 -706 -127 O \nATOM 3321 OE2 GLU B 105 -5.072 -1.705 -3.277 1.00115.31 O \nANISOU 3321 OE2 GLU B 105 13830 14708 15272 -1251 -688 -47 O \nATOM 3322 N ARG B 106 -6.267 2.277 -3.722 1.00 79.35 N \nANISOU 3322 N ARG B 106 9502 9661 10987 -1344 -682 9 N \nATOM 3323 CA ARG B 106 -5.277 3.019 -2.956 1.00 75.48 C \nANISOU 3323 CA ARG B 106 9026 9163 10490 -1422 -704 32 C \nATOM 3324 C ARG B 106 -5.966 4.183 -2.287 1.00 75.50 C \nANISOU 3324 C ARG B 106 9059 9092 10536 -1401 -706 30 C \nATOM 3325 O ARG B 106 -5.697 4.501 -1.125 1.00 82.26 O \nANISOU 3325 O ARG B 106 9922 9952 11383 -1433 -721 40 O \nATOM 3326 CB ARG B 106 -4.128 3.485 -3.846 1.00 77.60 C \nANISOU 3326 CB ARG B 106 9348 9396 10742 -1477 -729 48 C \nATOM 3327 CG ARG B 106 -3.276 2.316 -4.393 1.00 83.28 C \nANISOU 3327 CG ARG B 106 10024 10226 11393 -1535 -730 55 C \nATOM 3328 CD ARG B 106 -2.336 2.744 -5.507 1.00101.31 C \nANISOU 3328 CD ARG B 106 12383 12452 13660 -1587 -756 71 C \nATOM 3329 NE ARG B 106 -1.472 3.823 -5.041 1.00120.35 N \nANISOU 3329 NE ARG B 106 14923 14762 16042 -1657 -810 94 N \nATOM 3330 CZ ARG B 106 -1.757 5.129 -5.097 1.00133.79 C \nANISOU 3330 CZ ARG B 106 16711 16339 17784 -1574 -832 82 C \nATOM 3331 NH1 ARG B 106 -2.901 5.572 -5.612 1.00128.56 N \nANISOU 3331 NH1 ARG B 106 15996 15661 17192 -1454 -797 53 N \nATOM 3332 NH2 ARG B 106 -0.880 6.001 -4.630 1.00139.22 N \nANISOU 3332 NH2 ARG B 106 17549 16932 18415 -1614 -898 96 N \nATOM 3333 N THR B 107 -6.891 4.817 -2.997 1.00 77.05 N \nANISOU 3333 N THR B 107 9264 9245 10765 -1357 -693 19 N \nATOM 3334 CA THR B 107 -7.636 5.960 -2.418 1.00 71.91 C \nANISOU 3334 CA THR B 107 8613 8580 10130 -1344 -692 13 C \nATOM 3335 C THR B 107 -8.380 5.535 -1.156 1.00 69.47 C \nANISOU 3335 C THR B 107 8290 8286 9819 -1358 -684 14 C \nATOM 3336 O THR B 107 -8.376 6.235 -0.147 1.00 69.33 O \nANISOU 3336 O THR B 107 8268 8270 9804 -1365 -693 17 O \nATOM 3337 CB THR B 107 -8.629 6.541 -3.423 1.00 73.80 C \nANISOU 3337 CB THR B 107 8839 8832 10370 -1329 -676 1 C \nATOM 3338 OG1 THR B 107 -7.924 7.123 -4.523 1.00 74.69 O \nANISOU 3338 OG1 THR B 107 8962 8940 10478 -1295 -688 -6 O \nATOM 3339 CG2 THR B 107 -9.496 7.606 -2.785 1.00 77.42 C \nANISOU 3339 CG2 THR B 107 9266 9338 10812 -1336 -673 -6 C \nATOM 3340 N LEU B 108 -9.026 4.377 -1.208 1.00 67.63 N \nANISOU 3340 N LEU B 108 8067 8060 9569 -1343 -675 8 N \nATOM 3341 CA LEU B 108 -9.863 3.933 -0.088 1.00 66.39 C \nANISOU 3341 CA LEU B 108 7929 7904 9393 -1335 -678 3 C \nATOM 3342 C LEU B 108 -9.053 3.603 1.152 1.00 69.65 C \nANISOU 3342 C LEU B 108 8301 8368 9796 -1339 -685 7 C \nATOM 3343 O LEU B 108 -9.411 4.026 2.254 1.00 86.09 O \nANISOU 3343 O LEU B 108 10383 10444 11885 -1354 -688 10 O \nATOM 3344 CB LEU B 108 -10.761 2.757 -0.483 1.00 62.18 C \nANISOU 3344 CB LEU B 108 7467 7347 8812 -1283 -687 -14 C \nATOM 3345 CG LEU B 108 -11.871 3.070 -1.519 1.00 62.88 C \nANISOU 3345 CG LEU B 108 7637 7371 8885 -1319 -690 -11 C \nATOM 3346 CD1 LEU B 108 -12.846 1.884 -1.646 1.00 61.34 C \nANISOU 3346 CD1 LEU B 108 7583 7111 8612 -1262 -724 -28 C \nATOM 3347 CD2 LEU B 108 -12.641 4.346 -1.193 1.00 57.55 C \nANISOU 3347 CD2 LEU B 108 6954 6698 8214 -1413 -682 5 C \nATOM 3348 N ASP B 109 -7.958 2.869 1.017 1.00 65.40 N \nANISOU 3348 N ASP B 109 7723 7900 9226 -1344 -690 8 N \nATOM 3349 CA ASP B 109 -7.165 2.634 2.208 1.00 72.19 C \nANISOU 3349 CA ASP B 109 8540 8837 10052 -1388 -701 17 C \nATOM 3350 C ASP B 109 -6.162 3.763 2.533 1.00 64.65 C \nANISOU 3350 C ASP B 109 7617 7837 9111 -1474 -721 44 C \nATOM 3351 O ASP B 109 -5.592 3.796 3.606 1.00 68.75 O \nANISOU 3351 O ASP B 109 8130 8393 9599 -1533 -737 58 O \nATOM 3352 CB ASP B 109 -6.592 1.218 2.241 1.00 80.62 C \nANISOU 3352 CB ASP B 109 9536 10062 11033 -1369 -702 3 C \nATOM 3353 CG ASP B 109 -5.707 0.938 1.137 1.00 84.28 C \nANISOU 3353 CG ASP B 109 9980 10572 11470 -1410 -704 10 C \nATOM 3354 OD1 ASP B 109 -5.086 1.907 0.651 1.00 99.27 O \nANISOU 3354 OD1 ASP B 109 11933 12379 13405 -1485 -714 36 O \nATOM 3355 OD2 ASP B 109 -5.623 -0.263 0.773 1.00 84.63 O \nANISOU 3355 OD2 ASP B 109 9962 10754 11440 -1351 -701 -15 O \nATOM 3356 N PHE B 110 -6.021 4.728 1.649 1.00 60.01 N \nANISOU 3356 N PHE B 110 7081 7165 8555 -1468 -730 48 N \nATOM 3357 CA PHE B 110 -5.439 6.003 2.018 1.00 62.32 C \nANISOU 3357 CA PHE B 110 7445 7388 8848 -1485 -765 58 C \nATOM 3358 C PHE B 110 -6.284 6.613 3.159 1.00 67.56 C \nANISOU 3358 C PHE B 110 8091 8044 9535 -1455 -758 50 C \nATOM 3359 O PHE B 110 -5.744 7.003 4.184 1.00 81.07 O \nANISOU 3359 O PHE B 110 9839 9740 11224 -1488 -785 61 O \nATOM 3360 CB PHE B 110 -5.437 6.947 0.828 1.00 61.36 C \nANISOU 3360 CB PHE B 110 7369 7206 8739 -1427 -776 45 C \nATOM 3361 CG PHE B 110 -4.922 8.328 1.130 1.00 58.97 C \nANISOU 3361 CG PHE B 110 7159 6839 8408 -1383 -826 38 C \nATOM 3362 CD1 PHE B 110 -3.665 8.505 1.687 1.00 60.32 C \nANISOU 3362 CD1 PHE B 110 7455 6948 8518 -1444 -886 59 C \nATOM 3363 CD2 PHE B 110 -5.657 9.451 0.795 1.00 57.98 C \nANISOU 3363 CD2 PHE B 110 7013 6731 8288 -1278 -824 8 C \nATOM 3364 CE1 PHE B 110 -3.135 9.778 1.916 1.00 60.95 C \nANISOU 3364 CE1 PHE B 110 7674 6941 8544 -1372 -953 45 C \nATOM 3365 CE2 PHE B 110 -5.149 10.744 1.036 1.00 61.27 C \nANISOU 3365 CE2 PHE B 110 7521 7110 8648 -1185 -883 -14 C \nATOM 3366 CZ PHE B 110 -3.879 10.910 1.583 1.00 61.46 C \nANISOU 3366 CZ PHE B 110 7708 7030 8614 -1215 -953 2 C \nATOM 3367 N HIS B 111 -7.596 6.663 2.977 1.00 57.29 N \nANISOU 3367 N HIS B 111 6747 6754 8265 -1411 -727 34 N \nATOM 3368 CA HIS B 111 -8.521 7.164 4.001 1.00 57.57 C \nANISOU 3368 CA HIS B 111 6764 6799 8311 -1404 -719 29 C \nATOM 3369 C HIS B 111 -8.465 6.366 5.297 1.00 59.52 C \nANISOU 3369 C HIS B 111 6997 7070 8548 -1431 -719 37 C \nATOM 3370 O HIS B 111 -8.404 6.936 6.408 1.00 56.98 O \nANISOU 3370 O HIS B 111 6678 6745 8226 -1443 -731 41 O \nATOM 3371 CB HIS B 111 -9.974 7.120 3.496 1.00 54.22 C \nANISOU 3371 CB HIS B 111 6325 6388 7888 -1403 -694 20 C \nATOM 3372 CG HIS B 111 -10.265 8.081 2.394 1.00 51.68 C \nANISOU 3372 CG HIS B 111 5986 6093 7556 -1390 -690 10 C \nATOM 3373 ND1 HIS B 111 -9.882 9.403 2.448 1.00 57.23 N \nANISOU 3373 ND1 HIS B 111 6668 6836 8240 -1342 -708 -5 N \nATOM 3374 CD2 HIS B 111 -10.898 7.927 1.212 1.00 54.50 C \nANISOU 3374 CD2 HIS B 111 6344 6463 7900 -1406 -676 7 C \nATOM 3375 CE1 HIS B 111 -10.280 10.030 1.360 1.00 55.74 C \nANISOU 3375 CE1 HIS B 111 6445 6711 8024 -1323 -701 -20 C \nATOM 3376 NE2 HIS B 111 -10.893 9.154 0.586 1.00 57.25 N \nANISOU 3376 NE2 HIS B 111 6646 6883 8222 -1379 -679 -8 N \nATOM 3377 N ASP B 112 -8.457 5.041 5.169 1.00 58.12 N \nANISOU 3377 N ASP B 112 6801 6935 8348 -1425 -710 33 N \nATOM 3378 CA ASP B 112 -8.285 4.183 6.367 1.00 58.01 C \nANISOU 3378 CA ASP B 112 6754 6992 8297 -1430 -714 32 C \nATOM 3379 C ASP B 112 -6.986 4.495 7.104 1.00 60.11 C \nANISOU 3379 C ASP B 112 7015 7290 8536 -1513 -736 54 C \nATOM 3380 O ASP B 112 -6.961 4.581 8.333 1.00 65.11 O \nANISOU 3380 O ASP B 112 7638 7946 9157 -1538 -742 60 O \nATOM 3381 CB ASP B 112 -8.357 2.701 6.016 1.00 56.16 C \nANISOU 3381 CB ASP B 112 6487 6846 8005 -1373 -709 11 C \nATOM 3382 CG ASP B 112 -9.758 2.273 5.535 1.00 61.08 C \nANISOU 3382 CG ASP B 112 7177 7406 8623 -1286 -709 -13 C \nATOM 3383 OD1 ASP B 112 -10.675 3.117 5.592 1.00 67.04 O \nANISOU 3383 OD1 ASP B 112 7987 8069 9415 -1312 -707 -5 O \nATOM 3384 OD2 ASP B 112 -9.935 1.118 5.049 1.00 66.53 O \nANISOU 3384 OD2 ASP B 112 7878 8146 9254 -1199 -718 -40 O \nATOM 3385 N SER B 113 -5.915 4.692 6.353 1.00 63.23 N \nANISOU 3385 N SER B 113 7441 7674 8908 -1569 -754 70 N \nATOM 3386 CA SER B 113 -4.612 4.987 6.964 1.00 69.33 C \nANISOU 3386 CA SER B 113 8267 8453 9622 -1684 -795 99 C \nATOM 3387 C SER B 113 -4.667 6.338 7.691 1.00 66.29 C \nANISOU 3387 C SER B 113 7970 7955 9263 -1667 -824 103 C \nATOM 3388 O SER B 113 -4.156 6.481 8.793 1.00 70.94 O \nANISOU 3388 O SER B 113 8593 8550 9811 -1737 -851 120 O \nATOM 3389 CB SER B 113 -3.482 4.980 5.922 1.00 73.91 C \nANISOU 3389 CB SER B 113 8913 9017 10153 -1761 -824 118 C \nATOM 3390 OG SER B 113 -2.862 6.261 5.878 1.00 87.60 O \nANISOU 3390 OG SER B 113 10801 10608 11877 -1775 -878 130 O \nATOM 3391 N ASN B 114 -5.273 7.331 7.071 1.00 60.31 N \nANISOU 3391 N ASN B 114 7242 7119 8554 -1572 -822 83 N \nATOM 3392 CA ASN B 114 -5.358 8.663 7.691 1.00 60.84 C \nANISOU 3392 CA ASN B 114 7376 7120 8621 -1517 -855 74 C \nATOM 3393 C ASN B 114 -6.213 8.670 8.945 1.00 61.02 C \nANISOU 3393 C ASN B 114 7332 7181 8670 -1508 -831 69 C \nATOM 3394 O ASN B 114 -5.896 9.337 9.917 1.00 61.43 O \nANISOU 3394 O ASN B 114 7441 7201 8700 -1511 -864 73 O \nATOM 3395 CB ASN B 114 -5.935 9.679 6.693 1.00 67.65 C \nANISOU 3395 CB ASN B 114 8239 7965 9502 -1402 -853 44 C \nATOM 3396 CG ASN B 114 -4.937 10.099 5.623 1.00 67.86 C \nANISOU 3396 CG ASN B 114 8377 7925 9484 -1377 -900 41 C \nATOM 3397 OD1 ASN B 114 -3.738 10.128 5.845 1.00 69.81 O \nANISOU 3397 OD1 ASN B 114 8761 8097 9669 -1438 -959 62 O \nATOM 3398 ND2 ASN B 114 -5.443 10.400 4.449 1.00 74.13 N \nANISOU 3398 ND2 ASN B 114 9127 8745 10295 -1303 -880 19 N \nATOM 3399 N VAL B 115 -7.324 7.933 8.920 1.00 63.50 N \nANISOU 3399 N VAL B 115 7553 7551 9022 -1494 -782 60 N \nATOM 3400 CA VAL B 115 -8.170 7.793 10.116 1.00 57.32 C \nANISOU 3400 CA VAL B 115 6728 6797 8253 -1493 -765 57 C \nATOM 3401 C VAL B 115 -7.349 7.160 11.232 1.00 58.84 C \nANISOU 3401 C VAL B 115 6921 7025 8409 -1560 -781 75 C \nATOM 3402 O VAL B 115 -7.327 7.663 12.350 1.00 58.17 O \nANISOU 3402 O VAL B 115 6852 6929 8321 -1573 -795 80 O \nATOM 3403 CB VAL B 115 -9.436 6.933 9.839 1.00 52.25 C \nANISOU 3403 CB VAL B 115 6047 6181 7625 -1470 -730 45 C \nATOM 3404 CG1 VAL B 115 -10.096 6.457 11.127 1.00 53.75 C \nANISOU 3404 CG1 VAL B 115 6224 6393 7806 -1470 -726 43 C \nATOM 3405 CG2 VAL B 115 -10.446 7.723 9.047 1.00 44.97 C \nANISOU 3405 CG2 VAL B 115 5126 5246 6716 -1452 -718 35 C \nATOM 3406 N LYS B 116 -6.693 6.040 10.927 1.00 63.28 N \nANISOU 3406 N LYS B 116 7455 7660 8929 -1607 -778 83 N \nATOM 3407 CA LYS B 116 -5.790 5.372 11.897 1.00 69.04 C \nANISOU 3407 CA LYS B 116 8161 8485 9587 -1703 -795 102 C \nATOM 3408 C LYS B 116 -4.749 6.321 12.504 1.00 66.59 C \nANISOU 3408 C LYS B 116 7962 8101 9239 -1797 -846 131 C \nATOM 3409 O LYS B 116 -4.378 6.180 13.658 1.00 70.46 O \nANISOU 3409 O LYS B 116 8450 8639 9684 -1873 -862 146 O \nATOM 3410 CB LYS B 116 -5.039 4.197 11.246 1.00 78.25 C \nANISOU 3410 CB LYS B 116 9268 9784 10677 -1760 -791 106 C \nATOM 3411 CG LYS B 116 -5.687 2.834 11.386 1.00 85.08 C \nANISOU 3411 CG LYS B 116 10016 10805 11505 -1676 -761 75 C \nATOM 3412 CD LYS B 116 -5.531 2.356 12.809 1.00102.49 C \nANISOU 3412 CD LYS B 116 12156 13142 13645 -1712 -765 75 C \nATOM 3413 CE LYS B 116 -6.263 1.055 13.037 1.00114.46 C \nANISOU 3413 CE LYS B 116 13574 14813 15101 -1573 -749 28 C \nATOM 3414 NZ LYS B 116 -6.252 0.723 14.488 1.00122.45 N \nANISOU 3414 NZ LYS B 116 14524 15948 16054 -1584 -754 23 N \nATOM 3415 N ASN B 117 -4.261 7.273 11.721 1.00 60.76 N \nANISOU 3415 N ASN B 117 7340 7244 8501 -1785 -883 135 N \nATOM 3416 CA ASN B 117 -3.290 8.235 12.229 1.00 71.08 C \nANISOU 3416 CA ASN B 117 8816 8444 9747 -1842 -955 154 C \nATOM 3417 C ASN B 117 -3.864 9.167 13.268 1.00 80.89 C \nANISOU 3417 C ASN B 117 10080 9634 11020 -1763 -965 139 C \nATOM 3418 O ASN B 117 -3.206 9.471 14.273 1.00 98.56 O \nANISOU 3418 O ASN B 117 12418 11833 13197 -1837 -1014 159 O \nATOM 3419 CB ASN B 117 -2.662 9.038 11.096 1.00 76.93 C \nANISOU 3419 CB ASN B 117 9706 9065 10459 -1803 -1007 151 C \nATOM 3420 CG ASN B 117 -1.444 8.337 10.511 1.00 84.33 C \nANISOU 3420 CG ASN B 117 10719 10018 11303 -1967 -1041 186 C \nATOM 3421 OD1 ASN B 117 -0.627 7.794 11.255 1.00 93.67 O \nANISOU 3421 OD1 ASN B 117 11937 11259 12393 -2145 -1070 224 O \nATOM 3422 ND2 ASN B 117 -1.308 8.358 9.190 1.00 84.57 N \nANISOU 3422 ND2 ASN B 117 10774 10016 11343 -1925 -1042 178 N \nATOM 3423 N LEU B 118 -5.092 9.615 13.048 1.00 75.45 N \nANISOU 3423 N LEU B 118 9303 8956 10409 -1630 -922 106 N \nATOM 3424 CA LEU B 118 -5.796 10.369 14.070 1.00 66.83 C \nANISOU 3424 CA LEU B 118 8192 7861 9340 -1565 -920 90 C \nATOM 3425 C LEU B 118 -5.963 9.581 15.355 1.00 67.58 C \nANISOU 3425 C LEU B 118 8222 8018 9438 -1645 -898 108 C \nATOM 3426 O LEU B 118 -5.656 10.080 16.460 1.00 64.79 O \nANISOU 3426 O LEU B 118 7928 7634 9056 -1667 -932 116 O \nATOM 3427 CB LEU B 118 -7.135 10.812 13.564 1.00 71.52 C \nANISOU 3427 CB LEU B 118 8684 8500 9988 -1463 -875 59 C \nATOM 3428 CG LEU B 118 -7.231 12.294 13.227 1.00 72.78 C \nANISOU 3428 CG LEU B 118 8889 8649 10116 -1337 -910 26 C \nATOM 3429 CD1 LEU B 118 -6.024 12.720 12.419 1.00 75.40 C \nANISOU 3429 CD1 LEU B 118 9370 8891 10387 -1300 -975 23 C \nATOM 3430 CD2 LEU B 118 -8.526 12.574 12.475 1.00 69.08 C \nANISOU 3430 CD2 LEU B 118 8295 8280 9672 -1287 -860 1 C \nATOM 3431 N TYR B 119 -6.441 8.344 15.218 1.00 66.47 N \nANISOU 3431 N TYR B 119 7970 7970 9317 -1670 -850 108 N \nATOM 3432 CA TYR B 119 -6.616 7.436 16.390 1.00 65.15 C \nANISOU 3432 CA TYR B 119 7728 7895 9130 -1717 -832 115 C \nATOM 3433 C TYR B 119 -5.348 7.263 17.172 1.00 70.15 C \nANISOU 3433 C TYR B 119 8413 8563 9680 -1851 -873 146 C \nATOM 3434 O TYR B 119 -5.397 7.226 18.390 1.00 77.26 O \nANISOU 3434 O TYR B 119 9295 9498 10563 -1884 -877 152 O \nATOM 3435 CB TYR B 119 -7.144 6.080 15.944 1.00 59.13 C \nANISOU 3435 CB TYR B 119 6867 7238 8361 -1684 -793 99 C \nATOM 3436 CG TYR B 119 -7.501 5.144 17.072 1.00 64.54 C \nANISOU 3436 CG TYR B 119 7476 8037 9010 -1674 -780 89 C \nATOM 3437 CD1 TYR B 119 -8.771 5.175 17.671 1.00 64.31 C \nANISOU 3437 CD1 TYR B 119 7442 7975 9020 -1590 -764 68 C \nATOM 3438 CD2 TYR B 119 -6.577 4.200 17.537 1.00 70.52 C \nANISOU 3438 CD2 TYR B 119 8166 8958 9669 -1754 -788 98 C \nATOM 3439 CE1 TYR B 119 -9.101 4.301 18.703 1.00 69.64 C \nANISOU 3439 CE1 TYR B 119 8065 8747 9647 -1554 -761 53 C \nATOM 3440 CE2 TYR B 119 -6.891 3.324 18.572 1.00 68.71 C \nANISOU 3440 CE2 TYR B 119 7850 8871 9384 -1719 -779 79 C \nATOM 3441 CZ TYR B 119 -8.140 3.373 19.154 1.00 72.32 C \nANISOU 3441 CZ TYR B 119 8321 9266 9891 -1604 -768 54 C \nATOM 3442 OH TYR B 119 -8.425 2.502 20.174 1.00 70.44 O \nANISOU 3442 OH TYR B 119 8015 9164 9584 -1547 -768 30 O \nATOM 3443 N ASP B 120 -4.211 7.184 16.469 1.00 79.40 N \nANISOU 3443 N ASP B 120 9661 9724 10785 -1948 -908 169 N \nATOM 3444 CA ASP B 120 -2.895 6.975 17.119 1.00 86.98 C \nANISOU 3444 CA ASP B 120 10699 10725 11623 -2138 -961 210 C \nATOM 3445 C ASP B 120 -2.334 8.262 17.779 1.00 87.02 C \nANISOU 3445 C ASP B 120 10909 10559 11595 -2165 -1035 227 C \nATOM 3446 O ASP B 120 -1.842 8.210 18.884 1.00 84.60 O \nANISOU 3446 O ASP B 120 10645 10279 11219 -2282 -1065 252 O \nATOM 3447 CB ASP B 120 -1.878 6.403 16.131 1.00 95.83 C \nANISOU 3447 CB ASP B 120 11854 11902 12655 -2266 -983 234 C \nATOM 3448 CG ASP B 120 -1.987 4.890 15.971 1.00111.09 C \nANISOU 3448 CG ASP B 120 13583 14085 14541 -2298 -930 224 C \nATOM 3449 OD1 ASP B 120 -2.948 4.274 16.497 1.00115.31 O \nANISOU 3449 OD1 ASP B 120 13970 14724 15117 -2183 -880 192 O \nATOM 3450 OD2 ASP B 120 -1.101 4.307 15.294 1.00125.79 O \nANISOU 3450 OD2 ASP B 120 15441 16049 16305 -2430 -946 246 O \nATOM 3451 N LYS B 121 -2.414 9.406 17.104 1.00 83.10 N \nANISOU 3451 N LYS B 121 10543 9901 11131 -2041 -1070 207 N \nATOM 3452 CA LYS B 121 -2.099 10.692 17.732 1.00 89.35 C \nANISOU 3452 CA LYS B 121 11527 10539 11883 -1987 -1146 202 C \nATOM 3453 C LYS B 121 -2.767 10.864 19.113 1.00 90.23 C \nANISOU 3453 C LYS B 121 11561 10689 12032 -1955 -1122 194 C \nATOM 3454 O LYS B 121 -2.160 11.384 20.047 1.00 91.10 O \nANISOU 3454 O LYS B 121 11823 10722 12069 -2012 -1188 211 O \nATOM 3455 CB LYS B 121 -2.550 11.840 16.846 1.00 96.92 C \nANISOU 3455 CB LYS B 121 12543 11401 12879 -1776 -1163 157 C \nATOM 3456 CG LYS B 121 -1.695 12.124 15.619 1.00107.82 C \nANISOU 3456 CG LYS B 121 14091 12682 14193 -1772 -1224 159 C \nATOM 3457 CD LYS B 121 -2.310 13.240 14.761 1.00110.20 C \nANISOU 3457 CD LYS B 121 14399 12948 14525 -1530 -1231 102 C \nATOM 3458 CE LYS B 121 -2.607 14.517 15.559 1.00108.61 C \nANISOU 3458 CE LYS B 121 14273 12704 14288 -1359 -1280 61 C \nATOM 3459 NZ LYS B 121 -1.460 15.442 15.624 1.00116.69 N \nANISOU 3459 NZ LYS B 121 15627 13548 15164 -1299 -1418 53 N \nATOM 3460 N VAL B 122 -4.022 10.443 19.224 1.00 90.68 N \nANISOU 3460 N VAL B 122 11410 10851 12194 -1869 -1037 169 N \nATOM 3461 CA VAL B 122 -4.763 10.516 20.482 1.00 90.34 C \nANISOU 3461 CA VAL B 122 11285 10851 12188 -1841 -1010 162 C \nATOM 3462 C VAL B 122 -4.277 9.472 21.473 1.00 89.26 C \nANISOU 3462 C VAL B 122 11097 10821 11996 -1999 -1004 193 C \nATOM 3463 O VAL B 122 -3.913 9.813 22.596 1.00 86.62 O \nANISOU 3463 O VAL B 122 10834 10461 11618 -2059 -1040 210 O \nATOM 3464 CB VAL B 122 -6.275 10.337 20.267 1.00 91.94 C \nANISOU 3464 CB VAL B 122 11322 11121 12491 -1725 -935 129 C \nATOM 3465 CG1 VAL B 122 -7.032 10.419 21.576 1.00 96.34 C \nANISOU 3465 CG1 VAL B 122 11817 11714 13076 -1708 -915 124 C \nATOM 3466 CG2 VAL B 122 -6.792 11.413 19.334 1.00 93.18 C \nANISOU 3466 CG2 VAL B 122 11499 11229 12676 -1592 -939 98 C \nATOM 3467 N ARG B 123 -4.217 8.216 21.037 1.00 87.28 N \nANISOU 3467 N ARG B 123 10723 10710 11727 -2061 -964 199 N \nATOM 3468 CA ARG B 123 -3.783 7.106 21.901 1.00 84.14 C \nANISOU 3468 CA ARG B 123 10230 10493 11245 -2195 -953 219 C \nATOM 3469 C ARG B 123 -2.447 7.344 22.563 1.00 82.14 C \nANISOU 3469 C ARG B 123 10120 10228 10863 -2402 -1024 266 C \nATOM 3470 O ARG B 123 -2.247 6.901 23.685 1.00 92.49 O \nANISOU 3470 O ARG B 123 11374 11658 12109 -2502 -1025 282 O \nATOM 3471 CB ARG B 123 -3.686 5.799 21.132 1.00 80.85 C \nANISOU 3471 CB ARG B 123 9676 10260 10785 -2217 -917 211 C \nATOM 3472 CG ARG B 123 -3.332 4.611 21.995 1.00 81.75 C \nANISOU 3472 CG ARG B 123 9647 10631 10783 -2318 -903 216 C \nATOM 3473 CD ARG B 123 -3.500 3.321 21.208 1.00 93.44 C \nANISOU 3473 CD ARG B 123 10969 12320 12216 -2260 -865 187 C \nATOM 3474 NE ARG B 123 -3.045 2.142 21.963 1.00108.57 N \nANISOU 3474 NE ARG B 123 12720 14554 13977 -2344 -858 182 N \nATOM 3475 CZ ARG B 123 -2.524 1.042 21.412 1.00118.48 C \nANISOU 3475 CZ ARG B 123 13839 16076 15101 -2391 -848 171 C \nATOM 3476 NH1 ARG B 123 -2.368 0.941 20.092 1.00113.29 N \nANISOU 3476 NH1 ARG B 123 13206 15378 14463 -2371 -845 168 N \nATOM 3477 NH2 ARG B 123 -2.152 0.029 22.189 1.00120.83 N \nANISOU 3477 NH2 ARG B 123 13962 16715 15232 -2454 -843 159 N \nATOM 3478 N LEU B 124 -1.536 8.033 21.885 1.00 81.03 N \nANISOU 3478 N LEU B 124 10181 9941 10665 -2474 -1093 290 N \nATOM 3479 CA LEU B 124 -0.224 8.326 22.475 1.00 90.37 C \nANISOU 3479 CA LEU B 124 11574 11069 11692 -2699 -1185 342 C \nATOM 3480 C LEU B 124 -0.290 9.370 23.573 1.00 88.70 C \nANISOU 3480 C LEU B 124 11514 10704 11484 -2654 -1236 342 C \nATOM 3481 O LEU B 124 0.464 9.282 24.546 1.00 83.10 O \nANISOU 3481 O LEU B 124 10903 10018 10654 -2848 -1288 382 O \nATOM 3482 CB LEU B 124 0.785 8.779 21.426 1.00 91.49 C \nANISOU 3482 CB LEU B 124 11951 11065 11747 -2784 -1264 366 C \nATOM 3483 CG LEU B 124 1.345 7.637 20.589 1.00100.15 C \nANISOU 3483 CG LEU B 124 12940 12347 12763 -2946 -1240 389 C \nATOM 3484 CD1 LEU B 124 2.532 8.122 19.759 1.00100.47 C \nANISOU 3484 CD1 LEU B 124 13270 12225 12678 -3090 -1341 427 C \nATOM 3485 CD2 LEU B 124 1.719 6.429 21.446 1.00 98.01 C \nANISOU 3485 CD2 LEU B 124 12492 12377 12372 -3163 -1212 418 C \nATOM 3486 N GLN B 125 -1.214 10.322 23.439 1.00 89.81 N \nANISOU 3486 N GLN B 125 11660 10718 11747 -2409 -1221 295 N \nATOM 3487 CA GLN B 125 -1.346 11.395 24.424 1.00 93.02 C \nANISOU 3487 CA GLN B 125 12198 10995 12152 -2327 -1270 284 C \nATOM 3488 C GLN B 125 -1.971 10.996 25.754 1.00 85.48 C \nANISOU 3488 C GLN B 125 11083 10157 11237 -2345 -1219 284 C \nATOM 3489 O GLN B 125 -1.752 11.681 26.733 1.00 98.96 O \nANISOU 3489 O GLN B 125 12921 11776 12903 -2353 -1272 291 O \nATOM 3490 CB GLN B 125 -2.116 12.584 23.869 1.00 92.08 C \nANISOU 3490 CB GLN B 125 12109 10762 12115 -2059 -1274 229 C \nATOM 3491 CG GLN B 125 -1.325 13.427 22.887 1.00 89.94 C \nANISOU 3491 CG GLN B 125 12090 10323 11760 -1996 -1367 220 C \nATOM 3492 CD GLN B 125 -2.129 14.599 22.406 1.00 91.42 C \nANISOU 3492 CD GLN B 125 12265 10470 12002 -1713 -1368 154 C \nATOM 3493 OE1 GLN B 125 -1.825 15.738 22.720 1.00 94.66 O \nANISOU 3493 OE1 GLN B 125 12876 10758 12330 -1579 -1458 126 O \nATOM 3494 NE2 GLN B 125 -3.194 14.320 21.672 1.00 97.00 N \nANISOU 3494 NE2 GLN B 125 12732 11300 12825 -1619 -1271 127 N \nATOM 3495 N LEU B 126 -2.671 9.873 25.833 1.00 86.21 N \nANISOU 3495 N LEU B 126 10923 10442 11391 -2350 -1128 275 N \nATOM 3496 CA LEU B 126 -3.405 9.570 27.059 1.00 85.13 C \nANISOU 3496 CA LEU B 126 10648 10401 11296 -2323 -1084 265 C \nATOM 3497 C LEU B 126 -3.357 8.115 27.506 1.00 83.40 C \nANISOU 3497 C LEU B 126 10239 10426 11022 -2433 -1036 276 C \nATOM 3498 O LEU B 126 -4.273 7.610 28.125 1.00 93.36 O \nANISOU 3498 O LEU B 126 11347 11789 12338 -2342 -983 249 O \nATOM 3499 CB LEU B 126 -4.842 10.084 26.914 1.00 87.49 C \nANISOU 3499 CB LEU B 126 10850 10657 11734 -2101 -1030 218 C \nATOM 3500 CG LEU B 126 -5.585 9.890 25.596 1.00 80.90 C \nANISOU 3500 CG LEU B 126 9929 9832 10976 -1985 -982 189 C \nATOM 3501 CD1 LEU B 126 -6.099 8.470 25.464 1.00 85.92 C \nANISOU 3501 CD1 LEU B 126 10392 10631 11622 -1991 -921 181 C \nATOM 3502 CD2 LEU B 126 -6.723 10.863 25.491 1.00 74.43 C \nANISOU 3502 CD2 LEU B 126 9089 8949 10241 -1821 -962 154 C \nATOM 3503 N ARG B 127 -2.231 7.482 27.250 1.00 93.37 N \nANISOU 3503 N ARG B 127 11528 11798 12151 -2635 -1067 312 N \nATOM 3504 CA ARG B 127 -1.972 6.046 27.537 1.00 96.98 C \nANISOU 3504 CA ARG B 127 11783 12562 12501 -2752 -1030 317 C \nATOM 3505 C ARG B 127 -2.936 5.394 28.534 1.00 95.72 C \nANISOU 3505 C ARG B 127 11431 12559 12380 -2631 -974 281 C \nATOM 3506 O ARG B 127 -3.835 4.642 28.141 1.00 95.85 O \nANISOU 3506 O ARG B 127 11294 12675 12449 -2460 -919 235 O \nATOM 3507 CB ARG B 127 -0.501 5.803 27.982 1.00 97.52 C \nANISOU 3507 CB ARG B 127 11944 12744 12365 -3073 -1096 379 C \nATOM 3508 CG ARG B 127 0.509 6.843 27.487 1.00 99.35 C \nANISOU 3508 CG ARG B 127 12493 12720 12535 -3209 -1193 424 C \nATOM 3509 CD ARG B 127 0.968 7.753 28.628 1.00103.58 C \nANISOU 3509 CD ARG B 127 13252 13092 13012 -3308 -1271 456 C \nATOM 3510 NE ARG B 127 1.151 9.135 28.223 1.00109.25 N \nANISOU 3510 NE ARG B 127 14272 13473 13765 -3204 -1352 453 N \nATOM 3511 CZ ARG B 127 2.169 9.608 27.517 1.00117.68 C \nANISOU 3511 CZ ARG B 127 15619 14377 14716 -3327 -1448 487 C \nATOM 3512 NH1 ARG B 127 3.121 8.794 27.088 1.00127.54 N \nANISOU 3512 NH1 ARG B 127 16879 15771 15808 -3602 -1472 535 N \nATOM 3513 NH2 ARG B 127 2.224 10.902 27.219 1.00120.91 N \nANISOU 3513 NH2 ARG B 127 16301 14491 15147 -3164 -1527 466 N \nATOM 3514 N ASP B 128 -2.723 5.668 29.814 1.00 96.99 N \nANISOU 3514 N ASP B 128 11625 12730 12497 -2720 -997 301 N \nATOM 3515 CA ASP B 128 -3.506 5.047 30.881 1.00101.05 C \nANISOU 3515 CA ASP B 128 11972 13400 13021 -2624 -954 270 C \nATOM 3516 C ASP B 128 -4.525 6.027 31.498 1.00 99.41 C \nANISOU 3516 C ASP B 128 11837 12972 12962 -2464 -947 250 C \nATOM 3517 O ASP B 128 -5.257 5.666 32.417 1.00105.10 O \nANISOU 3517 O ASP B 128 12457 13773 13702 -2377 -918 225 O \nATOM 3518 CB ASP B 128 -2.602 4.420 31.958 1.00100.40 C \nANISOU 3518 CB ASP B 128 11819 13569 12758 -2847 -977 301 C \nATOM 3519 CG ASP B 128 -1.504 5.372 32.460 1.00104.97 C \nANISOU 3519 CG ASP B 128 12630 13994 13258 -3091 -1056 367 C \nATOM 3520 OD1 ASP B 128 -1.515 6.573 32.120 1.00 97.53 O \nANISOU 3520 OD1 ASP B 128 11907 12743 12407 -3036 -1097 376 O \nATOM 3521 OD2 ASP B 128 -0.613 4.888 33.189 1.00108.64 O \nANISOU 3521 OD2 ASP B 128 13067 14667 13544 -3337 -1085 405 O \nATOM 3522 N ASN B 129 -4.583 7.240 30.960 1.00 85.98 N \nANISOU 3522 N ASN B 129 10302 11019 11347 -2415 -975 257 N \nATOM 3523 CA ASN B 129 -5.634 8.160 31.299 1.00 85.19 C \nANISOU 3523 CA ASN B 129 10237 10760 11372 -2252 -962 231 C \nATOM 3524 C ASN B 129 -6.998 7.808 30.657 1.00 85.14 C \nANISOU 3524 C ASN B 129 10122 10760 11468 -2067 -903 187 C \nATOM 3525 O ASN B 129 -8.015 8.364 31.056 1.00 76.91 O \nANISOU 3525 O ASN B 129 9079 9639 10505 -1961 -886 167 O \nATOM 3526 CB ASN B 129 -5.211 9.573 30.919 1.00 87.76 C \nANISOU 3526 CB ASN B 129 10763 10867 11715 -2238 -1019 242 C \nATOM 3527 CG ASN B 129 -4.219 10.152 31.917 1.00 96.60 C \nANISOU 3527 CG ASN B 129 12047 11918 12737 -2377 -1093 278 C \nATOM 3528 OD1 ASN B 129 -3.665 9.423 32.750 1.00101.98 O \nANISOU 3528 OD1 ASN B 129 12687 12737 13326 -2540 -1099 307 O \nATOM 3529 ND2 ASN B 129 -4.014 11.466 31.864 1.00 92.63 N \nANISOU 3529 ND2 ASN B 129 11739 11219 12236 -2304 -1156 273 N \nATOM 3530 N ALA B 130 -7.007 6.888 29.686 1.00 78.13 N \nANISOU 3530 N ALA B 130 9160 9968 10560 -2044 -879 174 N \nATOM 3531 CA ALA B 130 -8.228 6.391 29.052 1.00 73.69 C \nANISOU 3531 CA ALA B 130 8534 9407 10060 -1887 -838 135 C \nATOM 3532 C ALA B 130 -8.206 4.899 28.715 1.00 74.59 C \nANISOU 3532 C ALA B 130 8532 9717 10091 -1846 -820 110 C \nATOM 3533 O ALA B 130 -7.136 4.312 28.531 1.00 73.33 O \nANISOU 3533 O ALA B 130 8320 9711 9831 -1956 -830 125 O \nATOM 3534 CB ALA B 130 -8.507 7.182 27.772 1.00 76.88 C \nANISOU 3534 CB ALA B 130 9011 9664 10537 -1837 -837 132 C \nATOM 3535 N LYS B 131 -9.409 4.326 28.577 1.00 77.01 N \nANISOU 3535 N LYS B 131 8818 10020 10421 -1687 -802 69 N \nATOM 3536 CA LYS B 131 -9.622 2.920 28.175 1.00 82.90 C \nANISOU 3536 CA LYS B 131 9486 10936 11077 -1573 -796 27 C \nATOM 3537 C LYS B 131 -9.884 2.876 26.670 1.00 85.56 C \nANISOU 3537 C LYS B 131 9870 11186 11453 -1520 -790 18 C \nATOM 3538 O LYS B 131 -10.773 3.549 26.193 1.00 67.77 O \nANISOU 3538 O LYS B 131 7713 8747 9288 -1479 -787 19 O \nATOM 3539 CB LYS B 131 -10.853 2.272 28.845 1.00 91.50 C \nANISOU 3539 CB LYS B 131 10594 12033 12141 -1400 -804 -20 C \nATOM 3540 CG LYS B 131 -10.665 1.678 30.234 1.00102.40 C \nANISOU 3540 CG LYS B 131 11885 13595 13429 -1380 -812 -37 C \nATOM 3541 CD LYS B 131 -11.924 0.945 30.735 1.00103.18 C \nANISOU 3541 CD LYS B 131 12042 13683 13479 -1169 -834 -93 C \nATOM 3542 CE LYS B 131 -11.851 0.521 32.232 1.00104.49 C \nANISOU 3542 CE LYS B 131 12130 14010 13561 -1136 -844 -112 C \nATOM 3543 NZ LYS B 131 -10.491 0.086 32.681 1.00103.77 N \nANISOU 3543 NZ LYS B 131 11853 14215 13361 -1257 -832 -99 N \nATOM 3544 N GLU B 132 -9.108 2.071 25.935 1.00 96.43 N \nANISOU 3544 N GLU B 132 11169 12723 12746 -1534 -789 11 N \nATOM 3545 CA GLU B 132 -9.410 1.770 24.534 1.00 93.28 C \nANISOU 3545 CA GLU B 132 10804 12273 12365 -1456 -784 -7 C \nATOM 3546 C GLU B 132 -10.577 0.796 24.462 1.00 93.86 C \nANISOU 3546 C GLU B 132 10910 12364 12387 -1243 -797 -65 C \nATOM 3547 O GLU B 132 -10.419 -0.391 24.765 1.00 96.34 O \nANISOU 3547 O GLU B 132 11134 12902 12568 -1131 -810 -110 O \nATOM 3548 CB GLU B 132 -8.203 1.158 23.829 1.00 93.00 C \nANISOU 3548 CB GLU B 132 10673 12426 12238 -1539 -783 1 C \nATOM 3549 CG GLU B 132 -6.999 2.071 23.720 1.00 93.84 C \nANISOU 3549 CG GLU B 132 10811 12480 12363 -1759 -791 60 C \nATOM 3550 CD GLU B 132 -5.879 1.452 22.904 1.00 96.89 C \nANISOU 3550 CD GLU B 132 11129 13041 12644 -1867 -796 73 C \nATOM 3551 OE1 GLU B 132 -6.027 1.324 21.678 1.00 91.07 O \nANISOU 3551 OE1 GLU B 132 10414 12250 11938 -1807 -789 62 O \nATOM 3552 OE2 GLU B 132 -4.842 1.090 23.495 1.00102.08 O \nANISOU 3552 OE2 GLU B 132 11710 13904 13173 -2032 -810 97 O \nATOM 3553 N LEU B 133 -11.736 1.299 24.055 1.00 88.37 N \nANISOU 3553 N LEU B 133 10358 11448 11772 -1187 -804 -68 N \nATOM 3554 CA LEU B 133 -12.961 0.490 24.013 1.00 90.50 C \nANISOU 3554 CA LEU B 133 10741 11667 11977 -1002 -838 -117 C \nATOM 3555 C LEU B 133 -12.907 -0.554 22.902 1.00 93.14 C \nANISOU 3555 C LEU B 133 11081 12083 12225 -869 -855 -158 C \nATOM 3556 O LEU B 133 -13.724 -1.508 22.889 1.00 88.93 O \nANISOU 3556 O LEU B 133 10653 11552 11586 -669 -902 -214 O \nATOM 3557 CB LEU B 133 -14.211 1.362 23.851 1.00 82.07 C \nANISOU 3557 CB LEU B 133 9846 10348 10989 -1038 -848 -97 C \nATOM 3558 CG LEU B 133 -14.782 2.093 25.036 1.00 79.92 C \nANISOU 3558 CG LEU B 133 9614 9996 10758 -1099 -850 -79 C \nATOM 3559 CD1 LEU B 133 -13.730 2.286 26.083 1.00 81.43 C \nANISOU 3559 CD1 LEU B 133 9655 10327 10959 -1165 -828 -63 C \nATOM 3560 CD2 LEU B 133 -15.379 3.420 24.600 1.00 81.16 C \nANISOU 3560 CD2 LEU B 133 9838 9990 11010 -1234 -835 -38 C \nATOM 3561 N GLY B 134 -11.948 -0.378 21.987 1.00 82.52 N \nANISOU 3561 N GLY B 134 9645 10799 10910 -968 -827 -133 N \nATOM 3562 CA GLY B 134 -11.780 -1.286 20.854 1.00 81.29 C \nANISOU 3562 CA GLY B 134 9474 10734 10678 -860 -837 -168 C \nATOM 3563 C GLY B 134 -12.805 -1.027 19.785 1.00 82.46 C \nANISOU 3563 C GLY B 134 9803 10648 10880 -816 -854 -169 C \nATOM 3564 O GLY B 134 -13.219 -1.943 19.077 1.00 90.47 O \nANISOU 3564 O GLY B 134 10890 11679 11805 -655 -887 -214 O \nATOM 3565 N ASN B 135 -13.204 0.237 19.667 1.00 86.16 N \nANISOU 3565 N ASN B 135 10345 10919 11475 -961 -835 -120 N \nATOM 3566 CA ASN B 135 -14.346 0.634 18.829 1.00 84.07 C \nANISOU 3566 CA ASN B 135 10255 10445 11242 -968 -853 -113 C \nATOM 3567 C ASN B 135 -14.100 1.974 18.109 1.00 82.76 C \nANISOU 3567 C ASN B 135 10059 10191 11196 -1139 -815 -62 C \nATOM 3568 O ASN B 135 -14.957 2.458 17.368 1.00 76.32 O \nANISOU 3568 O ASN B 135 9352 9246 10399 -1184 -822 -50 O \nATOM 3569 CB ASN B 135 -15.622 0.711 19.670 1.00 83.17 C \nANISOU 3569 CB ASN B 135 10304 10202 11093 -939 -892 -120 C \nATOM 3570 CG ASN B 135 -15.663 1.936 20.531 1.00 85.67 C \nANISOU 3570 CG ASN B 135 10572 10477 11501 -1091 -863 -77 C \nATOM 3571 OD1 ASN B 135 -14.614 2.474 20.931 1.00 95.67 O \nANISOU 3571 OD1 ASN B 135 11683 11837 12830 -1167 -825 -55 O \nATOM 3572 ND2 ASN B 135 -16.871 2.410 20.807 1.00 78.52 N \nANISOU 3572 ND2 ASN B 135 9816 9432 10586 -1146 -888 -65 N \nATOM 3573 N GLY B 136 -12.932 2.571 18.332 1.00 77.23 N \nANISOU 3573 N GLY B 136 9224 9569 10550 -1231 -783 -36 N \nATOM 3574 CA GLY B 136 -12.623 3.850 17.749 1.00 67.41 C \nANISOU 3574 CA GLY B 136 7966 8255 9394 -1345 -761 -1 C \nATOM 3575 C GLY B 136 -12.634 4.910 18.800 1.00 68.87 C \nANISOU 3575 C GLY B 136 8132 8413 9623 -1417 -756 20 C \nATOM 3576 O GLY B 136 -12.129 6.008 18.570 1.00 58.83 O \nANISOU 3576 O GLY B 136 6838 7116 8399 -1480 -748 40 O \nATOM 3577 N CYS B 137 -13.197 4.568 19.961 1.00 78.61 N \nANISOU 3577 N CYS B 137 9386 9656 10827 -1385 -767 9 N \nATOM 3578 CA CYS B 137 -13.404 5.520 21.046 1.00 79.96 C \nANISOU 3578 CA CYS B 137 9548 9800 11033 -1444 -764 26 C \nATOM 3579 C CYS B 137 -12.583 5.183 22.240 1.00 78.43 C \nANISOU 3579 C CYS B 137 9287 9697 10818 -1447 -768 27 C \nATOM 3580 O CYS B 137 -12.315 4.016 22.494 1.00 83.35 O \nANISOU 3580 O CYS B 137 9874 10423 11372 -1383 -775 6 O \nATOM 3581 CB CYS B 137 -14.855 5.497 21.497 1.00 73.98 C \nANISOU 3581 CB CYS B 137 8889 8971 10250 -1434 -780 18 C \nATOM 3582 SG CYS B 137 -16.003 5.783 20.168 1.00 81.40 S \nANISOU 3582 SG CYS B 137 9938 9819 11171 -1478 -788 23 S \nATOM 3583 N PHE B 138 -12.216 6.213 22.989 1.00 74.17 N \nANISOU 3583 N PHE B 138 8728 9138 10316 -1515 -766 48 N \nATOM 3584 CA PHE B 138 -11.575 6.028 24.257 1.00 73.67 C \nANISOU 3584 CA PHE B 138 8620 9146 10226 -1543 -773 55 C \nATOM 3585 C PHE B 138 -12.548 6.468 25.358 1.00 75.73 C \nANISOU 3585 C PHE B 138 8909 9361 10505 -1532 -775 52 C \nATOM 3586 O PHE B 138 -13.118 7.557 25.295 1.00 64.93 O \nANISOU 3586 O PHE B 138 7570 7921 9179 -1558 -772 60 O \nATOM 3587 CB PHE B 138 -10.307 6.874 24.359 1.00 83.44 C \nANISOU 3587 CB PHE B 138 9857 10376 11472 -1635 -787 83 C \nATOM 3588 CG PHE B 138 -9.302 6.647 23.256 1.00 81.92 C \nANISOU 3588 CG PHE B 138 9667 10205 11254 -1677 -794 94 C \nATOM 3589 CD1 PHE B 138 -8.347 5.659 23.367 1.00 78.11 C \nANISOU 3589 CD1 PHE B 138 9129 9860 10689 -1738 -800 101 C \nATOM 3590 CD2 PHE B 138 -9.292 7.466 22.132 1.00 80.21 C \nANISOU 3590 CD2 PHE B 138 9501 9896 11078 -1663 -797 96 C \nATOM 3591 CE1 PHE B 138 -7.415 5.471 22.375 1.00 83.79 C \nANISOU 3591 CE1 PHE B 138 9858 10608 11372 -1801 -810 115 C \nATOM 3592 CE2 PHE B 138 -8.364 7.283 21.134 1.00 78.56 C \nANISOU 3592 CE2 PHE B 138 9312 9696 10843 -1703 -809 106 C \nATOM 3593 CZ PHE B 138 -7.422 6.286 21.258 1.00 86.03 C \nANISOU 3593 CZ PHE B 138 10216 10760 11710 -1781 -816 118 C \nATOM 3594 N GLU B 139 -12.735 5.620 26.368 1.00 75.49 N \nANISOU 3594 N GLU B 139 8859 9398 10425 -1489 -783 37 N \nATOM 3595 CA GLU B 139 -13.402 6.038 27.590 1.00 78.03 C \nANISOU 3595 CA GLU B 139 9202 9686 10758 -1495 -787 39 C \nATOM 3596 C GLU B 139 -12.337 6.590 28.510 1.00 76.81 C \nANISOU 3596 C GLU B 139 8993 9578 10612 -1572 -789 61 C \nATOM 3597 O GLU B 139 -11.500 5.846 29.046 1.00 64.44 O \nANISOU 3597 O GLU B 139 7365 8133 8986 -1591 -794 61 O \nATOM 3598 CB GLU B 139 -14.162 4.890 28.275 1.00 86.26 C \nANISOU 3598 CB GLU B 139 10278 10767 11730 -1393 -806 7 C \nATOM 3599 CG GLU B 139 -14.898 5.337 29.533 1.00 86.14 C \nANISOU 3599 CG GLU B 139 10300 10706 11724 -1407 -814 10 C \nATOM 3600 CD GLU B 139 -15.947 4.359 30.042 1.00 89.00 C \nANISOU 3600 CD GLU B 139 10763 11048 12005 -1292 -848 -24 C \nATOM 3601 OE1 GLU B 139 -16.353 3.422 29.327 1.00 89.94 O \nANISOU 3601 OE1 GLU B 139 10961 11157 12055 -1186 -874 -55 O \nATOM 3602 OE2 GLU B 139 -16.393 4.546 31.186 1.00 96.17 O \nANISOU 3602 OE2 GLU B 139 11694 11940 12907 -1297 -858 -23 O \nATOM 3603 N PHE B 140 -12.380 7.906 28.702 1.00 81.16 N \nANISOU 3603 N PHE B 140 9571 10051 11214 -1617 -791 78 N \nATOM 3604 CA PHE B 140 -11.442 8.585 29.566 1.00 77.99 C \nANISOU 3604 CA PHE B 140 9169 9653 10809 -1679 -809 98 C \nATOM 3605 C PHE B 140 -11.623 8.008 30.940 1.00 85.81 C \nANISOU 3605 C PHE B 140 10125 10708 11770 -1681 -809 95 C \nATOM 3606 O PHE B 140 -12.729 7.669 31.370 1.00 91.72 O \nANISOU 3606 O PHE B 140 10878 11449 12522 -1623 -801 77 O \nATOM 3607 CB PHE B 140 -11.743 10.061 29.680 1.00 74.18 C \nANISOU 3607 CB PHE B 140 8725 9095 10365 -1670 -819 99 C \nATOM 3608 CG PHE B 140 -11.331 10.849 28.502 1.00 80.26 C \nANISOU 3608 CG PHE B 140 9531 9823 11142 -1652 -830 97 C \nATOM 3609 CD1 PHE B 140 -12.093 10.848 27.347 1.00 74.42 C \nANISOU 3609 CD1 PHE B 140 8774 9082 10421 -1619 -809 84 C \nATOM 3610 CD2 PHE B 140 -10.184 11.620 28.551 1.00 79.78 C \nANISOU 3610 CD2 PHE B 140 9545 9715 11051 -1665 -874 107 C \nATOM 3611 CE1 PHE B 140 -11.692 11.578 26.257 1.00 80.62 C \nANISOU 3611 CE1 PHE B 140 9582 9847 11203 -1590 -821 78 C \nATOM 3612 CE2 PHE B 140 -9.793 12.370 27.460 1.00 81.52 C \nANISOU 3612 CE2 PHE B 140 9820 9893 11262 -1617 -896 97 C \nATOM 3613 CZ PHE B 140 -10.544 12.346 26.307 1.00 78.03 C \nANISOU 3613 CZ PHE B 140 9325 9475 10846 -1575 -865 81 C \nATOM 3614 N TYR B 141 -10.532 7.886 31.660 1.00 96.01 N \nANISOU 3614 N TYR B 141 11401 12063 13016 -1759 -826 114 N \nATOM 3615 CA TYR B 141 -10.669 7.488 33.032 1.00 97.97 C \nANISOU 3615 CA TYR B 141 11608 12384 13231 -1766 -827 111 C \nATOM 3616 C TYR B 141 -11.234 8.734 33.670 1.00106.16 C \nANISOU 3616 C TYR B 141 12699 13307 14330 -1757 -833 116 C \nATOM 3617 O TYR B 141 -12.382 8.749 34.134 1.00124.83 O \nANISOU 3617 O TYR B 141 15060 15649 16720 -1700 -820 100 O \nATOM 3618 CB TYR B 141 -9.338 7.022 33.619 1.00 93.55 C \nANISOU 3618 CB TYR B 141 11013 11953 12580 -1888 -847 135 C \nATOM 3619 CG TYR B 141 -9.063 5.575 33.276 1.00 86.89 C \nANISOU 3619 CG TYR B 141 10061 11310 11643 -1871 -834 116 C \nATOM 3620 CD1 TYR B 141 -10.018 4.605 33.543 1.00 82.08 C \nANISOU 3620 CD1 TYR B 141 9391 10789 11008 -1725 -819 72 C \nATOM 3621 CD2 TYR B 141 -7.871 5.173 32.681 1.00 92.74 C \nANISOU 3621 CD2 TYR B 141 10774 12163 12299 -1991 -847 137 C \nATOM 3622 CE1 TYR B 141 -9.805 3.291 33.224 1.00 82.56 C \nANISOU 3622 CE1 TYR B 141 9350 11059 10958 -1660 -817 40 C \nATOM 3623 CE2 TYR B 141 -7.638 3.842 32.373 1.00 91.87 C \nANISOU 3623 CE2 TYR B 141 10536 12290 12080 -1964 -835 112 C \nATOM 3624 CZ TYR B 141 -8.616 2.914 32.652 1.00 92.52 C \nANISOU 3624 CZ TYR B 141 10545 12473 12137 -1779 -819 59 C \nATOM 3625 OH TYR B 141 -8.411 1.585 32.363 1.00115.92 O \nANISOU 3625 OH TYR B 141 13378 15700 14966 -1703 -816 19 O \nATOM 3626 N HIS B 142 -10.478 9.817 33.565 1.00 96.95 N \nANISOU 3626 N HIS B 142 11600 12066 13170 -1803 -861 134 N \nATOM 3627 CA HIS B 142 -10.898 11.092 34.153 1.00 89.34 C \nANISOU 3627 CA HIS B 142 10678 11028 12239 -1769 -874 130 C \nATOM 3628 C HIS B 142 -12.066 11.860 33.515 1.00 90.55 C \nANISOU 3628 C HIS B 142 10815 11152 12436 -1692 -855 108 C \nATOM 3629 O HIS B 142 -12.642 11.495 32.486 1.00 99.44 O \nANISOU 3629 O HIS B 142 11920 12286 13577 -1671 -832 98 O \nATOM 3630 CB HIS B 142 -9.692 12.021 34.343 1.00 83.69 C \nANISOU 3630 CB HIS B 142 10077 10242 11481 -1808 -931 147 C \nATOM 3631 CG HIS B 142 -8.984 12.404 33.095 1.00 80.13 C \nANISOU 3631 CG HIS B 142 9706 9733 11009 -1798 -959 148 C \nATOM 3632 ND1 HIS B 142 -8.000 11.608 32.545 1.00 89.83 N \nANISOU 3632 ND1 HIS B 142 10962 10983 12186 -1897 -972 171 N \nATOM 3633 CD2 HIS B 142 -9.031 13.527 32.344 1.00 75.66 C \nANISOU 3633 CD2 HIS B 142 9202 9102 10443 -1701 -984 126 C \nATOM 3634 CE1 HIS B 142 -7.506 12.205 31.476 1.00 92.07 C \nANISOU 3634 CE1 HIS B 142 11341 11188 12454 -1865 -1005 168 C \nATOM 3635 NE2 HIS B 142 -8.119 13.368 31.329 1.00 88.59 N \nANISOU 3635 NE2 HIS B 142 10921 10695 12043 -1733 -1013 137 N \nATOM 3636 N LYS B 143 -12.432 12.911 34.227 1.00 88.60 N \nANISOU 3636 N LYS B 143 10576 10897 12193 -1664 -866 100 N \nATOM 3637 CA LYS B 143 -13.335 13.923 33.752 1.00 86.41 C \nANISOU 3637 CA LYS B 143 10266 10648 11917 -1611 -857 78 C \nATOM 3638 C LYS B 143 -12.565 14.784 32.791 1.00 85.78 C \nANISOU 3638 C LYS B 143 10233 10550 11809 -1546 -889 64 C \nATOM 3639 O LYS B 143 -11.486 15.287 33.136 1.00 89.76 O \nANISOU 3639 O LYS B 143 10832 10994 12278 -1519 -940 66 O \nATOM 3640 CB LYS B 143 -13.773 14.784 34.926 1.00 88.04 C \nANISOU 3640 CB LYS B 143 10454 10886 12109 -1592 -867 69 C \nATOM 3641 CG LYS B 143 -14.639 15.976 34.552 1.00 96.26 C \nANISOU 3641 CG LYS B 143 11433 12025 13115 -1542 -862 41 C \nATOM 3642 CD LYS B 143 -14.769 16.953 35.708 1.00104.21 C \nANISOU 3642 CD LYS B 143 12423 13083 14088 -1498 -882 26 C \nATOM 3643 CE LYS B 143 -15.477 16.306 36.893 1.00106.43 C \nANISOU 3643 CE LYS B 143 12685 13354 14398 -1582 -859 46 C \nATOM 3644 NZ LYS B 143 -15.710 17.263 37.999 1.00102.39 N \nANISOU 3644 NZ LYS B 143 12145 12905 13853 -1546 -875 31 N \nATOM 3645 N CYS B 144 -13.135 14.979 31.608 1.00 82.12 N \nANISOU 3645 N CYS B 144 9726 10132 11345 -1521 -869 50 N \nATOM 3646 CA CYS B 144 -12.478 15.724 30.554 1.00 74.82 C \nANISOU 3646 CA CYS B 144 8841 9202 10386 -1440 -899 30 C \nATOM 3647 C CYS B 144 -13.405 16.804 30.040 1.00 76.00 C \nANISOU 3647 C CYS B 144 8900 9489 10489 -1372 -889 -5 C \nATOM 3648 O CYS B 144 -14.205 16.578 29.122 1.00 65.00 O \nANISOU 3648 O CYS B 144 7438 8162 9096 -1416 -853 -5 O \nATOM 3649 CB CYS B 144 -12.044 14.797 29.421 1.00 70.38 C \nANISOU 3649 CB CYS B 144 8302 8591 9848 -1481 -886 46 C \nATOM 3650 SG CYS B 144 -10.796 15.439 28.253 1.00 77.47 S \nANISOU 3650 SG CYS B 144 9308 9427 10698 -1399 -941 32 S \nATOM 3651 N ASP B 145 -13.287 17.991 30.641 1.00 87.83 N \nANISOU 3651 N ASP B 145 10398 11050 11924 -1266 -925 -37 N \nATOM 3652 CA ASP B 145 -14.093 19.158 30.226 1.00 91.70 C \nANISOU 3652 CA ASP B 145 10768 11744 12328 -1182 -921 -81 C \nATOM 3653 C ASP B 145 -13.811 19.540 28.774 1.00 87.20 C \nANISOU 3653 C ASP B 145 10192 11228 11713 -1096 -934 -109 C \nATOM 3654 O ASP B 145 -12.884 19.038 28.155 1.00 88.85 O \nANISOU 3654 O ASP B 145 10512 11290 11956 -1084 -955 -95 O \nATOM 3655 CB ASP B 145 -13.908 20.368 31.178 1.00 99.75 C \nANISOU 3655 CB ASP B 145 11791 12845 13265 -1040 -969 -123 C \nATOM 3656 CG ASP B 145 -12.444 20.792 31.354 1.00102.08 C \nANISOU 3656 CG ASP B 145 12282 12982 13522 -893 -1055 -140 C \nATOM 3657 OD1 ASP B 145 -11.633 20.633 30.432 1.00107.40 O \nANISOU 3657 OD1 ASP B 145 13062 13555 14189 -853 -1087 -140 O \nATOM 3658 OD2 ASP B 145 -12.103 21.317 32.433 1.00106.54 O \nANISOU 3658 OD2 ASP B 145 12919 13513 14047 -822 -1101 -154 O \nATOM 3659 N ASN B 146 -14.629 20.423 28.230 1.00 90.67 N \nANISOU 3659 N ASN B 146 10489 11902 12059 -1047 -920 -147 N \nATOM 3660 CA ASN B 146 -14.476 20.843 26.847 1.00 89.98 C \nANISOU 3660 CA ASN B 146 10369 11908 11912 -959 -929 -179 C \nATOM 3661 C ASN B 146 -13.055 21.270 26.500 1.00 89.65 C \nANISOU 3661 C ASN B 146 10495 11730 11839 -762 -1007 -210 C \nATOM 3662 O ASN B 146 -12.569 20.954 25.425 1.00 87.69 O \nANISOU 3662 O ASN B 146 10303 11408 11606 -749 -1014 -206 O \nATOM 3663 CB ASN B 146 -15.466 21.965 26.516 1.00 90.44 C \nANISOU 3663 CB ASN B 146 10229 12310 11826 -909 -916 -229 C \nATOM 3664 CG ASN B 146 -16.898 21.505 26.583 1.00 98.98 C \nANISOU 3664 CG ASN B 146 11182 13519 12907 -1156 -850 -189 C \nATOM 3665 OD1 ASN B 146 -17.750 22.178 27.161 1.00116.04 O \nANISOU 3665 OD1 ASN B 146 13209 15911 14970 -1198 -839 -205 O \nATOM 3666 ND2 ASN B 146 -17.173 20.336 26.019 1.00105.22 N \nANISOU 3666 ND2 ASN B 146 12033 14157 13790 -1325 -815 -136 N \nATOM 3667 N GLU B 147 -12.397 21.987 27.405 1.00 96.57 N \nANISOU 3667 N GLU B 147 11477 12560 12656 -615 -1075 -240 N \nATOM 3668 CA GLU B 147 -11.029 22.442 27.157 1.00102.26 C \nANISOU 3668 CA GLU B 147 12426 13116 13311 -433 -1174 -269 C \nATOM 3669 C GLU B 147 -10.042 21.285 27.183 1.00100.66 C \nANISOU 3669 C GLU B 147 12411 12627 13210 -588 -1186 -202 C \nATOM 3670 O GLU B 147 -9.075 21.288 26.430 1.00102.73 O \nANISOU 3670 O GLU B 147 12841 12758 13435 -529 -1245 -206 O \nATOM 3671 CB GLU B 147 -10.617 23.558 28.126 1.00106.22 C \nANISOU 3671 CB GLU B 147 13031 13636 13692 -223 -1261 -323 C \nATOM 3672 CG GLU B 147 -11.339 24.866 27.846 1.00115.37 C \nANISOU 3672 CG GLU B 147 14012 15129 14693 0 -1273 -411 C \nATOM 3673 CD GLU B 147 -10.834 26.026 28.687 1.00126.22 C \nANISOU 3673 CD GLU B 147 15514 16528 15916 273 -1378 -481 C \nATOM 3674 OE1 GLU B 147 -11.400 26.251 29.778 1.00128.24 O \nANISOU 3674 OE1 GLU B 147 15672 16883 16169 241 -1356 -482 O \nATOM 3675 OE2 GLU B 147 -9.869 26.709 28.272 1.00134.93 O \nANISOU 3675 OE2 GLU B 147 16838 17539 16891 527 -1492 -538 O \nATOM 3676 N CYS B 148 -10.284 20.302 28.047 1.00 98.79 N \nANISOU 3676 N CYS B 148 12141 12316 13077 -786 -1134 -144 N \nATOM 3677 CA CYS B 148 -9.489 19.073 28.066 1.00 91.41 C \nANISOU 3677 CA CYS B 148 11320 11193 12218 -955 -1130 -83 C \nATOM 3678 C CYS B 148 -9.659 18.326 26.743 1.00 96.00 C \nANISOU 3678 C CYS B 148 11834 11788 12852 -1025 -1082 -67 C \nATOM 3679 O CYS B 148 -8.707 17.768 26.210 1.00107.10 O \nANISOU 3679 O CYS B 148 13365 13068 14261 -1079 -1110 -41 O \nATOM 3680 CB CYS B 148 -9.901 18.173 29.250 1.00 93.48 C \nANISOU 3680 CB CYS B 148 11516 11441 12563 -1120 -1080 -38 C \nATOM 3681 SG CYS B 148 -9.331 16.452 29.285 1.00 96.93 S \nANISOU 3681 SG CYS B 148 11980 11774 13074 -1332 -1046 27 S \nATOM 3682 N MET B 149 -10.869 18.351 26.199 1.00 90.10 N \nANISOU 3682 N MET B 149 10903 11201 12129 -1036 -1015 -81 N \nATOM 3683 CA MET B 149 -11.150 17.728 24.928 1.00 83.48 C \nANISOU 3683 CA MET B 149 10007 10383 11329 -1094 -973 -69 C \nATOM 3684 C MET B 149 -10.494 18.496 23.792 1.00 82.94 C \nANISOU 3684 C MET B 149 10006 10320 11186 -945 -1023 -108 C \nATOM 3685 O MET B 149 -9.872 17.894 22.907 1.00 84.45 O \nANISOU 3685 O MET B 149 10270 10414 11403 -984 -1028 -89 O \nATOM 3686 CB MET B 149 -12.663 17.640 24.684 1.00 87.12 C \nANISOU 3686 CB MET B 149 10290 11010 11802 -1170 -903 -71 C \nATOM 3687 CG MET B 149 -13.183 16.228 24.520 1.00 87.79 C \nANISOU 3687 CG MET B 149 10358 11028 11969 -1331 -851 -26 C \nATOM 3688 SD MET B 149 -13.631 15.548 26.100 1.00104.44 S \nANISOU 3688 SD MET B 149 12469 13090 14122 -1426 -833 2 S \nATOM 3689 CE MET B 149 -14.088 13.874 25.699 1.00 76.04 C \nANISOU 3689 CE MET B 149 8891 9420 10582 -1538 -795 35 C \nATOM 3690 N GLU B 150 -10.647 19.817 23.772 1.00 85.41 N \nANISOU 3690 N GLU B 150 10294 10768 11391 -761 -1064 -168 N \nATOM 3691 CA GLU B 150 -9.986 20.612 22.731 1.00 93.42 C \nANISOU 3691 CA GLU B 150 11393 11794 12308 -572 -1128 -217 C \nATOM 3692 C GLU B 150 -8.501 20.280 22.745 1.00 92.55 C \nANISOU 3692 C GLU B 150 11556 11418 12191 -571 -1208 -193 C \nATOM 3693 O GLU B 150 -7.874 20.204 21.680 1.00 99.66 O \nANISOU 3693 O GLU B 150 12554 12246 13067 -533 -1239 -197 O \nATOM 3694 CB GLU B 150 -10.217 22.114 22.903 1.00 99.77 C \nANISOU 3694 CB GLU B 150 12152 12798 12959 -323 -1181 -299 C \nATOM 3695 CG GLU B 150 -9.611 22.997 21.805 1.00109.41 C \nANISOU 3695 CG GLU B 150 13458 14065 14047 -77 -1256 -367 C \nATOM 3696 CD GLU B 150 -10.173 22.714 20.412 1.00116.33 C \nANISOU 3696 CD GLU B 150 14177 15078 14945 -133 -1193 -366 C \nATOM 3697 OE1 GLU B 150 -11.418 22.712 20.257 1.00128.78 O \nANISOU 3697 OE1 GLU B 150 15505 16900 16527 -237 -1111 -364 O \nATOM 3698 OE2 GLU B 150 -9.383 22.504 19.469 1.00109.97 O \nANISOU 3698 OE2 GLU B 150 13509 14137 14138 -90 -1230 -365 O \nATOM 3699 N SER B 151 -7.972 20.068 23.953 1.00 88.47 N \nANISOU 3699 N SER B 151 11165 10766 11683 -638 -1243 -163 N \nATOM 3700 CA SER B 151 -6.542 19.873 24.162 1.00 91.95 C \nANISOU 3700 CA SER B 151 11895 10968 12074 -675 -1336 -135 C \nATOM 3701 C SER B 151 -6.058 18.581 23.526 1.00 95.03 C \nANISOU 3701 C SER B 151 12303 11264 12539 -886 -1299 -73 C \nATOM 3702 O SER B 151 -4.968 18.555 22.950 1.00106.14 O \nANISOU 3702 O SER B 151 13924 12526 13878 -896 -1374 -62 O \nATOM 3703 CB SER B 151 -6.147 19.899 25.649 1.00 93.74 C \nANISOU 3703 CB SER B 151 12240 11097 12279 -735 -1378 -112 C \nATOM 3704 OG SER B 151 -6.240 18.626 26.241 1.00100.11 O \nANISOU 3704 OG SER B 151 12962 11884 13193 -983 -1308 -44 O \nATOM 3705 N VAL B 152 -6.866 17.527 23.607 1.00 90.07 N \nANISOU 3705 N VAL B 152 11465 10725 12031 -1044 -1194 -38 N \nATOM 3706 CA VAL B 152 -6.485 16.252 22.990 1.00 93.14 C \nANISOU 3706 CA VAL B 152 11841 11072 12476 -1215 -1156 10 C \nATOM 3707 C VAL B 152 -6.594 16.283 21.458 1.00 93.11 C \nANISOU 3707 C VAL B 152 11801 11098 12478 -1153 -1141 -9 C \nATOM 3708 O VAL B 152 -5.939 15.504 20.773 1.00104.73 O \nANISOU 3708 O VAL B 152 13327 12508 13956 -1254 -1142 22 O \nATOM 3709 CB VAL B 152 -7.275 15.035 23.537 1.00 94.23 C \nANISOU 3709 CB VAL B 152 11798 11293 12713 -1362 -1065 44 C \nATOM 3710 CG1 VAL B 152 -7.206 14.974 25.048 1.00 93.55 C \nANISOU 3710 CG1 VAL B 152 11731 11193 12620 -1421 -1076 61 C \nATOM 3711 CG2 VAL B 152 -8.715 15.039 23.077 1.00 97.72 C \nANISOU 3711 CG2 VAL B 152 12048 11865 13216 -1317 -989 21 C \nATOM 3712 N ARG B 153 -7.418 17.182 20.932 1.00 91.08 N \nANISOU 3712 N ARG B 153 11441 10961 12203 -996 -1125 -60 N \nATOM 3713 CA ARG B 153 -7.578 17.319 19.484 1.00 90.87 C \nANISOU 3713 CA ARG B 153 11369 10988 12169 -929 -1112 -83 C \nATOM 3714 C ARG B 153 -6.400 18.020 18.838 1.00 98.16 C \nANISOU 3714 C ARG B 153 12517 11794 12987 -797 -1214 -108 C \nATOM 3715 O ARG B 153 -5.955 17.616 17.775 1.00 89.39 O \nANISOU 3715 O ARG B 153 11452 10631 11881 -828 -1217 -97 O \nATOM 3716 CB ARG B 153 -8.856 18.095 19.133 1.00 85.91 C \nANISOU 3716 CB ARG B 153 10542 10578 11521 -825 -1066 -130 C \nATOM 3717 CG ARG B 153 -10.151 17.382 19.506 1.00 78.37 C \nANISOU 3717 CG ARG B 153 9401 9727 10649 -977 -974 -102 C \nATOM 3718 CD ARG B 153 -11.333 18.013 18.802 1.00 79.98 C \nANISOU 3718 CD ARG B 153 9430 10154 10805 -941 -933 -135 C \nATOM 3719 NE ARG B 153 -12.520 18.124 19.647 1.00 83.23 N \nANISOU 3719 NE ARG B 153 9710 10699 11213 -1025 -890 -130 N \nATOM 3720 CZ ARG B 153 -12.951 19.254 20.207 1.00 89.55 C \nANISOU 3720 CZ ARG B 153 10427 11678 11919 -928 -907 -172 C \nATOM 3721 NH1 ARG B 153 -12.318 20.404 20.003 1.00 90.36 N \nANISOU 3721 NH1 ARG B 153 10563 11855 11914 -707 -971 -232 N \nATOM 3722 NH2 ARG B 153 -14.039 19.244 20.959 1.00 95.05 N \nANISOU 3722 NH2 ARG B 153 11013 12491 12610 -1043 -867 -159 N \nATOM 3723 N ASN B 154 -5.911 19.080 19.480 1.00111.76 N \nANISOU 3723 N ASN B 154 14397 13467 14598 -639 -1306 -146 N \nATOM 3724 CA ASN B 154 -4.820 19.904 18.920 1.00116.70 C \nANISOU 3724 CA ASN B 154 15297 13960 15083 -465 -1432 -184 C \nATOM 3725 C ASN B 154 -3.424 19.468 19.371 1.00111.68 C \nANISOU 3725 C ASN B 154 14977 13065 14390 -607 -1526 -131 C \nATOM 3726 O ASN B 154 -2.459 20.192 19.152 1.00113.71 O \nANISOU 3726 O ASN B 154 15538 13164 14500 -476 -1657 -157 O \nATOM 3727 CB ASN B 154 -5.037 21.387 19.264 1.00123.89 C \nANISOU 3727 CB ASN B 154 16247 14970 15857 -164 -1505 -270 C \nATOM 3728 CG ASN B 154 -5.278 21.609 20.742 1.00131.45 C \nANISOU 3728 CG ASN B 154 17196 15935 16814 -181 -1510 -265 C \nATOM 3729 OD1 ASN B 154 -5.199 20.661 21.515 1.00131.56 O \nANISOU 3729 OD1 ASN B 154 17196 15863 16926 -419 -1465 -196 O \nATOM 3730 ND2 ASN B 154 -5.619 22.842 21.150 1.00146.28 N \nANISOU 3730 ND2 ASN B 154 19058 17947 18574 78 -1561 -342 N \nATOM 3731 N GLY B 155 -3.327 18.309 20.025 1.00107.30 N \nANISOU 3731 N GLY B 155 14364 12480 13924 -874 -1468 -59 N \nATOM 3732 CA GLY B 155 -2.047 17.794 20.500 1.00102.99 C \nANISOU 3732 CA GLY B 155 14081 11747 13304 -1072 -1548 1 C \nATOM 3733 C GLY B 155 -1.567 18.419 21.804 1.00107.43 C \nANISOU 3733 C GLY B 155 14855 12197 13766 -1052 -1641 1 C \nATOM 3734 O GLY B 155 -0.710 17.866 22.491 1.00110.30 O \nANISOU 3734 O GLY B 155 15385 12450 14074 -1277 -1687 62 O \nATOM 3735 N THR B 156 -2.128 19.563 22.167 1.00106.71 N \nANISOU 3735 N THR B 156 14749 12158 13637 -792 -1669 -67 N \nATOM 3736 CA THR B 156 -1.684 20.299 23.326 1.00113.84 C \nANISOU 3736 CA THR B 156 15878 12948 14429 -720 -1771 -81 C \nATOM 3737 C THR B 156 -2.372 19.818 24.591 1.00104.06 C \nANISOU 3737 C THR B 156 14428 11815 13296 -853 -1683 -50 C \nATOM 3738 O THR B 156 -2.926 20.617 25.329 1.00 99.47 O \nANISOU 3738 O THR B 156 13797 11303 12694 -685 -1692 -96 O \nATOM 3739 CB THR B 156 -1.986 21.790 23.142 1.00125.14 C \nANISOU 3739 CB THR B 156 17375 14428 15744 -338 -1848 -182 C \nATOM 3740 OG1 THR B 156 -3.402 21.983 23.126 1.00126.62 O \nANISOU 3740 OG1 THR B 156 17173 14898 16038 -235 -1723 -223 O \nATOM 3741 CG2 THR B 156 -1.393 22.306 21.840 1.00125.91 C \nANISOU 3741 CG2 THR B 156 17669 14444 15727 -161 -1936 -225 C \nATOM 3742 N TYR B 157 -2.303 18.515 24.850 1.00105.53 N \nANISOU 3742 N TYR B 157 14494 12027 13574 -1142 -1605 23 N \nATOM 3743 CA TYR B 157 -2.951 17.908 26.017 1.00103.47 C \nANISOU 3743 CA TYR B 157 14032 11874 13409 -1270 -1520 52 C \nATOM 3744 C TYR B 157 -1.931 17.580 27.081 1.00109.24 C \nANISOU 3744 C TYR B 157 14981 12478 14048 -1475 -1595 108 C \nATOM 3745 O TYR B 157 -0.937 16.910 26.805 1.00126.83 O \nANISOU 3745 O TYR B 157 17357 14629 16205 -1689 -1636 163 O \nATOM 3746 CB TYR B 157 -3.693 16.630 25.614 1.00102.57 C \nANISOU 3746 CB TYR B 157 13617 11918 13439 -1416 -1385 82 C \nATOM 3747 CG TYR B 157 -4.063 15.689 26.766 1.00 93.08 C \nANISOU 3747 CG TYR B 157 12259 10804 12302 -1585 -1316 121 C \nATOM 3748 CD1 TYR B 157 -5.182 15.923 27.571 1.00 94.40 C \nANISOU 3748 CD1 TYR B 157 12252 11072 12545 -1504 -1256 97 C \nATOM 3749 CD2 TYR B 157 -3.308 14.562 27.030 1.00 87.90 C \nANISOU 3749 CD2 TYR B 157 11622 10160 11614 -1824 -1313 179 C \nATOM 3750 CE1 TYR B 157 -5.530 15.062 28.605 1.00 89.91 C \nANISOU 3750 CE1 TYR B 157 11556 10579 12026 -1636 -1201 127 C \nATOM 3751 CE2 TYR B 157 -3.642 13.691 28.063 1.00 88.90 C \nANISOU 3751 CE2 TYR B 157 11595 10402 11780 -1949 -1254 205 C \nATOM 3752 CZ TYR B 157 -4.758 13.947 28.848 1.00 92.77 C \nANISOU 3752 CZ TYR B 157 11935 10958 12354 -1843 -1200 177 C \nATOM 3753 OH TYR B 157 -5.082 13.090 29.868 1.00 82.10 O \nANISOU 3753 OH TYR B 157 10451 9715 11031 -1947 -1150 198 O \nATOM 3754 N ASP B 158 -2.187 18.034 28.305 1.00115.78 N \nANISOU 3754 N ASP B 158 15822 13305 14866 -1433 -1611 99 N \nATOM 3755 CA ASP B 158 -1.284 17.798 29.440 1.00117.31 C \nANISOU 3755 CA ASP B 158 16223 13389 14960 -1635 -1684 152 C \nATOM 3756 C ASP B 158 -1.642 16.503 30.170 1.00111.28 C \nANISOU 3756 C ASP B 158 15201 12788 14291 -1872 -1575 204 C \nATOM 3757 O ASP B 158 -2.622 16.446 30.904 1.00104.85 O \nANISOU 3757 O ASP B 158 14168 12092 13578 -1809 -1496 186 O \nATOM 3758 CB ASP B 158 -1.333 18.975 30.425 1.00120.05 C \nANISOU 3758 CB ASP B 158 16735 13647 15231 -1452 -1768 111 C \nATOM 3759 CG ASP B 158 -0.347 18.823 31.563 1.00121.57 C \nANISOU 3759 CG ASP B 158 17192 13702 15298 -1667 -1862 168 C \nATOM 3760 OD1 ASP B 158 0.861 18.681 31.271 1.00131.89 O \nANISOU 3760 OD1 ASP B 158 18813 14844 16456 -1837 -1970 213 O \nATOM 3761 OD2 ASP B 158 -0.781 18.847 32.733 1.00104.31 O \nANISOU 3761 OD2 ASP B 158 14909 11574 13151 -1682 -1830 171 O \nATOM 3762 N TYR B 159 -0.829 15.471 29.970 1.00115.67 N \nANISOU 3762 N TYR B 159 15790 13368 14791 -2138 -1577 265 N \nATOM 3763 CA TYR B 159 -1.030 14.175 30.631 1.00110.72 C \nANISOU 3763 CA TYR B 159 14923 12937 14210 -2348 -1487 306 C \nATOM 3764 C TYR B 159 -0.916 14.227 32.153 1.00114.36 C \nANISOU 3764 C TYR B 159 15421 13406 14626 -2445 -1510 329 C \nATOM 3765 O TYR B 159 -1.782 13.683 32.841 1.00109.13 O \nANISOU 3765 O TYR B 159 14501 12900 14062 -2427 -1416 319 O \nATOM 3766 CB TYR B 159 -0.059 13.117 30.061 1.00107.82 C \nANISOU 3766 CB TYR B 159 14581 12642 13743 -2618 -1497 362 C \nATOM 3767 CG TYR B 159 -0.101 11.783 30.795 1.00102.70 C \nANISOU 3767 CG TYR B 159 13693 12244 13084 -2826 -1422 397 C \nATOM 3768 CD1 TYR B 159 -1.009 10.781 30.413 1.00104.73 C \nANISOU 3768 CD1 TYR B 159 13623 12713 13458 -2755 -1302 371 C \nATOM 3769 CD2 TYR B 159 0.742 11.530 31.868 1.00 99.74 C \nANISOU 3769 CD2 TYR B 159 13429 11905 12562 -3078 -1479 449 C \nATOM 3770 CE1 TYR B 159 -1.067 9.565 31.075 1.00100.82 C \nANISOU 3770 CE1 TYR B 159 12909 12471 12927 -2891 -1243 387 C \nATOM 3771 CE2 TYR B 159 0.698 10.322 32.541 1.00100.39 C \nANISOU 3771 CE2 TYR B 159 13267 12267 12611 -3247 -1412 472 C \nATOM 3772 CZ TYR B 159 -0.207 9.344 32.145 1.00108.22 C \nANISOU 3772 CZ TYR B 159 13926 13478 13714 -3133 -1295 436 C \nATOM 3773 OH TYR B 159 -0.266 8.152 32.828 1.00102.80 O \nANISOU 3773 OH TYR B 159 13000 13090 12969 -3249 -1238 443 O \nATOM 3774 N PRO B 160 0.160 14.857 32.687 1.00125.57 N \nANISOU 3774 N PRO B 160 17185 14646 15880 -2551 -1643 359 N \nATOM 3775 CA PRO B 160 0.393 14.751 34.137 1.00123.16 C \nANISOU 3775 CA PRO B 160 16920 14362 15511 -2699 -1667 392 C \nATOM 3776 C PRO B 160 -0.665 15.368 35.031 1.00114.62 C \nANISOU 3776 C PRO B 160 15708 13296 14545 -2479 -1622 344 C \nATOM 3777 O PRO B 160 -0.774 14.966 36.192 1.00124.45 O \nANISOU 3777 O PRO B 160 16865 14631 15788 -2595 -1596 367 O \nATOM 3778 CB PRO B 160 1.746 15.451 34.345 1.00135.26 C \nANISOU 3778 CB PRO B 160 18920 15650 16824 -2838 -1841 430 C \nATOM 3779 CG PRO B 160 1.960 16.280 33.128 1.00135.33 C \nANISOU 3779 CG PRO B 160 19140 15474 16804 -2637 -1914 391 C \nATOM 3780 CD PRO B 160 1.269 15.558 32.010 1.00126.46 C \nANISOU 3780 CD PRO B 160 17689 14527 15832 -2575 -1786 371 C \nATOM 3781 N GLN B 161 -1.449 16.307 34.511 1.00108.02 N \nANISOU 3781 N GLN B 161 14843 12405 13795 -2179 -1611 278 N \nATOM 3782 CA GLN B 161 -2.532 16.908 35.312 1.00100.95 C \nANISOU 3782 CA GLN B 161 13797 11563 12995 -1983 -1564 231 C \nATOM 3783 C GLN B 161 -3.463 15.851 35.854 1.00 88.80 C \nANISOU 3783 C GLN B 161 11922 10232 11586 -2064 -1432 243 C \nATOM 3784 O GLN B 161 -3.802 15.868 37.017 1.00 81.01 O \nANISOU 3784 O GLN B 161 10877 9284 10617 -2080 -1416 246 O \nATOM 3785 CB GLN B 161 -3.358 17.902 34.490 1.00103.56 C \nANISOU 3785 CB GLN B 161 14066 11898 13385 -1678 -1550 158 C \nATOM 3786 CG GLN B 161 -3.584 19.232 35.172 1.00113.51 C \nANISOU 3786 CG GLN B 161 15445 13095 14589 -1452 -1619 105 C \nATOM 3787 CD GLN B 161 -4.569 20.078 34.410 1.00124.40 C \nANISOU 3787 CD GLN B 161 16669 14584 16014 -1173 -1583 29 C \nATOM 3788 OE1 GLN B 161 -5.065 19.673 33.363 1.00126.26 O \nANISOU 3788 OE1 GLN B 161 16730 14915 16326 -1166 -1509 22 O \nATOM 3789 NE2 GLN B 161 -4.861 21.266 34.932 1.00138.44 N \nANISOU 3789 NE2 GLN B 161 18504 16372 17725 -944 -1637 -30 N \nATOM 3790 N TYR B 162 -3.865 14.929 34.983 1.00 90.04 N \nANISOU 3790 N TYR B 162 11878 10513 11821 -2098 -1348 246 N \nATOM 3791 CA TYR B 162 -4.897 13.942 35.317 1.00 92.00 C \nANISOU 3791 CA TYR B 162 11833 10945 12180 -2111 -1234 241 C \nATOM 3792 C TYR B 162 -4.283 12.619 35.713 1.00 91.93 C \nANISOU 3792 C TYR B 162 11750 11071 12107 -2338 -1214 287 C \nATOM 3793 O TYR B 162 -5.002 11.632 35.887 1.00 91.05 O \nANISOU 3793 O TYR B 162 11416 11125 12055 -2335 -1133 277 O \nATOM 3794 CB TYR B 162 -5.862 13.740 34.127 1.00 87.66 C \nANISOU 3794 CB TYR B 162 11117 10456 11734 -1979 -1160 206 C \nATOM 3795 CG TYR B 162 -6.291 15.034 33.482 1.00 82.13 C \nANISOU 3795 CG TYR B 162 10478 9674 11053 -1778 -1186 161 C \nATOM 3796 CD1 TYR B 162 -5.584 15.539 32.394 1.00 79.70 C \nANISOU 3796 CD1 TYR B 162 10325 9272 10687 -1730 -1245 153 C \nATOM 3797 CD2 TYR B 162 -7.368 15.782 33.975 1.00 76.02 C \nANISOU 3797 CD2 TYR B 162 9609 8944 10330 -1636 -1157 123 C \nATOM 3798 CE1 TYR B 162 -5.942 16.727 31.803 1.00 81.70 C \nANISOU 3798 CE1 TYR B 162 10620 9493 10929 -1520 -1274 102 C \nATOM 3799 CE2 TYR B 162 -7.724 16.986 33.388 1.00 71.71 C \nANISOU 3799 CE2 TYR B 162 9090 8390 9765 -1450 -1184 75 C \nATOM 3800 CZ TYR B 162 -7.010 17.441 32.306 1.00 77.27 C \nANISOU 3800 CZ TYR B 162 9933 9017 10407 -1380 -1241 61 C \nATOM 3801 OH TYR B 162 -7.334 18.613 31.686 1.00 87.56 O \nANISOU 3801 OH TYR B 162 11249 10352 11667 -1170 -1271 4 O \nATOM 3802 N SER B 163 -2.962 12.620 35.882 1.00 97.10 N \nANISOU 3802 N SER B 163 12607 11670 12616 -2535 -1299 333 N \nATOM 3803 CA SER B 163 -2.211 11.397 36.146 1.00101.40 C \nANISOU 3803 CA SER B 163 13079 12396 13052 -2791 -1290 379 C \nATOM 3804 C SER B 163 -2.757 10.538 37.270 1.00 98.66 C \nANISOU 3804 C SER B 163 12504 12259 12722 -2826 -1223 377 C \nATOM 3805 O SER B 163 -3.210 9.420 37.015 1.00 96.90 O \nANISOU 3805 O SER B 163 12049 12246 12523 -2810 -1148 360 O \nATOM 3806 CB SER B 163 -0.760 11.727 36.405 1.00114.14 C \nANISOU 3806 CB SER B 163 14989 13903 14476 -3034 -1408 437 C \nATOM 3807 OG SER B 163 -0.205 12.271 35.232 1.00124.34 O \nANISOU 3807 OG SER B 163 16488 15026 15729 -3008 -1472 438 O \nATOM 3808 N GLU B 164 -2.720 11.052 38.500 1.00101.48 N \nANISOU 3808 N GLU B 164 12940 12561 13056 -2854 -1257 387 N \nATOM 3809 CA GLU B 164 -3.113 10.242 39.661 1.00104.22 C \nANISOU 3809 CA GLU B 164 13091 13113 13397 -2903 -1204 387 C \nATOM 3810 C GLU B 164 -4.613 10.117 39.775 1.00 94.06 C \nANISOU 3810 C GLU B 164 11606 11860 12272 -2658 -1119 332 C \nATOM 3811 O GLU B 164 -5.126 9.097 40.232 1.00 81.75 O \nANISOU 3811 O GLU B 164 9845 10503 10713 -2640 -1061 315 O \nATOM 3812 CB GLU B 164 -2.502 10.753 40.969 1.00111.34 C \nANISOU 3812 CB GLU B 164 14148 13954 14201 -3045 -1272 422 C \nATOM 3813 CG GLU B 164 -2.959 12.111 41.458 1.00110.60 C \nANISOU 3813 CG GLU B 164 14213 13622 14187 -2871 -1311 399 C \nATOM 3814 CD GLU B 164 -2.183 12.541 42.694 1.00110.77 C \nANISOU 3814 CD GLU B 164 14427 13577 14085 -3036 -1393 439 C \nATOM 3815 OE1 GLU B 164 -1.241 11.829 43.098 1.00104.47 O \nANISOU 3815 OE1 GLU B 164 13655 12909 13128 -3317 -1424 492 O \nATOM 3816 OE2 GLU B 164 -2.506 13.595 43.264 1.00119.28 O \nANISOU 3816 OE2 GLU B 164 15629 14487 15203 -2895 -1430 417 O \nATOM 3817 N GLU B 165 -5.313 11.160 39.344 1.00 96.92 N \nANISOU 3817 N GLU B 165 12040 12039 12747 -2471 -1120 301 N \nATOM 3818 CA GLU B 165 -6.765 11.086 39.154 1.00 89.62 C \nANISOU 3818 CA GLU B 165 10958 11137 11956 -2274 -1047 255 C \nATOM 3819 C GLU B 165 -7.113 9.849 38.338 1.00 89.16 C \nANISOU 3819 C GLU B 165 10742 11227 11907 -2253 -991 240 C \nATOM 3820 O GLU B 165 -7.973 9.062 38.746 1.00 88.52 O \nANISOU 3820 O GLU B 165 10520 11260 11854 -2179 -943 214 O \nATOM 3821 CB GLU B 165 -7.283 12.332 38.446 1.00 87.19 C \nANISOU 3821 CB GLU B 165 10736 10670 11724 -2116 -1061 227 C \nATOM 3822 CG GLU B 165 -8.802 12.351 38.308 1.00 86.71 C \nANISOU 3822 CG GLU B 165 10535 10641 11770 -1968 -995 189 C \nATOM 3823 CD GLU B 165 -9.329 13.718 37.901 1.00 82.35 C \nANISOU 3823 CD GLU B 165 10036 9997 11255 -1833 -1011 160 C \nATOM 3824 OE1 GLU B 165 -8.534 14.699 38.025 1.00 85.48 O \nANISOU 3824 OE1 GLU B 165 10588 10297 11594 -1814 -1080 162 O \nATOM 3825 OE2 GLU B 165 -10.510 13.793 37.436 1.00 70.91 O \nANISOU 3825 OE2 GLU B 165 8487 8588 9868 -1750 -963 135 O \nATOM 3826 N ALA B 166 -6.409 9.669 37.209 1.00 85.87 N \nANISOU 3826 N ALA B 166 10370 10805 11450 -2311 -1007 252 N \nATOM 3827 CA ALA B 166 -6.627 8.515 36.338 1.00 82.20 C \nANISOU 3827 CA ALA B 166 9769 10486 10978 -2284 -962 235 C \nATOM 3828 C ALA B 166 -6.259 7.236 37.046 1.00 93.58 C \nANISOU 3828 C ALA B 166 11068 12183 12307 -2378 -947 239 C \nATOM 3829 O ALA B 166 -6.966 6.229 36.904 1.00 80.36 O \nANISOU 3829 O ALA B 166 9247 10654 10632 -2262 -903 201 O \nATOM 3830 CB ALA B 166 -5.830 8.644 35.061 1.00 94.15 C \nANISOU 3830 CB ALA B 166 11368 11947 12459 -2346 -988 252 C \nATOM 3831 N ARG B 167 -5.153 7.288 37.806 1.00105.09 N \nANISOU 3831 N ARG B 167 12580 13704 13643 -2584 -991 283 N \nATOM 3832 CA ARG B 167 -4.617 6.124 38.508 1.00111.52 C \nANISOU 3832 CA ARG B 167 13243 14823 14306 -2717 -983 291 C \nATOM 3833 C ARG B 167 -5.545 5.740 39.647 1.00105.14 C \nANISOU 3833 C ARG B 167 12310 14110 13529 -2586 -948 255 C \nATOM 3834 O ARG B 167 -5.899 4.569 39.836 1.00 98.24 O \nANISOU 3834 O ARG B 167 11252 13487 12587 -2503 -914 216 O \nATOM 3835 CB ARG B 167 -3.176 6.432 39.017 1.00125.47 C \nANISOU 3835 CB ARG B 167 15145 16614 15915 -3022 -1052 357 C \nATOM 3836 CG ARG B 167 -2.829 6.013 40.451 1.00128.64 C \nANISOU 3836 CG ARG B 167 15469 17217 16193 -3168 -1062 376 C \nATOM 3837 CD ARG B 167 -1.449 6.524 40.882 1.00133.01 C \nANISOU 3837 CD ARG B 167 16231 17722 16583 -3494 -1149 450 C \nATOM 3838 NE ARG B 167 -1.486 7.576 41.913 1.00137.27 N \nANISOU 3838 NE ARG B 167 16957 18036 17164 -3502 -1196 469 N \nATOM 3839 CZ ARG B 167 -0.516 8.465 42.150 1.00134.83 C \nANISOU 3839 CZ ARG B 167 16947 17523 16758 -3696 -1295 524 C \nATOM 3840 NH1 ARG B 167 0.581 8.505 41.402 1.00132.96 N \nANISOU 3840 NH1 ARG B 167 16890 17248 16381 -3917 -1364 572 N \nATOM 3841 NH2 ARG B 167 -0.661 9.356 43.130 1.00135.91 N \nANISOU 3841 NH2 ARG B 167 17234 17475 16929 -3660 -1335 529 N \nATOM 3842 N LEU B 168 -5.946 6.753 40.392 1.00101.37 N \nANISOU 3842 N LEU B 168 11943 13431 13142 -2549 -963 262 N \nATOM 3843 CA LEU B 168 -6.768 6.532 41.575 1.00112.46 C \nANISOU 3843 CA LEU B 168 13260 14894 14573 -2449 -938 236 C \nATOM 3844 C LEU B 168 -8.163 6.026 41.204 1.00112.53 C \nANISOU 3844 C LEU B 168 13186 14898 14672 -2205 -893 178 C \nATOM 3845 O LEU B 168 -8.737 5.190 41.897 1.00105.93 O \nANISOU 3845 O LEU B 168 12240 14214 13792 -2105 -875 142 O \nATOM 3846 CB LEU B 168 -6.871 7.811 42.408 1.00110.49 C \nANISOU 3846 CB LEU B 168 13157 14428 14395 -2467 -968 257 C \nATOM 3847 CG LEU B 168 -7.293 7.636 43.861 1.00109.42 C \nANISOU 3847 CG LEU B 168 12954 14374 14247 -2450 -959 248 C \nATOM 3848 CD1 LEU B 168 -6.491 6.547 44.579 1.00105.70 C \nANISOU 3848 CD1 LEU B 168 12352 14206 13603 -2603 -962 261 C \nATOM 3849 CD2 LEU B 168 -7.163 8.979 44.571 1.00112.51 C \nANISOU 3849 CD2 LEU B 168 13511 14552 14687 -2487 -1000 273 C \nATOM 3850 N LYS B 169 -8.691 6.517 40.089 1.00113.05 N \nANISOU 3850 N LYS B 169 13324 14789 14840 -2112 -884 168 N \nATOM 3851 CA LYS B 169 -10.016 6.107 39.670 1.00111.73 C \nANISOU 3851 CA LYS B 169 13130 14584 14736 -1918 -855 122 C \nATOM 3852 C LYS B 169 -9.968 4.857 38.818 1.00 98.81 C \nANISOU 3852 C LYS B 169 11405 13116 13023 -1845 -844 90 C \nATOM 3853 O LYS B 169 -11.008 4.296 38.482 1.00 78.70 O \nANISOU 3853 O LYS B 169 8862 10552 10489 -1675 -835 47 O \nATOM 3854 CB LYS B 169 -10.685 7.233 38.926 1.00129.65 C \nANISOU 3854 CB LYS B 169 15509 16623 17129 -1869 -853 125 C \nATOM 3855 CG LYS B 169 -12.217 7.169 38.877 1.00135.70 C \nANISOU 3855 CG LYS B 169 16298 17307 17953 -1728 -836 92 C \nATOM 3856 CD LYS B 169 -12.678 7.475 37.455 1.00136.78 C \nANISOU 3856 CD LYS B 169 16486 17341 18143 -1688 -828 87 C \nATOM 3857 CE LYS B 169 -11.555 8.122 36.613 1.00149.44 C \nANISOU 3857 CE LYS B 169 18112 18911 19757 -1775 -837 114 C \nATOM 3858 NZ LYS B 169 -11.061 9.519 36.897 1.00152.65 N \nANISOU 3858 NZ LYS B 169 18592 19212 20196 -1832 -861 137 N \nATOM 3859 N ARG B 170 -8.751 4.432 38.477 1.00108.66 N \nANISOU 3859 N ARG B 170 12591 14527 14169 -1980 -852 112 N \nATOM 3860 CA ARG B 170 -8.509 3.125 37.866 1.00110.81 C \nANISOU 3860 CA ARG B 170 12734 15046 14321 -1924 -843 78 C \nATOM 3861 C ARG B 170 -8.632 2.155 39.024 1.00113.36 C \nANISOU 3861 C ARG B 170 12921 15634 14518 -1857 -843 42 C \nATOM 3862 O ARG B 170 -9.404 1.200 39.002 1.00 97.24 O \nANISOU 3862 O ARG B 170 10821 13706 12419 -1641 -841 -21 O \nATOM 3863 CB ARG B 170 -7.097 3.074 37.311 1.00116.30 C \nANISOU 3863 CB ARG B 170 13404 15862 14922 -2141 -857 122 C \nATOM 3864 CG ARG B 170 -6.829 2.073 36.198 1.00122.90 C \nANISOU 3864 CG ARG B 170 14139 16887 15669 -2096 -846 95 C \nATOM 3865 CD ARG B 170 -5.383 2.244 35.718 1.00120.96 C \nANISOU 3865 CD ARG B 170 13909 16721 15329 -2368 -869 153 C \nATOM 3866 NE ARG B 170 -5.126 3.635 35.302 1.00114.11 N \nANISOU 3866 NE ARG B 170 13257 15513 14586 -2463 -895 202 N \nATOM 3867 CZ ARG B 170 -3.941 4.251 35.333 1.00106.97 C \nANISOU 3867 CZ ARG B 170 12478 14552 13613 -2711 -942 263 C \nATOM 3868 NH1 ARG B 170 -2.850 3.607 35.738 1.00118.29 N \nANISOU 3868 NH1 ARG B 170 13840 16255 14851 -2949 -965 296 N \nATOM 3869 NH2 ARG B 170 -3.838 5.516 34.940 1.00 89.09 N \nANISOU 3869 NH2 ARG B 170 10426 11973 11450 -2723 -976 289 N \nATOM 3870 N GLU B 171 -7.896 2.479 40.082 1.00121.18 N \nANISOU 3870 N GLU B 171 13886 16703 15455 -2036 -854 81 N \nATOM 3871 CA GLU B 171 -7.835 1.674 41.299 1.00124.58 C \nANISOU 3871 CA GLU B 171 14172 17415 15748 -2014 -855 54 C \nATOM 3872 C GLU B 171 -9.176 1.473 42.013 1.00119.60 C \nANISOU 3872 C GLU B 171 13565 16707 15171 -1767 -852 -1 C \nATOM 3873 O GLU B 171 -9.271 0.626 42.905 1.00117.57 O \nANISOU 3873 O GLU B 171 13183 16704 14783 -1679 -857 -42 O \nATOM 3874 CB GLU B 171 -6.781 2.253 42.250 1.00124.14 C \nANISOU 3874 CB GLU B 171 14130 17405 15633 -2293 -874 118 C \nATOM 3875 CG GLU B 171 -5.359 2.060 41.729 1.00123.69 C \nANISOU 3875 CG GLU B 171 14038 17529 15431 -2565 -893 167 C \nATOM 3876 CD GLU B 171 -4.345 3.006 42.347 1.00127.80 C \nANISOU 3876 CD GLU B 171 14703 17934 15920 -2866 -936 246 C \nATOM 3877 OE1 GLU B 171 -3.305 3.263 41.702 1.00120.67 O \nANISOU 3877 OE1 GLU B 171 13894 17012 14944 -3092 -970 298 O \nATOM 3878 OE2 GLU B 171 -4.584 3.490 43.479 1.00134.50 O \nANISOU 3878 OE2 GLU B 171 15598 18701 16805 -2875 -945 256 O \nATOM 3879 N GLU B 172 -10.207 2.217 41.620 1.00114.44 N \nANISOU 3879 N GLU B 172 13071 15727 14683 -1662 -850 -2 N \nATOM 3880 CA GLU B 172 -11.576 1.840 42.004 1.00120.28 C \nANISOU 3880 CA GLU B 172 13871 16388 15441 -1426 -860 -57 C \nATOM 3881 C GLU B 172 -11.980 0.469 41.445 1.00130.81 C \nANISOU 3881 C GLU B 172 15154 17906 16642 -1193 -877 -132 C \nATOM 3882 O GLU B 172 -12.780 -0.227 42.069 1.00140.19 O \nANISOU 3882 O GLU B 172 16363 19152 17752 -986 -904 -191 O \nATOM 3883 CB GLU B 172 -12.623 2.867 41.599 1.00120.43 C \nANISOU 3883 CB GLU B 172 14073 16058 15628 -1399 -860 -40 C \nATOM 3884 CG GLU B 172 -13.979 2.587 42.250 1.00115.79 C \nANISOU 3884 CG GLU B 172 13584 15378 15035 -1222 -883 -82 C \nATOM 3885 CD GLU B 172 -14.975 3.726 42.141 1.00115.78 C \nANISOU 3885 CD GLU B 172 13741 15081 15169 -1264 -883 -55 C \nATOM 3886 OE1 GLU B 172 -14.632 4.864 42.518 1.00117.91 O \nANISOU 3886 OE1 GLU B 172 14006 15265 15530 -1412 -865 -8 O \nATOM 3887 OE2 GLU B 172 -16.117 3.478 41.707 1.00109.89 O \nANISOU 3887 OE2 GLU B 172 13134 14204 14416 -1150 -908 -81 O \nATOM 3888 N ILE B 173 -11.454 0.097 40.274 1.00135.17 N \nANISOU 3888 N ILE B 173 15660 18540 17159 -1208 -870 -134 N \nATOM 3889 CA ILE B 173 -11.692 -1.247 39.713 1.00139.98 C \nANISOU 3889 CA ILE B 173 16206 19366 17613 -973 -891 -212 C \nATOM 3890 C ILE B 173 -10.742 -2.280 40.337 1.00135.43 C \nANISOU 3890 C ILE B 173 15382 19258 16817 -976 -891 -245 C \nATOM 3891 O ILE B 173 -11.094 -2.977 41.296 1.00130.50 O \nANISOU 3891 O ILE B 173 14693 18823 16066 -807 -913 -302 O \nATOM 3892 CB ILE B 173 -11.610 -1.295 38.160 1.00136.68 C \nANISOU 3892 CB ILE B 173 15836 18861 17235 -965 -886 -208 C \nATOM 3893 CG1 ILE B 173 -12.147 -2.633 37.623 1.00137.36 C \nANISOU 3893 CG1 ILE B 173 15916 19111 17165 -662 -923 -300 C \nATOM 3894 CG2 ILE B 173 -10.198 -1.099 37.640 1.00140.38 C \nANISOU 3894 CG2 ILE B 173 16173 19486 17680 -1212 -858 -155 C \nATOM 3895 CD1 ILE B 173 -13.595 -2.902 37.977 1.00135.00 C \nANISOU 3895 CD1 ILE B 173 15823 18615 16856 -405 -975 -355 C \nTER 3896 ILE B 173 \nHETATM 3897 C1 NAG A 401 5.710 29.828 -66.680 1.00 83.68 C \nHETATM 3898 C2 NAG A 401 6.838 30.852 -66.364 1.00 90.43 C \nHETATM 3899 C3 NAG A 401 8.287 30.302 -66.439 1.00 98.70 C \nHETATM 3900 C4 NAG A 401 8.435 28.818 -66.142 1.00 98.24 C \nHETATM 3901 C5 NAG A 401 7.281 28.111 -66.848 1.00 96.14 C \nHETATM 3902 C6 NAG A 401 7.291 26.597 -66.749 1.00 96.77 C \nHETATM 3903 C7 NAG A 401 7.607 32.954 -67.433 1.00 96.37 C \nHETATM 3904 C8 NAG A 401 7.309 33.990 -68.484 1.00 91.89 C \nHETATM 3905 N2 NAG A 401 6.719 31.948 -67.319 1.00 98.43 N \nHETATM 3906 O3 NAG A 401 9.163 30.987 -65.565 1.00109.88 O \nHETATM 3907 O4 NAG A 401 9.699 28.413 -66.614 1.00 88.78 O \nHETATM 3908 O5 NAG A 401 6.107 28.559 -66.215 1.00 93.39 O \nHETATM 3909 O6 NAG A 401 6.980 26.209 -68.069 1.00 86.27 O \nHETATM 3910 O7 NAG A 401 8.616 33.063 -66.729 1.00 82.71 O \nHETATM 3911 C1 NAG B 201 -5.683 24.123 20.478 1.00139.78 C \nHETATM 3912 C2 NAG B 201 -6.197 25.123 19.448 1.00152.91 C \nHETATM 3913 C3 NAG B 201 -5.016 25.970 18.949 1.00145.45 C \nHETATM 3914 C4 NAG B 201 -4.206 26.564 20.111 1.00144.30 C \nHETATM 3915 C5 NAG B 201 -3.892 25.490 21.154 1.00151.00 C \nHETATM 3916 C6 NAG B 201 -3.213 26.015 22.425 1.00150.19 C \nHETATM 3917 C7 NAG B 201 -7.956 24.853 17.716 1.00154.15 C \nHETATM 3918 C8 NAG B 201 -8.474 23.983 16.601 1.00138.57 C \nHETATM 3919 N2 NAG B 201 -6.846 24.425 18.344 1.00167.86 N \nHETATM 3920 O3 NAG B 201 -5.485 26.995 18.095 1.00132.58 O \nHETATM 3921 O4 NAG B 201 -3.023 27.182 19.647 1.00138.55 O \nHETATM 3922 O5 NAG B 201 -5.164 24.970 21.495 1.00150.86 O \nHETATM 3923 O6 NAG B 201 -3.194 25.024 23.442 1.00134.09 O \nHETATM 3924 O7 NAG B 201 -8.562 25.891 17.996 1.00142.23 O \nHETATM 3925 O HOH A 501 -6.376 6.072 -54.237 1.00 31.99 O \nHETATM 3926 O HOH A 502 -5.482 10.458 -60.932 1.00 31.51 O \nHETATM 3927 O HOH A 503 -7.641 4.376 -68.956 1.00 32.53 O \nHETATM 3928 O HOH A 504 -5.594 11.918 -86.140 1.00 46.03 O \nHETATM 3929 O HOH A 505 -6.060 17.342 -41.933 1.00 48.80 O \nHETATM 3930 O HOH A 506 -19.855 12.646 -6.059 1.00 55.30 O \nHETATM 3931 O HOH A 507 -18.044 22.939 -58.123 1.00 53.39 O \nHETATM 3932 O HOH A 508 2.452 20.479 -53.601 1.00 57.16 O \nHETATM 3933 O HOH A 509 -1.266 5.324 -49.620 1.00 19.76 O \nHETATM 3934 O HOH A 510 -2.873 12.164 -51.498 1.00 30.40 O \nHETATM 3935 O HOH A 511 -10.753 24.127 -80.663 1.00 46.19 O \nHETATM 3936 O HOH A 512 -4.259 3.646 -71.495 1.00 53.73 O \nHETATM 3937 O HOH A 513 -0.824 15.308 -43.271 1.00 49.29 O \nHETATM 3938 O HOH A 514 -6.690 7.680 -85.354 1.00 45.37 O \nHETATM 3939 O HOH A 515 -6.855 1.950 -83.670 1.00 31.59 O \nHETATM 3940 O HOH A 516 3.406 20.462 -60.468 1.00 24.07 O \nHETATM 3941 O HOH A 517 -6.918 3.732 -70.839 1.00 33.39 O \nHETATM 3942 O HOH A 518 -10.262 1.708 -66.919 1.00 48.02 O \nHETATM 3943 O HOH A 519 -8.111 2.891 -79.177 1.00 30.05 O \nHETATM 3944 O HOH A 520 -22.135 6.961 -54.297 1.00 59.15 O \nHETATM 3945 O HOH A 521 -3.412 10.410 -59.558 1.00 31.17 O \nHETATM 3946 O HOH A 522 -6.744 4.470 -58.475 1.00 62.33 O \nHETATM 3947 O HOH A 523 -9.072 -1.001 -77.759 1.00 39.73 O \nHETATM 3948 O HOH A 524 -2.999 5.512 -79.745 1.00 39.76 O \nHETATM 3949 O HOH A 525 -9.469 4.803 -56.488 1.00 54.88 O \nHETATM 3950 O HOH A 526 2.903 12.699 -72.184 1.00 56.61 O \nHETATM 3951 O HOH A 527 -21.670 22.982 -46.407 1.00 59.63 O \nHETATM 3952 O HOH A 528 -8.981 5.396 -80.075 1.00 69.83 O \nHETATM 3953 O HOH A 529 -17.635 8.906 -52.670 1.00 62.21 O \nHETATM 3954 O HOH A 530 -15.792 7.875 35.056 1.00 54.80 O \nHETATM 3955 O HOH A 531 -25.725 7.243 -57.881 1.00 80.59 O \nHETATM 3956 O HOH A 532 -18.258 25.778 -44.042 1.00 54.44 O \nHETATM 3957 O HOH A 533 -15.646 30.365 -70.831 1.00 64.06 O \nHETATM 3958 O HOH A 534 3.583 9.983 -65.090 1.00 49.74 O \nHETATM 3959 O HOH A 535 -0.654 29.551 -68.898 1.00 76.55 O \nHETATM 3960 O HOH A 536 0.877 16.350 -73.586 1.00 57.63 O \nHETATM 3961 O HOH A 537 -2.646 12.420 -58.992 1.00 52.13 O \nHETATM 3962 O HOH A 538 -11.543 1.252 -64.661 1.00 59.98 O \nHETATM 3963 O HOH A 539 -15.785 16.827 -16.014 1.00 57.50 O \nHETATM 3964 O HOH B 301 -11.165 -4.912 -42.737 1.00 32.60 O \nHETATM 3965 O HOH B 302 -12.429 1.828 -46.582 1.00 29.21 O \nHETATM 3966 O HOH B 303 -10.813 1.544 21.045 1.00 46.54 O \nHETATM 3967 O HOH B 304 -16.874 7.370 11.821 1.00 48.88 O \nHETATM 3968 O HOH B 305 -10.477 -5.437 -44.863 1.00 42.66 O \nHETATM 3969 O HOH B 306 -11.998 2.215 -44.178 1.00 37.94 O \nHETATM 3970 O HOH B 307 -9.726 0.188 2.088 1.00 36.93 O \nHETATM 3971 O HOH B 308 -2.193 0.549 -52.116 1.00 23.26 O \nHETATM 3972 O HOH B 309 -10.245 1.209 -42.204 1.00 55.67 O \nHETATM 3973 O HOH B 310 -6.008 20.128 12.617 1.00 58.09 O \nHETATM 3974 O HOH B 311 0.000 0.000 -21.930 0.33 55.81 O \nHETATM 3975 O HOH B 312 -19.179 19.569 25.208 1.00 76.02 O \nHETATM 3976 O HOH B 313 -3.455 13.837 38.528 1.00 74.49 O \nHETATM 3977 O HOH B 314 1.040 16.973 7.576 1.00 67.10 O \nHETATM 3978 O HOH B 315 -16.540 16.312 19.677 1.00 66.83 O \nHETATM 3979 O HOH B 316 -11.340 -7.290 -46.099 1.00 84.95 O \nHETATM 3980 O HOH B 317 -11.847 -2.451 -42.559 1.00 51.73 O \nHETATM 3981 O HOH B 318 0.000 0.000 -18.054 0.33 75.84 O \nENDMDL \nMODEL 3 \nATOM 1 N PRO A -1 4.750 -21.816 33.812 1.00108.74 N \nANISOU 1 N PRO A -1 13644 13962 13711 -3983 -1018 181 N \nATOM 2 CA PRO A -1 4.797 -20.572 33.040 1.00107.88 C \nANISOU 2 CA PRO A -1 13518 13817 13656 -3861 -1014 198 C \nATOM 3 C PRO A -1 3.427 -19.863 33.107 1.00112.82 C \nANISOU 3 C PRO A -1 14031 14488 14346 -3841 -1113 272 C \nATOM 4 O PRO A -1 2.864 -19.757 34.202 1.00118.90 O \nANISOU 4 O PRO A -1 14761 15326 15088 -3913 -1170 308 O \nATOM 5 CB PRO A -1 5.124 -21.075 31.636 1.00101.66 C \nANISOU 5 CB PRO A -1 12763 12951 12912 -3793 -964 163 C \nATOM 6 CG PRO A -1 4.339 -22.356 31.560 1.00104.61 C \nANISOU 6 CG PRO A -1 13094 13350 13303 -3869 -1001 171 C \nATOM 7 CD PRO A -1 4.398 -22.964 32.955 1.00106.32 C \nANISOU 7 CD PRO A -1 13326 13631 13440 -3997 -1015 167 C \nATOM 8 N GLY A 0 2.903 -19.380 31.973 1.00102.11 N \nANISOU 8 N GLY A 0 12632 13095 13071 -3746 -1132 293 N \nATOM 9 CA GLY A 0 1.526 -18.893 31.903 1.00 89.42 C \nANISOU 9 CA GLY A 0 10930 11519 11529 -3726 -1226 361 C \nATOM 10 C GLY A 0 0.904 -19.276 30.578 1.00 79.86 C \nANISOU 10 C GLY A 0 9680 10264 10401 -3657 -1239 366 C \nATOM 11 O GLY A 0 1.610 -19.627 29.641 1.00 73.60 O \nANISOU 11 O GLY A 0 8934 9413 9619 -3611 -1172 320 O \nATOM 12 N ASP A 1 -0.423 -19.206 30.515 1.00 76.06 N \nANISOU 12 N ASP A 1 9117 9808 9973 -3648 -1324 421 N \nATOM 13 CA ASP A 1 -1.164 -19.578 29.313 1.00 76.02 C \nANISOU 13 CA ASP A 1 9067 9771 10046 -3582 -1346 430 C \nATOM 14 C ASP A 1 -0.840 -18.611 28.209 1.00 72.75 C \nANISOU 14 C ASP A 1 8670 9292 9681 -3475 -1313 423 C \nATOM 15 O ASP A 1 -0.449 -17.474 28.463 1.00 79.13 O \nANISOU 15 O ASP A 1 9497 10097 10471 -3450 -1304 433 O \nATOM 16 CB ASP A 1 -2.680 -19.586 29.566 1.00 76.89 C \nANISOU 16 CB ASP A 1 9092 9925 10199 -3584 -1449 495 C \nATOM 17 CG ASP A 1 -3.087 -20.492 30.712 1.00 77.18 C \nANISOU 17 CG ASP A 1 9101 10039 10185 -3688 -1489 509 C \nATOM 18 OD1 ASP A 1 -2.317 -21.416 31.093 1.00 79.02 O \nANISOU 18 OD1 ASP A 1 9375 10290 10361 -3763 -1437 463 O \nATOM 19 OD2 ASP A 1 -4.192 -20.277 31.224 1.00 76.73 O \nANISOU 19 OD2 ASP A 1 8986 10024 10142 -3696 -1573 566 O \nATOM 20 N GLN A 2 -1.029 -19.058 26.977 1.00 73.15 N \nANISOU 20 N GLN A 2 8707 9298 9789 -3414 -1298 407 N \nATOM 21 CA GLN A 2 -0.662 -18.269 25.812 1.00 68.19 C \nANISOU 21 CA GLN A 2 8096 8606 9206 -3312 -1260 395 C \nATOM 22 C GLN A 2 -1.670 -18.375 24.695 1.00 65.93 C \nANISOU 22 C GLN A 2 7752 8293 9004 -3243 -1301 418 C \nATOM 23 O GLN A 2 -2.186 -19.452 24.441 1.00 72.46 O \nANISOU 23 O GLN A 2 8547 9134 9850 -3264 -1318 413 O \nATOM 24 CB GLN A 2 0.699 -18.727 25.288 1.00 67.85 C \nANISOU 24 CB GLN A 2 8133 8516 9130 -3299 -1160 329 C \nATOM 25 CG GLN A 2 1.873 -18.223 26.117 1.00 69.48 C \nANISOU 25 CG GLN A 2 8410 8731 9258 -3326 -1106 302 C \nATOM 26 CD GLN A 2 3.197 -18.437 25.426 1.00 65.59 C \nANISOU 26 CD GLN A 2 8003 8178 8739 -3282 -1008 241 C \nATOM 27 OE1 GLN A 2 3.255 -18.604 24.205 1.00 59.84 O \nANISOU 27 OE1 GLN A 2 7279 7399 8061 -3215 -981 225 O \nATOM 28 NE2 GLN A 2 4.270 -18.468 26.210 1.00 66.69 N \nANISOU 28 NE2 GLN A 2 8217 8324 8798 -3321 -953 206 N \nATOM 29 N ILE A 3 -1.905 -17.269 23.994 1.00 63.89 N \nANISOU 29 N ILE A 3 7482 8001 8793 -3162 -1313 439 N \nATOM 30 CA ILE A 3 -2.544 -17.324 22.689 1.00 60.05 C \nANISOU 30 CA ILE A 3 6961 7472 8383 -3081 -1327 445 C \nATOM 31 C ILE A 3 -1.625 -16.691 21.677 1.00 60.33 C \nANISOU 31 C ILE A 3 7039 7450 8432 -3006 -1257 411 C \nATOM 32 O ILE A 3 -0.933 -15.734 21.989 1.00 63.82 O \nANISOU 32 O ILE A 3 7515 7895 8840 -2996 -1229 409 O \nATOM 33 CB ILE A 3 -3.954 -16.697 22.695 1.00 57.90 C \nANISOU 33 CB ILE A 3 6627 7209 8161 -3052 -1421 507 C \nATOM 34 CG1 ILE A 3 -4.733 -17.188 21.484 1.00 57.67 C \nANISOU 34 CG1 ILE A 3 6557 7149 8205 -2984 -1439 508 C \nATOM 35 CG2 ILE A 3 -3.884 -15.176 22.699 1.00 58.66 C \nANISOU 35 CG2 ILE A 3 6737 7290 8259 -3016 -1431 534 C \nATOM 36 CD1 ILE A 3 -6.223 -17.122 21.654 1.00 56.73 C \nANISOU 36 CD1 ILE A 3 6379 7050 8126 -2969 -1535 564 C \nATOM 37 N CYS A 4 -1.647 -17.203 20.451 1.00 66.68 N \nANISOU 37 N CYS A 4 7838 8211 9285 -2950 -1229 387 N \nATOM 38 CA CYS A 4 -0.781 -16.684 19.354 1.00 68.22 C \nANISOU 38 CA CYS A 4 8074 8351 9496 -2871 -1161 354 C \nATOM 39 C CYS A 4 -1.553 -16.356 18.070 1.00 66.44 C \nANISOU 39 C CYS A 4 7806 8088 9352 -2786 -1186 371 C \nATOM 40 O CYS A 4 -2.557 -16.965 17.766 1.00 63.02 O \nANISOU 40 O CYS A 4 7322 7659 8963 -2783 -1234 388 O \nATOM 41 CB CYS A 4 0.321 -17.677 19.046 1.00 68.04 C \nANISOU 41 CB CYS A 4 8113 8301 9438 -2886 -1078 295 C \nATOM 42 SG CYS A 4 1.417 -18.034 20.454 1.00 72.81 S \nANISOU 42 SG CYS A 4 8788 8937 9940 -2979 -1034 266 S \nATOM 43 N ILE A 5 -1.088 -15.347 17.338 1.00 72.56 N \nANISOU 43 N ILE A 5 8599 8830 10141 -2715 -1154 366 N \nATOM 44 CA ILE A 5 -1.642 -15.027 16.024 1.00 67.14 C \nANISOU 44 CA ILE A 5 7882 8102 9526 -2634 -1165 374 C \nATOM 45 C ILE A 5 -0.678 -15.497 14.990 1.00 62.66 C \nANISOU 45 C ILE A 5 7355 7489 8962 -2588 -1084 323 C \nATOM 46 O ILE A 5 0.502 -15.221 15.079 1.00 64.50 O \nANISOU 46 O ILE A 5 7645 7715 9148 -2579 -1019 293 O \nATOM 47 CB ILE A 5 -1.881 -13.522 15.852 1.00 73.95 C \nANISOU 47 CB ILE A 5 8733 8963 10403 -2590 -1191 408 C \nATOM 48 CG1 ILE A 5 -2.653 -12.962 17.057 1.00 81.95 C \nANISOU 48 CG1 ILE A 5 9723 10022 11395 -2648 -1266 458 C \nATOM 49 CG2 ILE A 5 -2.662 -13.248 14.577 1.00 71.79 C \nANISOU 49 CG2 ILE A 5 8426 8648 10204 -2515 -1215 420 C \nATOM 50 CD1 ILE A 5 -3.946 -13.683 17.403 1.00 84.12 C \nANISOU 50 CD1 ILE A 5 9952 10309 11701 -2678 -1343 491 C \nATOM 51 N GLY A 6 -1.183 -16.246 14.021 1.00 66.85 N \nANISOU 51 N GLY A 6 7860 7994 9546 -2558 -1087 312 N \nATOM 52 CA GLY A 6 -0.330 -16.868 13.008 1.00 68.04 C \nANISOU 52 CA GLY A 6 8051 8100 9699 -2523 -1012 263 C \nATOM 53 C GLY A 6 -1.062 -17.093 11.691 1.00 69.78 C \nANISOU 53 C GLY A 6 8229 8289 9993 -2460 -1027 265 C \nATOM 54 O GLY A 6 -2.209 -16.649 11.511 1.00 67.75 O \nANISOU 54 O GLY A 6 7915 8041 9788 -2433 -1095 303 O \nATOM 55 N TYR A 7 -0.412 -17.819 10.782 1.00 68.78 N \nANISOU 55 N TYR A 7 8135 8127 9871 -2439 -965 222 N \nATOM 56 CA TYR A 7 -0.954 -18.023 9.436 1.00 69.70 C \nANISOU 56 CA TYR A 7 8216 8213 10053 -2375 -969 217 C \nATOM 57 C TYR A 7 -0.567 -19.370 8.808 1.00 78.28 C \nANISOU 57 C TYR A 7 9324 9284 11134 -2397 -921 174 C \nATOM 58 O TYR A 7 0.258 -20.110 9.331 1.00 82.04 O \nANISOU 58 O TYR A 7 9857 9763 11553 -2459 -876 145 O \nATOM 59 CB TYR A 7 -0.551 -16.865 8.514 1.00 65.47 C \nANISOU 59 CB TYR A 7 7695 7638 9542 -2288 -940 218 C \nATOM 60 CG TYR A 7 0.949 -16.635 8.370 1.00 64.07 C \nANISOU 60 CG TYR A 7 7597 7434 9313 -2268 -855 182 C \nATOM 61 CD1 TYR A 7 1.654 -17.207 7.325 1.00 66.90 C \nANISOU 61 CD1 TYR A 7 7996 7747 9675 -2232 -791 142 C \nATOM 62 CD2 TYR A 7 1.642 -15.826 9.249 1.00 60.43 C \nANISOU 62 CD2 TYR A 7 7170 6993 8796 -2279 -840 188 C \nATOM 63 CE1 TYR A 7 2.998 -16.977 7.157 1.00 68.07 C \nANISOU 63 CE1 TYR A 7 8222 7867 9774 -2202 -715 111 C \nATOM 64 CE2 TYR A 7 3.000 -15.606 9.099 1.00 65.66 C \nANISOU 64 CE2 TYR A 7 7906 7634 9408 -2248 -763 154 C \nATOM 65 CZ TYR A 7 3.670 -16.185 8.043 1.00 68.68 C \nANISOU 65 CZ TYR A 7 8332 7966 9796 -2206 -701 117 C \nATOM 66 OH TYR A 7 5.027 -15.999 7.881 1.00 76.12 O \nANISOU 66 OH TYR A 7 9355 8882 10685 -2166 -624 84 O \nATOM 67 N HIS A 8 -1.195 -19.673 7.683 1.00 80.73 N \nANISOU 67 N HIS A 8 9591 9578 11502 -2350 -932 172 N \nATOM 68 CA HIS A 8 -1.021 -20.951 7.013 1.00 81.79 C \nANISOU 68 CA HIS A 8 9733 9708 11637 -2373 -896 135 C \nATOM 69 C HIS A 8 0.409 -21.184 6.552 1.00 85.24 C \nANISOU 69 C HIS A 8 10264 10094 12031 -2370 -805 90 C \nATOM 70 O HIS A 8 1.126 -20.255 6.186 1.00 95.04 O \nANISOU 70 O HIS A 8 11547 11295 13269 -2309 -768 86 O \nATOM 71 CB HIS A 8 -1.974 -21.029 5.829 1.00 83.51 C \nANISOU 71 CB HIS A 8 9884 9919 11926 -2309 -926 143 C \nATOM 72 CG HIS A 8 -2.271 -22.420 5.358 1.00 94.32 C \nANISOU 72 CG HIS A 8 11226 11313 13298 -2347 -919 117 C \nATOM 73 ND1 HIS A 8 -1.295 -23.337 5.043 1.00 95.94 N \nANISOU 73 ND1 HIS A 8 11492 11500 13461 -2391 -849 73 N \nATOM 74 CD2 HIS A 8 -3.452 -23.037 5.110 1.00 99.29 C \nANISOU 74 CD2 HIS A 8 11772 11989 13964 -2344 -973 130 C \nATOM 75 CE1 HIS A 8 -1.857 -24.460 4.640 1.00 99.71 C \nANISOU 75 CE1 HIS A 8 11923 12016 13947 -2424 -860 60 C \nATOM 76 NE2 HIS A 8 -3.167 -24.304 4.673 1.00 98.21 N \nANISOU 76 NE2 HIS A 8 11640 11870 13804 -2392 -935 93 N \nATOM 77 N ALA A 9 0.838 -22.435 6.622 1.00 85.74 N \nANISOU 77 N ALA A 9 10362 10161 12054 -2440 -769 57 N \nATOM 78 CA ALA A 9 2.082 -22.858 5.988 1.00 91.53 C \nANISOU 78 CA ALA A 9 11189 10838 12750 -2437 -684 12 C \nATOM 79 C ALA A 9 1.853 -24.229 5.370 1.00 94.22 C \nANISOU 79 C ALA A 9 11518 11190 13091 -2487 -671 -14 C \nATOM 80 O ALA A 9 0.923 -24.934 5.751 1.00 97.60 O \nANISOU 80 O ALA A 9 11875 11680 13527 -2543 -722 -2 O \nATOM 81 CB ALA A 9 3.229 -22.912 6.982 1.00 92.44 C \nANISOU 81 CB ALA A 9 11401 10939 12783 -2489 -637 -8 C \nATOM 82 N ASN A 10 2.681 -24.574 4.390 1.00 88.75 N \nANISOU 82 N ASN A 10 10892 10441 12388 -2465 -604 -49 N \nATOM 83 CA ASN A 10 2.653 -25.899 3.791 1.00 87.25 C \nANISOU 83 CA ASN A 10 10708 10258 12185 -2524 -581 -79 C \nATOM 84 C ASN A 10 4.014 -26.271 3.170 1.00 93.65 C \nANISOU 84 C ASN A 10 11643 10993 12947 -2526 -492 -122 C \nATOM 85 O ASN A 10 5.037 -25.651 3.465 1.00100.06 O \nANISOU 85 O ASN A 10 12544 11753 13720 -2495 -447 -131 O \nATOM 86 CB ASN A 10 1.461 -26.086 2.830 1.00 76.62 C \nANISOU 86 CB ASN A 10 9253 8947 10913 -2482 -627 -66 C \nATOM 87 CG ASN A 10 1.504 -25.154 1.615 1.00 81.72 C \nANISOU 87 CG ASN A 10 9892 9539 11618 -2365 -612 -61 C \nATOM 88 OD1 ASN A 10 2.557 -24.652 1.239 1.00 84.90 O \nANISOU 88 OD1 ASN A 10 10379 9879 12001 -2322 -554 -77 O \nATOM 89 ND2 ASN A 10 0.348 -24.955 0.968 1.00 70.36 N \nANISOU 89 ND2 ASN A 10 8355 8130 10249 -2312 -665 -40 N \nATOM 90 N ASN A 11 4.019 -27.306 2.348 1.00102.82 N \nANISOU 90 N ASN A 11 12812 12150 14103 -2563 -466 -148 N \nATOM 91 CA ASN A 11 5.237 -27.821 1.731 1.00112.57 C \nANISOU 91 CA ASN A 11 14172 13312 15287 -2577 -384 -189 C \nATOM 92 C ASN A 11 5.358 -27.360 0.275 1.00117.73 C \nANISOU 92 C ASN A 11 14824 13916 15993 -2474 -358 -193 C \nATOM 93 O ASN A 11 6.276 -27.762 -0.443 1.00120.99 O \nANISOU 93 O ASN A 11 15333 14266 16372 -2472 -293 -223 O \nATOM 94 CB ASN A 11 5.258 -29.355 1.820 1.00113.91 C \nANISOU 94 CB ASN A 11 14367 13512 15403 -2706 -368 -218 C \nATOM 95 CG ASN A 11 3.947 -29.993 1.369 1.00110.15 C \nANISOU 95 CG ASN A 11 13756 13120 14975 -2731 -424 -206 C \nATOM 96 OD1 ASN A 11 3.081 -29.335 0.779 1.00 99.60 O \nANISOU 96 OD1 ASN A 11 12323 11804 13718 -2641 -467 -181 O \nATOM 97 ND2 ASN A 11 3.790 -31.284 1.663 1.00109.74 N \nANISOU 97 ND2 ASN A 11 13700 13123 14872 -2853 -423 -225 N \nATOM 98 N SER A 12 4.416 -26.519 -0.147 1.00118.09 N \nANISOU 98 N SER A 12 14763 13989 16117 -2391 -410 -161 N \nATOM 99 CA SER A 12 4.396 -25.964 -1.496 1.00111.27 C \nANISOU 99 CA SER A 12 13883 13087 15309 -2291 -394 -161 C \nATOM 100 C SER A 12 5.718 -25.290 -1.814 1.00106.06 C \nANISOU 100 C SER A 12 13335 12348 14616 -2225 -326 -175 C \nATOM 101 O SER A 12 6.326 -24.657 -0.945 1.00108.41 O \nANISOU 101 O SER A 12 13683 12633 14876 -2214 -315 -169 O \nATOM 102 CB SER A 12 3.247 -24.963 -1.642 1.00113.56 C \nANISOU 102 CB SER A 12 14055 13414 15678 -2214 -463 -122 C \nATOM 103 OG SER A 12 3.475 -24.093 -2.720 1.00121.50 O \nANISOU 103 OG SER A 12 15064 14374 16725 -2110 -441 -119 O \nATOM 104 N THR A 13 6.149 -25.439 -3.062 1.00 99.86 N \nANISOU 104 N THR A 13 12587 11515 13842 -2179 -281 -194 N \nATOM 105 CA THR A 13 7.429 -24.892 -3.524 1.00 98.16 C \nANISOU 105 CA THR A 13 12482 11224 13591 -2107 -213 -209 C \nATOM 106 C THR A 13 7.239 -23.910 -4.687 1.00 91.16 C \nANISOU 106 C THR A 13 11547 10322 12768 -1989 -215 -195 C \nATOM 107 O THR A 13 8.205 -23.431 -5.260 1.00 86.71 O \nANISOU 107 O THR A 13 11059 9704 12182 -1917 -162 -205 O \nATOM 108 CB THR A 13 8.345 -26.017 -4.013 1.00 98.65 C \nANISOU 108 CB THR A 13 12661 11229 13593 -2161 -146 -249 C \nATOM 109 OG1 THR A 13 7.612 -26.812 -4.946 1.00103.60 O \nANISOU 109 OG1 THR A 13 13225 11879 14259 -2193 -160 -256 O \nATOM 110 CG2 THR A 13 8.804 -26.881 -2.861 1.00101.45 C \nANISOU 110 CG2 THR A 13 13093 11583 13869 -2275 -130 -267 C \nATOM 111 N GLU A 14 5.992 -23.625 -5.027 1.00 88.48 N \nANISOU 111 N GLU A 14 11084 10032 12503 -1969 -277 -171 N \nATOM 112 CA GLU A 14 5.678 -22.665 -6.066 1.00 93.03 C \nANISOU 112 CA GLU A 14 11606 10600 13140 -1865 -286 -155 C \nATOM 113 C GLU A 14 6.200 -21.287 -5.663 1.00 95.31 C \nANISOU 113 C GLU A 14 11914 10882 13418 -1790 -281 -135 C \nATOM 114 O GLU A 14 5.892 -20.761 -4.585 1.00 96.87 O \nANISOU 114 O GLU A 14 12081 11115 13609 -1809 -320 -113 O \nATOM 115 CB GLU A 14 4.176 -22.594 -6.331 1.00 94.45 C \nANISOU 115 CB GLU A 14 11656 10834 13396 -1862 -359 -133 C \nATOM 116 CG GLU A 14 3.582 -23.893 -6.864 1.00 99.20 C \nANISOU 116 CG GLU A 14 12222 11459 14012 -1923 -366 -152 C \nATOM 117 CD GLU A 14 2.065 -23.934 -6.777 1.00 97.35 C \nANISOU 117 CD GLU A 14 11861 11289 13837 -1927 -444 -129 C \nATOM 118 OE1 GLU A 14 1.508 -23.366 -5.821 1.00 87.98 O \nANISOU 118 OE1 GLU A 14 10633 10135 12662 -1930 -495 -101 O \nATOM 119 OE2 GLU A 14 1.427 -24.533 -7.665 1.00 98.69 O \nANISOU 119 OE2 GLU A 14 11977 11479 14042 -1925 -453 -139 O \nATOM 120 N GLN A 15 7.040 -20.740 -6.527 1.00 87.84 N \nANISOU 120 N GLN A 15 11020 9892 12462 -1708 -230 -144 N \nATOM 121 CA GLN A 15 7.601 -19.430 -6.326 1.00 82.06 C \nANISOU 121 CA GLN A 15 10301 9163 11715 -1628 -219 -128 C \nATOM 122 C GLN A 15 6.798 -18.391 -7.099 1.00 84.99 C \nANISOU 122 C GLN A 15 10576 9561 12155 -1557 -258 -101 C \nATOM 123 O GLN A 15 5.978 -18.718 -7.956 1.00 86.16 O \nANISOU 123 O GLN A 15 10664 9712 12361 -1556 -282 -101 O \nATOM 124 CB GLN A 15 9.046 -19.409 -6.751 1.00 80.23 C \nANISOU 124 CB GLN A 15 10186 8875 11422 -1575 -139 -152 C \nATOM 125 CG GLN A 15 9.965 -20.104 -5.772 1.00 90.71 C \nANISOU 125 CG GLN A 15 11624 10174 12669 -1633 -100 -175 C \nATOM 126 CD GLN A 15 11.397 -20.180 -6.280 1.00 94.03 C \nANISOU 126 CD GLN A 15 12175 10528 13026 -1573 -19 -201 C \nATOM 127 OE1 GLN A 15 11.717 -19.652 -7.350 1.00 90.17 O \nANISOU 127 OE1 GLN A 15 11688 10021 12553 -1483 7 -199 O \nATOM 128 NE2 GLN A 15 12.266 -20.825 -5.508 1.00 93.41 N \nANISOU 128 NE2 GLN A 15 12209 10411 12870 -1620 21 -224 N \nATOM 129 N VAL A 16 7.055 -17.129 -6.785 1.00 78.41 N \nANISOU 129 N VAL A 16 9730 8751 11310 -1500 -264 -80 N \nATOM 130 CA VAL A 16 6.275 -16.027 -7.319 1.00 70.53 C \nANISOU 130 CA VAL A 16 8645 7785 10368 -1446 -306 -52 C \nATOM 131 C VAL A 16 7.115 -14.795 -7.235 1.00 72.90 C \nANISOU 131 C VAL A 16 8968 8102 10628 -1375 -278 -42 C \nATOM 132 O VAL A 16 7.971 -14.686 -6.359 1.00 80.06 O \nANISOU 132 O VAL A 16 9935 9014 11471 -1380 -250 -48 O \nATOM 133 CB VAL A 16 4.972 -15.855 -6.517 1.00 73.84 C \nANISOU 133 CB VAL A 16 8980 8248 10828 -1501 -387 -23 C \nATOM 134 CG1 VAL A 16 4.740 -14.413 -6.126 1.00 75.37 C \nANISOU 134 CG1 VAL A 16 9131 8483 11023 -1466 -420 9 C \nATOM 135 CG2 VAL A 16 3.795 -16.412 -7.287 1.00 69.16 C \nANISOU 135 CG2 VAL A 16 8318 7653 10305 -1513 -427 -22 C \nATOM 136 N ASP A 17 6.916 -13.883 -8.171 1.00 73.77 N \nANISOU 136 N ASP A 17 9033 8226 10771 -1306 -283 -29 N \nATOM 137 CA ASP A 17 7.718 -12.648 -8.170 1.00 79.02 C \nANISOU 137 CA ASP A 17 9709 8923 11392 -1234 -256 -19 C \nATOM 138 C ASP A 17 7.000 -11.364 -7.765 1.00 71.97 C \nANISOU 138 C ASP A 17 8738 8093 10516 -1233 -312 17 C \nATOM 139 O ASP A 17 5.760 -11.295 -7.713 1.00 67.50 O \nANISOU 139 O ASP A 17 8103 7536 10006 -1274 -375 37 O \nATOM 140 CB ASP A 17 8.346 -12.450 -9.541 1.00 87.52 C \nANISOU 140 CB ASP A 17 10808 9976 12470 -1150 -206 -32 C \nATOM 141 CG ASP A 17 9.547 -13.329 -9.745 1.00 88.39 C \nANISOU 141 CG ASP A 17 11026 10030 12527 -1130 -134 -64 C \nATOM 142 OD1 ASP A 17 9.402 -14.568 -9.833 1.00 93.76 O \nANISOU 142 OD1 ASP A 17 11741 10663 13219 -1186 -127 -85 O \nATOM 143 OD2 ASP A 17 10.655 -12.762 -9.807 1.00 89.54 O \nANISOU 143 OD2 ASP A 17 11224 10182 12614 -1058 -85 -70 O \nATOM 144 N THR A 18 7.843 -10.375 -7.480 1.00 66.87 N \nANISOU 144 N THR A 18 8107 7488 9812 -1184 -284 24 N \nATOM 145 CA THR A 18 7.450 -9.083 -6.957 1.00 66.87 C \nANISOU 145 CA THR A 18 8046 7558 9803 -1186 -326 56 C \nATOM 146 C THR A 18 8.447 -8.051 -7.481 1.00 70.20 C \nANISOU 146 C THR A 18 8476 8024 10174 -1098 -278 55 C \nATOM 147 O THR A 18 9.596 -8.382 -7.830 1.00 72.57 O \nANISOU 147 O THR A 18 8845 8301 10429 -1038 -212 31 O \nATOM 148 CB THR A 18 7.469 -9.127 -5.404 1.00 68.47 C \nANISOU 148 CB THR A 18 8262 7789 9966 -1252 -349 64 C \nATOM 149 OG1 THR A 18 6.308 -9.818 -4.927 1.00 76.74 O \nANISOU 149 OG1 THR A 18 9277 8816 11064 -1333 -408 75 O \nATOM 150 CG2 THR A 18 7.476 -7.777 -4.780 1.00 74.10 C \nANISOU 150 CG2 THR A 18 8933 8581 10641 -1248 -372 92 C \nATOM 151 N ILE A 19 8.026 -6.795 -7.509 1.00 75.39 N \nANISOU 151 N ILE A 19 9067 8747 10831 -1090 -312 84 N \nATOM 152 CA ILE A 19 8.888 -5.675 -7.965 1.00 82.57 C \nANISOU 152 CA ILE A 19 9967 9721 11685 -1011 -274 88 C \nATOM 153 C ILE A 19 10.140 -5.486 -7.118 1.00 86.42 C \nANISOU 153 C ILE A 19 10506 10248 12083 -975 -226 76 C \nATOM 154 O ILE A 19 11.134 -4.986 -7.605 1.00 94.85 O \nANISOU 154 O ILE A 19 11592 11350 13098 -889 -174 67 O \nATOM 155 CB ILE A 19 8.110 -4.344 -8.091 1.00 83.86 C \nANISOU 155 CB ILE A 19 10047 9956 11861 -1028 -324 121 C \nATOM 156 CG1 ILE A 19 7.534 -3.945 -6.748 1.00 93.97 C \nANISOU 156 CG1 ILE A 19 11301 11277 13125 -1108 -378 145 C \nATOM 157 CG2 ILE A 19 6.973 -4.480 -9.096 1.00 79.08 C \nANISOU 157 CG2 ILE A 19 9400 9307 11339 -1044 -363 129 C \nATOM 158 CD1 ILE A 19 8.404 -2.956 -6.023 1.00 99.86 C \nANISOU 158 CD1 ILE A 19 12042 12118 13783 -1086 -355 153 C \nATOM 159 N MET A 20 10.089 -5.917 -5.862 1.00 92.36 N \nANISOU 159 N MET A 20 11284 10996 12815 -1038 -242 75 N \nATOM 160 CA MET A 20 11.208 -5.797 -4.921 1.00 91.38 C \nANISOU 160 CA MET A 20 11212 10906 12603 -1013 -200 62 C \nATOM 161 C MET A 20 11.838 -7.126 -4.544 1.00 89.12 C \nANISOU 161 C MET A 20 11023 10539 12298 -1024 -160 29 C \nATOM 162 O MET A 20 12.910 -7.148 -3.941 1.00 88.33 O \nANISOU 162 O MET A 20 10987 10451 12123 -986 -113 12 O \nATOM 163 CB MET A 20 10.741 -5.126 -3.624 1.00 96.50 C \nANISOU 163 CB MET A 20 11816 11624 13227 -1083 -249 87 C \nATOM 164 CG MET A 20 10.643 -3.620 -3.683 1.00 94.25 C \nANISOU 164 CG MET A 20 11455 11443 12911 -1064 -269 114 C \nATOM 165 SD MET A 20 10.035 -3.047 -2.096 1.00105.99 S \nANISOU 165 SD MET A 20 12903 12999 14371 -1164 -329 143 S \nATOM 166 CE MET A 20 9.812 -1.308 -2.447 1.00114.92 C \nANISOU 166 CE MET A 20 13945 14249 15472 -1150 -353 175 C \nATOM 167 N GLU A 21 11.156 -8.225 -4.841 1.00 91.25 N \nANISOU 167 N GLU A 21 11307 10733 12632 -1079 -179 21 N \nATOM 168 CA GLU A 21 11.637 -9.554 -4.446 1.00 95.53 C \nANISOU 168 CA GLU A 21 11940 11201 13156 -1111 -146 -9 C \nATOM 169 C GLU A 21 11.412 -10.593 -5.544 1.00 81.26 C \nANISOU 169 C GLU A 21 10159 9314 11402 -1112 -131 -27 C \nATOM 170 O GLU A 21 10.344 -10.661 -6.133 1.00 69.74 O \nANISOU 170 O GLU A 21 8633 7848 10016 -1141 -176 -13 O \nATOM 171 CB GLU A 21 10.948 -10.017 -3.155 1.00107.67 C \nANISOU 171 CB GLU A 21 13464 12743 14701 -1217 -195 -1 C \nATOM 172 CG GLU A 21 11.507 -9.421 -1.873 1.00115.80 C \nANISOU 172 CG GLU A 21 14509 13833 15658 -1226 -190 4 C \nATOM 173 CD GLU A 21 10.951 -10.090 -0.620 1.00122.34 C \nANISOU 173 CD GLU A 21 15341 14654 16488 -1333 -230 7 C \nATOM 174 OE1 GLU A 21 11.685 -10.889 -0.001 1.00126.19 O \nANISOU 174 OE1 GLU A 21 15913 15106 16926 -1353 -192 -19 O \nATOM 175 OE2 GLU A 21 9.779 -9.835 -0.258 1.00114.17 O \nANISOU 175 OE2 GLU A 21 14229 13649 15503 -1397 -300 37 O \nATOM 176 N LYS A 22 12.427 -11.411 -5.771 1.00 83.38 N \nANISOU 176 N LYS A 22 10531 9521 11628 -1082 -68 -59 N \nATOM 177 CA LYS A 22 12.408 -12.427 -6.795 1.00 92.47 C \nANISOU 177 CA LYS A 22 11723 10598 12814 -1083 -44 -79 C \nATOM 178 C LYS A 22 12.449 -13.792 -6.113 1.00102.06 C \nANISOU 178 C LYS A 22 13009 11755 14014 -1172 -37 -102 C \nATOM 179 O LYS A 22 13.107 -13.956 -5.091 1.00109.16 O \nANISOU 179 O LYS A 22 13973 12654 14850 -1191 -16 -114 O \nATOM 180 CB LYS A 22 13.602 -12.207 -7.743 1.00103.61 C \nANISOU 180 CB LYS A 22 13204 11984 14180 -972 26 -96 C \nATOM 181 CG LYS A 22 14.018 -13.416 -8.611 1.00110.35 C \nANISOU 181 CG LYS A 22 14146 12746 15036 -972 71 -125 C \nATOM 182 CD LYS A 22 13.137 -13.514 -9.860 1.00110.72 C \nANISOU 182 CD LYS A 22 14121 12784 15164 -973 46 -116 C \nATOM 183 CE LYS A 22 13.422 -14.730 -10.759 1.00105.57 C \nANISOU 183 CE LYS A 22 13544 12048 14518 -985 85 -143 C \nATOM 184 NZ LYS A 22 12.157 -15.273 -11.356 1.00 97.45 N \nANISOU 184 NZ LYS A 22 12435 11016 13575 -1050 38 -138 N \nATOM 185 N ASN A 23 11.734 -14.765 -6.683 1.00110.43 N \nANISOU 185 N ASN A 23 14055 12775 15130 -1229 -55 -110 N \nATOM 186 CA ASN A 23 11.759 -16.167 -6.215 1.00110.96 C \nANISOU 186 CA ASN A 23 14187 12793 15181 -1320 -45 -134 C \nATOM 187 C ASN A 23 11.251 -16.310 -4.782 1.00105.13 C \nANISOU 187 C ASN A 23 13422 12091 14431 -1408 -90 -124 C \nATOM 188 O ASN A 23 11.951 -16.793 -3.902 1.00 99.02 O \nANISOU 188 O ASN A 23 12731 11297 13594 -1445 -61 -142 O \nATOM 189 CB ASN A 23 13.157 -16.806 -6.373 1.00107.65 C \nANISOU 189 CB ASN A 23 13914 12304 14685 -1290 35 -168 C \nATOM 190 CG ASN A 23 13.584 -16.972 -7.831 1.00114.09 C \nANISOU 190 CG ASN A 23 14766 13072 15513 -1221 78 -180 C \nATOM 191 OD1 ASN A 23 14.616 -16.429 -8.250 1.00123.92 O \nANISOU 191 OD1 ASN A 23 16073 14301 16711 -1122 129 -186 O \nATOM 192 ND2 ASN A 23 12.813 -17.732 -8.606 1.00113.90 N \nANISOU 192 ND2 ASN A 23 14702 13027 15546 -1269 58 -184 N \nATOM 193 N VAL A 24 10.022 -15.862 -4.565 1.00106.45 N \nANISOU 193 N VAL A 24 13477 12311 14660 -1441 -161 -94 N \nATOM 194 CA VAL A 24 9.400 -15.895 -3.235 1.00 97.07 C \nANISOU 194 CA VAL A 24 12251 11164 13468 -1521 -212 -78 C \nATOM 195 C VAL A 24 8.422 -17.046 -3.109 1.00 85.94 C \nANISOU 195 C VAL A 24 10807 9748 12100 -1615 -252 -81 C \nATOM 196 O VAL A 24 7.392 -17.067 -3.788 1.00 77.13 O \nANISOU 196 O VAL A 24 9610 8642 11053 -1615 -295 -67 O \nATOM 197 CB VAL A 24 8.657 -14.579 -2.941 1.00 98.85 C \nANISOU 197 CB VAL A 24 12379 11456 13725 -1498 -269 -39 C \nATOM 198 CG1 VAL A 24 7.780 -14.712 -1.699 1.00 96.83 C \nANISOU 198 CG1 VAL A 24 12075 11238 13477 -1587 -332 -19 C \nATOM 199 CG2 VAL A 24 9.672 -13.459 -2.785 1.00 97.62 C \nANISOU 199 CG2 VAL A 24 12252 11327 13510 -1420 -230 -37 C \nATOM 200 N THR A 25 8.745 -17.993 -2.227 1.00 82.14 N \nANISOU 200 N THR A 25 10386 9253 11572 -1694 -239 -99 N \nATOM 201 CA THR A 25 7.967 -19.213 -2.112 1.00 77.97 C \nANISOU 201 CA THR A 25 9832 8725 11068 -1788 -269 -106 C \nATOM 202 C THR A 25 6.601 -18.894 -1.519 1.00 75.38 C \nANISOU 202 C THR A 25 9390 8457 10792 -1826 -353 -71 C \nATOM 203 O THR A 25 6.495 -18.112 -0.582 1.00 75.32 O \nANISOU 203 O THR A 25 9361 8488 10770 -1829 -382 -49 O \nATOM 204 CB THR A 25 8.705 -20.262 -1.275 1.00 73.10 C \nANISOU 204 CB THR A 25 9314 8084 10378 -1869 -232 -135 C \nATOM 205 OG1 THR A 25 10.114 -20.180 -1.535 1.00 78.39 O \nANISOU 205 OG1 THR A 25 10104 8696 10984 -1816 -155 -162 O \nATOM 206 CG2 THR A 25 8.203 -21.656 -1.607 1.00 67.26 C \nANISOU 206 CG2 THR A 25 8568 7335 9652 -1954 -238 -153 C \nATOM 207 N VAL A 26 5.557 -19.487 -2.079 1.00 71.56 N \nANISOU 207 N VAL A 26 8837 7985 10367 -1851 -392 -66 N \nATOM 208 CA VAL A 26 4.203 -19.135 -1.695 1.00 72.27 C \nANISOU 208 CA VAL A 26 8822 8127 10511 -1868 -474 -32 C \nATOM 209 C VAL A 26 3.394 -20.390 -1.388 1.00 80.10 C \nANISOU 209 C VAL A 26 9776 9144 11514 -1953 -508 -37 C \nATOM 210 O VAL A 26 3.792 -21.497 -1.747 1.00 84.30 O \nANISOU 210 O VAL A 26 10352 9657 12023 -1995 -469 -68 O \nATOM 211 CB VAL A 26 3.528 -18.259 -2.787 1.00 75.81 C \nANISOU 211 CB VAL A 26 9203 8574 11028 -1786 -499 -12 C \nATOM 212 CG1 VAL A 26 2.541 -19.052 -3.653 1.00 76.72 C \nANISOU 212 CG1 VAL A 26 9257 8692 11202 -1794 -527 -17 C \nATOM 213 CG2 VAL A 26 2.849 -17.051 -2.168 1.00 76.17 C \nANISOU 213 CG2 VAL A 26 9189 8657 11093 -1768 -558 28 C \nATOM 214 N THR A 27 2.263 -20.197 -0.713 1.00 80.37 N \nANISOU 214 N THR A 27 9730 9228 11579 -1980 -582 -5 N \nATOM 215 CA THR A 27 1.442 -21.281 -0.239 1.00 74.19 C \nANISOU 215 CA THR A 27 8901 8487 10800 -2057 -623 -5 C \nATOM 216 C THR A 27 0.476 -21.754 -1.329 1.00 78.11 C \nANISOU 216 C THR A 27 9325 8994 11360 -2030 -649 -6 C \nATOM 217 O THR A 27 0.331 -22.954 -1.538 1.00 79.94 O \nANISOU 217 O THR A 27 9549 9244 11581 -2083 -640 -28 O \nATOM 218 CB THR A 27 0.788 -20.887 1.089 1.00 76.71 C \nANISOU 218 CB THR A 27 9180 8855 11113 -2097 -686 29 C \nATOM 219 OG1 THR A 27 0.857 -21.979 2.009 1.00 87.66 O \nANISOU 219 OG1 THR A 27 10581 10274 12451 -2195 -688 17 O \nATOM 220 CG2 THR A 27 -0.638 -20.414 0.938 1.00 73.22 C \nANISOU 220 CG2 THR A 27 8640 8443 10736 -2062 -765 66 C \nATOM 221 N HIS A 28 -0.153 -20.820 -2.042 1.00 84.49 N \nANISOU 221 N HIS A 28 10083 9793 12227 -1949 -679 15 N \nATOM 222 CA HIS A 28 -1.030 -21.120 -3.183 1.00 80.07 C \nANISOU 222 CA HIS A 28 9459 9237 11728 -1908 -700 12 C \nATOM 223 C HIS A 28 -0.771 -20.082 -4.272 1.00 82.77 C \nANISOU 223 C HIS A 28 9810 9535 12105 -1816 -676 14 C \nATOM 224 O HIS A 28 -0.570 -18.895 -3.995 1.00 71.41 O \nANISOU 224 O HIS A 28 8384 8085 10665 -1779 -684 36 O \nATOM 225 CB HIS A 28 -2.524 -21.068 -2.816 1.00 81.45 C \nANISOU 225 CB HIS A 28 9541 9459 11946 -1905 -785 44 C \nATOM 226 CG HIS A 28 -2.980 -22.111 -1.841 1.00 88.38 C \nANISOU 226 CG HIS A 28 10390 10395 12796 -1988 -818 46 C \nATOM 227 ND1 HIS A 28 -4.123 -22.860 -2.037 1.00 89.12 N \nANISOU 227 ND1 HIS A 28 10404 10540 12920 -1993 -866 50 N \nATOM 228 CD2 HIS A 28 -2.482 -22.498 -0.644 1.00 91.11 C \nANISOU 228 CD2 HIS A 28 10772 10762 13082 -2067 -811 44 C \nATOM 229 CE1 HIS A 28 -4.290 -23.679 -1.012 1.00 91.86 C \nANISOU 229 CE1 HIS A 28 10737 10942 13226 -2073 -887 52 C \nATOM 230 NE2 HIS A 28 -3.308 -23.481 -0.155 1.00 91.06 N \nANISOU 230 NE2 HIS A 28 10707 10822 13071 -2123 -854 48 N \nATOM 231 N ALA A 29 -0.840 -20.527 -5.520 1.00 89.36 N \nANISOU 231 N ALA A 29 10633 10352 12969 -1783 -651 -7 N \nATOM 232 CA ALA A 29 -0.599 -19.649 -6.643 1.00 91.12 C \nANISOU 232 CA ALA A 29 10862 10536 13224 -1699 -627 -8 C \nATOM 233 C ALA A 29 -1.395 -20.075 -7.874 1.00 93.60 C \nANISOU 233 C ALA A 29 11119 10851 13594 -1663 -639 -18 C \nATOM 234 O ALA A 29 -1.876 -21.203 -7.948 1.00 98.89 O \nANISOU 234 O ALA A 29 11756 11551 14266 -1705 -650 -33 O \nATOM 235 CB ALA A 29 0.891 -19.613 -6.945 1.00 88.96 C \nANISOU 235 CB ALA A 29 10682 10220 12901 -1688 -546 -33 C \nATOM 236 N GLN A 30 -1.540 -19.153 -8.825 1.00 92.96 N \nANISOU 236 N GLN A 30 11023 10744 13552 -1586 -638 -11 N \nATOM 237 CA GLN A 30 -2.146 -19.452 -10.122 1.00 89.35 C \nANISOU 237 CA GLN A 30 10521 10282 13145 -1543 -640 -24 C \nATOM 238 C GLN A 30 -1.217 -19.059 -11.274 1.00 94.69 C \nANISOU 238 C GLN A 30 11244 10915 13819 -1489 -576 -43 C \nATOM 239 O GLN A 30 -0.822 -17.905 -11.416 1.00 92.94 O \nANISOU 239 O GLN A 30 11043 10674 13597 -1441 -566 -28 O \nATOM 240 CB GLN A 30 -3.482 -18.751 -10.290 1.00 84.39 C \nANISOU 240 CB GLN A 30 9823 9667 12575 -1497 -710 3 C \nATOM 241 CG GLN A 30 -4.674 -19.591 -9.897 1.00 84.48 C \nANISOU 241 CG GLN A 30 9768 9724 12608 -1524 -768 9 C \nATOM 242 CD GLN A 30 -5.964 -19.108 -10.552 1.00 82.37 C \nANISOU 242 CD GLN A 30 9438 9456 12402 -1459 -824 24 C \nATOM 243 OE1 GLN A 30 -6.102 -19.138 -11.773 1.00 88.05 O \nANISOU 243 OE1 GLN A 30 10142 10159 13153 -1411 -804 6 O \nATOM 244 NE2 GLN A 30 -6.922 -18.683 -9.742 1.00 78.42 N \nANISOU 244 NE2 GLN A 30 8908 8972 11915 -1457 -893 57 N \nATOM 245 N ASP A 31 -0.846 -20.047 -12.073 1.00 95.43 N \nANISOU 245 N ASP A 31 11355 10998 13905 -1503 -532 -75 N \nATOM 246 CA ASP A 31 -0.204 -19.796 -13.348 1.00 93.72 C \nANISOU 246 CA ASP A 31 11169 10744 13697 -1447 -479 -92 C \nATOM 247 C ASP A 31 -1.327 -19.344 -14.262 1.00 85.58 C \nANISOU 247 C ASP A 31 10061 9722 12733 -1390 -521 -83 C \nATOM 248 O ASP A 31 -2.378 -19.991 -14.317 1.00 90.46 O \nANISOU 248 O ASP A 31 10615 10372 13382 -1406 -563 -85 O \nATOM 249 CB ASP A 31 0.470 -21.068 -13.897 1.00 91.48 C \nANISOU 249 CB ASP A 31 10930 10447 13381 -1489 -423 -128 C \nATOM 250 CG ASP A 31 1.354 -20.799 -15.119 1.00 93.00 C \nANISOU 250 CG ASP A 31 11173 10594 13568 -1433 -361 -145 C \nATOM 251 OD1 ASP A 31 1.838 -19.667 -15.288 1.00 94.87 O \nANISOU 251 OD1 ASP A 31 11433 10809 13804 -1371 -347 -130 O \nATOM 252 OD2 ASP A 31 1.578 -21.727 -15.931 1.00 99.73 O \nANISOU 252 OD2 ASP A 31 12042 11436 14413 -1453 -326 -172 O \nATOM 253 N ILE A 32 -1.103 -18.240 -14.962 1.00 75.45 N \nANISOU 253 N ILE A 32 8785 8415 11468 -1322 -508 -73 N \nATOM 254 CA ILE A 32 -2.042 -17.780 -15.991 1.00 74.12 C \nANISOU 254 CA ILE A 32 8558 8247 11360 -1265 -538 -69 C \nATOM 255 C ILE A 32 -1.473 -17.909 -17.430 1.00 76.04 C \nANISOU 255 C ILE A 32 8819 8464 11610 -1223 -482 -94 C \nATOM 256 O ILE A 32 -2.221 -17.962 -18.378 1.00 68.42 O \nANISOU 256 O ILE A 32 7805 7500 10690 -1189 -498 -101 O \nATOM 257 CB ILE A 32 -2.496 -16.331 -15.708 1.00 75.54 C \nANISOU 257 CB ILE A 32 8719 8425 11558 -1227 -580 -35 C \nATOM 258 CG1 ILE A 32 -1.287 -15.388 -15.488 1.00 68.92 C \nANISOU 258 CG1 ILE A 32 7939 7574 10675 -1209 -537 -27 C \nATOM 259 CG2 ILE A 32 -3.443 -16.317 -14.514 1.00 75.50 C \nANISOU 259 CG2 ILE A 32 8680 8446 11561 -1264 -649 -10 C \nATOM 260 CD1 ILE A 32 -1.674 -13.955 -15.200 1.00 60.33 C \nANISOU 260 CD1 ILE A 32 6833 6496 9595 -1183 -576 6 C \nATOM 261 N LEU A 33 -0.145 -17.948 -17.574 1.00 79.05 N \nANISOU 261 N LEU A 33 9274 8819 11944 -1221 -417 -107 N \nATOM 262 CA LEU A 33 0.516 -18.225 -18.865 1.00 78.69 C \nANISOU 262 CA LEU A 33 9258 8746 11895 -1188 -359 -130 C \nATOM 263 C LEU A 33 0.401 -19.671 -19.363 1.00 76.79 C \nANISOU 263 C LEU A 33 9015 8510 11654 -1234 -340 -161 C \nATOM 264 O LEU A 33 0.962 -20.601 -18.781 1.00 84.27 O \nANISOU 264 O LEU A 33 10009 9454 12555 -1297 -315 -175 O \nATOM 265 CB LEU A 33 1.998 -17.867 -18.771 1.00 82.59 C \nANISOU 265 CB LEU A 33 9842 9210 12330 -1169 -297 -133 C \nATOM 266 CG LEU A 33 2.839 -18.044 -20.028 1.00 79.39 C \nANISOU 266 CG LEU A 33 9482 8772 11911 -1128 -234 -154 C \nATOM 267 CD1 LEU A 33 2.465 -17.020 -21.053 1.00 81.35 C \nANISOU 267 CD1 LEU A 33 9684 9026 12201 -1056 -244 -143 C \nATOM 268 CD2 LEU A 33 4.314 -17.929 -19.723 1.00 84.77 C \nANISOU 268 CD2 LEU A 33 10263 9422 12522 -1115 -173 -158 C \nATOM 269 N GLU A 34 -0.319 -19.864 -20.456 1.00 80.36 N \nANISOU 269 N GLU A 34 9412 8971 12151 -1206 -350 -172 N \nATOM 270 CA GLU A 34 -0.471 -21.211 -21.053 1.00 79.29 C \nANISOU 270 CA GLU A 34 9263 8849 12012 -1249 -331 -203 C \nATOM 271 C GLU A 34 0.723 -21.540 -21.933 1.00 71.49 C \nANISOU 271 C GLU A 34 8353 7822 10989 -1243 -257 -224 C \nATOM 272 O GLU A 34 1.174 -20.698 -22.684 1.00 70.67 O \nANISOU 272 O GLU A 34 8269 7690 10892 -1178 -232 -218 O \nATOM 273 CB GLU A 34 -1.744 -21.299 -21.867 1.00 83.60 C \nANISOU 273 CB GLU A 34 9719 9427 12619 -1216 -372 -208 C \nATOM 274 CG GLU A 34 -1.917 -22.618 -22.589 1.00 88.35 C \nANISOU 274 CG GLU A 34 10298 10054 13216 -1256 -351 -240 C \nATOM 275 CD GLU A 34 -1.938 -23.780 -21.630 1.00 97.59 C \nANISOU 275 CD GLU A 34 11471 11263 14347 -1346 -358 -249 C \nATOM 276 OE1 GLU A 34 -2.651 -23.649 -20.612 1.00108.34 O \nANISOU 276 OE1 GLU A 34 12791 12655 15719 -1359 -412 -230 O \nATOM 277 OE2 GLU A 34 -1.263 -24.801 -21.895 1.00 89.27 O \nANISOU 277 OE2 GLU A 34 10460 10209 13249 -1405 -312 -274 O \nATOM 278 N LYS A 35 1.262 -22.750 -21.800 1.00 67.54 N \nANISOU 278 N LYS A 35 7900 7319 10442 -1315 -222 -247 N \nATOM 279 CA LYS A 35 2.524 -23.108 -22.467 1.00 69.50 C \nANISOU 279 CA LYS A 35 8245 7519 10643 -1317 -150 -265 C \nATOM 280 C LYS A 35 2.488 -24.401 -23.293 1.00 73.33 C \nANISOU 280 C LYS A 35 8733 8016 11115 -1372 -122 -296 C \nATOM 281 O LYS A 35 3.475 -24.763 -23.906 1.00 70.62 O \nANISOU 281 O LYS A 35 8473 7629 10731 -1379 -64 -311 O \nATOM 282 CB LYS A 35 3.632 -23.205 -21.430 1.00 70.11 C \nANISOU 282 CB LYS A 35 8424 7563 10653 -1354 -117 -263 C \nATOM 283 CG LYS A 35 4.116 -21.862 -20.906 1.00 73.32 C \nANISOU 283 CG LYS A 35 8856 7949 11054 -1287 -119 -237 C \nATOM 284 CD LYS A 35 4.949 -21.999 -19.630 1.00 73.99 C \nANISOU 284 CD LYS A 35 9022 8016 11076 -1329 -101 -234 C \nATOM 285 CE LYS A 35 4.056 -22.363 -18.447 1.00 72.43 C \nANISOU 285 CE LYS A 35 8766 7865 10889 -1397 -159 -225 C \nATOM 286 NZ LYS A 35 4.840 -22.717 -17.251 1.00 74.90 N \nANISOU 286 NZ LYS A 35 9159 8161 11136 -1454 -139 -228 N \nATOM 287 N THR A 36 1.349 -25.081 -23.324 1.00 74.68 N \nANISOU 287 N THR A 36 8811 8246 11316 -1409 -165 -305 N \nATOM 288 CA THR A 36 1.277 -26.390 -23.928 1.00 76.50 C \nANISOU 288 CA THR A 36 9035 8505 11525 -1477 -142 -334 C \nATOM 289 C THR A 36 0.355 -26.393 -25.111 1.00 82.70 C \nANISOU 289 C THR A 36 9730 9327 12366 -1432 -161 -344 C \nATOM 290 O THR A 36 -0.687 -25.752 -25.078 1.00 93.31 O \nANISOU 290 O THR A 36 10987 10700 13767 -1376 -214 -330 O \nATOM 291 CB THR A 36 0.763 -27.439 -22.906 1.00 80.83 C \nANISOU 291 CB THR A 36 9551 9115 12048 -1574 -172 -341 C \nATOM 292 OG1 THR A 36 1.361 -27.202 -21.629 1.00 87.60 O \nANISOU 292 OG1 THR A 36 10472 9946 12866 -1604 -172 -326 O \nATOM 293 CG2 THR A 36 1.100 -28.858 -23.349 1.00 83.00 C \nANISOU 293 CG2 THR A 36 9854 9411 12269 -1669 -133 -373 C \nATOM 294 N HIS A 37 0.701 -27.167 -26.138 1.00 84.03 N \nANISOU 294 N HIS A 37 9920 9493 12514 -1459 -118 -369 N \nATOM 295 CA HIS A 37 -0.176 -27.363 -27.293 1.00 75.86 C \nANISOU 295 CA HIS A 37 8798 8502 11525 -1428 -132 -384 C \nATOM 296 C HIS A 37 -0.132 -28.783 -27.773 1.00 77.47 C \nANISOU 296 C HIS A 37 8998 8749 11687 -1516 -105 -416 C \nATOM 297 O HIS A 37 0.850 -29.475 -27.542 1.00 78.25 O \nANISOU 297 O HIS A 37 9192 8819 11720 -1592 -59 -426 O \nATOM 298 CB HIS A 37 0.244 -26.424 -28.410 1.00 74.18 C \nANISOU 298 CB HIS A 37 8611 8236 11339 -1340 -104 -380 C \nATOM 299 CG HIS A 37 1.635 -26.637 -28.906 1.00 67.63 C \nANISOU 299 CG HIS A 37 7900 7343 10454 -1358 -33 -388 C \nATOM 300 ND1 HIS A 37 1.904 -27.336 -30.058 1.00 65.45 N \nANISOU 300 ND1 HIS A 37 7641 7067 10161 -1380 7 -411 N \nATOM 301 CD2 HIS A 37 2.822 -26.183 -28.453 1.00 68.45 C \nANISOU 301 CD2 HIS A 37 8113 7381 10515 -1346 4 -375 C \nATOM 302 CE1 HIS A 37 3.200 -27.316 -30.288 1.00 69.90 C \nANISOU 302 CE1 HIS A 37 8325 7561 10673 -1382 65 -411 C \nATOM 303 NE2 HIS A 37 3.785 -26.632 -29.319 1.00 72.47 N \nANISOU 303 NE2 HIS A 37 8709 7847 10981 -1359 65 -390 N \nATOM 304 N ASN A 38 -1.174 -29.207 -28.485 1.00 77.50 N \nANISOU 304 N ASN A 38 8899 8823 11727 -1506 -131 -431 N \nATOM 305 CA ASN A 38 -1.301 -30.614 -28.905 1.00 72.29 C \nANISOU 305 CA ASN A 38 8214 8228 11025 -1597 -113 -462 C \nATOM 306 C ASN A 38 -0.519 -30.988 -30.158 1.00 76.18 C \nANISOU 306 C ASN A 38 8769 8687 11491 -1613 -51 -482 C \nATOM 307 O ASN A 38 -0.674 -32.081 -30.685 1.00 81.37 O \nANISOU 307 O ASN A 38 9400 9402 12116 -1685 -35 -509 O \nATOM 308 CB ASN A 38 -2.778 -30.989 -29.073 1.00 70.63 C \nANISOU 308 CB ASN A 38 7860 8121 10856 -1579 -168 -472 C \nATOM 309 CG ASN A 38 -3.341 -30.576 -30.401 1.00 71.46 C \nANISOU 309 CG ASN A 38 7905 8233 11014 -1496 -170 -482 C \nATOM 310 OD1 ASN A 38 -2.806 -29.696 -31.068 1.00 81.12 O \nANISOU 310 OD1 ASN A 38 9181 9382 12260 -1432 -144 -474 O \nATOM 311 ND2 ASN A 38 -4.433 -31.198 -30.790 1.00 65.50 N \nANISOU 311 ND2 ASN A 38 7039 7572 10276 -1494 -200 -501 N \nATOM 312 N GLY A 39 0.307 -30.074 -30.644 1.00 80.17 N \nANISOU 312 N GLY A 39 9352 9104 12004 -1547 -18 -470 N \nATOM 313 CA GLY A 39 1.204 -30.333 -31.773 1.00 73.42 C \nANISOU 313 CA GLY A 39 8575 8203 11118 -1556 44 -484 C \nATOM 314 C GLY A 39 0.527 -30.683 -33.083 1.00 68.53 C \nANISOU 314 C GLY A 39 7875 7636 10527 -1540 44 -505 C \nATOM 315 O GLY A 39 1.209 -31.092 -34.016 1.00 65.38 O \nANISOU 315 O GLY A 39 7536 7210 10094 -1565 94 -520 O \nATOM 316 N LYS A 40 -0.804 -30.560 -33.161 1.00 70.71 N \nANISOU 316 N LYS A 40 8020 7987 10860 -1499 -10 -509 N \nATOM 317 CA LYS A 40 -1.554 -30.991 -34.364 1.00 71.54 C \nANISOU 317 CA LYS A 40 8038 8155 10989 -1486 -12 -534 C \nATOM 318 C LYS A 40 -2.417 -29.886 -34.922 1.00 69.08 C \nANISOU 318 C LYS A 40 7649 7841 10757 -1366 -49 -524 C \nATOM 319 O LYS A 40 -2.701 -28.937 -34.233 1.00 92.50 O \nANISOU 319 O LYS A 40 10607 10779 13760 -1307 -85 -500 O \nATOM 320 CB LYS A 40 -2.445 -32.210 -34.066 1.00 69.88 C \nANISOU 320 CB LYS A 40 7733 8060 10759 -1562 -40 -556 C \nATOM 321 CG LYS A 40 -1.690 -33.500 -33.821 1.00 71.60 C \nANISOU 321 CG LYS A 40 8016 8299 10891 -1699 0 -574 C \nATOM 322 CD LYS A 40 -0.856 -33.909 -35.019 1.00 76.80 C \nANISOU 322 CD LYS A 40 8746 8923 11511 -1733 62 -591 C \nATOM 323 CE LYS A 40 0.543 -34.348 -34.599 1.00 82.52 C \nANISOU 323 CE LYS A 40 9626 9571 12158 -1822 115 -588 C \nATOM 324 NZ LYS A 40 1.425 -34.592 -35.785 1.00 89.51 N \nANISOU 324 NZ LYS A 40 10598 10404 13007 -1841 176 -599 N \nATOM 325 N LEU A 41 -2.842 -30.037 -36.169 1.00 58.71 N \nANISOU 325 N LEU A 41 6282 6559 9465 -1337 -39 -545 N \nATOM 326 CA LEU A 41 -3.831 -29.187 -36.747 1.00 55.01 C \nANISOU 326 CA LEU A 41 5732 6103 9067 -1235 -77 -543 C \nATOM 327 C LEU A 41 -5.193 -29.847 -36.554 1.00 60.81 C \nANISOU 327 C LEU A 41 6344 6942 9821 -1238 -127 -561 C \nATOM 328 O LEU A 41 -5.380 -31.016 -36.861 1.00 62.15 O \nANISOU 328 O LEU A 41 6471 7188 9954 -1305 -115 -588 O \nATOM 329 CB LEU A 41 -3.596 -28.954 -38.238 1.00 51.69 C \nANISOU 329 CB LEU A 41 5318 5662 8659 -1196 -40 -557 C \nATOM 330 CG LEU A 41 -2.259 -28.335 -38.644 1.00 53.22 C \nANISOU 330 CG LEU A 41 5629 5763 8831 -1182 13 -542 C \nATOM 331 CD1 LEU A 41 -2.294 -27.991 -40.122 1.00 52.82 C \nANISOU 331 CD1 LEU A 41 5561 5705 8803 -1129 37 -554 C \nATOM 332 CD2 LEU A 41 -1.889 -27.106 -37.830 1.00 50.58 C \nANISOU 332 CD2 LEU A 41 5343 5360 8514 -1125 -2 -507 C \nATOM 333 N CYS A 42 -6.142 -29.075 -36.033 1.00 63.73 N \nANISOU 333 N CYS A 42 6657 7314 10242 -1163 -185 -545 N \nATOM 334 CA CYS A 42 -7.441 -29.615 -35.650 1.00 72.51 C \nANISOU 334 CA CYS A 42 7660 8521 11371 -1152 -239 -556 C \nATOM 335 C CYS A 42 -8.582 -28.843 -36.263 1.00 68.05 C \nANISOU 335 C CYS A 42 7023 7961 10871 -1042 -280 -559 C \nATOM 336 O CYS A 42 -8.369 -27.752 -36.807 1.00 71.39 O \nANISOU 336 O CYS A 42 7486 8310 11329 -978 -271 -547 O \nATOM 337 CB CYS A 42 -7.565 -29.600 -34.122 1.00 78.66 C \nANISOU 337 CB CYS A 42 8445 9304 12138 -1180 -277 -532 C \nATOM 338 SG CYS A 42 -6.148 -30.288 -33.246 1.00 98.90 S \nANISOU 338 SG CYS A 42 11115 11838 14624 -1305 -230 -525 S \nATOM 339 N ASP A 43 -9.791 -29.382 -36.120 1.00 64.35 N \nANISOU 339 N ASP A 43 6454 7582 10413 -1018 -325 -573 N \nATOM 340 CA ASP A 43 -10.980 -28.640 -36.516 1.00 75.14 C \nANISOU 340 CA ASP A 43 7761 8949 11840 -907 -372 -574 C \nATOM 341 C ASP A 43 -11.121 -27.381 -35.669 1.00 77.96 C \nANISOU 341 C ASP A 43 8164 9226 12233 -854 -411 -536 C \nATOM 342 O ASP A 43 -10.442 -27.240 -34.656 1.00 86.10 O \nANISOU 342 O ASP A 43 9252 10221 13242 -903 -408 -511 O \nATOM 343 CB ASP A 43 -12.227 -29.481 -36.364 1.00 75.10 C \nANISOU 343 CB ASP A 43 7645 9058 11833 -887 -416 -594 C \nATOM 344 CG ASP A 43 -12.143 -30.760 -37.154 1.00 83.21 C \nANISOU 344 CG ASP A 43 8617 10182 12817 -946 -379 -632 C \nATOM 345 OD1 ASP A 43 -11.114 -30.925 -37.851 1.00 90.38 O \nANISOU 345 OD1 ASP A 43 9583 11056 13701 -1002 -320 -641 O \nATOM 346 OD2 ASP A 43 -13.084 -31.581 -37.094 1.00 78.93 O \nANISOU 346 OD2 ASP A 43 7975 9752 12262 -936 -409 -652 O \nATOM 347 N LEU A 44 -11.955 -26.453 -36.123 1.00 78.04 N \nANISOU 347 N LEU A 44 8153 9204 12295 -758 -444 -532 N \nATOM 348 CA LEU A 44 -12.484 -25.400 -35.263 1.00 78.33 C \nANISOU 348 CA LEU A 44 8211 9186 12363 -705 -497 -499 C \nATOM 349 C LEU A 44 -13.970 -25.630 -35.097 1.00 82.47 C \nANISOU 349 C LEU A 44 8654 9769 12911 -637 -559 -508 C \nATOM 350 O LEU A 44 -14.717 -25.582 -36.087 1.00 86.28 O \nANISOU 350 O LEU A 44 9092 10270 13419 -570 -565 -532 O \nATOM 351 CB LEU A 44 -12.296 -23.999 -35.861 1.00 78.90 C \nANISOU 351 CB LEU A 44 8339 9168 12472 -648 -491 -485 C \nATOM 352 CG LEU A 44 -10.943 -23.296 -35.753 1.00 77.92 C \nANISOU 352 CG LEU A 44 8305 8969 12330 -686 -447 -462 C \nATOM 353 CD1 LEU A 44 -11.028 -21.876 -36.324 1.00 60.88 C \nANISOU 353 CD1 LEU A 44 6182 6741 10208 -622 -453 -448 C \nATOM 354 CD2 LEU A 44 -10.481 -23.272 -34.304 1.00 79.31 C \nANISOU 354 CD2 LEU A 44 8521 9133 12482 -737 -462 -433 C \nATOM 355 N ASP A 45 -14.409 -25.807 -33.853 1.00 80.61 N \nANISOU 355 N ASP A 45 8404 9558 12667 -647 -605 -487 N \nATOM 356 CA ASP A 45 -15.840 -25.838 -33.547 1.00 90.22 C \nANISOU 356 CA ASP A 45 9557 10817 13906 -568 -671 -487 C \nATOM 357 C ASP A 45 -16.535 -26.856 -34.432 1.00 84.94 C \nANISOU 357 C ASP A 45 8795 10249 13230 -540 -666 -528 C \nATOM 358 O ASP A 45 -17.499 -26.532 -35.120 1.00 82.09 O \nANISOU 358 O ASP A 45 8401 9888 12900 -447 -691 -543 O \nATOM 359 CB ASP A 45 -16.472 -24.447 -33.759 1.00 97.87 C \nANISOU 359 CB ASP A 45 10566 11696 14924 -478 -707 -469 C \nATOM 360 CG ASP A 45 -15.579 -23.302 -33.248 1.00102.52 C \nANISOU 360 CG ASP A 45 11250 12185 15517 -510 -695 -433 C \nATOM 361 OD1 ASP A 45 -14.992 -23.435 -32.151 1.00 93.69 O \nANISOU 361 OD1 ASP A 45 10159 11065 14372 -573 -696 -410 O \nATOM 362 OD2 ASP A 45 -15.474 -22.279 -33.959 1.00111.66 O \nANISOU 362 OD2 ASP A 45 12452 13273 16702 -473 -684 -430 O \nATOM 363 N GLY A 46 -15.988 -28.073 -34.454 1.00 80.99 N \nANISOU 363 N GLY A 46 8259 9832 12682 -624 -630 -549 N \nATOM 364 CA GLY A 46 -16.540 -29.179 -35.244 1.00 77.84 C \nANISOU 364 CA GLY A 46 7765 9549 12263 -617 -620 -590 C \nATOM 365 C GLY A 46 -16.451 -29.047 -36.753 1.00 80.35 C \nANISOU 365 C GLY A 46 8077 9854 12599 -585 -580 -620 C \nATOM 366 O GLY A 46 -17.049 -29.843 -37.481 1.00 81.20 O \nANISOU 366 O GLY A 46 8101 10057 12694 -563 -576 -655 O \nATOM 367 N VAL A 47 -15.725 -28.032 -37.228 1.00 85.68 N \nANISOU 367 N VAL A 47 8837 10418 13301 -581 -550 -607 N \nATOM 368 CA VAL A 47 -15.533 -27.809 -38.665 1.00 81.17 C \nANISOU 368 CA VAL A 47 8270 9826 12746 -555 -509 -633 C \nATOM 369 C VAL A 47 -14.076 -27.968 -39.111 1.00 81.80 C \nANISOU 369 C VAL A 47 8416 9870 12797 -645 -440 -634 C \nATOM 370 O VAL A 47 -13.207 -27.180 -38.758 1.00 85.16 O \nANISOU 370 O VAL A 47 8927 10204 13226 -668 -423 -606 O \nATOM 371 CB VAL A 47 -16.028 -26.410 -39.093 1.00 82.91 C \nANISOU 371 CB VAL A 47 8531 9950 13021 -458 -534 -621 C \nATOM 372 CG1 VAL A 47 -15.689 -26.144 -40.554 1.00 81.30 C \nANISOU 372 CG1 VAL A 47 8338 9722 12829 -442 -487 -645 C \nATOM 373 CG2 VAL A 47 -17.534 -26.289 -38.852 1.00 78.85 C \nANISOU 373 CG2 VAL A 47 7961 9467 12533 -358 -600 -625 C \nATOM 374 N LYS A 48 -13.848 -28.974 -39.949 1.00 80.05 N \nANISOU 374 N LYS A 48 8151 9721 12542 -691 -399 -668 N \nATOM 375 CA LYS A 48 -12.523 -29.315 -40.429 1.00 75.42 C \nANISOU 375 CA LYS A 48 7627 9110 11920 -779 -333 -672 C \nATOM 376 C LYS A 48 -11.949 -28.176 -41.261 1.00 74.19 C \nANISOU 376 C LYS A 48 7542 8850 11795 -738 -304 -662 C \nATOM 377 O LYS A 48 -12.715 -27.352 -41.793 1.00 79.50 O \nANISOU 377 O LYS A 48 8196 9496 12516 -646 -330 -665 O \nATOM 378 CB LYS A 48 -12.616 -30.572 -41.269 1.00 75.07 C \nANISOU 378 CB LYS A 48 7515 9173 11837 -827 -302 -712 C \nATOM 379 CG LYS A 48 -11.296 -31.221 -41.642 1.00 80.20 C \nANISOU 379 CG LYS A 48 8227 9814 12433 -937 -236 -719 C \nATOM 380 CD LYS A 48 -11.508 -32.622 -42.227 1.00 83.56 C \nANISOU 380 CD LYS A 48 8575 10366 12809 -1002 -214 -757 C \nATOM 381 CE LYS A 48 -10.448 -32.930 -43.277 1.00 85.67 C \nANISOU 381 CE LYS A 48 8901 10608 13043 -1069 -147 -771 C \nATOM 382 NZ LYS A 48 -9.079 -32.990 -42.693 1.00 87.11 N \nANISOU 382 NZ LYS A 48 9200 10713 13184 -1160 -108 -747 N \nATOM 383 N PRO A 49 -10.600 -28.087 -41.332 1.00 61.62 N \nANISOU 383 N PRO A 49 6037 7200 10174 -803 -252 -649 N \nATOM 384 CA PRO A 49 -10.033 -27.097 -42.223 1.00 59.03 C \nANISOU 384 CA PRO A 49 5767 6791 9869 -764 -222 -642 C \nATOM 385 C PRO A 49 -9.822 -27.640 -43.604 1.00 66.71 C \nANISOU 385 C PRO A 49 6721 7798 10828 -778 -176 -674 C \nATOM 386 O PRO A 49 -10.151 -28.793 -43.890 1.00 77.54 O \nANISOU 386 O PRO A 49 8029 9260 12172 -819 -169 -704 O \nATOM 387 CB PRO A 49 -8.684 -26.790 -41.604 1.00 58.26 C \nANISOU 387 CB PRO A 49 5774 6622 9742 -819 -188 -612 C \nATOM 388 CG PRO A 49 -8.328 -28.018 -40.847 1.00 57.39 C \nANISOU 388 CG PRO A 49 5662 6564 9578 -914 -178 -618 C \nATOM 389 CD PRO A 49 -9.605 -28.624 -40.392 1.00 55.42 C \nANISOU 389 CD PRO A 49 5312 6404 9340 -898 -230 -633 C \nATOM 390 N LEU A 50 -9.307 -26.792 -44.476 1.00 68.84 N \nANISOU 390 N LEU A 50 7038 8002 11115 -743 -147 -668 N \nATOM 391 CA LEU A 50 -9.062 -27.169 -45.843 1.00 69.08 C \nANISOU 391 CA LEU A 50 7058 8057 11134 -752 -104 -696 C \nATOM 392 C LEU A 50 -7.581 -27.355 -46.046 1.00 66.84 C \nANISOU 392 C LEU A 50 6867 7726 10804 -821 -43 -684 C \nATOM 393 O LEU A 50 -6.840 -26.376 -46.220 1.00 75.30 O \nANISOU 393 O LEU A 50 8009 8717 11883 -792 -24 -660 O \nATOM 394 CB LEU A 50 -9.593 -26.092 -46.790 1.00 76.64 C \nANISOU 394 CB LEU A 50 8001 8979 12141 -661 -114 -700 C \nATOM 395 CG LEU A 50 -9.275 -26.292 -48.278 1.00 79.56 C \nANISOU 395 CG LEU A 50 8365 9362 12501 -663 -67 -725 C \nATOM 396 CD1 LEU A 50 -9.868 -27.581 -48.785 1.00 86.25 C \nANISOU 396 CD1 LEU A 50 9130 10315 13327 -695 -61 -765 C \nATOM 397 CD2 LEU A 50 -9.817 -25.143 -49.097 1.00 82.63 C \nANISOU 397 CD2 LEU A 50 8745 9714 12938 -575 -80 -727 C \nATOM 398 N ILE A 51 -7.122 -28.603 -46.024 1.00 60.37 N \nANISOU 398 N ILE A 51 6052 6957 9931 -912 -13 -700 N \nATOM 399 CA ILE A 51 -5.697 -28.872 -46.220 1.00 57.64 C \nANISOU 399 CA ILE A 51 5808 6560 9533 -980 46 -689 C \nATOM 400 C ILE A 51 -5.386 -29.077 -47.681 1.00 62.46 C \nANISOU 400 C ILE A 51 6421 7179 10131 -983 90 -710 C \nATOM 401 O ILE A 51 -5.720 -30.107 -48.248 1.00 73.30 O \nANISOU 401 O ILE A 51 7740 8631 11478 -1031 102 -741 O \nATOM 402 CB ILE A 51 -5.170 -30.047 -45.391 1.00 62.41 C \nANISOU 402 CB ILE A 51 6444 7195 10075 -1090 61 -691 C \nATOM 403 CG1 ILE A 51 -5.480 -29.894 -43.877 1.00 58.48 C \nANISOU 403 CG1 ILE A 51 5941 6694 9586 -1092 16 -670 C \nATOM 404 CG2 ILE A 51 -3.659 -30.122 -45.522 1.00 71.53 C \nANISOU 404 CG2 ILE A 51 7726 8274 11177 -1145 119 -676 C \nATOM 405 CD1 ILE A 51 -6.751 -30.578 -43.449 1.00 61.05 C \nANISOU 405 CD1 ILE A 51 6151 7123 9922 -1094 -32 -690 C \nATOM 406 N LEU A 52 -4.802 -28.061 -48.325 1.00 65.42 N \nANISOU 406 N LEU A 52 6852 7480 10523 -929 112 -693 N \nATOM 407 CA LEU A 52 -4.160 -28.269 -49.627 1.00 69.17 C \nANISOU 407 CA LEU A 52 7360 7949 10974 -944 164 -706 C \nATOM 408 C LEU A 52 -2.787 -28.837 -49.254 1.00 74.12 C \nANISOU 408 C LEU A 52 8100 8529 11532 -1027 210 -690 C \nATOM 409 O LEU A 52 -2.047 -28.247 -48.432 1.00 97.83 O \nANISOU 409 O LEU A 52 11183 11461 14527 -1016 213 -658 O \nATOM 410 CB LEU A 52 -4.027 -26.969 -50.422 1.00 67.42 C \nANISOU 410 CB LEU A 52 7155 7671 10789 -856 169 -692 C \nATOM 411 CG LEU A 52 -5.148 -26.075 -50.982 1.00 59.80 C \nANISOU 411 CG LEU A 52 6111 6721 9888 -765 132 -702 C \nATOM 412 CD1 LEU A 52 -6.463 -26.309 -50.314 1.00 58.22 C \nANISOU 412 CD1 LEU A 52 5822 6576 9722 -745 76 -717 C \nATOM 413 CD2 LEU A 52 -4.751 -24.604 -50.862 1.00 56.12 C \nANISOU 413 CD2 LEU A 52 5696 6179 9447 -698 126 -668 C \nATOM 414 N ARG A 53 -2.446 -29.995 -49.765 1.00 61.50 N \nANISOU 414 N ARG A 53 6515 6970 9882 -1112 246 -712 N \nATOM 415 CA ARG A 53 -1.323 -30.675 -49.168 1.00 65.20 C \nANISOU 415 CA ARG A 53 7091 7399 10282 -1201 281 -699 C \nATOM 416 C ARG A 53 -0.049 -30.121 -49.751 1.00 58.81 C \nANISOU 416 C ARG A 53 6401 6498 9446 -1180 330 -677 C \nATOM 417 O ARG A 53 0.715 -29.509 -49.039 1.00 59.12 O \nANISOU 417 O ARG A 53 6524 6464 9477 -1156 336 -647 O \nATOM 418 CB ARG A 53 -1.429 -32.242 -49.191 1.00 67.81 C \nANISOU 418 CB ARG A 53 7400 7812 10553 -1323 296 -729 C \nATOM 419 CG ARG A 53 -1.594 -32.896 -50.549 1.00 75.18 C \nANISOU 419 CG ARG A 53 8295 8804 11467 -1356 325 -759 C \nATOM 420 CD ARG A 53 -1.528 -34.423 -50.458 1.00 71.51 C \nANISOU 420 CD ARG A 53 7824 8417 10930 -1491 343 -784 C \nATOM 421 NE ARG A 53 -2.745 -34.960 -49.850 1.00 68.90 N \nANISOU 421 NE ARG A 53 7365 8198 10617 -1503 296 -806 N \nATOM 422 CZ ARG A 53 -2.785 -35.729 -48.759 1.00 80.26 C \nANISOU 422 CZ ARG A 53 8802 9677 12016 -1585 281 -806 C \nATOM 423 NH1 ARG A 53 -1.655 -36.085 -48.137 1.00 83.18 N \nANISOU 423 NH1 ARG A 53 9299 9979 12325 -1669 313 -789 N \nATOM 424 NH2 ARG A 53 -3.955 -36.172 -48.286 1.00 78.88 N \nANISOU 424 NH2 ARG A 53 8500 9614 11858 -1582 236 -825 N \nATOM 425 N ASP A 54 0.189 -30.369 -51.023 1.00 58.64 N \nANISOU 425 N ASP A 54 6386 6486 9407 -1189 365 -691 N \nATOM 426 CA ASP A 54 1.343 -29.815 -51.705 1.00 62.14 C \nANISOU 426 CA ASP A 54 6936 6849 9826 -1157 410 -669 C \nATOM 427 C ASP A 54 0.881 -28.824 -52.750 1.00 59.54 C \nANISOU 427 C ASP A 54 6545 6526 9551 -1061 402 -670 C \nATOM 428 O ASP A 54 1.674 -28.339 -53.534 1.00 59.26 O \nANISOU 428 O ASP A 54 6575 6442 9499 -1026 437 -656 O \nATOM 429 CB ASP A 54 2.141 -30.947 -52.356 1.00 70.55 C \nANISOU 429 CB ASP A 54 8079 7912 10815 -1255 462 -682 C \nATOM 430 CG ASP A 54 3.118 -31.577 -51.396 1.00 81.97 C \nANISOU 430 CG ASP A 54 9646 9304 12193 -1335 485 -668 C \nATOM 431 OD1 ASP A 54 3.745 -30.802 -50.621 1.00 85.96 O \nANISOU 431 OD1 ASP A 54 10224 9735 12702 -1283 484 -638 O \nATOM 432 OD2 ASP A 54 3.251 -32.829 -51.415 1.00 81.82 O \nANISOU 432 OD2 ASP A 54 9650 9320 12115 -1450 505 -688 O \nATOM 433 N CYS A 55 -0.421 -28.532 -52.751 1.00 63.62 N \nANISOU 433 N CYS A 55 6940 7104 10130 -1017 356 -688 N \nATOM 434 CA CYS A 55 -1.013 -27.554 -53.670 1.00 66.71 C \nANISOU 434 CA CYS A 55 7268 7503 10575 -927 342 -692 C \nATOM 435 C CYS A 55 -1.116 -26.135 -53.075 1.00 51.29 C \nANISOU 435 C CYS A 55 5319 5501 8668 -838 311 -662 C \nATOM 436 O CYS A 55 -1.291 -25.970 -51.871 1.00 43.03 O \nANISOU 436 O CYS A 55 4275 4443 7633 -838 280 -648 O \nATOM 437 CB CYS A 55 -2.372 -28.056 -54.171 1.00 69.45 C \nANISOU 437 CB CYS A 55 7488 7943 10956 -927 313 -731 C \nATOM 438 SG CYS A 55 -2.150 -29.364 -55.388 1.00 75.47 S \nANISOU 438 SG CYS A 55 8245 8767 11665 -1012 360 -765 S \nATOM 439 N SER A 56 -0.978 -25.138 -53.928 1.00 48.75 N \nANISOU 439 N SER A 56 5000 5156 8368 -769 320 -652 N \nATOM 440 CA SER A 56 -1.177 -23.729 -53.526 1.00 55.29 C \nANISOU 440 CA SER A 56 5819 5950 9237 -688 289 -627 C \nATOM 441 C SER A 56 -2.541 -23.241 -53.895 1.00 54.32 C \nANISOU 441 C SER A 56 5595 5870 9175 -638 246 -648 C \nATOM 442 O SER A 56 -3.252 -23.889 -54.676 1.00 69.05 O \nANISOU 442 O SER A 56 7395 7788 11051 -652 246 -682 O \nATOM 443 CB SER A 56 -0.152 -22.842 -54.217 1.00 57.07 C \nANISOU 443 CB SER A 56 6112 6130 9441 -641 326 -602 C \nATOM 444 OG SER A 56 -0.450 -22.759 -55.598 1.00 61.85 O \nANISOU 444 OG SER A 56 6677 6764 10059 -621 341 -621 O \nATOM 445 N VAL A 57 -2.901 -22.066 -53.396 1.00 53.50 N \nANISOU 445 N VAL A 57 5479 5740 9107 -579 211 -628 N \nATOM 446 CA VAL A 57 -4.257 -21.507 -53.674 1.00 46.53 C \nANISOU 446 CA VAL A 57 4512 4886 8282 -528 165 -646 C \nATOM 447 C VAL A 57 -4.519 -21.336 -55.159 1.00 43.40 C \nANISOU 447 C VAL A 57 4081 4513 7896 -501 185 -669 C \nATOM 448 O VAL A 57 -5.619 -21.676 -55.697 1.00 48.93 O \nANISOU 448 O VAL A 57 4706 5259 8626 -488 165 -703 O \nATOM 449 CB VAL A 57 -4.475 -20.185 -52.982 1.00 41.07 C \nANISOU 449 CB VAL A 57 3829 4157 7617 -477 129 -617 C \nATOM 450 CG1 VAL A 57 -5.727 -19.532 -53.467 1.00 37.55 C \nANISOU 450 CG1 VAL A 57 3319 3728 7222 -426 90 -635 C \nATOM 451 CG2 VAL A 57 -4.581 -20.383 -51.482 1.00 41.39 C \nANISOU 451 CG2 VAL A 57 3882 4186 7658 -501 97 -601 C \nATOM 452 N ALA A 58 -3.482 -20.941 -55.871 1.00 37.79 N \nANISOU 452 N ALA A 58 3427 3776 7155 -495 228 -652 N \nATOM 453 CA ALA A 58 -3.621 -20.812 -57.316 1.00 34.55 C \nANISOU 453 CA ALA A 58 2989 3389 6749 -475 252 -672 C \nATOM 454 C ALA A 58 -3.740 -22.140 -58.014 1.00 35.15 C \nANISOU 454 C ALA A 58 3038 3513 6806 -526 277 -707 C \nATOM 455 O ALA A 58 -4.661 -22.379 -58.808 1.00 35.21 O \nANISOU 455 O ALA A 58 2974 3568 6838 -514 267 -741 O \nATOM 456 CB ALA A 58 -2.471 -20.042 -57.859 1.00 34.81 C \nANISOU 456 CB ALA A 58 3088 3387 6751 -452 290 -643 C \nATOM 457 N GLY A 59 -2.790 -23.036 -57.711 1.00 39.95 N \nANISOU 457 N GLY A 59 3707 4109 7363 -589 311 -698 N \nATOM 458 CA GLY A 59 -2.881 -24.482 -58.149 1.00 40.19 C \nANISOU 458 CA GLY A 59 3716 4193 7363 -661 334 -730 C \nATOM 459 C GLY A 59 -4.243 -25.122 -57.907 1.00 36.07 C \nANISOU 459 C GLY A 59 3091 3739 6873 -668 294 -767 C \nATOM 460 O GLY A 59 -4.777 -25.741 -58.763 1.00 34.26 O \nANISOU 460 O GLY A 59 2804 3570 6643 -682 302 -801 O \nATOM 461 N TRP A 60 -4.837 -24.835 -56.778 1.00 35.57 N \nANISOU 461 N TRP A 60 3006 3670 6840 -647 248 -758 N \nATOM 462 CA TRP A 60 -6.146 -25.329 -56.443 1.00 37.68 C \nANISOU 462 CA TRP A 60 3180 4000 7137 -638 205 -788 C \nATOM 463 C TRP A 60 -7.230 -24.671 -57.247 1.00 43.88 C \nANISOU 463 C TRP A 60 3896 4807 7971 -564 180 -811 C \nATOM 464 O TRP A 60 -8.101 -25.359 -57.808 1.00 44.98 O \nANISOU 464 O TRP A 60 3957 5018 8116 -562 173 -850 O \nATOM 465 CB TRP A 60 -6.421 -25.165 -54.933 1.00 38.49 C \nANISOU 465 CB TRP A 60 3287 4083 7254 -635 163 -767 C \nATOM 466 CG TRP A 60 -7.882 -25.204 -54.558 1.00 39.91 C \nANISOU 466 CG TRP A 60 3376 4309 7476 -591 107 -789 C \nATOM 467 CD1 TRP A 60 -8.801 -26.075 -54.988 1.00 43.25 C \nANISOU 467 CD1 TRP A 60 3714 4816 7902 -594 97 -829 C \nATOM 468 CD2 TRP A 60 -8.528 -24.397 -53.585 1.00 40.79 C \nANISOU 468 CD2 TRP A 60 3482 4390 7628 -539 55 -771 C \nATOM 469 NE1 TRP A 60 -10.028 -25.845 -54.393 1.00 47.19 N \nANISOU 469 NE1 TRP A 60 4152 5337 8440 -537 40 -838 N \nATOM 470 CE2 TRP A 60 -9.888 -24.777 -53.559 1.00 43.83 C \nANISOU 470 CE2 TRP A 60 3779 4836 8040 -503 14 -801 C \nATOM 471 CE3 TRP A 60 -8.106 -23.356 -52.771 1.00 40.17 C \nANISOU 471 CE3 TRP A 60 3463 4239 7560 -518 39 -732 C \nATOM 472 CZ2 TRP A 60 -10.823 -24.136 -52.793 1.00 45.83 C \nANISOU 472 CZ2 TRP A 60 4010 5070 8332 -444 -42 -793 C \nATOM 473 CZ3 TRP A 60 -9.051 -22.709 -51.987 1.00 42.54 C \nANISOU 473 CZ3 TRP A 60 3738 4525 7900 -468 -17 -723 C \nATOM 474 CH2 TRP A 60 -10.380 -23.108 -51.982 1.00 46.73 C \nANISOU 474 CH2 TRP A 60 4190 5107 8457 -432 -57 -752 C \nATOM 475 N LEU A 61 -7.204 -23.330 -57.339 1.00 48.90 N \nANISOU 475 N LEU A 61 4559 5385 8636 -502 168 -789 N \nATOM 476 CA LEU A 61 -8.344 -22.626 -58.003 1.00 40.09 C \nANISOU 476 CA LEU A 61 3385 4281 7567 -431 138 -811 C \nATOM 477 C LEU A 61 -8.286 -22.787 -59.497 1.00 41.42 C \nANISOU 477 C LEU A 61 3531 4481 7725 -429 175 -838 C \nATOM 478 O LEU A 61 -9.326 -22.863 -60.156 1.00 48.33 O \nANISOU 478 O LEU A 61 4340 5398 8626 -391 158 -874 O \nATOM 479 CB LEU A 61 -8.399 -21.170 -57.620 1.00 37.98 C \nANISOU 479 CB LEU A 61 3154 3950 7328 -378 111 -781 C \nATOM 480 CG LEU A 61 -8.797 -20.847 -56.195 1.00 38.55 C \nANISOU 480 CG LEU A 61 3234 3995 7419 -366 64 -759 C \nATOM 481 CD1 LEU A 61 -8.786 -19.336 -55.993 1.00 36.18 C \nANISOU 481 CD1 LEU A 61 2972 3636 7140 -322 42 -730 C \nATOM 482 CD2 LEU A 61 -10.184 -21.373 -55.895 1.00 40.12 C \nANISOU 482 CD2 LEU A 61 3359 4238 7647 -339 18 -790 C \nATOM 483 N LEU A 62 -7.102 -22.872 -60.054 1.00 38.39 N \nANISOU 483 N LEU A 62 3204 4078 7303 -466 224 -822 N \nATOM 484 CA LEU A 62 -7.015 -23.048 -61.526 1.00 46.23 C \nANISOU 484 CA LEU A 62 4178 5103 8284 -467 260 -847 C \nATOM 485 C LEU A 62 -7.046 -24.519 -61.959 1.00 49.07 C \nANISOU 485 C LEU A 62 4501 5534 8609 -532 286 -879 C \nATOM 486 O LEU A 62 -6.958 -24.816 -63.134 1.00 43.42 O \nANISOU 486 O LEU A 62 3768 4853 7878 -543 317 -901 O \nATOM 487 CB LEU A 62 -5.716 -22.391 -62.040 1.00 43.82 C \nANISOU 487 CB LEU A 62 3953 4747 7949 -471 303 -813 C \nATOM 488 CG LEU A 62 -5.549 -20.921 -61.807 1.00 39.28 C \nANISOU 488 CG LEU A 62 3412 4118 7396 -414 286 -781 C \nATOM 489 CD1 LEU A 62 -4.152 -20.518 -62.132 1.00 37.53 C \nANISOU 489 CD1 LEU A 62 3269 3859 7133 -422 329 -745 C \nATOM 490 CD2 LEU A 62 -6.533 -20.188 -62.677 1.00 40.11 C \nANISOU 490 CD2 LEU A 62 3463 4240 7539 -361 266 -805 C \nATOM 491 N GLY A 63 -7.026 -25.426 -60.985 1.00 55.29 N \nANISOU 491 N GLY A 63 5285 6344 9378 -582 276 -879 N \nATOM 492 CA GLY A 63 -7.124 -26.850 -61.247 1.00 57.27 C \nANISOU 492 CA GLY A 63 5495 6674 9590 -653 295 -910 C \nATOM 493 C GLY A 63 -5.849 -27.469 -61.780 1.00 60.84 C \nANISOU 493 C GLY A 63 6021 7114 9982 -731 352 -899 C \nATOM 494 O GLY A 63 -5.877 -28.247 -62.722 1.00 57.30 O \nANISOU 494 O GLY A 63 5542 6725 9505 -773 381 -927 O \nATOM 495 N ASN A 64 -4.714 -27.116 -61.200 1.00 64.41 N \nANISOU 495 N ASN A 64 6573 7489 10411 -749 370 -857 N \nATOM 496 CA ASN A 64 -3.471 -27.804 -61.536 1.00 65.85 C \nANISOU 496 CA ASN A 64 6842 7651 10528 -826 423 -845 C \nATOM 497 C ASN A 64 -3.747 -29.320 -61.430 1.00 63.41 C \nANISOU 497 C ASN A 64 6493 7423 10178 -920 430 -876 C \nATOM 498 O ASN A 64 -4.245 -29.763 -60.416 1.00 57.59 O \nANISOU 498 O ASN A 64 5720 6715 9446 -941 400 -881 O \nATOM 499 CB ASN A 64 -2.353 -27.368 -60.567 1.00 64.44 C \nANISOU 499 CB ASN A 64 6773 7383 10327 -830 432 -799 C \nATOM 500 CG ASN A 64 -1.025 -28.082 -60.810 1.00 61.36 C \nANISOU 500 CG ASN A 64 6492 6959 9865 -906 485 -784 C \nATOM 501 OD1 ASN A 64 -0.964 -29.292 -60.867 1.00 67.28 O \nANISOU 501 OD1 ASN A 64 7241 7752 10570 -994 503 -804 O \nATOM 502 ND2 ASN A 64 0.052 -27.322 -60.889 1.00 59.44 N \nANISOU 502 ND2 ASN A 64 6345 6637 9603 -871 511 -747 N \nATOM 503 N PRO A 65 -3.357 -30.103 -62.454 1.00 62.05 N \nANISOU 503 N PRO A 65 6330 7287 9958 -982 472 -894 N \nATOM 504 CA PRO A 65 -3.613 -31.533 -62.597 1.00 66.49 C \nANISOU 504 CA PRO A 65 6849 7942 10473 -1080 484 -927 C \nATOM 505 C PRO A 65 -3.224 -32.414 -61.403 1.00 71.44 C \nANISOU 505 C PRO A 65 7519 8571 11055 -1168 482 -917 C \nATOM 506 O PRO A 65 -3.774 -33.516 -61.227 1.00 77.49 O \nANISOU 506 O PRO A 65 8217 9434 11792 -1239 475 -947 O \nATOM 507 CB PRO A 65 -2.773 -31.926 -63.803 1.00 64.14 C \nANISOU 507 CB PRO A 65 6609 7639 10123 -1134 538 -928 C \nATOM 508 CG PRO A 65 -2.644 -30.705 -64.599 1.00 59.21 C \nANISOU 508 CG PRO A 65 5999 6961 9538 -1040 543 -914 C \nATOM 509 CD PRO A 65 -2.558 -29.596 -63.580 1.00 62.75 C \nANISOU 509 CD PRO A 65 6480 7331 10031 -964 512 -880 C \nATOM 510 N MET A 66 -2.314 -31.917 -60.576 1.00 69.01 N \nANISOU 510 N MET A 66 7316 8164 10739 -1163 487 -877 N \nATOM 511 CA MET A 66 -1.859 -32.634 -59.396 1.00 68.48 C \nANISOU 511 CA MET A 66 7305 8085 10630 -1242 487 -865 C \nATOM 512 C MET A 66 -2.647 -32.265 -58.159 1.00 63.34 C \nANISOU 512 C MET A 66 6596 7444 10027 -1196 433 -860 C \nATOM 513 O MET A 66 -2.396 -32.746 -57.076 1.00 72.96 O \nANISOU 513 O MET A 66 7848 8654 11218 -1252 425 -850 O \nATOM 514 CB MET A 66 -0.370 -32.380 -59.222 1.00 76.72 C \nANISOU 514 CB MET A 66 8506 9016 11629 -1264 526 -825 C \nATOM 515 CG MET A 66 0.393 -32.774 -60.507 1.00 89.60 C \nANISOU 515 CG MET A 66 10199 10637 13207 -1309 579 -829 C \nATOM 516 SD MET A 66 2.158 -33.079 -60.333 1.00115.98 S \nANISOU 516 SD MET A 66 13738 13867 16463 -1375 633 -792 S \nATOM 517 CE MET A 66 2.813 -31.402 -60.559 1.00123.35 C \nANISOU 517 CE MET A 66 14733 14696 17439 -1234 637 -750 C \nATOM 518 N CYS A 67 -3.658 -31.440 -58.337 1.00 67.35 N \nANISOU 518 N CYS A 67 7014 7971 10604 -1096 395 -870 N \nATOM 519 CA CYS A 67 -4.477 -30.926 -57.244 1.00 60.23 C \nANISOU 519 CA CYS A 67 6061 7070 9754 -1038 341 -863 C \nATOM 520 C CYS A 67 -5.900 -31.477 -57.347 1.00 57.63 C \nANISOU 520 C CYS A 67 5594 6855 9449 -1022 304 -904 C \nATOM 521 O CYS A 67 -6.788 -31.060 -56.611 1.00 51.53 O \nANISOU 521 O CYS A 67 4764 6094 8722 -961 255 -903 O \nATOM 522 CB CYS A 67 -4.470 -29.373 -57.303 1.00 56.76 C \nANISOU 522 CB CYS A 67 5645 6549 9373 -928 324 -836 C \nATOM 523 SG CYS A 67 -2.824 -28.618 -57.128 1.00 61.86 S \nANISOU 523 SG CYS A 67 6444 7073 9989 -927 364 -787 S \nATOM 524 N ASP A 68 -6.077 -32.462 -58.208 1.00 63.28 N \nANISOU 524 N ASP A 68 6260 7658 10126 -1080 329 -937 N \nATOM 525 CA ASP A 68 -7.399 -33.083 -58.428 1.00 71.76 C \nANISOU 525 CA ASP A 68 7198 8857 11212 -1064 299 -980 C \nATOM 526 C ASP A 68 -8.198 -33.447 -57.188 1.00 73.29 C \nANISOU 526 C ASP A 68 7327 9104 11415 -1059 251 -984 C \nATOM 527 O ASP A 68 -9.424 -33.445 -57.230 1.00 70.50 O \nANISOU 527 O ASP A 68 6867 8824 11095 -992 212 -1010 O \nATOM 528 CB ASP A 68 -7.277 -34.307 -59.321 1.00 78.87 C \nANISOU 528 CB ASP A 68 8063 9853 12049 -1157 337 -1013 C \nATOM 529 CG ASP A 68 -7.439 -33.966 -60.779 1.00 79.49 C \nANISOU 529 CG ASP A 68 8116 9943 12143 -1114 360 -1034 C \nATOM 530 OD1 ASP A 68 -6.404 -33.797 -61.464 1.00 82.21 O \nANISOU 530 OD1 ASP A 68 8551 10224 12462 -1148 404 -1017 O \nATOM 531 OD2 ASP A 68 -8.599 -33.867 -61.235 1.00 84.84 O \nANISOU 531 OD2 ASP A 68 8685 10694 12856 -1043 333 -1067 O \nATOM 532 N GLU A 69 -7.521 -33.753 -56.089 1.00 75.05 N \nANISOU 532 N GLU A 69 7617 9292 11607 -1126 252 -958 N \nATOM 533 CA GLU A 69 -8.230 -34.068 -54.852 1.00 72.76 C \nANISOU 533 CA GLU A 69 7270 9051 11324 -1124 205 -957 C \nATOM 534 C GLU A 69 -9.051 -32.920 -54.315 1.00 76.33 C \nANISOU 534 C GLU A 69 7694 9457 11852 -1001 153 -943 C \nATOM 535 O GLU A 69 -9.774 -33.065 -53.324 1.00 67.01 O \nANISOU 535 O GLU A 69 6461 8315 10684 -981 108 -942 O \nATOM 536 CB GLU A 69 -7.254 -34.546 -53.780 1.00 76.02 C \nANISOU 536 CB GLU A 69 7774 9424 11687 -1223 220 -930 C \nATOM 537 CG GLU A 69 -6.059 -33.659 -53.535 1.00 80.19 C \nANISOU 537 CG GLU A 69 8439 9808 12221 -1213 244 -889 C \nATOM 538 CD GLU A 69 -5.184 -34.156 -52.387 1.00 92.21 C \nANISOU 538 CD GLU A 69 10049 11293 13692 -1305 255 -865 C \nATOM 539 OE1 GLU A 69 -5.718 -34.475 -51.276 1.00 74.16 O \nANISOU 539 OE1 GLU A 69 7719 9051 11407 -1319 217 -864 O \nATOM 540 OE2 GLU A 69 -3.951 -34.240 -52.629 1.00101.36 O \nANISOU 540 OE2 GLU A 69 11326 12379 14806 -1361 302 -849 O \nATOM 541 N PHE A 70 -8.889 -31.747 -54.936 1.00 86.21 N \nANISOU 541 N PHE A 70 8986 10620 13148 -922 158 -930 N \nATOM 542 CA PHE A 70 -9.576 -30.516 -54.480 1.00 80.85 C \nANISOU 542 CA PHE A 70 8299 9883 12538 -812 111 -913 C \nATOM 543 C PHE A 70 -10.478 -30.003 -55.582 1.00 83.94 C \nANISOU 543 C PHE A 70 8626 10296 12970 -723 101 -941 C \nATOM 544 O PHE A 70 -10.797 -28.802 -55.638 1.00 83.07 O \nANISOU 544 O PHE A 70 8534 10116 12911 -638 78 -927 O \nATOM 545 CB PHE A 70 -8.573 -29.428 -54.045 1.00 76.85 C \nANISOU 545 CB PHE A 70 7905 9248 12044 -798 122 -868 C \nATOM 546 CG PHE A 70 -7.486 -29.931 -53.123 1.00 67.09 C \nANISOU 546 CG PHE A 70 6752 7979 10759 -888 144 -842 C \nATOM 547 CD1 PHE A 70 -7.793 -30.342 -51.816 1.00 60.56 C \nANISOU 547 CD1 PHE A 70 5908 7178 9926 -915 110 -833 C \nATOM 548 CD2 PHE A 70 -6.159 -30.011 -53.573 1.00 62.31 C \nANISOU 548 CD2 PHE A 70 6246 7318 10111 -944 198 -826 C \nATOM 549 CE1 PHE A 70 -6.789 -30.803 -50.950 1.00 59.80 C \nANISOU 549 CE1 PHE A 70 5893 7049 9781 -1000 130 -811 C \nATOM 550 CE2 PHE A 70 -5.161 -30.495 -52.734 1.00 62.29 C \nANISOU 550 CE2 PHE A 70 6329 7280 10059 -1024 220 -805 C \nATOM 551 CZ PHE A 70 -5.483 -30.892 -51.412 1.00 61.54 C \nANISOU 551 CZ PHE A 70 6216 7210 9958 -1055 186 -798 C \nATOM 552 N ILE A 71 -10.890 -30.926 -56.455 1.00 84.95 N \nANISOU 552 N ILE A 71 8680 10526 13072 -749 118 -981 N \nATOM 553 CA ILE A 71 -11.755 -30.592 -57.554 1.00 83.54 C \nANISOU 553 CA ILE A 71 8436 10381 12926 -671 112 -1014 C \nATOM 554 C ILE A 71 -13.119 -30.103 -57.019 1.00 87.10 C \nANISOU 554 C ILE A 71 8822 10846 13426 -565 50 -1023 C \nATOM 555 O ILE A 71 -13.741 -29.262 -57.640 1.00 89.58 O \nANISOU 555 O ILE A 71 9124 11129 13783 -478 35 -1033 O \nATOM 556 CB ILE A 71 -11.935 -31.771 -58.538 1.00 88.90 C \nANISOU 556 CB ILE A 71 9041 11178 13558 -724 143 -1057 C \nATOM 557 CG1 ILE A 71 -12.635 -31.312 -59.818 1.00 89.04 C \nANISOU 557 CG1 ILE A 71 9010 11216 13607 -644 146 -1089 C \nATOM 558 CG2 ILE A 71 -12.761 -32.888 -57.900 1.00 97.13 C \nANISOU 558 CG2 ILE A 71 9985 12348 14573 -747 115 -1082 C \nATOM 559 CD1 ILE A 71 -12.580 -32.336 -60.938 1.00 90.94 C \nANISOU 559 CD1 ILE A 71 9195 11560 13799 -704 187 -1128 C \nATOM 560 N ASN A 72 -13.583 -30.625 -55.882 1.00 84.62 N \nANISOU 560 N ASN A 72 8470 10578 13104 -574 14 -1019 N \nATOM 561 CA ASN A 72 -14.886 -30.214 -55.326 1.00 86.61 C \nANISOU 561 CA ASN A 72 8667 10843 13399 -471 -47 -1025 C \nATOM 562 C ASN A 72 -14.964 -30.364 -53.823 1.00 86.19 C \nANISOU 562 C ASN A 72 8622 10785 13343 -488 -85 -998 C \nATOM 563 O ASN A 72 -15.655 -31.210 -53.284 1.00 93.92 O \nANISOU 563 O ASN A 72 9522 11862 14300 -490 -112 -1014 O \nATOM 564 CB ASN A 72 -16.041 -30.908 -56.042 1.00 86.21 C \nANISOU 564 CB ASN A 72 8500 10914 13342 -420 -59 -1076 C \nATOM 565 CG ASN A 72 -16.816 -29.950 -56.907 1.00 89.59 C \nANISOU 565 CG ASN A 72 8923 11300 13819 -309 -73 -1094 C \nATOM 566 OD1 ASN A 72 -17.317 -28.920 -56.430 1.00108.30 O \nANISOU 566 OD1 ASN A 72 11329 13587 16234 -230 -113 -1075 O \nATOM 567 ND2 ASN A 72 -16.916 -30.258 -58.183 1.00 91.89 N \nANISOU 567 ND2 ASN A 72 9173 11644 14096 -307 -41 -1130 N \nATOM 568 N VAL A 73 -14.214 -29.501 -53.164 1.00 89.20 N \nANISOU 568 N VAL A 73 9098 11052 13741 -500 -86 -955 N \nATOM 569 CA VAL A 73 -14.118 -29.509 -51.722 1.00 82.56 C \nANISOU 569 CA VAL A 73 8282 10190 12897 -522 -118 -923 C \nATOM 570 C VAL A 73 -15.429 -29.016 -51.081 1.00 78.32 C \nANISOU 570 C VAL A 73 7700 9655 12401 -420 -184 -923 C \nATOM 571 O VAL A 73 -16.202 -28.298 -51.711 1.00 67.51 O \nANISOU 571 O VAL A 73 6318 8261 11072 -328 -203 -937 O \nATOM 572 CB VAL A 73 -12.913 -28.651 -51.233 1.00 80.74 C \nANISOU 572 CB VAL A 73 8168 9837 12670 -558 -98 -878 C \nATOM 573 CG1 VAL A 73 -11.606 -29.172 -51.808 1.00 82.94 C \nANISOU 573 CG1 VAL A 73 8502 10108 12902 -653 -34 -877 C \nATOM 574 CG2 VAL A 73 -13.096 -27.168 -51.553 1.00 77.31 C \nANISOU 574 CG2 VAL A 73 7780 9304 12288 -473 -114 -861 C \nATOM 575 N PRO A 74 -15.647 -29.366 -49.807 1.00 80.98 N \nANISOU 575 N PRO A 74 8024 10016 12728 -437 -219 -905 N \nATOM 576 CA PRO A 74 -16.752 -28.847 -49.020 1.00 80.10 C \nANISOU 576 CA PRO A 74 7891 9892 12652 -346 -284 -895 C \nATOM 577 C PRO A 74 -16.325 -27.756 -48.073 1.00 82.69 C \nANISOU 577 C PRO A 74 8310 10102 13007 -342 -305 -848 C \nATOM 578 O PRO A 74 -15.184 -27.314 -48.114 1.00 84.95 O \nANISOU 578 O PRO A 74 8676 10316 13287 -398 -268 -825 O \nATOM 579 CB PRO A 74 -17.212 -30.076 -48.232 1.00 86.45 C \nANISOU 579 CB PRO A 74 8614 10817 13418 -379 -306 -906 C \nATOM 580 CG PRO A 74 -15.987 -30.915 -48.071 1.00 86.55 C \nANISOU 580 CG PRO A 74 8653 10855 13376 -512 -257 -900 C \nATOM 581 CD PRO A 74 -14.991 -30.500 -49.131 1.00 87.25 C \nANISOU 581 CD PRO A 74 8810 10875 13466 -547 -200 -901 C \nATOM 582 N GLU A 75 -17.257 -27.326 -47.227 1.00 86.70 N \nANISOU 582 N GLU A 75 8807 10594 13541 -273 -364 -834 N \nATOM 583 CA GLU A 75 -17.052 -26.178 -46.345 1.00 84.61 C \nANISOU 583 CA GLU A 75 8624 10219 13303 -258 -392 -791 C \nATOM 584 C GLU A 75 -15.837 -26.333 -45.439 1.00 83.01 C \nANISOU 584 C GLU A 75 8479 9988 13072 -357 -369 -758 C \nATOM 585 O GLU A 75 -15.472 -27.442 -45.089 1.00 97.18 O \nANISOU 585 O GLU A 75 10241 11857 14825 -429 -352 -765 O \nATOM 586 CB GLU A 75 -18.308 -25.982 -45.518 1.00 83.48 C \nANISOU 586 CB GLU A 75 8451 10086 13182 -178 -461 -784 C \nATOM 587 CG GLU A 75 -18.262 -24.807 -44.565 1.00 91.48 C \nANISOU 587 CG GLU A 75 9544 10993 14220 -160 -497 -739 C \nATOM 588 CD GLU A 75 -19.584 -24.601 -43.857 1.00101.19 C \nANISOU 588 CD GLU A 75 10751 12227 15470 -73 -567 -734 C \nATOM 589 OE1 GLU A 75 -20.603 -25.193 -44.299 1.00 98.84 O \nANISOU 589 OE1 GLU A 75 10380 12004 15172 -5 -586 -767 O \nATOM 590 OE2 GLU A 75 -19.591 -23.823 -42.868 1.00116.84 O \nANISOU 590 OE2 GLU A 75 12791 14137 17464 -71 -602 -695 O \nATOM 591 N TRP A 76 -15.227 -25.216 -45.041 1.00 75.90 N \nANISOU 591 N TRP A 76 7665 8984 12189 -360 -369 -721 N \nATOM 592 CA TRP A 76 -14.026 -25.261 -44.210 1.00 70.83 C \nANISOU 592 CA TRP A 76 7087 8308 11519 -445 -345 -690 C \nATOM 593 C TRP A 76 -13.934 -24.144 -43.166 1.00 74.52 C \nANISOU 593 C TRP A 76 7619 8691 12007 -427 -379 -648 C \nATOM 594 O TRP A 76 -14.480 -23.065 -43.350 1.00 84.77 O \nANISOU 594 O TRP A 76 8938 9932 13340 -361 -407 -638 O \nATOM 595 CB TRP A 76 -12.764 -25.240 -45.091 1.00 70.33 C \nANISOU 595 CB TRP A 76 7075 8214 11434 -498 -277 -693 C \nATOM 596 CG TRP A 76 -12.524 -23.874 -45.779 1.00 65.53 C \nANISOU 596 CG TRP A 76 6522 7520 10856 -448 -268 -679 C \nATOM 597 CD1 TRP A 76 -12.023 -22.770 -45.210 1.00 58.45 C \nANISOU 597 CD1 TRP A 76 5695 6543 9970 -442 -275 -643 C \nATOM 598 CD2 TRP A 76 -12.805 -23.530 -47.143 1.00 54.58 C \nANISOU 598 CD2 TRP A 76 5117 6131 9489 -402 -249 -704 C \nATOM 599 NE1 TRP A 76 -11.990 -21.759 -46.113 1.00 56.48 N \nANISOU 599 NE1 TRP A 76 5471 6247 9743 -398 -264 -642 N \nATOM 600 CE2 TRP A 76 -12.457 -22.209 -47.314 1.00 56.28 C \nANISOU 600 CE2 TRP A 76 5395 6265 9725 -373 -248 -679 C \nATOM 601 CE3 TRP A 76 -13.321 -24.223 -48.221 1.00 49.71 C \nANISOU 601 CE3 TRP A 76 4437 5580 8871 -385 -234 -745 C \nATOM 602 CZ2 TRP A 76 -12.589 -21.561 -48.534 1.00 56.17 C \nANISOU 602 CZ2 TRP A 76 5383 6230 9729 -331 -231 -694 C \nATOM 603 CZ3 TRP A 76 -13.448 -23.600 -49.416 1.00 50.61 C \nANISOU 603 CZ3 TRP A 76 4554 5669 9005 -341 -217 -760 C \nATOM 604 CH2 TRP A 76 -13.099 -22.283 -49.570 1.00 52.81 C \nANISOU 604 CH2 TRP A 76 4897 5864 9304 -314 -216 -735 C \nATOM 605 N SER A 77 -13.171 -24.403 -42.101 1.00 71.33 N \nANISOU 605 N SER A 77 7252 8278 11574 -495 -373 -623 N \nATOM 606 CA SER A 77 -12.958 -23.447 -41.038 1.00 72.43 C \nANISOU 606 CA SER A 77 7450 8347 11722 -492 -401 -582 C \nATOM 607 C SER A 77 -11.756 -22.525 -41.325 1.00 67.20 C \nANISOU 607 C SER A 77 6872 7608 11055 -512 -359 -560 C \nATOM 608 O SER A 77 -11.877 -21.309 -41.218 1.00 70.95 O \nANISOU 608 O SER A 77 7383 8021 11553 -472 -379 -538 O \nATOM 609 CB SER A 77 -12.791 -24.186 -39.706 1.00 78.18 C \nANISOU 609 CB SER A 77 8173 9110 12421 -551 -418 -567 C \nATOM 610 OG SER A 77 -11.686 -25.080 -39.716 1.00 81.24 O \nANISOU 610 OG SER A 77 8582 9523 12762 -640 -365 -574 O \nATOM 611 N TYR A 78 -10.632 -23.103 -41.738 1.00 64.36 N \nANISOU 611 N TYR A 78 6540 7255 10659 -573 -300 -568 N \nATOM 612 CA TYR A 78 -9.471 -22.326 -42.235 1.00 64.38 C \nANISOU 612 CA TYR A 78 6617 7195 10651 -581 -254 -551 C \nATOM 613 C TYR A 78 -8.712 -23.109 -43.294 1.00 59.79 C \nANISOU 613 C TYR A 78 6041 6637 10039 -619 -193 -576 C \nATOM 614 O TYR A 78 -9.100 -24.197 -43.634 1.00 64.05 O \nANISOU 614 O TYR A 78 6527 7242 10567 -644 -188 -605 O \nATOM 615 CB TYR A 78 -8.533 -21.930 -41.094 1.00 69.85 C \nANISOU 615 CB TYR A 78 7380 7843 11318 -619 -248 -516 C \nATOM 616 CG TYR A 78 -7.954 -23.121 -40.333 1.00 73.98 C \nANISOU 616 CG TYR A 78 7915 8399 11796 -699 -230 -519 C \nATOM 617 CD1 TYR A 78 -6.638 -23.511 -40.548 1.00 78.78 C \nANISOU 617 CD1 TYR A 78 8588 8986 12359 -753 -170 -518 C \nATOM 618 CD2 TYR A 78 -8.721 -23.839 -39.424 1.00 69.12 C \nANISOU 618 CD2 TYR A 78 7250 7833 11179 -720 -271 -523 C \nATOM 619 CE1 TYR A 78 -6.101 -24.584 -39.882 1.00 78.76 C \nANISOU 619 CE1 TYR A 78 8608 9008 12310 -832 -152 -522 C \nATOM 620 CE2 TYR A 78 -8.198 -24.902 -38.739 1.00 78.22 C \nANISOU 620 CE2 TYR A 78 8414 9020 12287 -800 -254 -526 C \nATOM 621 CZ TYR A 78 -6.887 -25.278 -38.978 1.00 84.91 C \nANISOU 621 CZ TYR A 78 9332 9841 13089 -860 -194 -527 C \nATOM 622 OH TYR A 78 -6.351 -26.331 -38.292 1.00 89.70 O \nANISOU 622 OH TYR A 78 9962 10476 13645 -947 -176 -531 O \nATOM 623 N ILE A 79 -7.666 -22.520 -43.863 1.00 55.85 N \nANISOU 623 N ILE A 79 5606 6089 9526 -621 -149 -564 N \nATOM 624 CA ILE A 79 -6.946 -23.121 -44.971 1.00 49.94 C \nANISOU 624 CA ILE A 79 4872 5354 8750 -650 -92 -584 C \nATOM 625 C ILE A 79 -5.500 -23.227 -44.569 1.00 56.21 C \nANISOU 625 C ILE A 79 5756 6106 9495 -701 -46 -563 C \nATOM 626 O ILE A 79 -4.940 -22.331 -43.981 1.00 67.96 O \nANISOU 626 O ILE A 79 7298 7543 10980 -683 -48 -532 O \nATOM 627 CB ILE A 79 -7.067 -22.293 -46.276 1.00 51.42 C \nANISOU 627 CB ILE A 79 5052 5522 8962 -591 -77 -592 C \nATOM 628 CG1 ILE A 79 -8.543 -22.289 -46.795 1.00 51.56 C \nANISOU 628 CG1 ILE A 79 4985 5581 9025 -537 -119 -619 C \nATOM 629 CG2 ILE A 79 -6.142 -22.842 -47.375 1.00 50.58 C \nANISOU 629 CG2 ILE A 79 4976 5421 8821 -623 -15 -606 C \nATOM 630 CD1 ILE A 79 -8.821 -21.246 -47.857 1.00 49.26 C \nANISOU 630 CD1 ILE A 79 4690 5262 8763 -475 -117 -623 C \nATOM 631 N VAL A 80 -4.903 -24.361 -44.878 1.00 56.68 N \nANISOU 631 N VAL A 80 5835 6190 9512 -766 -5 -580 N \nATOM 632 CA VAL A 80 -3.527 -24.573 -44.504 1.00 53.74 C \nANISOU 632 CA VAL A 80 5559 5772 9085 -816 40 -563 C \nATOM 633 C VAL A 80 -2.747 -24.881 -45.754 1.00 48.98 C \nANISOU 633 C VAL A 80 4996 5160 8453 -829 96 -575 C \nATOM 634 O VAL A 80 -3.151 -25.731 -46.538 1.00 40.49 O \nANISOU 634 O VAL A 80 3875 4137 7374 -858 107 -605 O \nATOM 635 CB VAL A 80 -3.374 -25.692 -43.426 1.00 59.73 C \nANISOU 635 CB VAL A 80 6332 6558 9806 -900 36 -566 C \nATOM 636 CG1 VAL A 80 -4.617 -26.578 -43.377 1.00 59.03 C \nANISOU 636 CG1 VAL A 80 6140 6556 9734 -920 -1 -595 C \nATOM 637 CG2 VAL A 80 -2.094 -26.507 -43.619 1.00 54.63 C \nANISOU 637 CG2 VAL A 80 5777 5887 9092 -974 97 -569 C \nATOM 638 N GLU A 81 -1.626 -24.179 -45.894 1.00 46.50 N \nANISOU 638 N GLU A 81 4768 4783 8116 -807 131 -551 N \nATOM 639 CA GLU A 81 -0.815 -24.220 -47.074 1.00 53.06 C \nANISOU 639 CA GLU A 81 5647 5595 8920 -802 184 -555 C \nATOM 640 C GLU A 81 0.577 -24.384 -46.585 1.00 56.55 C \nANISOU 640 C GLU A 81 6205 5980 9302 -834 226 -534 C \nATOM 641 O GLU A 81 0.863 -24.069 -45.425 1.00 72.75 O \nANISOU 641 O GLU A 81 8293 8005 11345 -835 211 -513 O \nATOM 642 CB GLU A 81 -0.956 -22.891 -47.814 1.00 56.46 C \nANISOU 642 CB GLU A 81 6058 6008 9387 -715 178 -542 C \nATOM 643 CG GLU A 81 -0.541 -22.915 -49.278 1.00 53.56 C \nANISOU 643 CG GLU A 81 5703 5641 9007 -701 220 -554 C \nATOM 644 CD GLU A 81 -0.714 -21.562 -49.937 1.00 47.54 C \nANISOU 644 CD GLU A 81 4918 4868 8278 -620 211 -541 C \nATOM 645 OE1 GLU A 81 -0.641 -20.574 -49.187 1.00 40.79 O \nANISOU 645 OE1 GLU A 81 4076 3989 7434 -582 188 -514 O \nATOM 646 OE2 GLU A 81 -0.830 -21.491 -51.185 1.00 42.65 O \nANISOU 646 OE2 GLU A 81 4274 4264 7665 -600 230 -556 O \nATOM 647 N LYS A 82 1.446 -24.928 -47.392 1.00 58.93 N \nANISOU 647 N LYS A 82 6571 6262 9557 -862 278 -540 N \nATOM 648 CA LYS A 82 2.817 -25.070 -46.949 1.00 72.32 C \nANISOU 648 CA LYS A 82 8393 7895 11190 -884 320 -520 C \nATOM 649 C LYS A 82 3.492 -23.772 -47.284 1.00 74.24 C \nANISOU 649 C LYS A 82 8676 8096 11436 -794 334 -492 C \nATOM 650 O LYS A 82 2.885 -22.891 -47.904 1.00 84.02 O \nANISOU 650 O LYS A 82 9845 9357 12721 -731 314 -491 O \nATOM 651 CB LYS A 82 3.507 -26.260 -47.619 1.00 81.91 C \nANISOU 651 CB LYS A 82 9675 9101 12344 -959 370 -538 C \nATOM 652 CG LYS A 82 2.657 -27.536 -47.499 1.00 86.38 C \nANISOU 652 CG LYS A 82 10175 9736 12911 -1051 353 -570 C \nATOM 653 CD LYS A 82 3.360 -28.734 -46.877 1.00 89.80 C \nANISOU 653 CD LYS A 82 10696 10153 13272 -1158 380 -576 C \nATOM 654 CE LYS A 82 2.334 -29.758 -46.372 1.00 89.84 C \nANISOU 654 CE LYS A 82 10609 10242 13283 -1238 347 -603 C \nATOM 655 NZ LYS A 82 1.670 -29.337 -45.088 1.00 89.87 N \nANISOU 655 NZ LYS A 82 10559 10262 13325 -1215 295 -592 N \nATOM 656 N ALA A 83 4.740 -23.636 -46.879 1.00 77.01 N \nANISOU 656 N ALA A 83 9140 8389 11732 -786 370 -470 N \nATOM 657 CA ALA A 83 5.482 -22.411 -47.160 1.00 78.31 C \nANISOU 657 CA ALA A 83 9344 8523 11888 -696 387 -441 C \nATOM 658 C ALA A 83 5.863 -22.349 -48.648 1.00 78.77 C \nANISOU 658 C ALA A 83 9416 8579 11933 -666 424 -446 C \nATOM 659 O ALA A 83 5.738 -21.290 -49.274 1.00 71.15 O \nANISOU 659 O ALA A 83 8410 7630 10994 -592 418 -434 O \nATOM 660 CB ALA A 83 6.715 -22.339 -46.292 1.00 82.82 C \nANISOU 660 CB ALA A 83 10033 9035 12398 -688 415 -419 C \nATOM 661 N ASN A 84 6.314 -23.477 -49.206 1.00 81.27 N \nANISOU 661 N ASN A 84 9791 8880 12207 -728 462 -462 N \nATOM 662 CA ASN A 84 6.643 -23.578 -50.638 1.00 88.11 C \nANISOU 662 CA ASN A 84 10673 9747 13058 -712 498 -468 C \nATOM 663 C ASN A 84 5.992 -24.788 -51.320 1.00 86.62 C \nANISOU 663 C ASN A 84 10440 9598 12873 -796 501 -503 C \nATOM 664 O ASN A 84 6.662 -25.801 -51.574 1.00 93.94 O \nANISOU 664 O ASN A 84 11451 10499 13742 -863 540 -511 O \nATOM 665 CB ASN A 84 8.159 -23.660 -50.848 1.00 99.95 C \nANISOU 665 CB ASN A 84 12318 11178 14481 -693 553 -447 C \nATOM 666 CG ASN A 84 8.876 -22.356 -50.553 1.00101.26 C \nANISOU 666 CG ASN A 84 12519 11320 14636 -590 558 -412 C \nATOM 667 OD1 ASN A 84 8.382 -21.500 -49.832 1.00109.47 O \nANISOU 667 OD1 ASN A 84 13494 12383 15715 -552 520 -402 O \nATOM 668 ND2 ASN A 84 10.061 -22.209 -51.117 1.00110.90 N \nANISOU 668 ND2 ASN A 84 13842 12496 15798 -544 604 -394 N \nATOM 669 N PRO A 85 4.680 -24.702 -51.599 1.00 81.09 N \nANISOU 669 N PRO A 85 9610 8963 12236 -795 461 -525 N \nATOM 670 CA PRO A 85 3.938 -25.785 -52.246 1.00 73.66 C \nANISOU 670 CA PRO A 85 8609 8078 11302 -866 460 -561 C \nATOM 671 C PRO A 85 4.548 -26.165 -53.554 1.00 71.71 C \nANISOU 671 C PRO A 85 8408 7822 11017 -879 507 -567 C \nATOM 672 O PRO A 85 4.902 -25.293 -54.348 1.00 74.50 O \nANISOU 672 O PRO A 85 8772 8159 11377 -806 522 -552 O \nATOM 673 CB PRO A 85 2.546 -25.180 -52.476 1.00 73.98 C \nANISOU 673 CB PRO A 85 8511 8178 11419 -818 410 -576 C \nATOM 674 CG PRO A 85 2.566 -23.805 -51.886 1.00 74.51 C \nANISOU 674 CG PRO A 85 8574 8218 11518 -736 384 -547 C \nATOM 675 CD PRO A 85 3.766 -23.715 -51.006 1.00 78.92 C \nANISOU 675 CD PRO A 85 9246 8714 12025 -739 408 -518 C \nATOM 676 N ALA A 86 4.678 -27.461 -53.787 1.00 75.69 N \nANISOU 676 N ALA A 86 8942 8341 11477 -975 530 -589 N \nATOM 677 CA ALA A 86 5.314 -27.942 -55.010 1.00 78.23 C \nANISOU 677 CA ALA A 86 9320 8651 11752 -1001 577 -595 C \nATOM 678 C ALA A 86 4.394 -27.801 -56.225 1.00 79.05 C \nANISOU 678 C ALA A 86 9311 8822 11901 -978 567 -619 C \nATOM 679 O ALA A 86 4.856 -27.779 -57.367 1.00 85.29 O \nANISOU 679 O ALA A 86 10134 9605 12669 -967 601 -618 O \nATOM 680 CB ALA A 86 5.751 -29.388 -54.846 1.00 81.05 C \nANISOU 680 CB ALA A 86 9750 9004 12040 -1124 606 -610 C \nATOM 681 N ASN A 87 3.096 -27.687 -55.980 1.00 69.72 N \nANISOU 681 N ASN A 87 8002 7708 10782 -966 520 -640 N \nATOM 682 CA ASN A 87 2.122 -27.638 -57.041 1.00 67.26 C \nANISOU 682 CA ASN A 87 7582 7464 10512 -945 507 -668 C \nATOM 683 C ASN A 87 1.404 -26.292 -57.108 1.00 70.42 C \nANISOU 683 C ASN A 87 7905 7868 10981 -842 470 -661 C \nATOM 684 O ASN A 87 0.283 -26.134 -56.646 1.00 68.35 O \nANISOU 684 O ASN A 87 7550 7648 10770 -823 424 -676 O \nATOM 685 CB ASN A 87 1.113 -28.752 -56.838 1.00 75.95 C \nANISOU 685 CB ASN A 87 8592 8647 11618 -1019 485 -706 C \nATOM 686 CG ASN A 87 1.765 -30.120 -56.825 1.00 70.63 C \nANISOU 686 CG ASN A 87 7989 7980 10869 -1137 521 -716 C \nATOM 687 OD1 ASN A 87 2.623 -30.423 -57.661 1.00 63.42 O \nANISOU 687 OD1 ASN A 87 7155 7037 9905 -1167 567 -712 O \nATOM 688 ND2 ASN A 87 1.322 -30.968 -55.905 1.00 69.58 N \nANISOU 688 ND2 ASN A 87 7825 7891 10723 -1208 501 -731 N \nATOM 689 N ASP A 88 2.068 -25.325 -57.724 1.00 70.49 N \nANISOU 689 N ASP A 88 7959 7837 10988 -776 491 -637 N \nATOM 690 CA ASP A 88 1.554 -23.988 -57.849 1.00 61.21 C \nANISOU 690 CA ASP A 88 6728 6663 9866 -686 461 -626 C \nATOM 691 C ASP A 88 1.083 -23.780 -59.290 1.00 61.48 C \nANISOU 691 C ASP A 88 6702 6737 9920 -660 470 -647 C \nATOM 692 O ASP A 88 0.249 -24.538 -59.839 1.00 56.82 O \nANISOU 692 O ASP A 88 6040 6205 9344 -697 464 -684 O \nATOM 693 CB ASP A 88 2.666 -23.007 -57.468 1.00 73.38 C \nANISOU 693 CB ASP A 88 8357 8141 11382 -630 477 -583 C \nATOM 694 CG ASP A 88 2.155 -21.592 -57.179 1.00 80.61 C \nANISOU 694 CG ASP A 88 9221 9060 12347 -551 440 -567 C \nATOM 695 OD1 ASP A 88 0.922 -21.338 -57.202 1.00 92.05 O \nANISOU 695 OD1 ASP A 88 10576 10549 13852 -538 398 -587 O \nATOM 696 OD2 ASP A 88 3.009 -20.730 -56.953 1.00 80.03 O \nANISOU 696 OD2 ASP A 88 9205 8951 12251 -502 453 -533 O \nATOM 697 N LEU A 89 1.603 -22.762 -59.942 1.00 55.22 N \nANISOU 697 N LEU A 89 5935 5921 9124 -597 486 -625 N \nATOM 698 CA LEU A 89 1.437 -22.666 -61.379 1.00 53.39 C \nANISOU 698 CA LEU A 89 5669 5721 8895 -582 506 -641 C \nATOM 699 C LEU A 89 2.360 -23.707 -62.019 1.00 50.38 C \nANISOU 699 C LEU A 89 5363 5328 8450 -643 558 -643 C \nATOM 700 O LEU A 89 3.350 -24.111 -61.466 1.00 54.28 O \nANISOU 700 O LEU A 89 5954 5774 8894 -672 582 -622 O \nATOM 701 CB LEU A 89 1.781 -21.245 -61.902 1.00 47.51 C \nANISOU 701 CB LEU A 89 4931 4961 8160 -500 509 -615 C \nATOM 702 CG LEU A 89 1.095 -20.103 -61.169 1.00 46.50 C \nANISOU 702 CG LEU A 89 4754 4834 8081 -447 462 -604 C \nATOM 703 CD1 LEU A 89 1.487 -18.760 -61.763 1.00 41.47 C \nANISOU 703 CD1 LEU A 89 4122 4193 7440 -378 469 -579 C \nATOM 704 CD2 LEU A 89 -0.448 -20.303 -61.172 1.00 43.06 C \nANISOU 704 CD2 LEU A 89 4215 4443 7705 -454 418 -643 C \nATOM 705 N CYS A 90 2.033 -24.084 -63.223 1.00 55.37 N \nANISOU 705 N CYS A 90 5953 6002 9081 -661 574 -669 N \nATOM 706 CA CYS A 90 2.825 -25.033 -63.967 1.00 60.82 C \nANISOU 706 CA CYS A 90 6712 6687 9711 -722 622 -672 C \nATOM 707 C CYS A 90 3.428 -24.381 -65.204 1.00 61.07 C \nANISOU 707 C CYS A 90 6772 6709 9724 -674 653 -656 C \nATOM 708 O CYS A 90 4.298 -24.928 -65.894 1.00 74.54 O \nANISOU 708 O CYS A 90 8555 8396 11372 -707 696 -648 O \nATOM 709 CB CYS A 90 1.920 -26.197 -64.353 1.00 62.18 C \nANISOU 709 CB CYS A 90 6807 6931 9888 -796 616 -718 C \nATOM 710 SG CYS A 90 0.428 -25.817 -65.285 1.00 70.46 S \nANISOU 710 SG CYS A 90 7708 8061 11002 -754 586 -759 S \nATOM 711 N TYR A 91 2.917 -23.219 -65.524 1.00 57.38 N \nANISOU 711 N TYR A 91 6240 6259 9302 -598 630 -653 N \nATOM 712 CA TYR A 91 3.583 -22.366 -66.443 1.00 59.22 C \nANISOU 712 CA TYR A 91 6505 6480 9516 -541 655 -629 C \nATOM 713 C TYR A 91 4.081 -21.203 -65.601 1.00 55.15 C \nANISOU 713 C TYR A 91 6023 5925 9004 -470 641 -590 C \nATOM 714 O TYR A 91 3.364 -20.730 -64.730 1.00 62.43 O \nANISOU 714 O TYR A 91 6894 6853 9972 -452 600 -593 O \nATOM 715 CB TYR A 91 2.599 -21.899 -67.503 1.00 57.43 C \nANISOU 715 CB TYR A 91 6176 6312 9334 -515 641 -658 C \nATOM 716 CG TYR A 91 3.111 -21.967 -68.916 1.00 56.27 C \nANISOU 716 CG TYR A 91 6049 6180 9151 -515 681 -657 C \nATOM 717 CD1 TYR A 91 3.252 -23.198 -69.584 1.00 49.98 C \nANISOU 717 CD1 TYR A 91 5271 5401 8318 -589 711 -679 C \nATOM 718 CD2 TYR A 91 3.387 -20.777 -69.633 1.00 48.12 C \nANISOU 718 CD2 TYR A 91 5011 5152 8119 -445 686 -636 C \nATOM 719 CE1 TYR A 91 3.694 -23.230 -70.910 1.00 53.69 C \nANISOU 719 CE1 TYR A 91 5759 5887 8755 -590 746 -678 C \nATOM 720 CE2 TYR A 91 3.817 -20.798 -70.988 1.00 54.47 C \nANISOU 720 CE2 TYR A 91 5828 5976 8891 -443 721 -635 C \nATOM 721 CZ TYR A 91 3.964 -22.006 -71.615 1.00 58.73 C \nANISOU 721 CZ TYR A 91 6390 6527 9398 -513 750 -656 C \nATOM 722 OH TYR A 91 4.414 -22.002 -72.921 1.00 69.93 O \nANISOU 722 OH TYR A 91 7826 7963 10782 -510 784 -652 O \nATOM 723 N PRO A 92 5.312 -20.753 -65.832 1.00 51.57 N \nANISOU 723 N PRO A 92 5659 5436 8500 -430 674 -552 N \nATOM 724 CA PRO A 92 5.796 -19.585 -65.087 1.00 50.97 C \nANISOU 724 CA PRO A 92 5606 5336 8421 -357 661 -515 C \nATOM 725 C PRO A 92 5.073 -18.278 -65.478 1.00 44.32 C \nANISOU 725 C PRO A 92 4674 4541 7626 -299 632 -516 C \nATOM 726 O PRO A 92 4.657 -18.116 -66.606 1.00 48.35 O \nANISOU 726 O PRO A 92 5134 5089 8149 -294 637 -533 O \nATOM 727 CB PRO A 92 7.285 -19.498 -65.477 1.00 50.16 C \nANISOU 727 CB PRO A 92 5619 5196 8246 -322 708 -478 C \nATOM 728 CG PRO A 92 7.367 -20.141 -66.827 1.00 51.28 C \nANISOU 728 CG PRO A 92 5766 5354 8365 -354 740 -494 C \nATOM 729 CD PRO A 92 6.162 -21.054 -66.986 1.00 55.64 C \nANISOU 729 CD PRO A 92 6236 5944 8962 -432 720 -543 C \nATOM 730 N GLY A 93 4.895 -17.376 -64.527 1.00 38.26 N \nANISOU 730 N GLY A 93 3887 3769 6879 -261 600 -498 N \nATOM 731 CA GLY A 93 4.121 -16.193 -64.780 1.00 39.91 C \nANISOU 731 CA GLY A 93 4015 4019 7129 -221 569 -501 C \nATOM 732 C GLY A 93 3.588 -15.563 -63.536 1.00 43.49 C \nANISOU 732 C GLY A 93 4440 4466 7616 -210 525 -493 C \nATOM 733 O GLY A 93 3.820 -16.040 -62.425 1.00 45.79 O \nANISOU 733 O GLY A 93 4772 4725 7903 -231 518 -486 O \nATOM 734 N ASN A 94 2.898 -14.441 -63.721 1.00 45.00 N \nANISOU 734 N ASN A 94 4568 4691 7839 -180 495 -494 N \nATOM 735 CA ASN A 94 2.342 -13.712 -62.609 1.00 51.33 C \nANISOU 735 CA ASN A 94 5344 5490 8671 -171 451 -485 C \nATOM 736 C ASN A 94 0.873 -14.080 -62.352 1.00 52.85 C \nANISOU 736 C ASN A 94 5468 5684 8926 -204 408 -523 C \nATOM 737 O ASN A 94 0.061 -14.207 -63.278 1.00 70.53 O \nANISOU 737 O ASN A 94 7656 7949 11195 -212 403 -555 O \nATOM 738 CB ASN A 94 2.434 -12.205 -62.926 1.00 60.33 C \nANISOU 738 CB ASN A 94 6457 6665 9799 -124 442 -461 C \nATOM 739 CG ASN A 94 2.137 -11.327 -61.719 1.00 74.23 C \nANISOU 739 CG ASN A 94 8206 8423 11573 -115 402 -442 C \nATOM 740 OD1 ASN A 94 1.202 -10.506 -61.762 1.00 69.04 O \nANISOU 740 OD1 ASN A 94 7496 7787 10948 -116 366 -451 O \nATOM 741 ND2 ASN A 94 2.895 -11.514 -60.626 1.00 81.60 N \nANISOU 741 ND2 ASN A 94 9195 9330 12481 -109 408 -418 N \nATOM 742 N PHE A 95 0.507 -14.185 -61.090 1.00 51.55 N \nANISOU 742 N PHE A 95 5306 5499 8784 -219 375 -519 N \nATOM 743 CA PHE A 95 -0.885 -14.211 -60.705 1.00 36.28 C \nANISOU 743 CA PHE A 95 3311 3568 6906 -233 326 -547 C \nATOM 744 C PHE A 95 -1.220 -12.862 -60.139 1.00 34.40 C \nANISOU 744 C PHE A 95 3058 3331 6680 -206 290 -526 C \nATOM 745 O PHE A 95 -0.922 -12.551 -58.975 1.00 38.15 O \nANISOU 745 O PHE A 95 3560 3788 7147 -205 274 -500 O \nATOM 746 CB PHE A 95 -1.148 -15.289 -59.702 1.00 40.50 C \nANISOU 746 CB PHE A 95 3852 4082 7454 -271 312 -559 C \nATOM 747 CG PHE A 95 -2.580 -15.709 -59.595 1.00 37.50 C \nANISOU 747 CG PHE A 95 3406 3716 7126 -285 271 -595 C \nATOM 748 CD1 PHE A 95 -2.931 -16.987 -59.827 1.00 46.25 C \nANISOU 748 CD1 PHE A 95 4492 4841 8241 -321 279 -627 C \nATOM 749 CD2 PHE A 95 -3.537 -14.860 -59.150 1.00 38.92 C \nANISOU 749 CD2 PHE A 95 3551 3892 7343 -263 223 -596 C \nATOM 750 CE1 PHE A 95 -4.262 -17.413 -59.729 1.00 49.79 C \nANISOU 750 CE1 PHE A 95 4875 5311 8734 -324 242 -662 C \nATOM 751 CE2 PHE A 95 -4.885 -15.260 -59.006 1.00 43.63 C \nANISOU 751 CE2 PHE A 95 4093 4497 7986 -265 183 -630 C \nATOM 752 CZ PHE A 95 -5.253 -16.549 -59.322 1.00 45.16 C \nANISOU 752 CZ PHE A 95 4257 4716 8187 -291 193 -664 C \nATOM 753 N ASN A 96 -1.876 -12.012 -60.949 1.00 33.07 N \nANISOU 753 N ASN A 96 2848 3187 6530 -188 276 -537 N \nATOM 754 CA ASN A 96 -2.246 -10.649 -60.555 1.00 33.01 C \nANISOU 754 CA ASN A 96 2829 3186 6528 -172 242 -518 C \nATOM 755 C ASN A 96 -3.071 -10.580 -59.253 1.00 33.89 C \nANISOU 755 C ASN A 96 2934 3270 6673 -186 191 -517 C \nATOM 756 O ASN A 96 -3.944 -11.399 -58.995 1.00 45.85 O \nANISOU 756 O ASN A 96 4425 4768 8225 -201 168 -546 O \nATOM 757 CB ASN A 96 -2.975 -9.976 -61.680 1.00 36.62 C \nANISOU 757 CB ASN A 96 3246 3668 7000 -163 235 -538 C \nATOM 758 CG ASN A 96 -2.848 -8.464 -61.629 1.00 41.93 C \nANISOU 758 CG ASN A 96 3919 4363 7650 -151 221 -510 C \nATOM 759 OD1 ASN A 96 -1.722 -7.922 -61.628 1.00 38.89 O \nANISOU 759 OD1 ASN A 96 3558 4004 7215 -134 248 -476 O \nATOM 760 ND2 ASN A 96 -3.997 -7.763 -61.528 1.00 45.59 N \nANISOU 760 ND2 ASN A 96 4359 4820 8144 -160 177 -524 N \nATOM 761 N ASP A 97 -2.760 -9.590 -58.419 1.00 36.12 N \nANISOU 761 N ASP A 97 3235 3552 6937 -180 173 -484 N \nATOM 762 CA ASP A 97 -3.362 -9.359 -57.099 1.00 31.35 C \nANISOU 762 CA ASP A 97 2633 2923 6354 -194 126 -474 C \nATOM 763 C ASP A 97 -3.624 -10.658 -56.385 1.00 32.58 C \nANISOU 763 C ASP A 97 2793 3052 6534 -213 118 -491 C \nATOM 764 O ASP A 97 -4.683 -10.878 -55.826 1.00 40.77 O \nANISOU 764 O ASP A 97 3809 4072 7611 -222 75 -507 O \nATOM 765 CB ASP A 97 -4.647 -8.539 -57.229 1.00 32.25 C \nANISOU 765 CB ASP A 97 2719 3033 6503 -196 79 -488 C \nATOM 766 CG ASP A 97 -4.409 -7.123 -57.672 1.00 36.04 C \nANISOU 766 CG ASP A 97 3198 3543 6950 -191 80 -467 C \nATOM 767 OD1 ASP A 97 -3.625 -6.358 -57.021 1.00 33.92 O \nANISOU 767 OD1 ASP A 97 2951 3294 6643 -191 83 -430 O \nATOM 768 OD2 ASP A 97 -4.986 -6.758 -58.670 1.00 45.68 O \nANISOU 768 OD2 ASP A 97 4399 4776 8183 -188 78 -488 O \nATOM 769 N TYR A 98 -2.618 -11.501 -56.332 1.00 33.33 N \nANISOU 769 N TYR A 98 2920 3144 6601 -220 158 -484 N \nATOM 770 CA TYR A 98 -2.679 -12.799 -55.615 1.00 33.40 C \nANISOU 770 CA TYR A 98 2938 3132 6619 -249 157 -497 C \nATOM 771 C TYR A 98 -3.002 -12.696 -54.204 1.00 35.19 C \nANISOU 771 C TYR A 98 3172 3340 6858 -262 117 -483 C \nATOM 772 O TYR A 98 -3.894 -13.380 -53.716 1.00 44.12 O \nANISOU 772 O TYR A 98 4277 4464 8024 -279 86 -503 O \nATOM 773 CB TYR A 98 -1.323 -13.560 -55.815 1.00 33.46 C \nANISOU 773 CB TYR A 98 2999 3135 6579 -258 212 -486 C \nATOM 774 CG TYR A 98 -1.405 -15.017 -55.464 1.00 40.52 C \nANISOU 774 CG TYR A 98 3900 4018 7476 -299 220 -508 C \nATOM 775 CD1 TYR A 98 -2.626 -15.737 -55.577 1.00 36.40 C \nANISOU 775 CD1 TYR A 98 3321 3511 6998 -319 191 -544 C \nATOM 776 CD2 TYR A 98 -0.271 -15.706 -54.988 1.00 41.16 C \nANISOU 776 CD2 TYR A 98 4048 4078 7513 -321 255 -492 C \nATOM 777 CE1 TYR A 98 -2.696 -17.080 -55.193 1.00 37.65 C \nANISOU 777 CE1 TYR A 98 3479 3674 7154 -363 196 -563 C \nATOM 778 CE2 TYR A 98 -0.352 -17.040 -54.633 1.00 44.18 C \nANISOU 778 CE2 TYR A 98 4438 4455 7893 -370 261 -512 C \nATOM 779 CZ TYR A 98 -1.554 -17.721 -54.778 1.00 41.44 C \nANISOU 779 CZ TYR A 98 4025 4134 7587 -394 232 -547 C \nATOM 780 OH TYR A 98 -1.588 -19.058 -54.467 1.00 47.79 O \nANISOU 780 OH TYR A 98 4833 4946 8381 -448 240 -567 O \nATOM 781 N GLU A 99 -2.263 -11.802 -53.507 1.00 36.43 N \nANISOU 781 N GLU A 99 3364 3494 6985 -251 118 -446 N \nATOM 782 CA GLU A 99 -2.363 -11.683 -52.041 1.00 36.32 C \nANISOU 782 CA GLU A 99 3365 3461 6972 -267 85 -426 C \nATOM 783 C GLU A 99 -3.707 -11.107 -51.654 1.00 36.83 C \nANISOU 783 C GLU A 99 3392 3520 7080 -269 26 -433 C \nATOM 784 O GLU A 99 -4.249 -11.448 -50.617 1.00 45.25 O \nANISOU 784 O GLU A 99 4456 4569 8167 -286 -10 -433 O \nATOM 785 CB GLU A 99 -1.250 -10.823 -51.495 1.00 37.33 C \nANISOU 785 CB GLU A 99 3535 3596 7052 -251 102 -387 C \nATOM 786 CG GLU A 99 0.139 -11.361 -51.730 1.00 37.12 C \nANISOU 786 CG GLU A 99 3561 3567 6976 -240 159 -377 C \nATOM 787 CD GLU A 99 0.625 -11.153 -53.137 1.00 45.73 C \nANISOU 787 CD GLU A 99 4651 4680 8046 -212 198 -381 C \nATOM 788 OE1 GLU A 99 0.035 -10.332 -53.885 1.00 43.44 O \nANISOU 788 OE1 GLU A 99 4319 4415 7773 -198 184 -386 O \nATOM 789 OE2 GLU A 99 1.628 -11.818 -53.515 1.00 58.19 O \nANISOU 789 OE2 GLU A 99 6275 6248 9588 -205 245 -378 O \nATOM 790 N GLU A 100 -4.280 -10.315 -52.533 1.00 35.41 N \nANISOU 790 N GLU A 100 3188 3353 6915 -252 16 -442 N \nATOM 791 CA GLU A 100 -5.634 -9.769 -52.270 1.00 37.89 C \nANISOU 791 CA GLU A 100 3477 3652 7268 -252 -41 -452 C \nATOM 792 C GLU A 100 -6.665 -10.797 -52.420 1.00 36.62 C \nANISOU 792 C GLU A 100 3285 3481 7150 -251 -61 -488 C \nATOM 793 O GLU A 100 -7.570 -10.928 -51.579 1.00 50.09 O \nANISOU 793 O GLU A 100 4982 5167 8883 -255 -107 -492 O \nATOM 794 CB GLU A 100 -5.910 -8.585 -53.208 1.00 43.53 C \nANISOU 794 CB GLU A 100 4181 4381 7976 -239 -43 -451 C \nATOM 795 CG GLU A 100 -5.251 -7.277 -52.761 1.00 41.40 C \nANISOU 795 CG GLU A 100 3934 4130 7665 -245 -45 -412 C \nATOM 796 CD GLU A 100 -6.025 -6.616 -51.669 1.00 44.03 C \nANISOU 796 CD GLU A 100 4277 4442 8011 -264 -101 -397 C \nATOM 797 OE1 GLU A 100 -7.290 -6.753 -51.721 1.00 49.52 O \nANISOU 797 OE1 GLU A 100 4960 5107 8747 -264 -140 -420 O \nATOM 798 OE2 GLU A 100 -5.365 -6.016 -50.755 1.00 34.34 O \nANISOU 798 OE2 GLU A 100 3071 3227 6749 -277 -104 -363 O \nATOM 799 N LEU A 101 -6.515 -11.614 -53.442 1.00 37.39 N \nANISOU 799 N LEU A 101 3363 3596 7249 -246 -25 -516 N \nATOM 800 CA LEU A 101 -7.346 -12.908 -53.589 1.00 38.64 C \nANISOU 800 CA LEU A 101 3482 3760 7438 -249 -35 -554 C \nATOM 801 C LEU A 101 -7.222 -13.808 -52.372 1.00 39.59 C \nANISOU 801 C LEU A 101 3610 3875 7557 -275 -47 -547 C \nATOM 802 O LEU A 101 -8.207 -14.193 -51.768 1.00 40.24 O \nANISOU 802 O LEU A 101 3667 3954 7668 -272 -89 -560 O \nATOM 803 CB LEU A 101 -6.928 -13.684 -54.807 1.00 33.86 C \nANISOU 803 CB LEU A 101 2861 3181 6822 -251 13 -579 C \nATOM 804 CG LEU A 101 -7.727 -14.926 -55.075 1.00 37.64 C \nANISOU 804 CG LEU A 101 3293 3682 7324 -256 7 -619 C \nATOM 805 CD1 LEU A 101 -9.250 -14.690 -55.037 1.00 40.88 C \nANISOU 805 CD1 LEU A 101 3665 4089 7778 -223 -46 -643 C \nATOM 806 CD2 LEU A 101 -7.332 -15.548 -56.417 1.00 35.79 C \nANISOU 806 CD2 LEU A 101 3044 3479 7076 -261 55 -644 C \nATOM 807 N LYS A 102 -5.996 -14.123 -52.013 1.00 37.69 N \nANISOU 807 N LYS A 102 3408 3633 7278 -299 -10 -526 N \nATOM 808 CA LYS A 102 -5.734 -14.896 -50.813 1.00 40.86 C \nANISOU 808 CA LYS A 102 3827 4028 7671 -330 -18 -517 C \nATOM 809 C LYS A 102 -6.460 -14.295 -49.591 1.00 42.17 C \nANISOU 809 C LYS A 102 3991 4176 7858 -327 -75 -499 C \nATOM 810 O LYS A 102 -7.022 -14.983 -48.727 1.00 45.62 O \nANISOU 810 O LYS A 102 4411 4613 8309 -343 -105 -504 O \nATOM 811 CB LYS A 102 -4.221 -14.943 -50.525 1.00 41.20 C \nANISOU 811 CB LYS A 102 3930 4061 7663 -348 28 -490 C \nATOM 812 CG LYS A 102 -3.548 -16.241 -50.950 1.00 45.48 C \nANISOU 812 CG LYS A 102 4490 4613 8180 -380 74 -507 C \nATOM 813 CD LYS A 102 -2.035 -16.068 -50.990 1.00 46.81 C \nANISOU 813 CD LYS A 102 4729 4763 8294 -380 124 -481 C \nATOM 814 CE LYS A 102 -1.363 -17.397 -51.044 1.00 47.93 C \nANISOU 814 CE LYS A 102 4906 4902 8403 -424 163 -493 C \nATOM 815 NZ LYS A 102 -1.399 -18.029 -49.717 1.00 48.21 N \nANISOU 815 NZ LYS A 102 4958 4927 8433 -464 143 -488 N \nATOM 816 N HIS A 103 -6.398 -12.990 -49.463 1.00 39.58 N \nANISOU 816 N HIS A 103 3682 3833 7525 -310 -90 -474 N \nATOM 817 CA HIS A 103 -6.985 -12.339 -48.281 1.00 35.63 C \nANISOU 817 CA HIS A 103 3188 3312 7036 -314 -142 -452 C \nATOM 818 C HIS A 103 -8.516 -12.436 -48.384 1.00 38.16 C \nANISOU 818 C HIS A 103 3471 3625 7402 -293 -192 -477 C \nATOM 819 O HIS A 103 -9.239 -12.492 -47.442 1.00 33.51 O \nANISOU 819 O HIS A 103 2879 3022 6831 -296 -238 -471 O \nATOM 820 CB HIS A 103 -6.602 -10.882 -48.225 1.00 32.71 C \nANISOU 820 CB HIS A 103 2845 2938 6646 -307 -146 -421 C \nATOM 821 CG HIS A 103 -7.251 -10.159 -47.117 1.00 32.27 C \nANISOU 821 CG HIS A 103 2800 2863 6599 -316 -200 -400 C \nATOM 822 ND1 HIS A 103 -8.268 -9.249 -47.312 1.00 31.62 N \nANISOU 822 ND1 HIS A 103 2712 2764 6536 -305 -242 -401 N \nATOM 823 CD2 HIS A 103 -7.033 -10.201 -45.783 1.00 33.33 C \nANISOU 823 CD2 HIS A 103 2954 2987 6721 -338 -220 -376 C \nATOM 824 CE1 HIS A 103 -8.674 -8.780 -46.143 1.00 33.11 C \nANISOU 824 CE1 HIS A 103 2919 2934 6726 -321 -287 -378 C \nATOM 825 NE2 HIS A 103 -7.912 -9.315 -45.199 1.00 33.28 N \nANISOU 825 NE2 HIS A 103 2954 2963 6730 -341 -274 -362 N \nATOM 826 N LEU A 104 -9.015 -12.469 -49.566 1.00 39.07 N \nANISOU 826 N LEU A 104 3561 3750 7535 -269 -183 -505 N \nATOM 827 CA LEU A 104 -10.436 -12.609 -49.714 1.00 45.13 C \nANISOU 827 CA LEU A 104 4297 4510 8341 -241 -228 -531 C \nATOM 828 C LEU A 104 -10.945 -13.969 -49.213 1.00 52.71 C \nANISOU 828 C LEU A 104 5220 5491 9316 -244 -242 -552 C \nATOM 829 O LEU A 104 -12.029 -14.058 -48.619 1.00 54.75 O \nANISOU 829 O LEU A 104 5464 5740 9599 -223 -292 -558 O \nATOM 830 CB LEU A 104 -10.704 -12.460 -51.191 1.00 46.51 C \nANISOU 830 CB LEU A 104 4451 4696 8524 -216 -205 -560 C \nATOM 831 CG LEU A 104 -12.131 -12.516 -51.647 1.00 50.41 C \nANISOU 831 CG LEU A 104 4917 5183 9054 -176 -242 -593 C \nATOM 832 CD1 LEU A 104 -12.950 -11.410 -51.041 1.00 50.33 C \nANISOU 832 CD1 LEU A 104 4940 5128 9055 -163 -296 -576 C \nATOM 833 CD2 LEU A 104 -12.125 -12.425 -53.167 1.00 52.08 C \nANISOU 833 CD2 LEU A 104 5110 5412 9266 -158 -208 -622 C \nATOM 834 N LEU A 105 -10.134 -15.013 -49.390 1.00 54.01 N \nANISOU 834 N LEU A 105 5374 5686 9460 -272 -198 -562 N \nATOM 835 CA LEU A 105 -10.453 -16.325 -48.813 1.00 55.08 C \nANISOU 835 CA LEU A 105 5476 5853 9598 -290 -208 -578 C \nATOM 836 C LEU A 105 -10.348 -16.422 -47.342 1.00 57.60 C \nANISOU 836 C LEU A 105 5815 6161 9910 -315 -236 -551 C \nATOM 837 O LEU A 105 -10.122 -17.518 -46.804 1.00 73.55 O \nANISOU 837 O LEU A 105 7820 8209 11915 -349 -228 -557 O \nATOM 838 CB LEU A 105 -9.512 -17.389 -49.329 1.00 52.18 C \nANISOU 838 CB LEU A 105 5106 5520 9202 -328 -152 -592 C \nATOM 839 CG LEU A 105 -9.423 -17.486 -50.865 1.00 55.53 C \nANISOU 839 CG LEU A 105 5511 5964 9626 -313 -113 -620 C \nATOM 840 CD1 LEU A 105 -8.407 -18.524 -51.199 1.00 56.67 C \nANISOU 840 CD1 LEU A 105 5665 6133 9733 -361 -60 -627 C \nATOM 841 CD2 LEU A 105 -10.744 -17.805 -51.550 1.00 56.80 C \nANISOU 841 CD2 LEU A 105 5610 6154 9819 -272 -139 -659 C \nATOM 842 N SER A 106 -10.510 -15.311 -46.668 1.00 55.02 N \nANISOU 842 N SER A 106 5522 5796 9589 -305 -270 -521 N \nATOM 843 CA SER A 106 -10.257 -15.305 -45.254 1.00 56.99 C \nANISOU 843 CA SER A 106 5795 6033 9826 -333 -292 -492 C \nATOM 844 C SER A 106 -11.535 -14.875 -44.645 1.00 54.76 C \nANISOU 844 C SER A 106 5502 5732 9572 -303 -357 -488 C \nATOM 845 O SER A 106 -11.635 -14.734 -43.439 1.00 48.73 O \nANISOU 845 O SER A 106 4756 4955 8805 -319 -391 -463 O \nATOM 846 CB SER A 106 -9.153 -14.314 -44.930 1.00 56.32 C \nANISOU 846 CB SER A 106 5764 5922 9711 -352 -271 -456 C \nATOM 847 OG SER A 106 -9.309 -13.161 -45.716 1.00 60.13 O \nANISOU 847 OG SER A 106 6257 6388 10199 -325 -271 -452 O \nATOM 848 N ARG A 107 -12.501 -14.610 -45.518 1.00 53.75 N \nANISOU 848 N ARG A 107 5353 5599 9472 -258 -375 -512 N \nATOM 849 CA ARG A 107 -13.800 -14.210 -45.063 1.00 65.00 C \nANISOU 849 CA ARG A 107 6776 6998 10922 -219 -437 -511 C \nATOM 850 C ARG A 107 -14.784 -15.145 -45.755 1.00 58.91 C \nANISOU 850 C ARG A 107 5948 6261 10173 -175 -446 -554 C \nATOM 851 O ARG A 107 -15.981 -15.035 -45.629 1.00 56.89 O \nANISOU 851 O ARG A 107 5684 5992 9939 -127 -494 -564 O \nATOM 852 CB ARG A 107 -14.030 -12.711 -45.418 1.00 73.17 C \nANISOU 852 CB ARG A 107 7857 7984 11960 -205 -453 -496 C \nATOM 853 CG ARG A 107 -14.348 -11.808 -44.180 1.00 82.78 C \nANISOU 853 CG ARG A 107 9120 9160 13174 -219 -504 -457 C \nATOM 854 CD ARG A 107 -15.210 -12.578 -43.131 1.00 90.52 C \nANISOU 854 CD ARG A 107 10080 10144 14168 -203 -553 -457 C \nATOM 855 NE ARG A 107 -16.661 -12.337 -42.968 1.00 88.76 N \nANISOU 855 NE ARG A 107 9866 9889 13970 -151 -614 -464 N \nATOM 856 CZ ARG A 107 -17.512 -11.896 -43.899 1.00 97.36 C \nANISOU 856 CZ ARG A 107 10964 10951 15075 -104 -627 -487 C \nATOM 857 NH1 ARG A 107 -17.120 -11.565 -45.128 1.00 93.23 N \nANISOU 857 NH1 ARG A 107 10440 10434 14551 -104 -585 -506 N \nATOM 858 NH2 ARG A 107 -18.804 -11.755 -43.580 1.00107.09 N \nANISOU 858 NH2 ARG A 107 12214 12150 16324 -54 -684 -491 N \nATOM 859 N ILE A 108 -14.216 -16.105 -46.453 1.00 53.21 N \nANISOU 859 N ILE A 108 5189 5587 9440 -193 -398 -578 N \nATOM 860 CA ILE A 108 -14.968 -17.081 -47.173 1.00 50.85 C \nANISOU 860 CA ILE A 108 4829 5339 9154 -159 -397 -621 C \nATOM 861 C ILE A 108 -14.755 -18.413 -46.510 1.00 53.56 C \nANISOU 861 C ILE A 108 5131 5741 9480 -195 -391 -627 C \nATOM 862 O ILE A 108 -13.707 -18.644 -45.922 1.00 52.39 O \nANISOU 862 O ILE A 108 5009 5593 9306 -254 -365 -605 O \nATOM 863 CB ILE A 108 -14.508 -17.245 -48.595 1.00 45.27 C \nANISOU 863 CB ILE A 108 4106 4653 8441 -161 -345 -648 C \nATOM 864 CG1 ILE A 108 -14.778 -15.954 -49.360 1.00 41.89 C \nANISOU 864 CG1 ILE A 108 3713 4175 8027 -127 -350 -646 C \nATOM 865 CG2 ILE A 108 -15.244 -18.426 -49.234 1.00 47.31 C \nANISOU 865 CG2 ILE A 108 4292 4979 8706 -134 -342 -693 C \nATOM 866 CD1 ILE A 108 -14.443 -16.023 -50.850 1.00 41.63 C \nANISOU 866 CD1 ILE A 108 3663 4162 7990 -122 -301 -674 C \nATOM 867 N ASN A 109 -15.786 -19.246 -46.594 1.00 52.11 N \nANISOU 867 N ASN A 109 4886 5608 9307 -156 -417 -656 N \nATOM 868 CA ASN A 109 -15.869 -20.464 -45.850 1.00 54.08 C \nANISOU 868 CA ASN A 109 5087 5922 9537 -184 -425 -662 C \nATOM 869 C ASN A 109 -16.155 -21.675 -46.710 1.00 55.86 C \nANISOU 869 C ASN A 109 5238 6235 9753 -180 -401 -707 C \nATOM 870 O ASN A 109 -15.832 -22.814 -46.311 1.00 63.78 O \nANISOU 870 O ASN A 109 6202 7304 10726 -232 -386 -714 O \nATOM 871 CB ASN A 109 -17.011 -20.357 -44.879 1.00 60.08 C \nANISOU 871 CB ASN A 109 5835 6678 10314 -134 -492 -652 C \nATOM 872 CG ASN A 109 -16.598 -19.843 -43.521 1.00 63.67 C \nANISOU 872 CG ASN A 109 6341 7087 10762 -171 -517 -608 C \nATOM 873 OD1 ASN A 109 -17.398 -19.200 -42.806 1.00 71.56 O \nANISOU 873 OD1 ASN A 109 7364 8048 11778 -131 -572 -588 O \nATOM 874 ND2 ASN A 109 -15.381 -20.147 -43.128 1.00 57.63 N \nANISOU 874 ND2 ASN A 109 5599 6328 9969 -247 -478 -591 N \nATOM 875 N HIS A 110 -16.782 -21.416 -47.864 1.00 51.91 N \nANISOU 875 N HIS A 110 4715 5736 9271 -122 -397 -737 N \nATOM 876 CA HIS A 110 -17.194 -22.459 -48.790 1.00 58.65 C \nANISOU 876 CA HIS A 110 5492 6675 10115 -108 -377 -782 C \nATOM 877 C HIS A 110 -17.509 -21.956 -50.212 1.00 54.24 C \nANISOU 877 C HIS A 110 4932 6103 9575 -59 -357 -811 C \nATOM 878 O HIS A 110 -18.045 -20.875 -50.398 1.00 47.31 O \nANISOU 878 O HIS A 110 4095 5158 8725 -4 -383 -805 O \nATOM 879 CB HIS A 110 -18.350 -23.258 -48.208 1.00 66.69 C \nANISOU 879 CB HIS A 110 6442 7766 11134 -61 -423 -799 C \nATOM 880 CG HIS A 110 -18.768 -24.423 -49.050 1.00 71.38 C \nANISOU 880 CG HIS A 110 6946 8468 11709 -50 -403 -847 C \nATOM 881 ND1 HIS A 110 -20.097 -24.779 -49.212 1.00 75.44 N \nANISOU 881 ND1 HIS A 110 7393 9038 12231 38 -442 -877 N \nATOM 882 CD2 HIS A 110 -18.042 -25.322 -49.757 1.00 69.97 C \nANISOU 882 CD2 HIS A 110 6732 8354 11499 -116 -350 -868 C \nATOM 883 CE1 HIS A 110 -20.169 -25.843 -49.988 1.00 76.01 C \nANISOU 883 CE1 HIS A 110 7387 9215 12279 26 -412 -916 C \nATOM 884 NE2 HIS A 110 -18.939 -26.194 -50.330 1.00 77.29 N \nANISOU 884 NE2 HIS A 110 7567 9382 12416 -72 -356 -912 N \nATOM 885 N PHE A 111 -17.098 -22.749 -51.198 1.00 55.28 N \nANISOU 885 N PHE A 111 5022 6296 9687 -90 -309 -841 N \nATOM 886 CA PHE A 111 -17.272 -22.462 -52.591 1.00 61.01 C \nANISOU 886 CA PHE A 111 5737 7020 10421 -57 -283 -871 C \nATOM 887 C PHE A 111 -18.275 -23.385 -53.242 1.00 73.40 C \nANISOU 887 C PHE A 111 7218 8682 11988 -8 -290 -920 C \nATOM 888 O PHE A 111 -18.685 -24.390 -52.666 1.00 89.25 O \nANISOU 888 O PHE A 111 9164 10769 13978 -12 -307 -932 O \nATOM 889 CB PHE A 111 -15.966 -22.743 -53.306 1.00 69.28 C \nANISOU 889 CB PHE A 111 6805 8077 11443 -133 -218 -869 C \nATOM 890 CG PHE A 111 -15.001 -21.580 -53.317 1.00 64.47 C \nANISOU 890 CG PHE A 111 6282 7378 10837 -157 -198 -832 C \nATOM 891 CD1 PHE A 111 -15.460 -20.287 -53.228 1.00 65.93 C \nANISOU 891 CD1 PHE A 111 6509 7489 11050 -106 -230 -816 C \nATOM 892 CD2 PHE A 111 -13.646 -21.806 -53.447 1.00 60.48 C \nANISOU 892 CD2 PHE A 111 5813 6866 10300 -229 -147 -815 C \nATOM 893 CE1 PHE A 111 -14.581 -19.240 -53.248 1.00 68.32 C \nANISOU 893 CE1 PHE A 111 6881 7727 11350 -129 -212 -783 C \nATOM 894 CE2 PHE A 111 -12.753 -20.763 -53.439 1.00 62.20 C \nANISOU 894 CE2 PHE A 111 6104 7014 10517 -243 -130 -781 C \nATOM 895 CZ PHE A 111 -13.215 -19.469 -53.369 1.00 64.41 C \nANISOU 895 CZ PHE A 111 6416 7233 10825 -193 -161 -765 C \nATOM 896 N GLU A 112 -18.674 -23.043 -54.461 1.00 73.60 N \nANISOU 896 N GLU A 112 7234 8705 12026 39 -275 -951 N \nATOM 897 CA GLU A 112 -19.388 -23.990 -55.323 1.00 71.37 C \nANISOU 897 CA GLU A 112 6864 8523 11733 74 -266 -1002 C \nATOM 898 C GLU A 112 -18.954 -23.821 -56.787 1.00 65.48 C \nANISOU 898 C GLU A 112 6120 7778 10983 60 -215 -1026 C \nATOM 899 O GLU A 112 -19.385 -22.924 -57.494 1.00 63.54 O \nANISOU 899 O GLU A 112 5902 7478 10760 115 -221 -1037 O \nATOM 900 CB GLU A 112 -20.908 -23.890 -55.155 1.00 72.80 C \nANISOU 900 CB GLU A 112 7010 8717 11934 185 -321 -1025 C \nATOM 901 CG GLU A 112 -21.654 -25.071 -55.785 1.00 85.59 C \nANISOU 901 CG GLU A 112 8524 10464 13532 222 -315 -1077 C \nATOM 902 CD GLU A 112 -23.177 -24.995 -55.653 1.00 87.10 C \nANISOU 902 CD GLU A 112 8682 10672 13739 347 -370 -1102 C \nATOM 903 OE1 GLU A 112 -23.662 -24.265 -54.776 1.00 98.71 O \nANISOU 903 OE1 GLU A 112 10206 12066 15232 394 -418 -1075 O \nATOM 904 OE2 GLU A 112 -23.880 -25.672 -56.426 1.00 81.47 O \nANISOU 904 OE2 GLU A 112 7892 10051 13013 400 -364 -1150 O \nATOM 905 N LYS A 113 -18.023 -24.666 -57.184 1.00 62.54 N \nANISOU 905 N LYS A 113 5725 7461 10575 -22 -165 -1032 N \nATOM 906 CA LYS A 113 -17.476 -24.695 -58.532 1.00 61.71 C \nANISOU 906 CA LYS A 113 5620 7370 10459 -49 -113 -1052 C \nATOM 907 C LYS A 113 -18.589 -24.885 -59.566 1.00 64.66 C \nANISOU 907 C LYS A 113 5927 7800 10841 27 -119 -1104 C \nATOM 908 O LYS A 113 -19.300 -25.852 -59.536 1.00 66.74 O \nANISOU 908 O LYS A 113 6109 8160 11088 50 -131 -1136 O \nATOM 909 CB LYS A 113 -16.481 -25.824 -58.599 1.00 59.59 C \nANISOU 909 CB LYS A 113 5331 7166 10143 -150 -67 -1052 C \nATOM 910 CG LYS A 113 -15.658 -25.939 -59.854 1.00 62.14 C \nANISOU 910 CG LYS A 113 5667 7497 10444 -198 -9 -1063 C \nATOM 911 CD LYS A 113 -15.012 -27.331 -59.791 1.00 71.61 C \nANISOU 911 CD LYS A 113 6834 8784 11591 -294 26 -1072 C \nATOM 912 CE LYS A 113 -13.881 -27.554 -60.765 1.00 71.75 C \nANISOU 912 CE LYS A 113 6888 8798 11575 -367 87 -1070 C \nATOM 913 NZ LYS A 113 -12.671 -27.031 -60.116 1.00 75.41 N \nANISOU 913 NZ LYS A 113 7451 9170 12033 -415 102 -1021 N \nATOM 914 N ILE A 114 -18.746 -23.900 -60.440 1.00 73.59 N \nANISOU 914 N ILE A 114 7095 8870 11995 70 -113 -1111 N \nATOM 915 CA ILE A 114 -19.796 -23.882 -61.452 1.00 73.58 C \nANISOU 915 CA ILE A 114 7048 8905 12004 149 -119 -1160 C \nATOM 916 C ILE A 114 -19.194 -23.843 -62.833 1.00 76.16 C \nANISOU 916 C ILE A 114 7374 9246 12318 114 -65 -1179 C \nATOM 917 O ILE A 114 -18.270 -23.016 -63.098 1.00 77.02 O \nANISOU 917 O ILE A 114 7554 9280 12430 72 -39 -1148 O \nATOM 918 CB ILE A 114 -20.649 -22.588 -61.377 1.00 85.37 C \nANISOU 918 CB ILE A 114 8599 10303 13537 235 -161 -1156 C \nATOM 919 CG1 ILE A 114 -21.574 -22.627 -60.176 1.00 90.48 C \nANISOU 919 CG1 ILE A 114 9241 10941 14198 296 -221 -1147 C \nATOM 920 CG2 ILE A 114 -21.500 -22.433 -62.639 1.00 86.45 C \nANISOU 920 CG2 ILE A 114 8707 10460 13679 306 -155 -1206 C \nATOM 921 CD1 ILE A 114 -22.424 -21.382 -60.066 1.00 88.91 C \nANISOU 921 CD1 ILE A 114 9110 10641 14030 375 -265 -1142 C \nATOM 922 N GLN A 115 -19.759 -24.632 -63.744 1.00 70.34 N \nANISOU 922 N GLN A 115 6559 8603 11564 138 -48 -1229 N \nATOM 923 CA GLN A 115 -19.383 -24.474 -65.155 1.00 69.84 C \nANISOU 923 CA GLN A 115 6495 8549 11492 119 -2 -1252 C \nATOM 924 C GLN A 115 -20.021 -23.213 -65.751 1.00 70.34 C \nANISOU 924 C GLN A 115 6605 8532 11588 195 -19 -1262 C \nATOM 925 O GLN A 115 -21.232 -23.048 -65.715 1.00 69.79 O \nANISOU 925 O GLN A 115 6516 8465 11537 286 -57 -1290 O \nATOM 926 CB GLN A 115 -19.768 -25.659 -65.961 1.00 67.21 C \nANISOU 926 CB GLN A 115 6066 8343 11128 117 22 -1302 C \nATOM 927 CG GLN A 115 -19.013 -25.739 -67.264 1.00 69.55 C \nANISOU 927 CG GLN A 115 6365 8660 11403 62 78 -1315 C \nATOM 928 CD GLN A 115 -19.479 -26.891 -68.126 1.00 67.72 C \nANISOU 928 CD GLN A 115 6033 8562 11137 61 101 -1369 C \nATOM 929 OE1 GLN A 115 -20.678 -27.143 -68.205 1.00 75.43 O \nANISOU 929 OE1 GLN A 115 6946 9595 12120 146 72 -1410 O \nATOM 930 NE2 GLN A 115 -18.537 -27.605 -68.744 1.00 61.37 N \nANISOU 930 NE2 GLN A 115 5215 7809 10292 -35 152 -1370 N \nATOM 931 N ILE A 116 -19.187 -22.317 -66.275 1.00 72.32 N \nANISOU 931 N ILE A 116 6923 8714 11844 157 8 -1237 N \nATOM 932 CA ILE A 116 -19.596 -20.955 -66.592 1.00 67.44 C \nANISOU 932 CA ILE A 116 6366 8004 11252 208 -11 -1232 C \nATOM 933 C ILE A 116 -19.686 -20.748 -68.094 1.00 65.60 C \nANISOU 933 C ILE A 116 6121 7793 11013 218 24 -1269 C \nATOM 934 O ILE A 116 -20.549 -20.004 -68.587 1.00 65.52 O \nANISOU 934 O ILE A 116 6130 7744 11021 284 5 -1293 O \nATOM 935 CB ILE A 116 -18.652 -19.940 -65.879 1.00 70.09 C \nANISOU 935 CB ILE A 116 6790 8247 11596 160 -14 -1172 C \nATOM 936 CG1 ILE A 116 -19.440 -18.767 -65.354 1.00 72.44 C \nANISOU 936 CG1 ILE A 116 7146 8457 11922 219 -63 -1160 C \nATOM 937 CG2 ILE A 116 -17.429 -19.515 -66.699 1.00 67.51 C \nANISOU 937 CG2 ILE A 116 6497 7904 11250 97 37 -1152 C \nATOM 938 CD1 ILE A 116 -20.267 -19.165 -64.158 1.00 71.30 C \nANISOU 938 CD1 ILE A 116 6985 8314 11790 264 -114 -1158 C \nATOM 939 N ILE A 117 -18.770 -21.378 -68.819 1.00 62.30 N \nANISOU 939 N ILE A 117 5675 7430 10566 150 75 -1271 N \nATOM 940 CA ILE A 117 -18.837 -21.503 -70.279 1.00 66.78 C \nANISOU 940 CA ILE A 117 6210 8043 11119 153 113 -1310 C \nATOM 941 C ILE A 117 -18.149 -22.821 -70.665 1.00 78.62 C \nANISOU 941 C ILE A 117 7651 9641 12580 82 157 -1322 C \nATOM 942 O ILE A 117 -16.909 -22.935 -70.598 1.00 85.19 O \nANISOU 942 O ILE A 117 8518 10459 13390 2 189 -1285 O \nATOM 943 CB ILE A 117 -18.219 -20.307 -71.061 1.00 61.46 C \nANISOU 943 CB ILE A 117 5602 7300 10448 133 136 -1291 C \nATOM 944 CG1 ILE A 117 -16.988 -19.754 -70.378 1.00 62.49 C \nANISOU 944 CG1 ILE A 117 5801 7369 10573 72 145 -1228 C \nATOM 945 CG2 ILE A 117 -19.239 -19.186 -71.186 1.00 61.72 C \nANISOU 945 CG2 ILE A 117 5673 7266 10510 208 99 -1306 C \nATOM 946 CD1 ILE A 117 -16.317 -18.595 -71.086 1.00 60.78 C \nANISOU 946 CD1 ILE A 117 5642 7100 10353 52 168 -1205 C \nATOM 947 N PRO A 118 -18.960 -23.818 -71.074 1.00 85.28 N \nANISOU 947 N PRO A 118 8407 10584 13410 111 157 -1373 N \nATOM 948 CA PRO A 118 -18.507 -25.177 -71.346 1.00 80.21 C \nANISOU 948 CA PRO A 118 7699 10050 12725 43 192 -1389 C \nATOM 949 C PRO A 118 -17.386 -25.269 -72.369 1.00 78.19 C \nANISOU 949 C PRO A 118 7466 9804 12439 -37 249 -1380 C \nATOM 950 O PRO A 118 -17.321 -24.475 -73.311 1.00 90.78 O \nANISOU 950 O PRO A 118 9089 11361 14043 -19 265 -1386 O \nATOM 951 CB PRO A 118 -19.763 -25.863 -71.888 1.00 82.27 C \nANISOU 951 CB PRO A 118 7866 10413 12979 112 181 -1453 C \nATOM 952 CG PRO A 118 -20.901 -25.080 -71.342 1.00 80.41 C \nANISOU 952 CG PRO A 118 7650 10118 12785 221 127 -1460 C \nATOM 953 CD PRO A 118 -20.414 -23.669 -71.318 1.00 82.31 C \nANISOU 953 CD PRO A 118 7993 10226 13054 217 123 -1421 C \nATOM 954 N LYS A 119 -16.536 -26.265 -72.173 1.00 73.71 N \nANISOU 954 N LYS A 119 6886 9288 11832 -127 278 -1366 N \nATOM 955 CA LYS A 119 -15.328 -26.495 -72.954 1.00 72.76 C \nANISOU 955 CA LYS A 119 6799 9172 11675 -214 332 -1349 C \nATOM 956 C LYS A 119 -15.680 -26.983 -74.337 1.00 74.88 C \nANISOU 956 C LYS A 119 7004 9527 11920 -215 362 -1399 C \nATOM 957 O LYS A 119 -14.898 -26.846 -75.291 1.00 83.96 O \nANISOU 957 O LYS A 119 8184 10669 13048 -262 404 -1391 O \nATOM 958 CB LYS A 119 -14.441 -27.531 -72.234 1.00 72.11 C \nANISOU 958 CB LYS A 119 6727 9121 11552 -310 349 -1323 C \nATOM 959 CG LYS A 119 -13.077 -27.779 -72.854 1.00 76.56 C \nANISOU 959 CG LYS A 119 7347 9670 12071 -403 403 -1298 C \nATOM 960 CD LYS A 119 -12.416 -29.028 -72.252 1.00 79.50 C \nANISOU 960 CD LYS A 119 7719 10093 12392 -503 420 -1286 C \nATOM 961 CE LYS A 119 -11.044 -29.301 -72.868 1.00 81.55 C \nANISOU 961 CE LYS A 119 8050 10331 12604 -595 474 -1260 C \nATOM 962 NZ LYS A 119 -9.993 -28.520 -72.168 1.00 93.01 N \nANISOU 962 NZ LYS A 119 9612 11665 14063 -603 476 -1200 N \nATOM 963 N SER A 120 -16.866 -27.563 -74.451 1.00 78.87 N \nANISOU 963 N SER A 120 7420 10121 12427 -161 342 -1450 N \nATOM 964 CA SER A 120 -17.346 -28.111 -75.724 1.00 73.77 C \nANISOU 964 CA SER A 120 6699 9574 11756 -154 369 -1504 C \nATOM 965 C SER A 120 -18.087 -27.037 -76.567 1.00 70.95 C \nANISOU 965 C SER A 120 6353 9171 11435 -63 359 -1531 C \nATOM 966 O SER A 120 -18.441 -27.283 -77.711 1.00 79.61 O \nANISOU 966 O SER A 120 7400 10333 12514 -53 383 -1574 O \nATOM 967 CB SER A 120 -18.213 -29.326 -75.439 1.00 69.62 C \nANISOU 967 CB SER A 120 6068 9180 11206 -141 354 -1548 C \nATOM 968 OG SER A 120 -19.004 -29.102 -74.281 1.00 73.20 O \nANISOU 968 OG SER A 120 6514 9607 11692 -66 301 -1543 O \nATOM 969 N SER A 121 -18.248 -25.831 -76.036 1.00 62.73 N \nANISOU 969 N SER A 121 5381 8015 10438 -8 327 -1503 N \nATOM 970 CA SER A 121 -18.829 -24.730 -76.807 1.00 65.36 C \nANISOU 970 CA SER A 121 5742 8293 10799 62 320 -1523 C \nATOM 971 C SER A 121 -17.871 -24.155 -77.844 1.00 61.08 C \nANISOU 971 C SER A 121 5247 7717 10243 8 364 -1505 C \nATOM 972 O SER A 121 -18.300 -23.608 -78.835 1.00 70.96 O \nANISOU 972 O SER A 121 6496 8965 11500 45 372 -1534 O \nATOM 973 CB SER A 121 -19.250 -23.611 -75.877 1.00 66.20 C \nANISOU 973 CB SER A 121 5914 8290 10950 124 272 -1496 C \nATOM 974 OG SER A 121 -18.101 -22.868 -75.528 1.00 77.55 O \nANISOU 974 OG SER A 121 7434 9641 12391 66 283 -1436 O \nATOM 975 N TRP A 122 -16.573 -24.271 -77.610 1.00 63.73 N \nANISOU 975 N TRP A 122 5629 8027 10557 -77 390 -1456 N \nATOM 976 CA TRP A 122 -15.535 -23.690 -78.495 1.00 66.18 C \nANISOU 976 CA TRP A 122 5993 8301 10850 -125 430 -1429 C \nATOM 977 C TRP A 122 -15.466 -24.527 -79.768 1.00 70.67 C \nANISOU 977 C TRP A 122 6504 8967 11380 -164 473 -1468 C \nATOM 978 O TRP A 122 -14.552 -25.340 -79.979 1.00 80.89 O \nANISOU 978 O TRP A 122 7800 10302 12633 -247 510 -1453 O \nATOM 979 CB TRP A 122 -14.148 -23.610 -77.784 1.00 65.17 C \nANISOU 979 CB TRP A 122 5938 8116 10706 -195 445 -1364 C \nATOM 980 CG TRP A 122 -14.176 -22.894 -76.443 1.00 57.49 C \nANISOU 980 CG TRP A 122 5017 7058 9767 -164 404 -1325 C \nATOM 981 CD1 TRP A 122 -14.014 -23.444 -75.238 1.00 57.99 C \nANISOU 981 CD1 TRP A 122 5086 7118 9831 -185 385 -1303 C \nATOM 982 CD2 TRP A 122 -14.458 -21.519 -76.224 1.00 54.09 C \nANISOU 982 CD2 TRP A 122 4636 6544 9372 -110 376 -1307 C \nATOM 983 NE1 TRP A 122 -14.184 -22.506 -74.257 1.00 57.28 N \nANISOU 983 NE1 TRP A 122 5044 6946 9776 -144 346 -1273 N \nATOM 984 CE2 TRP A 122 -14.473 -21.310 -74.848 1.00 52.15 C \nANISOU 984 CE2 TRP A 122 4422 6246 9147 -99 339 -1274 C \nATOM 985 CE3 TRP A 122 -14.748 -20.451 -77.070 1.00 56.64 C \nANISOU 985 CE3 TRP A 122 4980 6835 9708 -75 377 -1317 C \nATOM 986 CZ2 TRP A 122 -14.708 -20.061 -74.275 1.00 53.09 C \nANISOU 986 CZ2 TRP A 122 4594 6282 9297 -58 305 -1249 C \nATOM 987 CZ3 TRP A 122 -14.989 -19.195 -76.497 1.00 56.12 C \nANISOU 987 CZ3 TRP A 122 4967 6685 9670 -36 342 -1292 C \nATOM 988 CH2 TRP A 122 -14.949 -19.023 -75.109 1.00 55.26 C \nANISOU 988 CH2 TRP A 122 4890 6525 9579 -29 307 -1258 C \nATOM 989 N SER A 123 -16.438 -24.295 -80.634 1.00 72.74 N \nANISOU 989 N SER A 123 6722 9263 11653 -104 470 -1519 N \nATOM 990 CA SER A 123 -16.571 -25.016 -81.905 1.00 80.01 C \nANISOU 990 CA SER A 123 7579 10281 12538 -129 507 -1565 C \nATOM 991 C SER A 123 -15.553 -24.617 -82.965 1.00 88.82 C \nANISOU 991 C SER A 123 8739 11380 13629 -186 552 -1543 C \nATOM 992 O SER A 123 -15.187 -25.440 -83.803 1.00 99.52 O \nANISOU 992 O SER A 123 10058 12813 14942 -244 590 -1560 O \nATOM 993 CB SER A 123 -17.962 -24.777 -82.467 1.00 81.84 C \nANISOU 993 CB SER A 123 7759 10547 12791 -36 487 -1627 C \nATOM 994 OG SER A 123 -18.877 -24.704 -81.397 1.00 92.97 O \nANISOU 994 OG SER A 123 9158 11934 14233 37 438 -1635 O \nATOM 995 N ASP A 124 -15.104 -23.359 -82.940 1.00 93.21 N \nANISOU 995 N ASP A 124 9371 11838 14207 -171 546 -1504 N \nATOM 996 CA ASP A 124 -14.255 -22.824 -84.013 1.00 90.10 C \nANISOU 996 CA ASP A 124 9015 11430 13789 -210 585 -1485 C \nATOM 997 C ASP A 124 -12.796 -22.697 -83.586 1.00 86.91 C \nANISOU 997 C ASP A 124 8685 10973 13363 -273 604 -1417 C \nATOM 998 O ASP A 124 -11.938 -22.233 -84.364 1.00 83.48 O \nANISOU 998 O ASP A 124 8291 10523 12905 -304 636 -1391 O \nATOM 999 CB ASP A 124 -14.805 -21.473 -84.484 1.00 90.61 C \nANISOU 999 CB ASP A 124 9106 11439 13883 -149 568 -1494 C \nATOM 1000 CG ASP A 124 -16.304 -21.528 -84.772 1.00 97.37 C \nANISOU 1000 CG ASP A 124 9905 12330 14762 -73 544 -1561 C \nATOM 1001 OD1 ASP A 124 -16.736 -22.459 -85.485 1.00102.63 O \nANISOU 1001 OD1 ASP A 124 10500 13090 15406 -78 563 -1610 O \nATOM 1002 OD2 ASP A 124 -17.052 -20.667 -84.270 1.00 95.48 O \nANISOU 1002 OD2 ASP A 124 9693 12026 14558 -9 505 -1565 O \nATOM 1003 N HIS A 125 -12.509 -23.104 -82.353 1.00 75.71 N \nANISOU 1003 N HIS A 125 7288 9530 11950 -290 586 -1388 N \nATOM 1004 CA HIS A 125 -11.151 -23.052 -81.863 1.00 73.12 C \nANISOU 1004 CA HIS A 125 7033 9150 11597 -344 605 -1326 C \nATOM 1005 C HIS A 125 -10.793 -24.418 -81.311 1.00 73.17 C \nANISOU 1005 C HIS A 125 7025 9203 11572 -409 616 -1325 C \nATOM 1006 O HIS A 125 -11.653 -25.195 -80.885 1.00 69.97 O \nANISOU 1006 O HIS A 125 6555 8855 11175 -399 596 -1362 O \nATOM 1007 CB HIS A 125 -10.998 -22.015 -80.754 1.00 71.18 C \nANISOU 1007 CB HIS A 125 6847 8812 11386 -306 570 -1283 C \nATOM 1008 CG HIS A 125 -11.458 -20.642 -81.126 1.00 67.26 C \nANISOU 1008 CG HIS A 125 6367 8271 10919 -248 552 -1284 C \nATOM 1009 ND1 HIS A 125 -12.794 -20.289 -81.163 1.00 61.50 N \nANISOU 1009 ND1 HIS A 125 5596 7546 10226 -185 519 -1329 N \nATOM 1010 CD2 HIS A 125 -10.753 -19.517 -81.411 1.00 69.94 C \nANISOU 1010 CD2 HIS A 125 6762 8560 11251 -245 562 -1245 C \nATOM 1011 CE1 HIS A 125 -12.887 -19.019 -81.521 1.00 69.89 C \nANISOU 1011 CE1 HIS A 125 6694 8560 11301 -154 510 -1319 C \nATOM 1012 NE2 HIS A 125 -11.666 -18.519 -81.662 1.00 70.44 N \nANISOU 1012 NE2 HIS A 125 6818 8602 11346 -191 535 -1268 N \nATOM 1013 N GLU A 126 -9.506 -24.705 -81.322 1.00 71.70 N \nANISOU 1013 N GLU A 126 6904 8994 11345 -475 649 -1282 N \nATOM 1014 CA GLU A 126 -9.021 -25.970 -80.832 1.00 70.90 C \nANISOU 1014 CA GLU A 126 6806 8929 11205 -551 664 -1276 C \nATOM 1015 C GLU A 126 -8.736 -25.881 -79.329 1.00 74.15 C \nANISOU 1015 C GLU A 126 7264 9277 11633 -548 636 -1238 C \nATOM 1016 O GLU A 126 -7.665 -25.458 -78.922 1.00 78.04 O \nANISOU 1016 O GLU A 126 7842 9696 12111 -564 647 -1186 O \nATOM 1017 CB GLU A 126 -7.761 -26.387 -81.591 1.00 68.36 C \nANISOU 1017 CB GLU A 126 6543 8606 10823 -627 715 -1249 C \nATOM 1018 CG GLU A 126 -7.397 -27.838 -81.379 1.00 74.35 C \nANISOU 1018 CG GLU A 126 7299 9422 11530 -721 736 -1256 C \nATOM 1019 CD GLU A 126 -8.544 -28.743 -81.770 1.00 76.82 C \nANISOU 1019 CD GLU A 126 7497 9850 11839 -729 729 -1320 C \nATOM 1020 OE1 GLU A 126 -9.080 -29.362 -80.832 1.00 87.42 O \nANISOU 1020 OE1 GLU A 126 8800 11226 13190 -735 704 -1335 O \nATOM 1021 OE2 GLU A 126 -8.925 -28.794 -82.981 1.00 73.42 O \nANISOU 1021 OE2 GLU A 126 7017 9482 11399 -725 748 -1356 O \nATOM 1022 N ALA A 127 -9.692 -26.343 -78.523 1.00 82.80 N \nANISOU 1022 N ALA A 127 8300 10407 12753 -526 601 -1266 N \nATOM 1023 CA ALA A 127 -9.590 -26.316 -77.060 1.00 86.86 C \nANISOU 1023 CA ALA A 127 8846 10872 13285 -522 571 -1237 C \nATOM 1024 C ALA A 127 -8.650 -27.387 -76.501 1.00 89.41 C \nANISOU 1024 C ALA A 127 9210 11204 13557 -615 594 -1213 C \nATOM 1025 O ALA A 127 -7.756 -27.101 -75.705 1.00 81.18 O \nANISOU 1025 O ALA A 127 8251 10087 12508 -632 595 -1164 O \nATOM 1026 CB ALA A 127 -10.980 -26.445 -76.429 1.00 80.60 C \nANISOU 1026 CB ALA A 127 7973 10117 12532 -462 524 -1275 C \nATOM 1027 N SER A 128 -8.852 -28.622 -76.951 1.00110.04 N \nANISOU 1027 N SER A 128 11768 13913 16129 -678 614 -1248 N \nATOM 1028 CA SER A 128 -8.182 -29.799 -76.369 1.00116.37 C \nANISOU 1028 CA SER A 128 12597 14741 16878 -777 631 -1235 C \nATOM 1029 C SER A 128 -6.648 -29.804 -76.476 1.00110.26 C \nANISOU 1029 C SER A 128 11943 13894 16056 -844 671 -1185 C \nATOM 1030 O SER A 128 -5.980 -30.544 -75.727 1.00100.42 O \nANISOU 1030 O SER A 128 10749 12634 14770 -917 681 -1163 O \nATOM 1031 CB SER A 128 -8.730 -31.066 -77.023 1.00119.22 C \nANISOU 1031 CB SER A 128 12869 15233 17197 -836 648 -1286 C \nATOM 1032 OG SER A 128 -8.389 -31.096 -78.399 1.00120.95 O \nANISOU 1032 OG SER A 128 13092 15478 17386 -862 687 -1298 O \nATOM 1033 N SER A 129 -6.103 -28.986 -77.385 1.00 98.09 N \nANISOU 1033 N SER A 129 10448 12306 14515 -816 694 -1166 N \nATOM 1034 CA SER A 129 -4.648 -28.847 -77.521 1.00 97.01 C \nANISOU 1034 CA SER A 129 10431 12095 14335 -858 730 -1115 C \nATOM 1035 C SER A 129 -4.097 -27.816 -76.535 1.00 91.46 C \nANISOU 1035 C SER A 129 9803 11286 13660 -802 711 -1065 C \nATOM 1036 O SER A 129 -2.932 -27.428 -76.598 1.00 73.18 O \nANISOU 1036 O SER A 129 7588 8902 11316 -808 736 -1020 O \nATOM 1037 CB SER A 129 -4.258 -28.471 -78.939 1.00104.37 C \nANISOU 1037 CB SER A 129 11377 13032 15247 -853 764 -1115 C \nATOM 1038 OG SER A 129 -2.999 -27.823 -78.945 1.00113.76 O \nANISOU 1038 OG SER A 129 12679 14131 16413 -845 786 -1059 O \nATOM 1039 N GLY A 130 -4.952 -27.371 -75.628 1.00 91.36 N \nANISOU 1039 N GLY A 130 9744 11267 13703 -745 666 -1074 N \nATOM 1040 CA GLY A 130 -4.521 -26.504 -74.568 1.00 87.03 C \nANISOU 1040 CA GLY A 130 9257 10631 13178 -702 644 -1030 C \nATOM 1041 C GLY A 130 -3.664 -27.235 -73.569 1.00 78.69 C \nANISOU 1041 C GLY A 130 8275 9540 12082 -767 654 -1001 C \nATOM 1042 O GLY A 130 -4.048 -27.342 -72.405 1.00 75.64 O \nANISOU 1042 O GLY A 130 7876 9144 11719 -761 622 -999 O \nATOM 1043 N VAL A 131 -2.494 -27.699 -74.023 1.00 71.60 N \nANISOU 1043 N VAL A 131 7463 8618 11123 -827 698 -977 N \nATOM 1044 CA VAL A 131 -1.663 -28.629 -73.244 1.00 65.95 C \nANISOU 1044 CA VAL A 131 6828 7877 10355 -909 715 -956 C \nATOM 1045 C VAL A 131 -0.176 -28.299 -73.399 1.00 61.88 C \nANISOU 1045 C VAL A 131 6446 7274 9791 -915 752 -905 C \nATOM 1046 O VAL A 131 0.247 -27.771 -74.427 1.00 56.66 O \nANISOU 1046 O VAL A 131 5808 6602 9119 -886 776 -894 O \nATOM 1047 CB VAL A 131 -1.952 -30.079 -73.695 1.00 66.10 C \nANISOU 1047 CB VAL A 131 6803 7985 10328 -1009 734 -995 C \nATOM 1048 CG1 VAL A 131 -0.798 -31.029 -73.347 1.00 73.34 C \nANISOU 1048 CG1 VAL A 131 7832 8866 11168 -1111 769 -970 C \nATOM 1049 CG2 VAL A 131 -3.251 -30.565 -73.079 1.00 61.14 C \nANISOU 1049 CG2 VAL A 131 6060 7437 9735 -1007 695 -1037 C \nATOM 1050 N SER A 132 0.619 -28.616 -72.390 1.00 62.28 N \nANISOU 1050 N SER A 132 6587 7265 9810 -949 758 -875 N \nATOM 1051 CA SER A 132 2.065 -28.380 -72.468 1.00 77.03 C \nANISOU 1051 CA SER A 132 8594 9048 11626 -950 793 -827 C \nATOM 1052 C SER A 132 2.870 -29.263 -71.511 1.00 77.12 C \nANISOU 1052 C SER A 132 8707 9012 11581 -1027 808 -808 C \nATOM 1053 O SER A 132 2.370 -29.725 -70.493 1.00 62.42 O \nANISOU 1053 O SER A 132 6813 7167 9735 -1058 782 -822 O \nATOM 1054 CB SER A 132 2.369 -26.888 -72.191 1.00 87.12 C \nANISOU 1054 CB SER A 132 9894 10266 12940 -840 778 -790 C \nATOM 1055 OG SER A 132 3.770 -26.620 -72.188 1.00 93.84 O \nANISOU 1055 OG SER A 132 10878 11040 13738 -826 811 -742 O \nATOM 1056 N SER A 133 4.140 -29.443 -71.851 1.00 93.04 N \nANISOU 1056 N SER A 133 10855 10965 13532 -1052 849 -775 N \nATOM 1057 CA SER A 133 5.084 -30.270 -71.066 1.00 93.25 C \nANISOU 1057 CA SER A 133 11008 10931 13493 -1127 870 -754 C \nATOM 1058 C SER A 133 5.465 -29.584 -69.757 1.00 89.94 C \nANISOU 1058 C SER A 133 10640 10440 13094 -1068 850 -722 C \nATOM 1059 O SER A 133 5.842 -30.247 -68.793 1.00 79.48 O \nANISOU 1059 O SER A 133 9383 9080 11735 -1127 852 -716 O \nATOM 1060 CB SER A 133 6.368 -30.532 -71.865 1.00 93.82 C \nANISOU 1060 CB SER A 133 11218 10943 13485 -1155 920 -725 C \nATOM 1061 OG SER A 133 6.107 -30.605 -73.257 1.00106.53 O \nANISOU 1061 OG SER A 133 12778 12609 15090 -1164 938 -743 O \nATOM 1062 N ALA A 134 5.390 -28.249 -69.737 1.00 95.63 N \nANISOU 1062 N ALA A 134 11331 11140 13864 -954 831 -702 N \nATOM 1063 CA ALA A 134 5.670 -27.466 -68.518 1.00 86.44 C \nANISOU 1063 CA ALA A 134 10201 9919 12723 -890 809 -672 C \nATOM 1064 C ALA A 134 4.705 -27.847 -67.389 1.00 77.21 C \nANISOU 1064 C ALA A 134 8955 8785 11597 -923 768 -697 C \nATOM 1065 O ALA A 134 5.030 -27.726 -66.203 1.00 70.52 O \nANISOU 1065 O ALA A 134 8157 7891 10748 -916 755 -678 O \nATOM 1066 CB ALA A 134 5.587 -25.985 -68.814 1.00 75.39 C \nANISOU 1066 CB ALA A 134 8761 8515 11368 -774 794 -652 C \nATOM 1067 N CYS A 135 3.525 -28.320 -67.782 1.00 79.24 N \nANISOU 1067 N CYS A 135 9091 9128 11889 -956 748 -741 N \nATOM 1068 CA CYS A 135 2.493 -28.756 -66.848 1.00 88.59 C \nANISOU 1068 CA CYS A 135 10189 10361 13111 -985 708 -769 C \nATOM 1069 C CYS A 135 2.235 -30.267 -66.961 1.00 92.71 C \nANISOU 1069 C CYS A 135 10691 10945 13588 -1104 721 -802 C \nATOM 1070 O CYS A 135 1.343 -30.708 -67.681 1.00 90.21 O \nANISOU 1070 O CYS A 135 10273 10715 13287 -1126 715 -841 O \nATOM 1071 CB CYS A 135 1.184 -27.984 -67.110 1.00 85.79 C \nANISOU 1071 CB CYS A 135 9698 10064 12836 -910 667 -794 C \nATOM 1072 SG CYS A 135 0.086 -27.768 -65.694 1.00103.82 S \nANISOU 1072 SG CYS A 135 11900 12367 15181 -882 607 -805 S \nATOM 1073 N PRO A 136 3.001 -31.067 -66.220 1.00102.37 N \nANISOU 1073 N PRO A 136 12014 12130 14754 -1184 739 -789 N \nATOM 1074 CA PRO A 136 2.756 -32.491 -66.186 1.00109.90 C \nANISOU 1074 CA PRO A 136 12949 13148 15659 -1307 749 -819 C \nATOM 1075 C PRO A 136 1.512 -32.845 -65.376 1.00109.56 C \nANISOU 1075 C PRO A 136 12781 13188 15660 -1319 703 -851 C \nATOM 1076 O PRO A 136 1.015 -32.033 -64.601 1.00123.73 O \nANISOU 1076 O PRO A 136 14531 14966 17515 -1240 665 -842 O \nATOM 1077 CB PRO A 136 4.025 -33.049 -65.517 1.00116.42 C \nANISOU 1077 CB PRO A 136 13936 13890 16410 -1379 780 -789 C \nATOM 1078 CG PRO A 136 5.029 -31.941 -65.574 1.00117.29 C \nANISOU 1078 CG PRO A 136 14150 13893 16521 -1285 796 -744 C \nATOM 1079 CD PRO A 136 4.201 -30.708 -65.450 1.00115.07 C \nANISOU 1079 CD PRO A 136 13761 13631 16328 -1166 755 -744 C \nATOM 1080 N TYR A 137 1.032 -34.064 -65.567 1.00110.05 N \nANISOU 1080 N TYR A 137 12787 13343 15685 -1420 708 -886 N \nATOM 1081 CA TYR A 137 -0.104 -34.610 -64.834 1.00110.16 C \nANISOU 1081 CA TYR A 137 12682 13452 15723 -1442 668 -918 C \nATOM 1082 C TYR A 137 0.295 -35.947 -64.233 1.00116.15 C \nANISOU 1082 C TYR A 137 13489 14240 16404 -1583 685 -925 C \nATOM 1083 O TYR A 137 0.557 -36.078 -63.031 1.00121.73 O \nANISOU 1083 O TYR A 137 14242 14909 17100 -1608 671 -908 O \nATOM 1084 CB TYR A 137 -1.309 -34.808 -65.769 1.00103.23 C \nANISOU 1084 CB TYR A 137 11655 12693 14876 -1421 654 -964 C \nATOM 1085 CG TYR A 137 -2.366 -35.799 -65.283 1.00 93.84 C \nANISOU 1085 CG TYR A 137 10345 11630 13680 -1476 626 -1003 C \nATOM 1086 CD1 TYR A 137 -2.665 -35.940 -63.930 1.00 95.50 C \nANISOU 1086 CD1 TYR A 137 10541 11844 13903 -1481 592 -997 C \nATOM 1087 CD2 TYR A 137 -3.070 -36.584 -66.190 1.00 95.91 C \nANISOU 1087 CD2 TYR A 137 10506 12017 13920 -1519 634 -1047 C \nATOM 1088 CE1 TYR A 137 -3.627 -36.840 -63.498 1.00 93.12 C \nANISOU 1088 CE1 TYR A 137 10125 11666 13590 -1526 566 -1032 C \nATOM 1089 CE2 TYR A 137 -4.038 -37.485 -65.769 1.00 94.89 C \nANISOU 1089 CE2 TYR A 137 10259 12016 13778 -1562 609 -1084 C \nATOM 1090 CZ TYR A 137 -4.313 -37.602 -64.422 1.00 93.61 C \nANISOU 1090 CZ TYR A 137 10084 11855 13628 -1564 574 -1075 C \nATOM 1091 OH TYR A 137 -5.270 -38.479 -64.000 1.00 95.91 O \nANISOU 1091 OH TYR A 137 10255 12281 13903 -1601 548 -1109 O \nATOM 1092 N GLN A 138 0.303 -36.952 -65.089 1.00105.69 N \nANISOU 1092 N GLN A 138 12148 12990 15020 -1681 713 -951 N \nATOM 1093 CA GLN A 138 0.705 -38.265 -64.693 1.00100.73 C \nANISOU 1093 CA GLN A 138 11569 12398 14305 -1830 734 -959 C \nATOM 1094 C GLN A 138 1.826 -38.610 -65.664 1.00 97.92 C \nANISOU 1094 C GLN A 138 11342 11987 13877 -1900 788 -945 C \nATOM 1095 O GLN A 138 1.801 -39.656 -66.332 1.00 87.06 O \nANISOU 1095 O GLN A 138 9952 10692 12437 -2013 813 -970 O \nATOM 1096 CB GLN A 138 -0.494 -39.195 -64.805 1.00 97.01 C \nANISOU 1096 CB GLN A 138 10940 12094 13827 -1886 712 -1008 C \nATOM 1097 CG GLN A 138 -0.370 -40.442 -63.979 1.00 97.74 C \nANISOU 1097 CG GLN A 138 11049 12244 13845 -2029 715 -1018 C \nATOM 1098 CD GLN A 138 -0.645 -40.243 -62.502 1.00 88.57 C \nANISOU 1098 CD GLN A 138 9874 11064 12715 -2001 676 -1006 C \nATOM 1099 OE1 GLN A 138 -1.715 -39.784 -62.108 1.00 85.11 O \nANISOU 1099 OE1 GLN A 138 9311 10680 12347 -1909 631 -1019 O \nATOM 1100 NE2 GLN A 138 0.297 -40.652 -61.674 1.00 90.71 N \nANISOU 1100 NE2 GLN A 138 10276 11262 12928 -2088 694 -981 N \nATOM 1101 N GLY A 139 2.817 -37.713 -65.728 1.00 92.23 N \nANISOU 1101 N GLY A 139 10747 11131 13164 -1830 806 -904 N \nATOM 1102 CA GLY A 139 3.905 -37.795 -66.696 1.00 95.76 C \nANISOU 1102 CA GLY A 139 11324 11509 13552 -1862 855 -884 C \nATOM 1103 C GLY A 139 3.520 -37.136 -68.012 1.00104.82 C \nANISOU 1103 C GLY A 139 12398 12687 14742 -1780 860 -893 C \nATOM 1104 O GLY A 139 4.279 -36.345 -68.582 1.00114.48 O \nANISOU 1104 O GLY A 139 13705 13823 15968 -1710 881 -862 O \nATOM 1105 N THR A 140 2.330 -37.477 -68.496 1.00105.65 N \nANISOU 1105 N THR A 140 12344 12922 14876 -1788 840 -937 N \nATOM 1106 CA THR A 140 1.797 -36.935 -69.734 1.00111.10 C \nANISOU 1106 CA THR A 140 12949 13658 15607 -1716 841 -954 C \nATOM 1107 C THR A 140 1.756 -35.409 -69.666 1.00108.80 C \nANISOU 1107 C THR A 140 12652 13289 15397 -1561 820 -929 C \nATOM 1108 O THR A 140 1.558 -34.842 -68.592 1.00111.94 O \nANISOU 1108 O THR A 140 13042 13649 15841 -1501 788 -915 O \nATOM 1109 CB THR A 140 0.357 -37.433 -69.994 1.00113.46 C \nANISOU 1109 CB THR A 140 13064 14110 15936 -1725 814 -1008 C \nATOM 1110 OG1 THR A 140 -0.504 -36.948 -68.957 1.00124.97 O \nANISOU 1110 OG1 THR A 140 14436 15583 17463 -1648 764 -1014 O \nATOM 1111 CG2 THR A 140 0.280 -38.957 -70.034 1.00115.31 C \nANISOU 1111 CG2 THR A 140 13280 14447 16086 -1883 831 -1037 C \nATOM 1112 N PRO A 141 1.941 -34.742 -70.815 1.00105.42 N \nANISOU 1112 N PRO A 141 12228 12844 14983 -1500 838 -922 N \nATOM 1113 CA PRO A 141 1.750 -33.305 -70.838 1.00108.41 C \nANISOU 1113 CA PRO A 141 12582 13173 15438 -1360 816 -904 C \nATOM 1114 C PRO A 141 0.284 -32.933 -70.632 1.00109.79 C \nANISOU 1114 C PRO A 141 12597 13428 15691 -1294 768 -940 C \nATOM 1115 O PRO A 141 -0.579 -33.387 -71.377 1.00119.55 O \nANISOU 1115 O PRO A 141 13726 14764 16933 -1312 765 -982 O \nATOM 1116 CB PRO A 141 2.209 -32.906 -72.246 1.00104.30 C \nANISOU 1116 CB PRO A 141 12090 12639 14900 -1334 848 -896 C \nATOM 1117 CG PRO A 141 2.055 -34.127 -73.070 1.00100.54 C \nANISOU 1117 CG PRO A 141 11587 12247 14365 -1447 874 -929 C \nATOM 1118 CD PRO A 141 2.346 -35.265 -72.134 1.00106.28 C \nANISOU 1118 CD PRO A 141 12367 12980 15036 -1562 879 -931 C \nATOM 1119 N SER A 142 0.009 -32.142 -69.602 1.00110.56 N \nANISOU 1119 N SER A 142 12682 13482 15843 -1218 732 -923 N \nATOM 1120 CA SER A 142 -1.355 -31.683 -69.314 1.00 98.64 C \nANISOU 1120 CA SER A 142 11040 12032 14409 -1145 684 -952 C \nATOM 1121 C SER A 142 -1.346 -30.165 -69.086 1.00 85.82 C \nANISOU 1121 C SER A 142 9429 10332 12846 -1026 661 -923 C \nATOM 1122 O SER A 142 -0.445 -29.455 -69.556 1.00 80.42 O \nANISOU 1122 O SER A 142 8827 9580 12149 -992 686 -891 O \nATOM 1123 CB SER A 142 -1.936 -32.469 -68.136 1.00 99.38 C \nANISOU 1123 CB SER A 142 11086 12174 14501 -1194 654 -968 C \nATOM 1124 OG SER A 142 -1.218 -32.133 -66.969 1.00105.97 O \nANISOU 1124 OG SER A 142 12014 12918 15333 -1188 648 -929 O \nATOM 1125 N PHE A 143 -2.345 -29.684 -68.360 1.00 77.68 N \nANISOU 1125 N PHE A 143 8319 9319 11877 -965 614 -935 N \nATOM 1126 CA PHE A 143 -2.594 -28.263 -68.186 1.00 69.93 C \nANISOU 1126 CA PHE A 143 7330 8286 10955 -858 587 -916 C \nATOM 1127 C PHE A 143 -3.714 -28.059 -67.184 1.00 61.66 C \nANISOU 1127 C PHE A 143 6205 7261 9963 -816 533 -931 C \nATOM 1128 O PHE A 143 -4.428 -28.969 -66.879 1.00 59.83 O \nANISOU 1128 O PHE A 143 5906 7100 9727 -855 518 -962 O \nATOM 1129 CB PHE A 143 -2.985 -27.645 -69.508 1.00 63.84 C \nANISOU 1129 CB PHE A 143 6510 7539 10206 -806 595 -934 C \nATOM 1130 CG PHE A 143 -3.074 -26.158 -69.470 1.00 61.83 C \nANISOU 1130 CG PHE A 143 6263 7231 10000 -710 574 -911 C \nATOM 1131 CD1 PHE A 143 -1.915 -25.375 -69.499 1.00 61.68 C \nANISOU 1131 CD1 PHE A 143 6339 7136 9959 -686 597 -864 C \nATOM 1132 CD2 PHE A 143 -4.303 -25.524 -69.424 1.00 60.18 C \nANISOU 1132 CD2 PHE A 143 5967 7047 9852 -643 532 -935 C \nATOM 1133 CE1 PHE A 143 -1.993 -23.982 -69.502 1.00 51.67 C \nANISOU 1133 CE1 PHE A 143 5071 5832 8729 -603 578 -843 C \nATOM 1134 CE2 PHE A 143 -4.381 -24.140 -69.416 1.00 52.19 C \nANISOU 1134 CE2 PHE A 143 4965 5987 8877 -566 514 -914 C \nATOM 1135 CZ PHE A 143 -3.233 -23.374 -69.445 1.00 48.32 C \nANISOU 1135 CZ PHE A 143 4562 5434 8364 -550 536 -868 C \nATOM 1136 N PHE A 144 -3.831 -26.864 -66.653 1.00 55.82 N \nANISOU 1136 N PHE A 144 5478 6463 9268 -738 505 -906 N \nATOM 1137 CA PHE A 144 -4.892 -26.537 -65.705 1.00 57.88 C \nANISOU 1137 CA PHE A 144 5675 6735 9581 -691 451 -916 C \nATOM 1138 C PHE A 144 -6.229 -27.098 -66.176 1.00 57.64 C \nANISOU 1138 C PHE A 144 5529 6798 9574 -680 430 -968 C \nATOM 1139 O PHE A 144 -6.528 -27.105 -67.373 1.00 58.92 O \nANISOU 1139 O PHE A 144 5652 7001 9737 -668 447 -995 O \nATOM 1140 CB PHE A 144 -5.030 -25.007 -65.544 1.00 58.15 C \nANISOU 1140 CB PHE A 144 5724 6708 9663 -602 426 -891 C \nATOM 1141 CG PHE A 144 -3.780 -24.313 -65.044 1.00 49.70 C \nANISOU 1141 CG PHE A 144 4757 5556 8571 -596 444 -840 C \nATOM 1142 CD1 PHE A 144 -3.046 -23.444 -65.879 1.00 44.33 C \nANISOU 1142 CD1 PHE A 144 4123 4841 7879 -562 471 -817 C \nATOM 1143 CD2 PHE A 144 -3.343 -24.556 -63.774 1.00 44.60 C \nANISOU 1143 CD2 PHE A 144 4159 4875 7912 -623 433 -816 C \nATOM 1144 CE1 PHE A 144 -1.889 -22.828 -65.409 1.00 52.12 C \nANISOU 1144 CE1 PHE A 144 5201 5762 8839 -549 487 -771 C \nATOM 1145 CE2 PHE A 144 -2.214 -23.939 -63.278 1.00 48.27 C \nANISOU 1145 CE2 PHE A 144 4718 5269 8354 -612 449 -771 C \nATOM 1146 CZ PHE A 144 -1.474 -23.079 -64.083 1.00 54.92 C \nANISOU 1146 CZ PHE A 144 5605 6080 9183 -572 476 -748 C \nATOM 1147 N ARG A 145 -7.023 -27.567 -65.228 1.00 53.10 N \nANISOU 1147 N ARG A 145 4901 6260 9016 -681 393 -983 N \nATOM 1148 CA ARG A 145 -8.308 -28.183 -65.539 1.00 53.25 C \nANISOU 1148 CA ARG A 145 4807 6376 9050 -664 370 -1032 C \nATOM 1149 C ARG A 145 -9.462 -27.215 -65.570 1.00 49.47 C \nANISOU 1149 C ARG A 145 4275 5887 8633 -560 326 -1046 C \nATOM 1150 O ARG A 145 -10.481 -27.514 -66.183 1.00 53.55 O \nANISOU 1150 O ARG A 145 4708 6476 9164 -527 314 -1090 O \nATOM 1151 CB ARG A 145 -8.595 -29.278 -64.524 1.00 57.78 C \nANISOU 1151 CB ARG A 145 5345 7008 9600 -719 352 -1041 C \nATOM 1152 CG ARG A 145 -7.563 -30.403 -64.567 1.00 68.12 C \nANISOU 1152 CG ARG A 145 6705 8340 10839 -837 396 -1035 C \nATOM 1153 CD ARG A 145 -8.042 -31.634 -63.836 1.00 79.87 C \nANISOU 1153 CD ARG A 145 8131 9919 12296 -900 381 -1057 C \nATOM 1154 NE ARG A 145 -6.984 -32.629 -63.695 1.00 92.62 N \nANISOU 1154 NE ARG A 145 9813 11540 13838 -1021 421 -1045 N \nATOM 1155 CZ ARG A 145 -6.614 -33.506 -64.632 1.00 98.78 C \nANISOU 1155 CZ ARG A 145 10592 12378 14563 -1102 462 -1065 C \nATOM 1156 NH1 ARG A 145 -7.197 -33.527 -65.839 1.00101.66 N \nANISOU 1156 NH1 ARG A 145 10884 12806 14936 -1072 472 -1100 N \nATOM 1157 NH2 ARG A 145 -5.645 -34.373 -64.361 1.00 93.39 N \nANISOU 1157 NH2 ARG A 145 9984 11688 13810 -1217 495 -1052 N \nATOM 1158 N ASN A 146 -9.313 -26.063 -64.895 1.00 44.55 N \nANISOU 1158 N ASN A 146 3705 5177 8045 -510 302 -1011 N \nATOM 1159 CA ASN A 146 -10.437 -25.153 -64.697 1.00 42.09 C \nANISOU 1159 CA ASN A 146 3356 4847 7789 -420 254 -1021 C \nATOM 1160 C ASN A 146 -10.464 -24.024 -65.719 1.00 42.18 C \nANISOU 1160 C ASN A 146 3386 4819 7822 -368 263 -1021 C \nATOM 1161 O ASN A 146 -11.231 -23.050 -65.617 1.00 35.93 O \nANISOU 1161 O ASN A 146 2586 3993 7071 -299 228 -1023 O \nATOM 1162 CB ASN A 146 -10.403 -24.552 -63.332 1.00 43.14 C \nANISOU 1162 CB ASN A 146 3530 4917 7944 -401 217 -985 C \nATOM 1163 CG ASN A 146 -10.901 -25.456 -62.285 1.00 42.23 C \nANISOU 1163 CG ASN A 146 3374 4848 7823 -422 189 -993 C \nATOM 1164 OD1 ASN A 146 -11.753 -26.277 -62.549 1.00 50.07 O \nANISOU 1164 OD1 ASN A 146 4286 5924 8813 -417 179 -1033 O \nATOM 1165 ND2 ASN A 146 -10.301 -25.362 -61.072 1.00 47.67 N \nANISOU 1165 ND2 ASN A 146 4118 5489 8505 -451 178 -955 N \nATOM 1166 N VAL A 147 -9.608 -24.160 -66.716 1.00 42.98 N \nANISOU 1166 N VAL A 147 3514 4925 7890 -407 312 -1018 N \nATOM 1167 CA VAL A 147 -9.270 -23.078 -67.592 1.00 42.38 C \nANISOU 1167 CA VAL A 147 3472 4807 7823 -374 328 -1006 C \nATOM 1168 C VAL A 147 -8.756 -23.654 -68.906 1.00 46.55 C \nANISOU 1168 C VAL A 147 3994 5380 8314 -415 378 -1024 C \nATOM 1169 O VAL A 147 -8.012 -24.622 -68.929 1.00 60.91 O \nANISOU 1169 O VAL A 147 5833 7222 10088 -484 411 -1019 O \nATOM 1170 CB VAL A 147 -8.224 -22.215 -66.849 1.00 44.27 C \nANISOU 1170 CB VAL A 147 3799 4965 8056 -376 331 -950 C \nATOM 1171 CG1 VAL A 147 -6.871 -22.188 -67.536 1.00 42.60 C \nANISOU 1171 CG1 VAL A 147 3653 4734 7800 -414 383 -924 C \nATOM 1172 CG2 VAL A 147 -8.772 -20.809 -66.613 1.00 44.14 C \nANISOU 1172 CG2 VAL A 147 3791 4899 8081 -309 294 -937 C \nATOM 1173 N VAL A 148 -9.212 -23.080 -70.008 1.00 50.00 N \nANISOU 1173 N VAL A 148 4403 5830 8766 -374 384 -1047 N \nATOM 1174 CA VAL A 148 -8.925 -23.587 -71.327 1.00 46.31 C \nANISOU 1174 CA VAL A 148 3917 5411 8267 -406 427 -1069 C \nATOM 1175 C VAL A 148 -7.916 -22.721 -72.089 1.00 45.32 C \nANISOU 1175 C VAL A 148 3856 5240 8123 -405 460 -1037 C \nATOM 1176 O VAL A 148 -8.119 -21.521 -72.255 1.00 41.59 O \nANISOU 1176 O VAL A 148 3395 4728 7677 -352 444 -1026 O \nATOM 1177 CB VAL A 148 -10.209 -23.669 -72.156 1.00 41.66 C \nANISOU 1177 CB VAL A 148 3242 4884 7702 -361 413 -1125 C \nATOM 1178 CG1 VAL A 148 -9.937 -24.450 -73.422 1.00 43.15 C \nANISOU 1178 CG1 VAL A 148 3403 5140 7852 -407 458 -1152 C \nATOM 1179 CG2 VAL A 148 -11.295 -24.305 -71.327 1.00 43.40 C \nANISOU 1179 CG2 VAL A 148 3399 5147 7944 -339 373 -1154 C \nATOM 1180 N TRP A 149 -6.908 -23.369 -72.640 1.00 42.57 N \nANISOU 1180 N TRP A 149 3545 4905 7726 -465 506 -1025 N \nATOM 1181 CA TRP A 149 -5.917 -22.710 -73.486 1.00 42.92 C \nANISOU 1181 CA TRP A 149 3647 4918 7744 -464 541 -996 C \nATOM 1182 C TRP A 149 -6.253 -22.873 -74.925 1.00 48.44 C \nANISOU 1182 C TRP A 149 4299 5672 8433 -467 565 -1032 C \nATOM 1183 O TRP A 149 -5.897 -23.878 -75.553 1.00 57.95 O \nANISOU 1183 O TRP A 149 5499 6921 9597 -525 599 -1046 O \nATOM 1184 CB TRP A 149 -4.545 -23.343 -73.246 1.00 40.77 C \nANISOU 1184 CB TRP A 149 3457 4618 7416 -526 579 -960 C \nATOM 1185 CG TRP A 149 -3.434 -22.720 -73.975 1.00 42.16 C \nANISOU 1185 CG TRP A 149 3701 4760 7558 -518 614 -924 C \nATOM 1186 CD1 TRP A 149 -3.523 -21.788 -74.928 1.00 43.79 C \nANISOU 1186 CD1 TRP A 149 3893 4971 7774 -475 620 -924 C \nATOM 1187 CD2 TRP A 149 -2.032 -23.028 -73.842 1.00 43.35 C \nANISOU 1187 CD2 TRP A 149 3949 4868 7653 -556 651 -882 C \nATOM 1188 NE1 TRP A 149 -2.268 -21.468 -75.391 1.00 44.14 N \nANISOU 1188 NE1 TRP A 149 4013 4986 7773 -479 656 -884 N \nATOM 1189 CE2 TRP A 149 -1.343 -22.228 -74.738 1.00 44.23 C \nANISOU 1189 CE2 TRP A 149 4097 4965 7744 -524 676 -858 C \nATOM 1190 CE3 TRP A 149 -1.307 -23.911 -73.048 1.00 47.20 C \nANISOU 1190 CE3 TRP A 149 4502 5330 8103 -612 664 -864 C \nATOM 1191 CZ2 TRP A 149 0.041 -22.233 -74.830 1.00 48.25 C \nANISOU 1191 CZ2 TRP A 149 4705 5430 8197 -535 712 -814 C \nATOM 1192 CZ3 TRP A 149 0.059 -23.944 -73.168 1.00 47.45 C \nANISOU 1192 CZ3 TRP A 149 4637 5312 8079 -629 701 -823 C \nATOM 1193 CH2 TRP A 149 0.717 -23.113 -74.043 1.00 49.34 C \nANISOU 1193 CH2 TRP A 149 4911 5535 8300 -586 724 -798 C \nATOM 1194 N LEU A 150 -6.994 -21.914 -75.468 1.00 47.86 N \nANISOU 1194 N LEU A 150 4190 5599 8394 -408 547 -1049 N \nATOM 1195 CA LEU A 150 -7.560 -22.052 -76.826 1.00 44.09 C \nANISOU 1195 CA LEU A 150 3656 5181 7915 -403 564 -1092 C \nATOM 1196 C LEU A 150 -6.477 -21.843 -77.835 1.00 48.92 C \nANISOU 1196 C LEU A 150 4316 5789 8484 -429 609 -1067 C \nATOM 1197 O LEU A 150 -5.560 -21.056 -77.602 1.00 67.14 O \nANISOU 1197 O LEU A 150 6690 8041 10779 -417 617 -1019 O \nATOM 1198 CB LEU A 150 -8.711 -21.090 -77.025 1.00 46.03 C \nANISOU 1198 CB LEU A 150 3859 5421 8208 -333 529 -1119 C \nATOM 1199 CG LEU A 150 -9.909 -21.283 -76.106 1.00 50.59 C \nANISOU 1199 CG LEU A 150 4390 6005 8827 -296 482 -1147 C \nATOM 1200 CD1 LEU A 150 -10.923 -20.172 -76.331 1.00 57.50 C \nANISOU 1200 CD1 LEU A 150 5249 6856 9743 -227 449 -1167 C \nATOM 1201 CD2 LEU A 150 -10.577 -22.624 -76.352 1.00 58.25 C \nANISOU 1201 CD2 LEU A 150 5287 7059 9787 -319 487 -1196 C \nATOM 1202 N ILE A 151 -6.567 -22.544 -78.956 1.00 49.54 N \nANISOU 1202 N ILE A 151 4358 5929 8536 -462 639 -1099 N \nATOM 1203 CA ILE A 151 -5.689 -22.329 -80.096 1.00 52.16 C \nANISOU 1203 CA ILE A 151 4726 6265 8828 -482 681 -1082 C \nATOM 1204 C ILE A 151 -6.484 -22.391 -81.386 1.00 51.48 C \nANISOU 1204 C ILE A 151 4569 6244 8746 -474 691 -1132 C \nATOM 1205 O ILE A 151 -7.653 -22.713 -81.369 1.00 49.78 O \nANISOU 1205 O ILE A 151 4281 6073 8561 -454 668 -1181 O \nATOM 1206 CB ILE A 151 -4.488 -23.283 -80.152 1.00 58.08 C \nANISOU 1206 CB ILE A 151 5540 7011 9518 -554 721 -1054 C \nATOM 1207 CG1 ILE A 151 -4.913 -24.732 -80.380 1.00 68.44 C \nANISOU 1207 CG1 ILE A 151 6801 8396 10807 -620 733 -1097 C \nATOM 1208 CG2 ILE A 151 -3.669 -23.157 -78.890 1.00 56.04 C \nANISOU 1208 CG2 ILE A 151 5359 6682 9252 -557 713 -1005 C \nATOM 1209 CD1 ILE A 151 -3.844 -25.592 -81.030 1.00 76.96 C \nANISOU 1209 CD1 ILE A 151 7937 9487 11817 -699 781 -1081 C \nATOM 1210 N LYS A 152 -5.831 -22.024 -82.487 1.00 55.38 N \nANISOU 1210 N LYS A 152 5088 6744 9208 -483 724 -1118 N \nATOM 1211 CA LYS A 152 -6.489 -21.934 -83.776 1.00 56.67 C \nANISOU 1211 CA LYS A 152 5192 6966 9373 -474 736 -1162 C \nATOM 1212 C LYS A 152 -6.940 -23.265 -84.333 1.00 69.78 C \nANISOU 1212 C LYS A 152 6793 8708 11012 -524 754 -1210 C \nATOM 1213 O LYS A 152 -6.264 -24.294 -84.171 1.00 73.36 O \nANISOU 1213 O LYS A 152 7274 9176 11424 -591 778 -1197 O \nATOM 1214 CB LYS A 152 -5.554 -21.254 -84.785 1.00 50.98 C \nANISOU 1214 CB LYS A 152 4517 6236 8618 -477 769 -1129 C \nATOM 1215 CG LYS A 152 -4.328 -22.017 -85.149 1.00 49.04 C \nANISOU 1215 CG LYS A 152 4330 5991 8311 -538 812 -1098 C \nATOM 1216 CD LYS A 152 -3.466 -21.212 -86.111 1.00 54.03 C \nANISOU 1216 CD LYS A 152 5005 6613 8909 -525 839 -1064 C \nATOM 1217 CE LYS A 152 -2.230 -21.967 -86.592 1.00 53.46 C \nANISOU 1217 CE LYS A 152 5003 6539 8770 -582 883 -1032 C \nATOM 1218 NZ LYS A 152 -1.778 -21.443 -87.919 1.00 58.12 N \nANISOU 1218 NZ LYS A 152 5601 7155 9328 -576 912 -1021 N \nATOM 1219 N LYS A 153 -8.080 -23.228 -85.017 1.00 82.99 N \nANISOU 1219 N LYS A 153 8387 10436 12708 -494 744 -1266 N \nATOM 1220 CA LYS A 153 -8.606 -24.377 -85.744 1.00 83.60 C \nANISOU 1220 CA LYS A 153 8394 10609 12762 -534 763 -1318 C \nATOM 1221 C LYS A 153 -8.461 -24.079 -87.230 1.00 83.52 C \nANISOU 1221 C LYS A 153 8372 10633 12726 -542 795 -1332 C \nATOM 1222 O LYS A 153 -8.779 -22.983 -87.674 1.00 79.91 O \nANISOU 1222 O LYS A 153 7916 10152 12295 -489 786 -1335 O \nATOM 1223 CB LYS A 153 -10.062 -24.588 -85.382 1.00 87.87 C \nANISOU 1223 CB LYS A 153 8850 11192 13343 -483 727 -1374 C \nATOM 1224 CG LYS A 153 -10.554 -25.996 -85.632 1.00 91.94 C \nANISOU 1224 CG LYS A 153 9291 11812 13830 -528 739 -1421 C \nATOM 1225 CD LYS A 153 -12.053 -26.069 -85.368 1.00100.23 C \nANISOU 1225 CD LYS A 153 10255 12908 14920 -457 703 -1478 C \nATOM 1226 CE LYS A 153 -12.474 -27.421 -84.818 1.00 98.34 C \nANISOU 1226 CE LYS A 153 9952 12755 14660 -492 697 -1507 C \nATOM 1227 NZ LYS A 153 -13.683 -27.302 -83.956 1.00101.96 N \nANISOU 1227 NZ LYS A 153 10360 13218 15164 -410 649 -1535 N \nATOM 1228 N ASN A 154 -7.988 -25.060 -87.995 1.00 87.02 N \nANISOU 1228 N ASN A 154 8808 11137 13117 -613 834 -1341 N \nATOM 1229 CA ASN A 154 -7.423 -24.795 -89.315 1.00 82.84 C \nANISOU 1229 CA ASN A 154 8297 10626 12553 -636 870 -1334 C \nATOM 1230 C ASN A 154 -6.330 -23.772 -89.104 1.00 80.70 C \nANISOU 1230 C ASN A 154 8119 10267 12276 -617 875 -1267 C \nATOM 1231 O ASN A 154 -5.645 -23.825 -88.079 1.00 83.62 O \nANISOU 1231 O ASN A 154 8552 10578 12644 -626 867 -1224 O \nATOM 1232 CB ASN A 154 -8.486 -24.311 -90.303 1.00 84.47 C \nANISOU 1232 CB ASN A 154 8430 10882 12782 -589 865 -1389 C \nATOM 1233 CG ASN A 154 -9.289 -25.453 -90.884 1.00 88.00 C \nANISOU 1233 CG ASN A 154 8788 11437 13210 -620 877 -1453 C \nATOM 1234 OD1 ASN A 154 -9.285 -25.697 -92.101 1.00 82.64 O \nANISOU 1234 OD1 ASN A 154 8080 10820 12500 -649 907 -1477 O \nATOM 1235 ND2 ASN A 154 -10.005 -26.155 -90.015 1.00 87.90 N \nANISOU 1235 ND2 ASN A 154 8728 11455 13216 -612 852 -1480 N \nATOM 1236 N ASN A 155 -6.141 -22.859 -90.044 1.00 72.98 N \nANISOU 1236 N ASN A 155 7151 9285 11294 -592 887 -1259 N \nATOM 1237 CA ASN A 155 -5.334 -21.690 -89.757 1.00 79.64 C \nANISOU 1237 CA ASN A 155 8064 10056 12139 -555 882 -1201 C \nATOM 1238 C ASN A 155 -6.223 -20.467 -89.506 1.00 73.88 C \nANISOU 1238 C ASN A 155 7305 9302 11464 -483 845 -1216 C \nATOM 1239 O ASN A 155 -6.296 -19.532 -90.306 1.00 71.20 O \nANISOU 1239 O ASN A 155 6960 8969 11123 -458 850 -1217 O \nATOM 1240 CB ASN A 155 -4.335 -21.480 -90.874 1.00 86.10 C \nANISOU 1240 CB ASN A 155 8925 10886 12905 -580 922 -1170 C \nATOM 1241 CG ASN A 155 -3.369 -22.634 -90.979 1.00 89.12 C \nANISOU 1241 CG ASN A 155 9359 11274 13229 -652 956 -1148 C \nATOM 1242 OD1 ASN A 155 -3.431 -23.578 -90.187 1.00 81.04 O \nANISOU 1242 OD1 ASN A 155 8339 10248 12204 -689 950 -1155 O \nATOM 1243 ND2 ASN A 155 -2.481 -22.573 -91.958 1.00 97.75 N \nANISOU 1243 ND2 ASN A 155 10495 12375 14270 -676 991 -1120 N \nATOM 1244 N THR A 156 -6.951 -20.530 -88.403 1.00 63.08 N \nANISOU 1244 N THR A 156 5919 7910 10140 -455 808 -1231 N \nATOM 1245 CA THR A 156 -7.935 -19.514 -88.088 1.00 70.55 C \nANISOU 1245 CA THR A 156 6839 8830 11135 -393 770 -1251 C \nATOM 1246 C THR A 156 -8.277 -19.427 -86.583 1.00 72.45 C \nANISOU 1246 C THR A 156 7094 9018 11415 -364 729 -1239 C \nATOM 1247 O THR A 156 -8.761 -20.386 -85.985 1.00 67.73 O \nANISOU 1247 O THR A 156 6465 8441 10830 -375 718 -1263 O \nATOM 1248 CB THR A 156 -9.229 -19.745 -88.859 1.00 70.27 C \nANISOU 1248 CB THR A 156 6727 8853 11119 -373 764 -1323 C \nATOM 1249 OG1 THR A 156 -8.908 -20.011 -90.223 1.00 83.70 O \nANISOU 1249 OG1 THR A 156 8410 10611 12780 -408 804 -1337 O \nATOM 1250 CG2 THR A 156 -10.130 -18.502 -88.778 1.00 75.58 C \nANISOU 1250 CG2 THR A 156 7395 9491 11833 -311 730 -1340 C \nATOM 1251 N TYR A 157 -8.023 -18.255 -86.003 1.00 69.12 N \nANISOU 1251 N TYR A 157 6716 8535 11009 -331 708 -1200 N \nATOM 1252 CA TYR A 157 -8.469 -17.935 -84.652 1.00 57.87 C \nANISOU 1252 CA TYR A 157 5304 7059 9625 -298 665 -1190 C \nATOM 1253 C TYR A 157 -9.498 -16.786 -84.812 1.00 60.10 C \nANISOU 1253 C TYR A 157 5570 7323 9942 -248 634 -1215 C \nATOM 1254 O TYR A 157 -9.162 -15.615 -84.740 1.00 56.32 O \nANISOU 1254 O TYR A 157 5128 6809 9461 -234 625 -1182 O \nATOM 1255 CB TYR A 157 -7.273 -17.539 -83.781 1.00 51.99 C \nANISOU 1255 CB TYR A 157 4631 6260 8863 -306 667 -1122 C \nATOM 1256 CG TYR A 157 -7.578 -17.428 -82.269 1.00 43.14 C \nANISOU 1256 CG TYR A 157 3526 5088 7777 -285 627 -1107 C \nATOM 1257 CD1 TYR A 157 -6.954 -18.228 -81.371 1.00 40.66 C \nANISOU 1257 CD1 TYR A 157 3241 4756 7451 -313 631 -1082 C \nATOM 1258 CD2 TYR A 157 -8.481 -16.492 -81.773 1.00 37.98 C \nANISOU 1258 CD2 TYR A 157 2863 4403 7164 -240 585 -1118 C \nATOM 1259 CE1 TYR A 157 -7.233 -18.160 -80.025 1.00 39.26 C \nANISOU 1259 CE1 TYR A 157 3077 4538 7304 -296 595 -1069 C \nATOM 1260 CE2 TYR A 157 -8.738 -16.377 -80.416 1.00 35.86 C \nANISOU 1260 CE2 TYR A 157 2612 4088 6924 -223 548 -1102 C \nATOM 1261 CZ TYR A 157 -8.133 -17.217 -79.558 1.00 36.45 C \nANISOU 1261 CZ TYR A 157 2708 4152 6989 -249 553 -1079 C \nATOM 1262 OH TYR A 157 -8.383 -17.140 -78.200 1.00 35.95 O \nANISOU 1262 OH TYR A 157 2660 4048 6953 -234 517 -1063 O \nATOM 1263 N PRO A 158 -10.756 -17.136 -85.066 1.00 62.35 N \nANISOU 1263 N PRO A 158 5801 7636 10254 -222 617 -1275 N \nATOM 1264 CA PRO A 158 -11.745 -16.088 -85.200 1.00 58.68 C \nANISOU 1264 CA PRO A 158 5333 7144 9817 -176 587 -1300 C \nATOM 1265 C PRO A 158 -11.913 -15.341 -83.906 1.00 54.77 C \nANISOU 1265 C PRO A 158 4880 6579 9352 -150 545 -1270 C \nATOM 1266 O PRO A 158 -11.564 -15.857 -82.838 1.00 57.90 O \nANISOU 1266 O PRO A 158 5289 6955 9755 -157 534 -1244 O \nATOM 1267 CB PRO A 158 -13.058 -16.876 -85.556 1.00 63.23 C \nANISOU 1267 CB PRO A 158 5846 7765 10415 -146 577 -1373 C \nATOM 1268 CG PRO A 158 -12.842 -18.273 -85.083 1.00 59.38 C \nANISOU 1268 CG PRO A 158 5325 7317 9918 -172 587 -1377 C \nATOM 1269 CD PRO A 158 -11.360 -18.496 -85.190 1.00 65.97 C \nANISOU 1269 CD PRO A 158 6199 8153 10714 -232 623 -1323 C \nATOM 1270 N THR A 159 -12.520 -14.165 -83.978 1.00 52.84 N \nANISOU 1270 N THR A 159 4656 6298 9122 -122 520 -1276 N \nATOM 1271 CA THR A 159 -12.616 -13.326 -82.803 1.00 48.72 C \nANISOU 1271 CA THR A 159 4180 5712 8621 -105 480 -1243 C \nATOM 1272 C THR A 159 -13.682 -13.812 -81.849 1.00 54.89 C \nANISOU 1272 C THR A 159 4946 6466 9442 -66 440 -1271 C \nATOM 1273 O THR A 159 -14.811 -13.970 -82.237 1.00 67.55 O \nANISOU 1273 O THR A 159 6524 8080 11064 -29 426 -1325 O \nATOM 1274 CB THR A 159 -12.788 -11.861 -83.182 1.00 39.32 C \nANISOU 1274 CB THR A 159 3023 4493 7422 -102 469 -1234 C \nATOM 1275 OG1 THR A 159 -11.570 -11.449 -83.820 1.00 37.96 O \nANISOU 1275 OG1 THR A 159 2864 4350 7208 -138 505 -1193 O \nATOM 1276 CG2 THR A 159 -12.971 -11.011 -81.967 1.00 36.71 C \nANISOU 1276 CG2 THR A 159 2739 4100 7111 -90 426 -1203 C \nATOM 1277 N ILE A 160 -13.273 -14.070 -80.600 1.00 59.82 N \nANISOU 1277 N ILE A 160 5592 7062 10077 -71 422 -1234 N \nATOM 1278 CA ILE A 160 -14.129 -14.600 -79.568 1.00 51.68 C \nANISOU 1278 CA ILE A 160 4547 6010 9079 -37 384 -1252 C \nATOM 1279 C ILE A 160 -14.901 -13.491 -78.923 1.00 60.84 C \nANISOU 1279 C ILE A 160 5750 7103 10264 -3 338 -1248 C \nATOM 1280 O ILE A 160 -14.336 -12.445 -78.600 1.00 68.12 O \nANISOU 1280 O ILE A 160 6720 7986 11176 -23 331 -1205 O \nATOM 1281 CB ILE A 160 -13.303 -15.309 -78.501 1.00 46.27 C \nANISOU 1281 CB ILE A 160 3870 5320 8389 -65 386 -1212 C \nATOM 1282 CG1 ILE A 160 -12.710 -16.618 -79.095 1.00 43.67 C \nANISOU 1282 CG1 ILE A 160 3501 5059 8033 -104 429 -1224 C \nATOM 1283 CG2 ILE A 160 -14.151 -15.693 -77.280 1.00 47.93 C \nANISOU 1283 CG2 ILE A 160 4072 5505 8633 -31 341 -1223 C \nATOM 1284 CD1 ILE A 160 -11.608 -17.246 -78.241 1.00 42.86 C \nANISOU 1284 CD1 ILE A 160 3423 4949 7912 -146 442 -1179 C \nATOM 1285 N LYS A 161 -16.195 -13.733 -78.718 1.00 59.70 N \nANISOU 1285 N LYS A 161 5589 6948 10148 49 305 -1294 N \nATOM 1286 CA LYS A 161 -17.085 -12.772 -78.109 1.00 64.07 C \nANISOU 1286 CA LYS A 161 6190 7431 10723 85 258 -1295 C \nATOM 1287 C LYS A 161 -18.114 -13.578 -77.342 1.00 60.12 C \nANISOU 1287 C LYS A 161 5664 6928 10252 139 223 -1326 C \nATOM 1288 O LYS A 161 -19.019 -14.160 -77.903 1.00 76.59 O \nANISOU 1288 O LYS A 161 7710 9046 12344 184 222 -1380 O \nATOM 1289 CB LYS A 161 -17.726 -11.889 -79.175 1.00 72.61 C \nANISOU 1289 CB LYS A 161 7291 8499 11796 98 260 -1329 C \nATOM 1290 CG LYS A 161 -17.542 -10.403 -78.929 1.00 78.94 C \nANISOU 1290 CG LYS A 161 8164 9242 12589 73 241 -1293 C \nATOM 1291 CD LYS A 161 -18.020 -9.602 -80.132 1.00 81.26 C \nANISOU 1291 CD LYS A 161 8476 9536 12866 72 252 -1326 C \nATOM 1292 CE LYS A 161 -17.845 -8.103 -79.891 1.00 88.49 C \nANISOU 1292 CE LYS A 161 9459 10401 13763 36 233 -1290 C \nATOM 1293 NZ LYS A 161 -18.794 -7.593 -78.859 1.00 91.04 N \nANISOU 1293 NZ LYS A 161 9838 10645 14107 65 179 -1290 N \nATOM 1294 N ARG A 162 -17.917 -13.642 -76.043 1.00 58.57 N \nANISOU 1294 N ARG A 162 5488 6698 10069 136 196 -1289 N \nATOM 1295 CA ARG A 162 -18.723 -14.446 -75.142 1.00 56.09 C \nANISOU 1295 CA ARG A 162 5147 6386 9777 183 162 -1307 C \nATOM 1296 C ARG A 162 -18.995 -13.601 -73.915 1.00 52.39 C \nANISOU 1296 C ARG A 162 4742 5836 9327 195 113 -1272 C \nATOM 1297 O ARG A 162 -18.113 -12.845 -73.473 1.00 55.95 O \nANISOU 1297 O ARG A 162 5238 6254 9768 148 116 -1221 O \nATOM 1298 CB ARG A 162 -17.965 -15.745 -74.708 1.00 53.98 C \nANISOU 1298 CB ARG A 162 4828 6180 9501 148 184 -1293 C \nATOM 1299 CG ARG A 162 -17.480 -16.596 -75.860 1.00 58.85 C \nANISOU 1299 CG ARG A 162 5390 6878 10092 117 235 -1319 C \nATOM 1300 CD ARG A 162 -18.620 -17.404 -76.500 1.00 64.55 C \nANISOU 1300 CD ARG A 162 6046 7661 10818 171 233 -1386 C \nATOM 1301 NE ARG A 162 -19.086 -18.380 -75.527 1.00 67.61 N \nANISOU 1301 NE ARG A 162 6393 8080 11216 195 207 -1394 N \nATOM 1302 CZ ARG A 162 -18.798 -19.665 -75.537 1.00 62.70 C \nANISOU 1302 CZ ARG A 162 5707 7542 10575 166 229 -1406 C \nATOM 1303 NH1 ARG A 162 -18.066 -20.179 -76.504 1.00 62.02 N \nANISOU 1303 NH1 ARG A 162 5592 7513 10458 111 278 -1413 N \nATOM 1304 NH2 ARG A 162 -19.276 -20.422 -74.573 1.00 63.82 N \nANISOU 1304 NH2 ARG A 162 5814 7710 10724 189 201 -1411 N \nATOM 1305 N SER A 163 -20.150 -13.822 -73.300 1.00 46.57 N \nANISOU 1305 N SER A 163 4006 5076 8612 258 70 -1297 N \nATOM 1306 CA SER A 163 -20.472 -13.110 -72.082 1.00 50.94 C \nANISOU 1306 CA SER A 163 4620 5554 9182 270 22 -1264 C \nATOM 1307 C SER A 163 -21.350 -13.926 -71.178 1.00 46.18 C \nANISOU 1307 C SER A 163 3991 4956 8598 329 -16 -1281 C \nATOM 1308 O SER A 163 -22.049 -14.791 -71.634 1.00 58.49 O \nANISOU 1308 O SER A 163 5494 6568 10160 380 -13 -1329 O \nATOM 1309 CB SER A 163 -21.131 -11.748 -72.410 1.00 59.30 C \nANISOU 1309 CB SER A 163 5754 6537 10239 285 -2 -1271 C \nATOM 1310 OG SER A 163 -22.542 -11.846 -72.453 1.00 64.41 O \nANISOU 1310 OG SER A 163 6414 7157 10901 365 -36 -1317 O \nATOM 1311 N TYR A 164 -21.290 -13.643 -69.886 1.00 42.60 N \nANISOU 1311 N TYR A 164 3576 4455 8157 323 -52 -1241 N \nATOM 1312 CA TYR A 164 -21.947 -14.431 -68.856 1.00 44.65 C \nANISOU 1312 CA TYR A 164 3809 4724 8432 371 -89 -1246 C \nATOM 1313 C TYR A 164 -22.645 -13.540 -67.884 1.00 51.85 C \nANISOU 1313 C TYR A 164 4797 5546 9358 401 -145 -1224 C \nATOM 1314 O TYR A 164 -22.020 -12.653 -67.288 1.00 54.46 O \nANISOU 1314 O TYR A 164 5184 5823 9684 349 -153 -1176 O \nATOM 1315 CB TYR A 164 -20.956 -15.307 -68.098 1.00 41.38 C \nANISOU 1315 CB TYR A 164 3353 4359 8012 318 -72 -1212 C \nATOM 1316 CG TYR A 164 -21.602 -16.091 -66.966 1.00 44.08 C \nANISOU 1316 CG TYR A 164 3666 4715 8365 360 -112 -1214 C \nATOM 1317 CD1 TYR A 164 -22.379 -17.220 -67.239 1.00 43.32 C \nANISOU 1317 CD1 TYR A 164 3495 4696 8269 415 -114 -1262 C \nATOM 1318 CD2 TYR A 164 -21.469 -15.681 -65.614 1.00 38.07 C \nANISOU 1318 CD2 TYR A 164 2952 3899 7614 346 -149 -1168 C \nATOM 1319 CE1 TYR A 164 -22.984 -17.939 -66.210 1.00 43.91 C \nANISOU 1319 CE1 TYR A 164 3538 4795 8350 456 -151 -1262 C \nATOM 1320 CE2 TYR A 164 -22.077 -16.371 -64.621 1.00 40.67 C \nANISOU 1320 CE2 TYR A 164 3254 4244 7952 385 -186 -1169 C \nATOM 1321 CZ TYR A 164 -22.855 -17.508 -64.926 1.00 45.72 C \nANISOU 1321 CZ TYR A 164 3816 4965 8590 443 -188 -1217 C \nATOM 1322 OH TYR A 164 -23.502 -18.251 -63.923 1.00 54.81 O \nANISOU 1322 OH TYR A 164 4932 6146 9746 487 -226 -1218 O \nATOM 1323 N ASN A 165 -23.940 -13.778 -67.726 1.00 58.16 N \nANISOU 1323 N ASN A 165 5599 6331 10170 487 -183 -1260 N \nATOM 1324 CA ASN A 165 -24.736 -13.026 -66.799 1.00 68.71 C \nANISOU 1324 CA ASN A 165 7012 7579 11517 525 -239 -1243 C \nATOM 1325 C ASN A 165 -24.912 -13.891 -65.556 1.00 64.12 C \nANISOU 1325 C ASN A 165 6394 7024 10946 550 -270 -1227 C \nATOM 1326 O ASN A 165 -25.620 -14.871 -65.584 1.00 71.22 O \nANISOU 1326 O ASN A 165 7233 7980 11848 617 -279 -1263 O \nATOM 1327 CB ASN A 165 -26.078 -12.644 -67.456 1.00 77.89 C \nANISOU 1327 CB ASN A 165 8216 8697 12680 610 -263 -1292 C \nATOM 1328 CG ASN A 165 -26.871 -11.625 -66.661 1.00 84.11 C \nANISOU 1328 CG ASN A 165 9110 9375 13472 638 -319 -1273 C \nATOM 1329 OD1 ASN A 165 -26.609 -11.429 -65.475 1.00 88.32 O \nANISOU 1329 OD1 ASN A 165 9670 9875 14011 611 -348 -1227 O \nATOM 1330 ND2 ASN A 165 -27.857 -10.985 -67.311 1.00 91.58 N \nANISOU 1330 ND2 ASN A 165 10123 10261 14413 691 -335 -1309 N \nATOM 1331 N ASN A 166 -24.246 -13.512 -64.471 1.00 55.69 N \nANISOU 1331 N ASN A 166 5360 5921 9880 495 -285 -1172 N \nATOM 1332 CA ASN A 166 -24.449 -14.159 -63.194 1.00 57.53 C \nANISOU 1332 CA ASN A 166 5572 6165 10122 515 -319 -1152 C \nATOM 1333 C ASN A 166 -25.959 -14.155 -62.826 1.00 64.29 C \nANISOU 1333 C ASN A 166 6457 6983 10988 620 -375 -1178 C \nATOM 1334 O ASN A 166 -26.513 -13.169 -62.363 1.00 60.67 O \nANISOU 1334 O ASN A 166 6088 6431 10533 637 -416 -1161 O \nATOM 1335 CB ASN A 166 -23.610 -13.479 -62.114 1.00 54.10 C \nANISOU 1335 CB ASN A 166 5189 5681 9685 443 -332 -1089 C \nATOM 1336 CG ASN A 166 -23.628 -14.207 -60.769 1.00 51.96 C \nANISOU 1336 CG ASN A 166 4891 5430 9420 448 -362 -1065 C \nATOM 1337 OD1 ASN A 166 -24.235 -15.253 -60.626 1.00 60.18 O \nANISOU 1337 OD1 ASN A 166 5870 6530 10465 503 -373 -1093 O \nATOM 1338 ND2 ASN A 166 -23.041 -13.586 -59.752 1.00 46.96 N \nANISOU 1338 ND2 ASN A 166 4307 4750 8786 395 -378 -1013 N \nATOM 1339 N THR A 167 -26.601 -15.299 -63.024 1.00 67.26 N \nANISOU 1339 N THR A 167 6754 7437 11364 689 -376 -1219 N \nATOM 1340 CA THR A 167 -28.007 -15.459 -62.698 1.00 64.52 C \nANISOU 1340 CA THR A 167 6423 7070 11022 802 -426 -1246 C \nATOM 1341 C THR A 167 -28.246 -15.811 -61.226 1.00 70.27 C \nANISOU 1341 C THR A 167 7150 7794 11756 821 -472 -1213 C \nATOM 1342 O THR A 167 -29.385 -16.051 -60.843 1.00 76.53 O \nANISOU 1342 O THR A 167 7949 8579 12550 921 -516 -1231 O \nATOM 1343 CB THR A 167 -28.639 -16.539 -63.566 1.00 57.89 C \nANISOU 1343 CB THR A 167 5492 6330 10175 877 -407 -1308 C \nATOM 1344 OG1 THR A 167 -27.995 -17.804 -63.361 1.00 61.48 O \nANISOU 1344 OG1 THR A 167 5838 6903 10620 838 -380 -1307 O \nATOM 1345 CG2 THR A 167 -28.532 -16.203 -65.007 1.00 56.47 C \nANISOU 1345 CG2 THR A 167 5315 6153 9988 867 -365 -1344 C \nATOM 1346 N ASN A 168 -27.186 -15.842 -60.415 1.00 67.87 N \nANISOU 1346 N ASN A 168 6840 7497 11453 730 -463 -1164 N \nATOM 1347 CA ASN A 168 -27.282 -16.317 -59.029 1.00 66.08 C \nANISOU 1347 CA ASN A 168 6598 7282 11228 737 -501 -1132 C \nATOM 1348 C ASN A 168 -27.317 -15.170 -58.065 1.00 67.43 C \nANISOU 1348 C ASN A 168 6874 7341 11406 714 -543 -1084 C \nATOM 1349 O ASN A 168 -27.213 -14.031 -58.495 1.00 74.47 O \nANISOU 1349 O ASN A 168 7846 8153 12298 686 -540 -1075 O \nATOM 1350 CB ASN A 168 -26.095 -17.206 -58.708 1.00 68.60 C \nANISOU 1350 CB ASN A 168 6841 7686 11538 650 -464 -1112 C \nATOM 1351 CG ASN A 168 -25.940 -18.350 -59.695 1.00 74.53 C \nANISOU 1351 CG ASN A 168 7490 8553 12276 653 -418 -1158 C \nATOM 1352 OD1 ASN A 168 -26.665 -19.344 -59.624 1.00 99.43 O \nANISOU 1352 OD1 ASN A 168 10570 11788 15421 717 -432 -1189 O \nATOM 1353 ND2 ASN A 168 -24.978 -18.233 -60.606 1.00 65.83 N \nANISOU 1353 ND2 ASN A 168 6380 7465 11167 582 -363 -1160 N \nATOM 1354 N GLN A 169 -27.488 -15.470 -56.783 1.00 71.45 N \nANISOU 1354 N GLN A 169 7382 7850 11917 723 -583 -1053 N \nATOM 1355 CA GLN A 169 -27.587 -14.438 -55.740 1.00 80.00 C \nANISOU 1355 CA GLN A 169 8563 8831 13003 702 -627 -1006 C \nATOM 1356 C GLN A 169 -26.305 -14.337 -54.957 1.00 77.17 C \nANISOU 1356 C GLN A 169 8199 8481 12641 594 -609 -956 C \nATOM 1357 O GLN A 169 -26.245 -13.654 -53.928 1.00 76.03 O \nANISOU 1357 O GLN A 169 8119 8272 12496 566 -644 -912 O \nATOM 1358 CB GLN A 169 -28.763 -14.697 -54.768 1.00 84.06 C \nANISOU 1358 CB GLN A 169 9095 9324 13519 793 -692 -1002 C \nATOM 1359 CG GLN A 169 -30.121 -14.245 -55.267 1.00 87.69 C \nANISOU 1359 CG GLN A 169 9619 9721 13979 902 -727 -1036 C \nATOM 1360 CD GLN A 169 -30.744 -15.252 -56.197 1.00 90.56 C \nANISOU 1360 CD GLN A 169 9897 10173 14339 991 -708 -1096 C \nATOM 1361 OE1 GLN A 169 -31.265 -16.282 -55.752 1.00 91.86 O \nANISOU 1361 OE1 GLN A 169 9989 10416 14499 1059 -728 -1110 O \nATOM 1362 NE2 GLN A 169 -30.715 -14.955 -57.494 1.00 85.41 N \nANISOU 1362 NE2 GLN A 169 9251 9516 13686 992 -671 -1133 N \nATOM 1363 N GLU A 170 -25.275 -15.007 -55.454 1.00 73.73 N \nANISOU 1363 N GLU A 170 7692 8122 12199 534 -554 -962 N \nATOM 1364 CA GLU A 170 -23.976 -14.956 -54.810 1.00 71.37 C \nANISOU 1364 CA GLU A 170 7392 7832 11892 436 -530 -918 C \nATOM 1365 C GLU A 170 -22.937 -14.378 -55.724 1.00 65.72 C \nANISOU 1365 C GLU A 170 6691 7109 11169 368 -477 -914 C \nATOM 1366 O GLU A 170 -22.931 -14.623 -56.922 1.00 73.81 O \nANISOU 1366 O GLU A 170 7683 8169 12191 381 -441 -951 O \nATOM 1367 CB GLU A 170 -23.531 -16.350 -54.374 1.00 76.45 C \nANISOU 1367 CB GLU A 170 7946 8575 12528 416 -512 -922 C \nATOM 1368 CG GLU A 170 -24.534 -17.086 -53.486 1.00 79.79 C \nANISOU 1368 CG GLU A 170 8334 9028 12953 484 -562 -928 C \nATOM 1369 CD GLU A 170 -25.485 -17.939 -54.275 1.00 80.74 C \nANISOU 1369 CD GLU A 170 8386 9219 13072 571 -562 -983 C \nATOM 1370 OE1 GLU A 170 -25.665 -17.653 -55.470 1.00 85.57 O \nANISOU 1370 OE1 GLU A 170 9003 9824 13687 594 -537 -1016 O \nATOM 1371 OE2 GLU A 170 -26.056 -18.885 -53.699 1.00 90.42 O \nANISOU 1371 OE2 GLU A 170 9551 10514 14292 616 -588 -993 O \nATOM 1372 N ASP A 171 -22.038 -13.607 -55.140 1.00 58.88 N \nANISOU 1372 N ASP A 171 5875 6203 10295 297 -472 -868 N \nATOM 1373 CA ASP A 171 -20.837 -13.193 -55.835 1.00 55.83 C \nANISOU 1373 CA ASP A 171 5493 5827 9894 229 -419 -856 C \nATOM 1374 C ASP A 171 -20.170 -14.423 -56.368 1.00 55.95 C \nANISOU 1374 C ASP A 171 5429 5929 9902 209 -369 -877 C \nATOM 1375 O ASP A 171 -20.079 -15.428 -55.661 1.00 51.57 O \nANISOU 1375 O ASP A 171 4828 5421 9345 204 -374 -875 O \nATOM 1376 CB ASP A 171 -19.883 -12.480 -54.871 1.00 55.63 C \nANISOU 1376 CB ASP A 171 5513 5768 9856 160 -421 -801 C \nATOM 1377 CG ASP A 171 -20.504 -11.219 -54.250 1.00 62.06 C \nANISOU 1377 CG ASP A 171 6410 6499 10671 165 -471 -775 C \nATOM 1378 OD1 ASP A 171 -21.466 -10.662 -54.821 1.00 78.24 O \nANISOU 1378 OD1 ASP A 171 8496 8505 12726 209 -493 -798 O \nATOM 1379 OD2 ASP A 171 -20.027 -10.773 -53.198 1.00 62.22 O \nANISOU 1379 OD2 ASP A 171 6463 6496 10681 122 -488 -732 O \nATOM 1380 N LEU A 172 -19.691 -14.392 -57.609 1.00 59.69 N \nANISOU 1380 N LEU A 172 5885 6427 10367 193 -322 -899 N \nATOM 1381 CA LEU A 172 -18.851 -15.506 -58.051 1.00 57.72 C \nANISOU 1381 CA LEU A 172 5573 6255 10104 157 -272 -911 C \nATOM 1382 C LEU A 172 -17.461 -15.110 -58.570 1.00 54.67 C \nANISOU 1382 C LEU A 172 5207 5869 9696 90 -219 -887 C \nATOM 1383 O LEU A 172 -17.268 -14.065 -59.178 1.00 48.71 O \nANISOU 1383 O LEU A 172 4493 5078 8938 83 -209 -880 O \nATOM 1384 CB LEU A 172 -19.585 -16.438 -58.998 1.00 59.51 C \nANISOU 1384 CB LEU A 172 5732 6546 10334 205 -260 -966 C \nATOM 1385 CG LEU A 172 -20.158 -15.981 -60.306 1.00 62.51 C \nANISOU 1385 CG LEU A 172 6114 6917 10720 246 -248 -1004 C \nATOM 1386 CD1 LEU A 172 -19.196 -16.212 -61.435 1.00 69.36 C \nANISOU 1386 CD1 LEU A 172 6957 7828 11569 198 -187 -1014 C \nATOM 1387 CD2 LEU A 172 -21.419 -16.782 -60.588 1.00 66.19 C \nANISOU 1387 CD2 LEU A 172 6526 7430 11196 326 -271 -1053 C \nATOM 1388 N LEU A 173 -16.491 -15.977 -58.276 1.00 50.63 N \nANISOU 1388 N LEU A 173 4670 5402 9167 40 -186 -875 N \nATOM 1389 CA LEU A 173 -15.107 -15.688 -58.547 1.00 45.02 C \nANISOU 1389 CA LEU A 173 3987 4688 8431 -17 -140 -846 C \nATOM 1390 C LEU A 173 -14.733 -16.325 -59.847 1.00 45.13 C \nANISOU 1390 C LEU A 173 3963 4754 8431 -28 -89 -877 C \nATOM 1391 O LEU A 173 -14.749 -17.532 -59.944 1.00 34.78 O \nANISOU 1391 O LEU A 173 2602 3500 7112 -39 -74 -900 O \nATOM 1392 CB LEU A 173 -14.238 -16.197 -57.405 1.00 43.40 C \nANISOU 1392 CB LEU A 173 3794 4488 8209 -65 -134 -812 C \nATOM 1393 CG LEU A 173 -12.744 -16.423 -57.701 1.00 43.76 C \nANISOU 1393 CG LEU A 173 3859 4548 8221 -122 -77 -792 C \nATOM 1394 CD1 LEU A 173 -12.006 -15.059 -57.847 1.00 40.19 C \nANISOU 1394 CD1 LEU A 173 3464 4052 7756 -130 -66 -756 C \nATOM 1395 CD2 LEU A 173 -12.140 -17.270 -56.617 1.00 39.27 C \nANISOU 1395 CD2 LEU A 173 3293 3992 7635 -164 -74 -772 C \nATOM 1396 N ILE A 174 -14.356 -15.469 -60.841 1.00 46.52 N \nANISOU 1396 N ILE A 174 4163 4914 8599 -31 -63 -876 N \nATOM 1397 CA ILE A 174 -13.954 -15.935 -62.184 1.00 36.24 C \nANISOU 1397 CA ILE A 174 2831 3657 7281 -43 -13 -903 C \nATOM 1398 C ILE A 174 -12.459 -15.650 -62.386 1.00 39.09 C \nANISOU 1398 C ILE A 174 3229 4014 7610 -93 33 -866 C \nATOM 1399 O ILE A 174 -11.938 -14.696 -61.894 1.00 45.82 O \nANISOU 1399 O ILE A 174 4129 4827 8454 -103 26 -828 O \nATOM 1400 CB ILE A 174 -14.749 -15.238 -63.272 1.00 33.26 C \nANISOU 1400 CB ILE A 174 2449 3270 6916 -2 -19 -933 C \nATOM 1401 CG1 ILE A 174 -16.269 -15.197 -62.882 1.00 32.31 C \nANISOU 1401 CG1 ILE A 174 2317 3132 6828 60 -74 -961 C \nATOM 1402 CG2 ILE A 174 -14.550 -15.893 -64.613 1.00 30.96 C \nANISOU 1402 CG2 ILE A 174 2116 3036 6612 -9 27 -968 C \nATOM 1403 CD1 ILE A 174 -17.117 -14.506 -63.929 1.00 31.16 C \nANISOU 1403 CD1 ILE A 174 2179 2969 6692 103 -80 -994 C \nATOM 1404 N LEU A 175 -11.763 -16.543 -63.077 1.00 44.03 N \nANISOU 1404 N LEU A 175 3833 4684 8211 -123 79 -878 N \nATOM 1405 CA LEU A 175 -10.352 -16.437 -63.316 1.00 42.29 C \nANISOU 1405 CA LEU A 175 3653 4461 7956 -163 125 -846 C \nATOM 1406 C LEU A 175 -10.040 -16.743 -64.781 1.00 45.93 C \nANISOU 1406 C LEU A 175 4093 4961 8399 -172 171 -870 C \nATOM 1407 O LEU A 175 -10.613 -17.657 -65.368 1.00 53.78 O \nANISOU 1407 O LEU A 175 5036 6001 9397 -171 178 -911 O \nATOM 1408 CB LEU A 175 -9.585 -17.406 -62.460 1.00 44.51 C \nANISOU 1408 CB LEU A 175 3947 4750 8214 -207 139 -828 C \nATOM 1409 CG LEU A 175 -9.734 -17.222 -60.949 1.00 51.03 C \nANISOU 1409 CG LEU A 175 4794 5541 9052 -207 99 -801 C \nATOM 1410 CD1 LEU A 175 -10.753 -18.170 -60.364 1.00 49.90 C \nANISOU 1410 CD1 LEU A 175 4601 5429 8931 -200 66 -830 C \nATOM 1411 CD2 LEU A 175 -8.404 -17.445 -60.244 1.00 49.41 C \nANISOU 1411 CD2 LEU A 175 4642 5320 8812 -250 126 -763 C \nATOM 1412 N TRP A 176 -9.135 -15.956 -65.361 1.00 43.47 N \nANISOU 1412 N TRP A 176 3819 4636 8063 -179 201 -844 N \nATOM 1413 CA TRP A 176 -8.718 -16.121 -66.752 1.00 35.11 C \nANISOU 1413 CA TRP A 176 2749 3611 6982 -188 245 -860 C \nATOM 1414 C TRP A 176 -7.284 -15.735 -66.853 1.00 33.09 C \nANISOU 1414 C TRP A 176 2546 3341 6684 -208 283 -817 C \nATOM 1415 O TRP A 176 -6.670 -15.288 -65.874 1.00 31.26 O \nANISOU 1415 O TRP A 176 2358 3077 6442 -211 274 -778 O \nATOM 1416 CB TRP A 176 -9.580 -15.265 -67.693 1.00 33.33 C \nANISOU 1416 CB TRP A 176 2500 3388 6775 -152 232 -886 C \nATOM 1417 CG TRP A 176 -9.465 -13.794 -67.470 1.00 33.58 C \nANISOU 1417 CG TRP A 176 2570 3383 6807 -137 214 -855 C \nATOM 1418 CD1 TRP A 176 -8.660 -12.939 -68.119 1.00 31.68 C \nANISOU 1418 CD1 TRP A 176 2354 3146 6537 -142 240 -830 C \nATOM 1419 CD2 TRP A 176 -10.160 -13.041 -66.504 1.00 34.36 C \nANISOU 1419 CD2 TRP A 176 2685 3441 6931 -118 164 -844 C \nATOM 1420 NE1 TRP A 176 -8.802 -11.708 -67.622 1.00 32.22 N \nANISOU 1420 NE1 TRP A 176 2449 3186 6608 -132 212 -806 N \nATOM 1421 CE2 TRP A 176 -9.714 -11.729 -66.614 1.00 32.15 C \nANISOU 1421 CE2 TRP A 176 2439 3145 6631 -120 164 -813 C \nATOM 1422 CE3 TRP A 176 -11.122 -13.363 -65.522 1.00 38.50 C \nANISOU 1422 CE3 TRP A 176 3199 3944 7487 -101 118 -856 C \nATOM 1423 CZ2 TRP A 176 -10.194 -10.712 -65.834 1.00 35.57 C \nANISOU 1423 CZ2 TRP A 176 2900 3541 7076 -113 122 -795 C \nATOM 1424 CZ3 TRP A 176 -11.593 -12.325 -64.687 1.00 39.40 C \nANISOU 1424 CZ3 TRP A 176 3345 4011 7614 -88 74 -835 C \nATOM 1425 CH2 TRP A 176 -11.142 -11.020 -64.873 1.00 40.41 C \nANISOU 1425 CH2 TRP A 176 3509 4123 7721 -98 77 -806 C \nATOM 1426 N GLY A 177 -6.729 -15.891 -68.028 1.00 29.88 N \nANISOU 1426 N GLY A 177 2139 2961 6251 -218 325 -823 N \nATOM 1427 CA GLY A 177 -5.299 -15.756 -68.197 1.00 33.12 C \nANISOU 1427 CA GLY A 177 2605 3365 6616 -233 366 -784 C \nATOM 1428 C GLY A 177 -4.902 -15.300 -69.589 1.00 34.66 C \nANISOU 1428 C GLY A 177 2797 3585 6787 -225 400 -786 C \nATOM 1429 O GLY A 177 -5.736 -15.245 -70.461 1.00 32.05 O \nANISOU 1429 O GLY A 177 2421 3282 6476 -216 396 -822 O \nATOM 1430 N ILE A 178 -3.592 -15.035 -69.760 1.00 35.06 N \nANISOU 1430 N ILE A 178 2900 3629 6791 -227 436 -746 N \nATOM 1431 CA ILE A 178 -3.048 -14.581 -71.019 1.00 35.84 C \nANISOU 1431 CA ILE A 178 3003 3754 6859 -217 470 -740 C \nATOM 1432 C ILE A 178 -1.723 -15.313 -71.248 1.00 41.55 C \nANISOU 1432 C ILE A 178 3783 4474 7531 -237 517 -715 C \nATOM 1433 O ILE A 178 -1.003 -15.593 -70.273 1.00 39.85 O \nANISOU 1433 O ILE A 178 3620 4225 7296 -243 521 -686 O \nATOM 1434 CB ILE A 178 -2.806 -13.050 -71.053 1.00 37.25 C \nANISOU 1434 CB ILE A 178 3191 3935 7027 -183 459 -709 C \nATOM 1435 CG1 ILE A 178 -2.236 -12.631 -72.390 1.00 38.42 C \nANISOU 1435 CG1 ILE A 178 3339 4119 7139 -174 495 -702 C \nATOM 1436 CG2 ILE A 178 -1.778 -12.624 -70.043 1.00 37.21 C \nANISOU 1436 CG2 ILE A 178 3241 3904 6992 -170 462 -659 C \nATOM 1437 CD1 ILE A 178 -2.116 -11.142 -72.581 1.00 40.10 C \nANISOU 1437 CD1 ILE A 178 3548 4351 7337 -147 485 -678 C \nATOM 1438 N HIS A 179 -1.443 -15.678 -72.517 1.00 38.98 N \nANISOU 1438 N HIS A 179 3452 4178 7180 -249 553 -728 N \nATOM 1439 CA HIS A 179 -0.223 -16.380 -72.822 1.00 37.50 C \nANISOU 1439 CA HIS A 179 3328 3982 6939 -269 598 -705 C \nATOM 1440 C HIS A 179 0.708 -15.483 -73.548 1.00 32.82 C \nANISOU 1440 C HIS A 179 2766 3399 6304 -233 625 -670 C \nATOM 1441 O HIS A 179 0.475 -15.159 -74.700 1.00 30.12 O \nANISOU 1441 O HIS A 179 2390 3094 5958 -226 636 -685 O \nATOM 1442 CB HIS A 179 -0.453 -17.678 -73.671 1.00 37.13 C \nANISOU 1442 CB HIS A 179 3262 3963 6884 -319 624 -743 C \nATOM 1443 CG HIS A 179 0.827 -18.307 -74.166 1.00 32.78 C \nANISOU 1443 CG HIS A 179 2785 3399 6269 -343 672 -718 C \nATOM 1444 ND1 HIS A 179 1.075 -18.550 -75.501 1.00 38.18 N \nANISOU 1444 ND1 HIS A 179 3466 4116 6925 -356 706 -728 N \nATOM 1445 CD2 HIS A 179 1.921 -18.713 -73.503 1.00 30.68 C \nANISOU 1445 CD2 HIS A 179 2607 3089 5961 -353 692 -683 C \nATOM 1446 CE1 HIS A 179 2.287 -19.066 -75.634 1.00 33.37 C \nANISOU 1446 CE1 HIS A 179 2943 3480 6258 -373 744 -697 C \nATOM 1447 NE2 HIS A 179 2.802 -19.201 -74.431 1.00 37.02 N \nANISOU 1447 NE2 HIS A 179 3463 3893 6710 -372 737 -671 N \nATOM 1448 N HIS A 180 1.825 -15.189 -72.908 1.00 31.51 N \nANISOU 1448 N HIS A 180 2669 3203 6099 -209 638 -624 N \nATOM 1449 CA HIS A 180 2.887 -14.457 -73.551 1.00 29.63 C \nANISOU 1449 CA HIS A 180 2470 2980 5809 -168 667 -585 C \nATOM 1450 C HIS A 180 3.730 -15.478 -74.290 1.00 30.64 C \nANISOU 1450 C HIS A 180 2656 3098 5889 -193 713 -581 C \nATOM 1451 O HIS A 180 4.469 -16.232 -73.652 1.00 32.81 O \nANISOU 1451 O HIS A 180 3004 3328 6135 -209 730 -564 O \nATOM 1452 CB HIS A 180 3.708 -13.678 -72.506 1.00 30.56 C \nANISOU 1452 CB HIS A 180 2636 3075 5901 -124 661 -538 C \nATOM 1453 CG HIS A 180 2.912 -12.736 -71.648 1.00 27.12 C \nANISOU 1453 CG HIS A 180 2153 2645 5507 -110 615 -539 C \nATOM 1454 ND1 HIS A 180 2.262 -11.646 -72.155 1.00 27.17 N \nANISOU 1454 ND1 HIS A 180 2099 2693 5530 -94 594 -547 N \nATOM 1455 CD2 HIS A 180 2.631 -12.741 -70.339 1.00 27.36 C \nANISOU 1455 CD2 HIS A 180 2189 2644 5562 -116 584 -535 C \nATOM 1456 CE1 HIS A 180 1.625 -10.984 -71.204 1.00 25.89 C \nANISOU 1456 CE1 HIS A 180 1913 2524 5401 -91 553 -546 C \nATOM 1457 NE2 HIS A 180 1.855 -11.607 -70.074 1.00 29.56 N \nANISOU 1457 NE2 HIS A 180 2416 2946 5872 -101 546 -538 N \nATOM 1458 N SER A 181 3.646 -15.480 -75.614 1.00 30.78 N \nANISOU 1458 N SER A 181 2646 3154 5894 -198 734 -595 N \nATOM 1459 CA SER A 181 4.486 -16.266 -76.459 1.00 38.45 C \nANISOU 1459 CA SER A 181 3675 4121 6814 -218 778 -587 C \nATOM 1460 C SER A 181 5.888 -15.747 -76.581 1.00 42.55 C \nANISOU 1460 C SER A 181 4274 4625 7266 -165 807 -532 C \nATOM 1461 O SER A 181 6.200 -14.649 -76.078 1.00 53.02 O \nANISOU 1461 O SER A 181 5600 5959 8587 -107 793 -501 O \nATOM 1462 CB SER A 181 3.844 -16.358 -77.866 1.00 45.61 C \nANISOU 1462 CB SER A 181 4517 5081 7730 -240 788 -622 C \nATOM 1463 OG SER A 181 3.280 -15.086 -78.285 1.00 41.07 O \nANISOU 1463 OG SER A 181 3876 4549 7179 -200 767 -625 O \nATOM 1464 N ASN A 182 6.747 -16.490 -77.285 1.00 47.04 N \nANISOU 1464 N ASN A 182 4913 5179 7781 -180 848 -520 N \nATOM 1465 CA ASN A 182 8.231 -16.206 -77.312 1.00 53.62 C \nANISOU 1465 CA ASN A 182 5848 5985 8541 -123 880 -465 C \nATOM 1466 C ASN A 182 8.728 -15.434 -78.521 1.00 55.86 C \nANISOU 1466 C ASN A 182 6122 6317 8784 -75 901 -442 C \nATOM 1467 O ASN A 182 9.620 -14.593 -78.394 1.00 62.84 O \nANISOU 1467 O ASN A 182 7044 7208 9624 -1 909 -397 O \nATOM 1468 CB ASN A 182 9.012 -17.475 -77.201 1.00 55.20 C \nANISOU 1468 CB ASN A 182 6155 6125 8695 -166 912 -458 C \nATOM 1469 CG ASN A 182 8.912 -18.062 -75.838 1.00 63.34 C \nANISOU 1469 CG ASN A 182 7219 7102 9743 -197 895 -463 C \nATOM 1470 OD1 ASN A 182 8.973 -17.323 -74.822 1.00 64.88 O \nANISOU 1470 OD1 ASN A 182 7410 7287 9954 -150 872 -445 O \nATOM 1471 ND2 ASN A 182 8.803 -19.381 -75.772 1.00 62.11 N \nANISOU 1471 ND2 ASN A 182 7100 6917 9581 -278 908 -488 N \nATOM 1472 N ASP A 183 8.070 -15.632 -79.649 1.00 56.74 N \nANISOU 1472 N ASP A 183 6172 6472 8912 -112 905 -474 N \nATOM 1473 CA ASP A 183 8.448 -14.978 -80.889 1.00 54.82 C \nANISOU 1473 CA ASP A 183 5915 6282 8633 -76 925 -457 C \nATOM 1474 C ASP A 183 7.305 -14.969 -81.892 1.00 56.47 C \nANISOU 1474 C ASP A 183 6024 6546 8884 -120 916 -505 C \nATOM 1475 O ASP A 183 6.280 -15.659 -81.712 1.00 51.94 O \nANISOU 1475 O ASP A 183 5403 5969 8363 -179 899 -553 O \nATOM 1476 CB ASP A 183 9.666 -15.697 -81.522 1.00 59.41 C \nANISOU 1476 CB ASP A 183 6604 6832 9139 -72 970 -427 C \nATOM 1477 CG ASP A 183 9.525 -17.240 -81.549 1.00 59.81 C \nANISOU 1477 CG ASP A 183 6700 6835 9188 -160 986 -456 C \nATOM 1478 OD1 ASP A 183 10.239 -17.931 -80.824 1.00 64.21 O \nANISOU 1478 OD1 ASP A 183 7357 7327 9714 -171 999 -437 O \nATOM 1479 OD2 ASP A 183 8.756 -17.759 -82.321 1.00 64.51 O \nANISOU 1479 OD2 ASP A 183 7238 7465 9809 -220 987 -496 O \nATOM 1480 N ALA A 184 7.505 -14.222 -82.985 1.00 53.83 N \nANISOU 1480 N ALA A 184 5661 6269 8522 -89 928 -493 N \nATOM 1481 CA ALA A 184 6.460 -14.063 -83.992 1.00 54.24 C \nANISOU 1481 CA ALA A 184 5621 6377 8609 -123 921 -537 C \nATOM 1482 C ALA A 184 6.014 -15.425 -84.542 1.00 59.65 C \nANISOU 1482 C ALA A 184 6305 7052 9305 -198 937 -579 C \nATOM 1483 O ALA A 184 4.844 -15.636 -84.814 1.00 66.33 O \nANISOU 1483 O ALA A 184 7074 7927 10203 -238 919 -630 O \nATOM 1484 CB ALA A 184 6.911 -13.152 -85.118 1.00 45.80 C \nANISOU 1484 CB ALA A 184 4534 5371 7497 -83 937 -513 C \nATOM 1485 N ALA A 185 6.964 -16.334 -84.704 1.00 62.86 N \nANISOU 1485 N ALA A 185 6803 7422 9659 -216 970 -557 N \nATOM 1486 CA ALA A 185 6.686 -17.661 -85.275 1.00 62.59 C \nANISOU 1486 CA ALA A 185 6776 7385 9620 -296 989 -592 C \nATOM 1487 C ALA A 185 5.716 -18.457 -84.394 1.00 60.44 C \nANISOU 1487 C ALA A 185 6465 7095 9404 -350 964 -636 C \nATOM 1488 O ALA A 185 4.679 -18.942 -84.887 1.00 64.47 O \nANISOU 1488 O ALA A 185 6899 7648 9950 -399 957 -689 O \nATOM 1489 CB ALA A 185 7.991 -18.429 -85.499 1.00 63.16 C \nANISOU 1489 CB ALA A 185 6972 7411 9617 -307 1029 -553 C \nATOM 1490 N GLU A 186 6.051 -18.592 -83.109 1.00 54.32 N \nANISOU 1490 N GLU A 186 5741 6264 8633 -340 952 -617 N \nATOM 1491 CA GLU A 186 5.169 -19.269 -82.145 1.00 55.67 C \nANISOU 1491 CA GLU A 186 5875 6421 8855 -385 925 -654 C \nATOM 1492 C GLU A 186 3.834 -18.633 -82.118 1.00 56.18 C \nANISOU 1492 C GLU A 186 5827 6529 8989 -371 888 -694 C \nATOM 1493 O GLU A 186 2.808 -19.307 -82.044 1.00 62.03 O \nANISOU 1493 O GLU A 186 6506 7293 9770 -416 872 -742 O \nATOM 1494 CB GLU A 186 5.717 -19.261 -80.732 1.00 55.90 C \nANISOU 1494 CB GLU A 186 5972 6387 8880 -365 914 -623 C \nATOM 1495 CG GLU A 186 4.923 -20.104 -79.743 1.00 62.12 C \nANISOU 1495 CG GLU A 186 6732 7161 9711 -419 889 -658 C \nATOM 1496 CD GLU A 186 5.375 -19.957 -78.285 1.00 67.56 C \nANISOU 1496 CD GLU A 186 7478 7791 10401 -396 874 -629 C \nATOM 1497 OE1 GLU A 186 6.290 -19.145 -77.999 1.00 76.17 O \nANISOU 1497 OE1 GLU A 186 8628 8852 11462 -332 880 -582 O \nATOM 1498 OE2 GLU A 186 4.821 -20.696 -77.430 1.00 63.52 O \nANISOU 1498 OE2 GLU A 186 6951 7267 9917 -442 855 -653 O \nATOM 1499 N GLN A 187 3.832 -17.315 -82.193 1.00 59.45 N \nANISOU 1499 N GLN A 187 6216 6960 9414 -309 873 -674 N \nATOM 1500 CA GLN A 187 2.560 -16.599 -82.123 1.00 50.88 C \nANISOU 1500 CA GLN A 187 5035 5906 8391 -295 836 -710 C \nATOM 1501 C GLN A 187 1.668 -17.059 -83.249 1.00 49.53 C \nANISOU 1501 C GLN A 187 4795 5788 8237 -333 842 -762 C \nATOM 1502 O GLN A 187 0.545 -17.508 -83.005 1.00 62.90 O \nANISOU 1502 O GLN A 187 6428 7493 9978 -357 819 -809 O \nATOM 1503 CB GLN A 187 2.771 -15.093 -82.157 1.00 43.64 C \nANISOU 1503 CB GLN A 187 4105 5006 7469 -233 823 -679 C \nATOM 1504 CG GLN A 187 1.451 -14.291 -82.221 1.00 37.98 C \nANISOU 1504 CG GLN A 187 3301 4320 6809 -226 786 -716 C \nATOM 1505 CD GLN A 187 0.630 -14.379 -80.929 1.00 38.17 C \nANISOU 1505 CD GLN A 187 3305 4309 6887 -230 746 -735 C \nATOM 1506 OE1 GLN A 187 1.142 -14.675 -79.865 1.00 34.37 O \nANISOU 1506 OE1 GLN A 187 2873 3785 6401 -226 741 -709 O \nATOM 1507 NE2 GLN A 187 -0.654 -14.065 -81.026 1.00 42.58 N \nANISOU 1507 NE2 GLN A 187 3797 4886 7497 -233 715 -778 N \nATOM 1508 N THR A 188 2.175 -16.978 -84.480 1.00 45.70 N \nANISOU 1508 N THR A 188 4320 5336 7710 -335 874 -753 N \nATOM 1509 CA THR A 188 1.424 -17.386 -85.681 1.00 44.14 C \nANISOU 1509 CA THR A 188 4058 5193 7520 -371 885 -801 C \nATOM 1510 C THR A 188 0.990 -18.834 -85.654 1.00 49.01 C \nANISOU 1510 C THR A 188 4662 5817 8143 -436 893 -841 C \nATOM 1511 O THR A 188 -0.114 -19.157 -86.065 1.00 54.16 O \nANISOU 1511 O THR A 188 5237 6512 8829 -457 882 -895 O \nATOM 1512 CB THR A 188 2.209 -17.106 -86.979 1.00 48.63 C \nANISOU 1512 CB THR A 188 4650 5794 8033 -365 921 -778 C \nATOM 1513 OG1 THR A 188 3.557 -16.702 -86.699 1.00 52.50 O \nANISOU 1513 OG1 THR A 188 5226 6250 8471 -326 938 -714 O \nATOM 1514 CG2 THR A 188 1.554 -15.966 -87.770 1.00 52.58 C \nANISOU 1514 CG2 THR A 188 5080 6345 8553 -335 909 -795 C \nATOM 1515 N LYS A 189 1.878 -19.723 -85.206 1.00 62.38 N \nANISOU 1515 N LYS A 189 6434 7471 9795 -470 914 -815 N \nATOM 1516 CA LYS A 189 1.576 -21.175 -85.182 1.00 61.22 C \nANISOU 1516 CA LYS A 189 6281 7339 9641 -547 925 -849 C \nATOM 1517 C LYS A 189 0.502 -21.521 -84.186 1.00 62.87 C \nANISOU 1517 C LYS A 189 6430 7551 9906 -555 888 -887 C \nATOM 1518 O LYS A 189 -0.303 -22.419 -84.429 1.00 59.86 O \nANISOU 1518 O LYS A 189 5989 7217 9537 -602 887 -936 O \nATOM 1519 CB LYS A 189 2.801 -22.048 -84.943 1.00 67.89 C \nANISOU 1519 CB LYS A 189 7236 8138 10422 -590 957 -812 C \nATOM 1520 CG LYS A 189 3.540 -21.877 -83.637 1.00 74.70 C \nANISOU 1520 CG LYS A 189 8178 8926 11277 -565 947 -769 C \nATOM 1521 CD LYS A 189 4.341 -23.150 -83.284 1.00 91.91 C \nANISOU 1521 CD LYS A 189 10453 11067 13402 -636 974 -756 C \nATOM 1522 CE LYS A 189 5.804 -22.868 -82.864 1.00 97.36 C \nANISOU 1522 CE LYS A 189 11277 11681 14036 -601 995 -692 C \nATOM 1523 NZ LYS A 189 6.631 -24.095 -82.628 1.00 92.15 N \nANISOU 1523 NZ LYS A 189 10726 10974 13313 -674 1024 -678 N \nATOM 1524 N LEU A 190 0.484 -20.820 -83.052 1.00 56.26 N \nANISOU 1524 N LEU A 190 5607 6668 9100 -509 858 -865 N \nATOM 1525 CA LEU A 190 -0.533 -21.088 -82.068 1.00 53.11 C \nANISOU 1525 CA LEU A 190 5155 6270 8754 -511 821 -897 C \nATOM 1526 C LEU A 190 -1.838 -20.439 -82.412 1.00 58.08 C \nANISOU 1526 C LEU A 190 5690 6939 9438 -475 791 -940 C \nATOM 1527 O LEU A 190 -2.912 -21.038 -82.223 1.00 60.61 O \nANISOU 1527 O LEU A 190 5943 7292 9792 -489 771 -988 O \nATOM 1528 CB LEU A 190 -0.102 -20.598 -80.697 1.00 48.52 C \nANISOU 1528 CB LEU A 190 4625 5626 8185 -479 799 -857 C \nATOM 1529 CG LEU A 190 0.935 -21.505 -80.052 1.00 50.96 C \nANISOU 1529 CG LEU A 190 5025 5891 8447 -523 821 -827 C \nATOM 1530 CD1 LEU A 190 1.392 -20.947 -78.706 1.00 46.91 C \nANISOU 1530 CD1 LEU A 190 4564 5317 7944 -486 800 -788 C \nATOM 1531 CD2 LEU A 190 0.369 -22.910 -79.841 1.00 50.50 C \nANISOU 1531 CD2 LEU A 190 4935 5863 8388 -598 821 -868 C \nATOM 1532 N TYR A 191 -1.744 -19.199 -82.885 1.00 61.65 N \nANISOU 1532 N TYR A 191 6140 7388 9896 -425 788 -922 N \nATOM 1533 CA TYR A 191 -2.921 -18.322 -82.871 1.00 58.40 C \nANISOU 1533 CA TYR A 191 5662 6990 9537 -383 751 -953 C \nATOM 1534 C TYR A 191 -3.281 -17.678 -84.128 1.00 65.60 C \nANISOU 1534 C TYR A 191 6534 7944 10447 -368 761 -973 C \nATOM 1535 O TYR A 191 -4.376 -17.160 -84.217 1.00 67.03 O \nANISOU 1535 O TYR A 191 6662 8138 10670 -343 734 -1009 O \nATOM 1536 CB TYR A 191 -2.711 -17.187 -81.921 1.00 51.05 C \nANISOU 1536 CB TYR A 191 4761 6013 8624 -337 724 -915 C \nATOM 1537 CG TYR A 191 -2.288 -17.584 -80.562 1.00 45.39 C \nANISOU 1537 CG TYR A 191 4090 5247 7910 -343 711 -888 C \nATOM 1538 CD1 TYR A 191 -3.182 -18.207 -79.708 1.00 45.35 C \nANISOU 1538 CD1 TYR A 191 4049 5237 7944 -354 681 -919 C \nATOM 1539 CD2 TYR A 191 -1.021 -17.343 -80.115 1.00 45.94 C \nANISOU 1539 CD2 TYR A 191 4236 5279 7939 -334 728 -832 C \nATOM 1540 CE1 TYR A 191 -2.813 -18.610 -78.427 1.00 42.81 C \nANISOU 1540 CE1 TYR A 191 3769 4874 7624 -365 669 -895 C \nATOM 1541 CE2 TYR A 191 -0.640 -17.754 -78.847 1.00 47.08 C \nANISOU 1541 CE2 TYR A 191 4427 5378 8085 -342 718 -810 C \nATOM 1542 CZ TYR A 191 -1.547 -18.377 -78.023 1.00 43.77 C \nANISOU 1542 CZ TYR A 191 3969 4955 7706 -361 688 -842 C \nATOM 1543 OH TYR A 191 -1.152 -18.760 -76.777 1.00 44.52 O \nANISOU 1543 OH TYR A 191 4109 5007 7798 -372 678 -820 O \nATOM 1544 N GLN A 192 -2.363 -17.666 -85.085 1.00 70.75 N \nANISOU 1544 N GLN A 192 7218 8614 11049 -382 799 -950 N \nATOM 1545 CA GLN A 192 -2.674 -17.124 -86.376 1.00 67.20 C \nANISOU 1545 CA GLN A 192 6730 8212 10592 -375 812 -970 C \nATOM 1546 C GLN A 192 -2.407 -15.626 -86.317 1.00 61.55 C \nANISOU 1546 C GLN A 192 6029 7483 9876 -328 798 -935 C \nATOM 1547 O GLN A 192 -1.414 -15.181 -86.873 1.00 57.70 O \nANISOU 1547 O GLN A 192 5577 7004 9340 -319 824 -895 O \nATOM 1548 CB GLN A 192 -4.110 -17.407 -86.767 1.00 79.78 C \nANISOU 1548 CB GLN A 192 8242 9843 12227 -378 794 -1039 C \nATOM 1549 CG GLN A 192 -4.332 -18.013 -88.166 1.00 93.15 C \nANISOU 1549 CG GLN A 192 9896 11601 13898 -411 825 -1077 C \nATOM 1550 CD GLN A 192 -3.132 -17.909 -89.124 1.00 87.75 C \nANISOU 1550 CD GLN A 192 9256 10931 13152 -430 866 -1038 C \nATOM 1551 OE1 GLN A 192 -2.296 -18.799 -89.157 1.00 92.08 O \nANISOU 1551 OE1 GLN A 192 9850 11476 13661 -469 894 -1017 O \nATOM 1552 NE2 GLN A 192 -3.069 -16.843 -89.918 1.00 76.39 N \nANISOU 1552 NE2 GLN A 192 7809 9512 11704 -404 871 -1029 N \nATOM 1553 N ASN A 193 -3.229 -14.856 -85.594 1.00 56.75 N \nANISOU 1553 N ASN A 193 5396 6853 9312 -298 758 -947 N \nATOM 1554 CA ASN A 193 -3.122 -13.409 -85.648 1.00 52.85 C \nANISOU 1554 CA ASN A 193 4908 6361 8814 -265 744 -921 C \nATOM 1555 C ASN A 193 -1.863 -12.924 -84.915 1.00 48.01 C \nANISOU 1555 C ASN A 193 4357 5720 8165 -244 750 -854 C \nATOM 1556 O ASN A 193 -1.593 -13.372 -83.820 1.00 49.53 O \nANISOU 1556 O ASN A 193 4582 5870 8367 -243 740 -836 O \nATOM 1557 CB ASN A 193 -4.397 -12.772 -85.065 1.00 60.58 C \nANISOU 1557 CB ASN A 193 5851 7321 9846 -247 699 -954 C \nATOM 1558 CG ASN A 193 -5.655 -13.645 -85.290 1.00 52.95 C \nANISOU 1558 CG ASN A 193 4833 6366 8920 -258 687 -1020 C \nATOM 1559 OD1 ASN A 193 -5.888 -14.060 -86.371 1.00 47.35 O \nANISOU 1559 OD1 ASN A 193 4092 5698 8199 -274 710 -1053 O \nATOM 1560 ND2 ASN A 193 -6.417 -13.942 -84.247 1.00 51.51 N \nANISOU 1560 ND2 ASN A 193 4641 6149 8781 -246 653 -1039 N \nATOM 1561 N PRO A 194 -1.095 -12.003 -85.520 1.00 42.76 N \nANISOU 1561 N PRO A 194 3707 5085 7456 -224 767 -816 N \nATOM 1562 CA PRO A 194 0.145 -11.500 -85.009 1.00 42.04 C \nANISOU 1562 CA PRO A 194 3671 4982 7322 -194 777 -754 C \nATOM 1563 C PRO A 194 -0.026 -10.431 -83.936 1.00 47.42 C \nANISOU 1563 C PRO A 194 4352 5646 8020 -167 741 -732 C \nATOM 1564 O PRO A 194 0.792 -10.310 -83.024 1.00 44.21 O \nANISOU 1564 O PRO A 194 3992 5214 7594 -143 740 -688 O \nATOM 1565 CB PRO A 194 0.799 -10.857 -86.237 1.00 41.49 C \nANISOU 1565 CB PRO A 194 3597 4969 7198 -182 805 -731 C \nATOM 1566 CG PRO A 194 -0.327 -10.460 -87.080 1.00 41.72 C \nANISOU 1566 CG PRO A 194 3562 5034 7254 -202 793 -780 C \nATOM 1567 CD PRO A 194 -1.346 -11.521 -86.894 1.00 45.50 C \nANISOU 1567 CD PRO A 194 4016 5487 7784 -231 782 -836 C \nATOM 1568 N THR A 195 -1.105 -9.669 -84.047 1.00 51.61 N \nANISOU 1568 N THR A 195 4835 6190 8584 -172 711 -763 N \nATOM 1569 CA THR A 195 -1.392 -8.625 -83.051 1.00 51.68 C \nANISOU 1569 CA THR A 195 4845 6184 8608 -157 674 -746 C \nATOM 1570 C THR A 195 -2.716 -8.903 -82.394 1.00 53.12 C \nANISOU 1570 C THR A 195 5004 6324 8854 -171 636 -792 C \nATOM 1571 O THR A 195 -3.762 -8.986 -83.063 1.00 56.18 O \nANISOU 1571 O THR A 195 5354 6721 9270 -185 628 -842 O \nATOM 1572 CB THR A 195 -1.410 -7.219 -83.706 1.00 47.16 C \nANISOU 1572 CB THR A 195 4248 5667 8004 -153 670 -733 C \nATOM 1573 OG1 THR A 195 -0.260 -7.082 -84.513 1.00 47.24 O \nANISOU 1573 OG1 THR A 195 4271 5726 7953 -137 707 -697 O \nATOM 1574 CG2 THR A 195 -1.363 -6.165 -82.630 1.00 44.97 C \nANISOU 1574 CG2 THR A 195 3981 5383 7723 -140 638 -702 C \nATOM 1575 N THR A 196 -2.687 -9.073 -81.091 1.00 54.65 N \nANISOU 1575 N THR A 196 5223 6473 9070 -162 613 -776 N \nATOM 1576 CA THR A 196 -3.866 -9.642 -80.388 1.00 57.96 C \nANISOU 1576 CA THR A 196 5624 6849 9549 -171 579 -818 C \nATOM 1577 C THR A 196 -4.080 -8.969 -79.036 1.00 51.18 C \nANISOU 1577 C THR A 196 4785 5953 8710 -160 540 -796 C \nATOM 1578 O THR A 196 -3.240 -8.200 -78.604 1.00 51.42 O \nANISOU 1578 O THR A 196 4840 5991 8705 -148 542 -749 O \nATOM 1579 CB THR A 196 -3.721 -11.185 -80.172 1.00 58.57 C \nANISOU 1579 CB THR A 196 5709 6908 9638 -185 596 -834 C \nATOM 1580 OG1 THR A 196 -2.511 -11.483 -79.464 1.00 55.29 O \nANISOU 1580 OG1 THR A 196 5344 6471 9191 -179 613 -785 O \nATOM 1581 CG2 THR A 196 -3.663 -11.892 -81.441 1.00 68.02 C \nANISOU 1581 CG2 THR A 196 6884 8142 10818 -203 631 -860 C \nATOM 1582 N TYR A 197 -5.171 -9.362 -78.353 1.00 42.85 N \nANISOU 1582 N TYR A 197 3717 4860 7706 -162 505 -830 N \nATOM 1583 CA TYR A 197 -5.626 -8.708 -77.134 1.00 39.40 C \nANISOU 1583 CA TYR A 197 3295 4384 7293 -156 462 -817 C \nATOM 1584 C TYR A 197 -6.651 -9.552 -76.434 1.00 36.71 C \nANISOU 1584 C TYR A 197 2941 4003 7003 -153 432 -854 C \nATOM 1585 O TYR A 197 -7.471 -10.237 -77.105 1.00 35.07 O \nANISOU 1585 O TYR A 197 2701 3805 6820 -153 435 -903 O \nATOM 1586 CB TYR A 197 -6.270 -7.307 -77.488 1.00 37.87 C \nANISOU 1586 CB TYR A 197 3093 4202 7094 -160 438 -823 C \nATOM 1587 CG TYR A 197 -7.492 -7.452 -78.359 1.00 33.09 C \nANISOU 1587 CG TYR A 197 2459 3597 6517 -163 429 -881 C \nATOM 1588 CD1 TYR A 197 -8.729 -7.403 -77.826 1.00 33.39 C \nANISOU 1588 CD1 TYR A 197 2497 3591 6598 -156 388 -914 C \nATOM 1589 CD2 TYR A 197 -7.394 -7.658 -79.712 1.00 40.78 C \nANISOU 1589 CD2 TYR A 197 3409 4615 7473 -170 463 -904 C \nATOM 1590 CE1 TYR A 197 -9.862 -7.602 -78.573 1.00 33.56 C \nANISOU 1590 CE1 TYR A 197 2498 3611 6644 -149 381 -970 C \nATOM 1591 CE2 TYR A 197 -8.536 -7.839 -80.503 1.00 41.78 C \nANISOU 1591 CE2 TYR A 197 3508 4742 7623 -169 456 -961 C \nATOM 1592 CZ TYR A 197 -9.775 -7.820 -79.890 1.00 40.43 C \nANISOU 1592 CZ TYR A 197 3341 4524 7496 -155 414 -995 C \nATOM 1593 OH TYR A 197 -10.933 -7.961 -80.605 1.00 48.24 O \nANISOU 1593 OH TYR A 197 4310 5511 8508 -144 406 -1052 O \nATOM 1594 N ILE A 198 -6.682 -9.467 -75.111 1.00 32.88 N \nANISOU 1594 N ILE A 198 2478 3479 6534 -148 403 -832 N \nATOM 1595 CA ILE A 198 -7.794 -9.995 -74.367 1.00 34.73 C \nANISOU 1595 CA ILE A 198 2701 3677 6817 -141 365 -864 C \nATOM 1596 C ILE A 198 -8.491 -8.788 -73.782 1.00 44.45 C \nANISOU 1596 C ILE A 198 3950 4879 8062 -135 322 -857 C \nATOM 1597 O ILE A 198 -7.829 -7.857 -73.264 1.00 44.15 O \nANISOU 1597 O ILE A 198 3938 4840 7996 -143 317 -813 O \nATOM 1598 CB ILE A 198 -7.361 -10.882 -73.196 1.00 40.86 C \nANISOU 1598 CB ILE A 198 3494 4430 7603 -145 361 -845 C \nATOM 1599 CG1 ILE A 198 -6.785 -12.179 -73.673 1.00 40.33 C \nANISOU 1599 CG1 ILE A 198 3417 4387 7521 -160 401 -855 C \nATOM 1600 CG2 ILE A 198 -8.558 -11.202 -72.277 1.00 39.50 C \nANISOU 1600 CG2 ILE A 198 3310 4222 7478 -132 314 -872 C \nATOM 1601 CD1 ILE A 198 -5.312 -12.102 -74.022 1.00 45.52 C \nANISOU 1601 CD1 ILE A 198 4109 5060 8126 -169 444 -813 C \nATOM 1602 N SER A 199 -9.818 -8.798 -73.812 1.00 48.47 N \nANISOU 1602 N SER A 199 4445 5364 8608 -122 289 -900 N \nATOM 1603 CA SER A 199 -10.608 -7.636 -73.376 1.00 50.68 C \nANISOU 1603 CA SER A 199 4752 5609 8897 -121 246 -898 C \nATOM 1604 C SER A 199 -11.691 -8.161 -72.468 1.00 53.02 C \nANISOU 1604 C SER A 199 5051 5858 9238 -98 204 -923 C \nATOM 1605 O SER A 199 -12.524 -8.954 -72.874 1.00 56.47 O \nANISOU 1605 O SER A 199 5460 6296 9701 -74 201 -969 O \nATOM 1606 CB SER A 199 -11.175 -6.896 -74.592 1.00 55.21 C \nANISOU 1606 CB SER A 199 5320 6198 9458 -127 251 -928 C \nATOM 1607 OG SER A 199 -12.423 -6.307 -74.292 1.00 56.18 O \nANISOU 1607 OG SER A 199 5467 6273 9604 -118 207 -953 O \nATOM 1608 N VAL A 200 -11.646 -7.773 -71.200 1.00 55.55 N \nANISOU 1608 N VAL A 200 5401 6141 9564 -102 172 -890 N \nATOM 1609 CA VAL A 200 -12.589 -8.301 -70.200 1.00 49.38 C \nANISOU 1609 CA VAL A 200 4623 5317 8822 -78 129 -907 C \nATOM 1610 C VAL A 200 -13.276 -7.128 -69.502 1.00 49.21 C \nANISOU 1610 C VAL A 200 4649 5246 8805 -83 82 -893 C \nATOM 1611 O VAL A 200 -12.599 -6.160 -69.106 1.00 45.25 O \nANISOU 1611 O VAL A 200 4175 4745 8273 -114 80 -851 O \nATOM 1612 CB VAL A 200 -11.887 -9.085 -69.126 1.00 44.48 C \nANISOU 1612 CB VAL A 200 4000 4695 8204 -84 132 -878 C \nATOM 1613 CG1 VAL A 200 -12.895 -9.814 -68.269 1.00 36.19 C \nANISOU 1613 CG1 VAL A 200 2941 3615 7193 -57 93 -900 C \nATOM 1614 CG2 VAL A 200 -10.914 -10.026 -69.729 1.00 51.91 C \nANISOU 1614 CG2 VAL A 200 4914 5683 9127 -96 183 -877 C \nATOM 1615 N GLY A 201 -14.599 -7.204 -69.376 1.00 45.49 N \nANISOU 1615 N GLY A 201 4188 4733 8363 -52 44 -930 N \nATOM 1616 CA GLY A 201 -15.406 -6.115 -68.834 1.00 49.12 C \nANISOU 1616 CA GLY A 201 4703 5136 8824 -57 -3 -923 C \nATOM 1617 C GLY A 201 -16.555 -6.551 -67.956 1.00 51.06 C \nANISOU 1617 C GLY A 201 4966 5328 9106 -16 -51 -942 C \nATOM 1618 O GLY A 201 -17.308 -7.465 -68.273 1.00 49.41 O \nANISOU 1618 O GLY A 201 4727 5122 8923 31 -54 -986 O \nATOM 1619 N THR A 202 -16.679 -5.895 -66.812 1.00 51.17 N \nANISOU 1619 N THR A 202 5026 5299 9119 -32 -90 -909 N \nATOM 1620 CA THR A 202 -17.864 -6.003 -65.981 1.00 47.44 C \nANISOU 1620 CA THR A 202 4587 4765 8674 5 -143 -922 C \nATOM 1621 C THR A 202 -18.433 -4.574 -65.811 1.00 56.17 C \nANISOU 1621 C THR A 202 5770 5813 9759 -23 -179 -910 C \nATOM 1622 O THR A 202 -18.143 -3.675 -66.594 1.00 67.41 O \nANISOU 1622 O THR A 202 7211 7251 11152 -63 -161 -907 O \nATOM 1623 CB THR A 202 -17.535 -6.636 -64.644 1.00 45.05 C \nANISOU 1623 CB THR A 202 4272 4459 8386 8 -161 -892 C \nATOM 1624 OG1 THR A 202 -16.824 -5.720 -63.796 1.00 40.77 O \nANISOU 1624 OG1 THR A 202 3766 3906 7819 -43 -171 -839 O \nATOM 1625 CG2 THR A 202 -16.677 -7.807 -64.813 1.00 44.99 C \nANISOU 1625 CG2 THR A 202 4199 4511 8382 10 -119 -893 C \nATOM 1626 N SER A 203 -19.237 -4.357 -64.784 1.00 59.89 N \nANISOU 1626 N SER A 203 6291 6221 10244 -8 -231 -902 N \nATOM 1627 CA SER A 203 -19.643 -3.018 -64.424 1.00 57.40 C \nANISOU 1627 CA SER A 203 6056 5851 9902 -50 -266 -881 C \nATOM 1628 C SER A 203 -18.492 -2.225 -63.801 1.00 55.27 C \nANISOU 1628 C SER A 203 5790 5612 9597 -121 -257 -824 C \nATOM 1629 O SER A 203 -18.452 -0.982 -63.845 1.00 65.17 O \nANISOU 1629 O SER A 203 7093 6854 10813 -177 -268 -804 O \nATOM 1630 CB SER A 203 -20.802 -3.061 -63.465 1.00 57.83 C \nANISOU 1630 CB SER A 203 6167 5828 9978 -11 -324 -886 C \nATOM 1631 OG SER A 203 -20.379 -3.567 -62.235 1.00 61.19 O \nANISOU 1631 OG SER A 203 6571 6261 10417 -11 -339 -852 O \nATOM 1632 N THR A 204 -17.561 -2.941 -63.220 1.00 48.74 N \nANISOU 1632 N THR A 204 4912 4828 8778 -119 -237 -799 N \nATOM 1633 CA THR A 204 -16.484 -2.333 -62.423 1.00 46.28 C \nANISOU 1633 CA THR A 204 4604 4545 8436 -172 -232 -744 C \nATOM 1634 C THR A 204 -15.143 -2.477 -63.102 1.00 48.55 C \nANISOU 1634 C THR A 204 4838 4910 8699 -190 -174 -730 C \nATOM 1635 O THR A 204 -14.253 -1.699 -62.855 1.00 54.05 O \nANISOU 1635 O THR A 204 5539 5643 9357 -233 -162 -691 O \nATOM 1636 CB THR A 204 -16.448 -3.014 -61.035 1.00 55.68 C \nANISOU 1636 CB THR A 204 5790 5716 9650 -155 -258 -722 C \nATOM 1637 OG1 THR A 204 -16.474 -1.998 -60.003 1.00 60.65 O \nANISOU 1637 OG1 THR A 204 6472 6316 10255 -200 -295 -683 O \nATOM 1638 CG2 THR A 204 -15.180 -3.928 -60.867 1.00 56.02 C \nANISOU 1638 CG2 THR A 204 5773 5819 9694 -153 -214 -705 C \nATOM 1639 N LEU A 205 -15.033 -3.452 -64.013 1.00 47.42 N \nANISOU 1639 N LEU A 205 4646 4795 8574 -154 -138 -763 N \nATOM 1640 CA LEU A 205 -13.786 -3.843 -64.601 1.00 43.75 C \nANISOU 1640 CA LEU A 205 4136 4397 8091 -162 -84 -751 C \nATOM 1641 C LEU A 205 -13.782 -3.494 -66.092 1.00 44.08 C \nANISOU 1641 C LEU A 205 4163 4471 8114 -167 -53 -777 C \nATOM 1642 O LEU A 205 -14.767 -3.714 -66.791 1.00 42.87 O \nANISOU 1642 O LEU A 205 4013 4294 7983 -142 -61 -822 O \nATOM 1643 CB LEU A 205 -13.583 -5.370 -64.419 1.00 40.63 C \nANISOU 1643 CB LEU A 205 3697 4014 7728 -125 -66 -767 C \nATOM 1644 CG LEU A 205 -12.264 -5.892 -64.999 1.00 40.01 C \nANISOU 1644 CG LEU A 205 3581 3995 7626 -133 -9 -754 C \nATOM 1645 CD1 LEU A 205 -11.089 -5.533 -64.128 1.00 32.98 C \nANISOU 1645 CD1 LEU A 205 2703 3121 6705 -158 1 -701 C \nATOM 1646 CD2 LEU A 205 -12.385 -7.420 -65.223 1.00 43.19 C \nANISOU 1646 CD2 LEU A 205 3942 4410 8058 -103 9 -786 C \nATOM 1647 N ASN A 206 -12.607 -3.082 -66.560 1.00 44.53 N \nANISOU 1647 N ASN A 206 4201 4587 8131 -193 -13 -750 N \nATOM 1648 CA ASN A 206 -12.391 -2.620 -67.894 1.00 47.04 C \nANISOU 1648 CA ASN A 206 4505 4947 8422 -206 19 -764 C \nATOM 1649 C ASN A 206 -10.902 -2.790 -68.199 1.00 47.75 C \nANISOU 1649 C ASN A 206 4561 5104 8477 -211 68 -732 C \nATOM 1650 O ASN A 206 -10.134 -1.838 -68.101 1.00 52.35 O \nANISOU 1650 O ASN A 206 5150 5727 9014 -240 76 -694 O \nATOM 1651 CB ASN A 206 -12.827 -1.138 -68.035 1.00 42.22 C \nANISOU 1651 CB ASN A 206 3936 4329 7777 -251 -6 -755 C \nATOM 1652 CG ASN A 206 -12.783 -0.638 -69.465 1.00 43.39 C \nANISOU 1652 CG ASN A 206 4071 4519 7896 -268 23 -776 C \nATOM 1653 OD1 ASN A 206 -12.642 -1.407 -70.439 1.00 57.03 O \nANISOU 1653 OD1 ASN A 206 5762 6272 9637 -241 58 -804 O \nATOM 1654 ND2 ASN A 206 -12.886 0.643 -69.622 1.00 40.90 N \nANISOU 1654 ND2 ASN A 206 3785 4217 7539 -318 10 -762 N \nATOM 1655 N GLN A 207 -10.516 -4.002 -68.604 1.00 41.08 N \nANISOU 1655 N GLN A 207 3683 4274 7650 -182 101 -748 N \nATOM 1656 CA GLN A 207 -9.147 -4.274 -68.937 1.00 38.59 C \nANISOU 1656 CA GLN A 207 3349 4012 7303 -182 148 -720 C \nATOM 1657 C GLN A 207 -8.912 -4.621 -70.428 1.00 40.12 C \nANISOU 1657 C GLN A 207 3512 4248 7485 -175 191 -745 C \nATOM 1658 O GLN A 207 -9.790 -4.969 -71.166 1.00 37.12 O \nANISOU 1658 O GLN A 207 3118 3856 7129 -165 188 -790 O \nATOM 1659 CB GLN A 207 -8.571 -5.357 -68.042 1.00 39.95 C \nANISOU 1659 CB GLN A 207 3520 4171 7490 -165 156 -705 C \nATOM 1660 CG GLN A 207 -8.796 -6.747 -68.486 1.00 43.95 C \nANISOU 1660 CG GLN A 207 4000 4673 8027 -146 175 -741 C \nATOM 1661 CD GLN A 207 -8.030 -7.808 -67.650 1.00 43.73 C \nANISOU 1661 CD GLN A 207 3975 4639 8001 -142 190 -722 C \nATOM 1662 OE1 GLN A 207 -7.992 -8.998 -68.007 1.00 40.75 O \nANISOU 1662 OE1 GLN A 207 3578 4270 7637 -137 212 -746 O \nATOM 1663 NE2 GLN A 207 -7.460 -7.393 -66.553 1.00 43.39 N \nANISOU 1663 NE2 GLN A 207 3960 4585 7943 -149 177 -682 N \nATOM 1664 N ARG A 208 -7.690 -4.437 -70.874 1.00 40.86 N \nANISOU 1664 N ARG A 208 3598 4393 7534 -177 231 -714 N \nATOM 1665 CA ARG A 208 -7.314 -4.862 -72.177 1.00 38.51 C \nANISOU 1665 CA ARG A 208 3275 4135 7222 -171 273 -732 C \nATOM 1666 C ARG A 208 -5.868 -5.296 -72.091 1.00 46.07 C \nANISOU 1666 C ARG A 208 4237 5123 8144 -158 313 -693 C \nATOM 1667 O ARG A 208 -5.015 -4.491 -71.755 1.00 45.66 O \nANISOU 1667 O ARG A 208 4198 5102 8050 -159 319 -650 O \nATOM 1668 CB ARG A 208 -7.444 -3.778 -73.187 1.00 38.15 C \nANISOU 1668 CB ARG A 208 3221 4130 7144 -189 279 -736 C \nATOM 1669 CG ARG A 208 -7.975 -4.305 -74.506 1.00 36.59 C \nANISOU 1669 CG ARG A 208 2999 3944 6961 -185 300 -783 C \nATOM 1670 CD ARG A 208 -8.014 -3.263 -75.548 1.00 36.13 C \nANISOU 1670 CD ARG A 208 2933 3930 6865 -207 310 -786 C \nATOM 1671 NE ARG A 208 -6.865 -3.367 -76.448 1.00 38.35 N \nANISOU 1671 NE ARG A 208 3193 4275 7103 -202 358 -765 N \nATOM 1672 CZ ARG A 208 -6.924 -3.609 -77.755 1.00 39.50 C \nANISOU 1672 CZ ARG A 208 3315 4454 7240 -203 386 -792 C \nATOM 1673 NH1 ARG A 208 -8.107 -3.847 -78.346 1.00 42.19 N \nANISOU 1673 NH1 ARG A 208 3647 4770 7615 -207 374 -847 N \nATOM 1674 NH2 ARG A 208 -5.788 -3.644 -78.457 1.00 37.42 N \nANISOU 1674 NH2 ARG A 208 3040 4248 6932 -197 428 -765 N \nATOM 1675 N LEU A 209 -5.609 -6.591 -72.361 1.00 49.78 N \nANISOU 1675 N LEU A 209 4700 5587 8629 -147 340 -710 N \nATOM 1676 CA LEU A 209 -4.282 -7.205 -72.148 1.00 38.61 C \nANISOU 1676 CA LEU A 209 3304 4183 7182 -136 376 -676 C \nATOM 1677 C LEU A 209 -3.685 -7.491 -73.498 1.00 39.18 C \nANISOU 1677 C LEU A 209 3366 4298 7224 -133 422 -681 C \nATOM 1678 O LEU A 209 -4.353 -7.910 -74.404 1.00 39.00 O \nANISOU 1678 O LEU A 209 3315 4282 7221 -140 428 -722 O \nATOM 1679 CB LEU A 209 -4.412 -8.485 -71.411 1.00 42.78 C \nANISOU 1679 CB LEU A 209 3841 4671 7742 -138 372 -689 C \nATOM 1680 CG LEU A 209 -5.098 -8.430 -70.045 1.00 45.17 C \nANISOU 1680 CG LEU A 209 4153 4929 8080 -140 326 -688 C \nATOM 1681 CD1 LEU A 209 -5.436 -9.803 -69.493 1.00 40.48 C \nANISOU 1681 CD1 LEU A 209 3556 4307 7520 -145 321 -711 C \nATOM 1682 CD2 LEU A 209 -4.281 -7.624 -69.084 1.00 46.37 C \nANISOU 1682 CD2 LEU A 209 4337 5081 8201 -136 319 -638 C \nATOM 1683 N VAL A 210 -2.424 -7.114 -73.656 1.00 48.54 N \nANISOU 1683 N VAL A 210 4571 5515 8355 -117 452 -638 N \nATOM 1684 CA VAL A 210 -1.696 -7.325 -74.920 1.00 47.03 C \nANISOU 1684 CA VAL A 210 4377 5367 8126 -110 497 -634 C \nATOM 1685 C VAL A 210 -0.498 -8.175 -74.583 1.00 42.95 C \nANISOU 1685 C VAL A 210 3905 4835 7580 -94 529 -605 C \nATOM 1686 O VAL A 210 0.194 -7.881 -73.602 1.00 49.04 O \nANISOU 1686 O VAL A 210 4709 5594 8330 -75 525 -567 O \nATOM 1687 CB VAL A 210 -1.214 -6.000 -75.538 1.00 46.45 C \nANISOU 1687 CB VAL A 210 4292 5355 8002 -100 505 -606 C \nATOM 1688 CG1 VAL A 210 -0.199 -6.307 -76.623 1.00 56.48 C \nANISOU 1688 CG1 VAL A 210 5570 6665 9225 -82 553 -590 C \nATOM 1689 CG2 VAL A 210 -2.371 -5.269 -76.167 1.00 49.41 C \nANISOU 1689 CG2 VAL A 210 4630 5747 8399 -125 481 -641 C \nATOM 1690 N PRO A 211 -0.294 -9.264 -75.317 1.00 36.74 N \nANISOU 1690 N PRO A 211 3124 4043 6791 -104 561 -624 N \nATOM 1691 CA PRO A 211 0.782 -10.217 -75.016 1.00 35.36 C \nANISOU 1691 CA PRO A 211 3005 3844 6587 -98 592 -600 C \nATOM 1692 C PRO A 211 2.110 -9.600 -75.299 1.00 34.87 C \nANISOU 1692 C PRO A 211 2980 3810 6458 -60 623 -551 C \nATOM 1693 O PRO A 211 2.259 -8.937 -76.357 1.00 35.01 O \nANISOU 1693 O PRO A 211 2973 3880 6448 -48 637 -546 O \nATOM 1694 CB PRO A 211 0.503 -11.363 -75.987 1.00 32.38 C \nANISOU 1694 CB PRO A 211 2615 3469 6219 -128 617 -638 C \nATOM 1695 CG PRO A 211 -0.317 -10.788 -77.066 1.00 34.49 C \nANISOU 1695 CG PRO A 211 2825 3778 6500 -134 610 -669 C \nATOM 1696 CD PRO A 211 -1.177 -9.779 -76.355 1.00 35.37 C \nANISOU 1696 CD PRO A 211 2909 3883 6645 -127 565 -673 C \nATOM 1697 N LYS A 212 3.032 -9.728 -74.378 1.00 34.95 N \nANISOU 1697 N LYS A 212 3046 3793 6441 -36 630 -514 N \nATOM 1698 CA LYS A 212 4.419 -9.259 -74.535 1.00 37.25 C \nANISOU 1698 CA LYS A 212 3384 4108 6662 14 662 -464 C \nATOM 1699 C LYS A 212 5.292 -10.298 -75.198 1.00 39.21 C \nANISOU 1699 C LYS A 212 3691 4336 6872 16 706 -457 C \nATOM 1700 O LYS A 212 5.736 -11.251 -74.555 1.00 37.70 O \nANISOU 1700 O LYS A 212 3559 4089 6675 5 717 -453 O \nATOM 1701 CB LYS A 212 5.028 -9.008 -73.130 1.00 38.00 C \nANISOU 1701 CB LYS A 212 3522 4175 6741 42 650 -429 C \nATOM 1702 CG LYS A 212 4.739 -7.617 -72.569 1.00 39.49 C \nANISOU 1702 CG LYS A 212 3669 4407 6930 59 618 -412 C \nATOM 1703 CD LYS A 212 3.779 -7.701 -71.422 1.00 38.10 C \nANISOU 1703 CD LYS A 212 3476 4190 6811 26 575 -433 C \nATOM 1704 CE LYS A 212 4.321 -6.977 -70.217 1.00 41.59 C \nANISOU 1704 CE LYS A 212 3938 4636 7227 54 560 -395 C \nATOM 1705 NZ LYS A 212 3.601 -7.378 -68.948 1.00 39.97 N \nANISOU 1705 NZ LYS A 212 3737 4376 7073 23 524 -411 N \nATOM 1706 N ILE A 213 5.511 -10.138 -76.484 1.00 44.90 N \nANISOU 1706 N ILE A 213 4396 5099 7564 23 731 -457 N \nATOM 1707 CA ILE A 213 6.225 -11.160 -77.271 1.00 53.75 C \nANISOU 1707 CA ILE A 213 5572 6200 8649 15 772 -455 C \nATOM 1708 C ILE A 213 7.727 -10.865 -77.070 1.00 61.81 C \nANISOU 1708 C ILE A 213 6672 7218 9596 81 801 -398 C \nATOM 1709 O ILE A 213 8.245 -9.909 -77.633 1.00 67.48 O \nANISOU 1709 O ILE A 213 7376 7994 10271 130 810 -369 O \nATOM 1710 CB ILE A 213 5.905 -11.027 -78.784 1.00 49.61 C \nANISOU 1710 CB ILE A 213 5001 5729 8118 1 788 -474 C \nATOM 1711 CG1 ILE A 213 4.401 -10.880 -79.045 1.00 52.72 C \nANISOU 1711 CG1 ILE A 213 5309 6144 8580 -43 756 -527 C \nATOM 1712 CG2 ILE A 213 6.535 -12.162 -79.567 1.00 43.96 C \nANISOU 1712 CG2 ILE A 213 4342 4992 7368 -18 828 -475 C \nATOM 1713 CD1 ILE A 213 3.644 -12.194 -79.049 1.00 55.12 C \nANISOU 1713 CD1 ILE A 213 5605 6412 8926 -100 754 -574 C \nATOM 1714 N ALA A 214 8.425 -11.688 -76.318 1.00 64.24 N \nANISOU 1714 N ALA A 214 7063 7461 9884 83 815 -383 N \nATOM 1715 CA ALA A 214 9.863 -11.517 -76.180 1.00 68.63 C \nANISOU 1715 CA ALA A 214 7706 8005 10364 151 845 -332 C \nATOM 1716 C ALA A 214 10.597 -12.822 -75.845 1.00 65.60 C \nANISOU 1716 C ALA A 214 7434 7540 9953 131 873 -326 C \nATOM 1717 O ALA A 214 9.988 -13.839 -75.548 1.00 62.37 O \nANISOU 1717 O ALA A 214 7027 7087 9582 60 866 -361 O \nATOM 1718 CB ALA A 214 10.130 -10.489 -75.100 1.00 69.60 C \nANISOU 1718 CB ALA A 214 7820 8146 10478 205 824 -303 C \nATOM 1719 N THR A 215 11.915 -12.752 -75.870 1.00 71.25 N \nANISOU 1719 N THR A 215 8242 8237 10594 197 904 -282 N \nATOM 1720 CA THR A 215 12.800 -13.900 -75.541 1.00 75.21 C \nANISOU 1720 CA THR A 215 8872 8653 11052 186 935 -270 C \nATOM 1721 C THR A 215 13.045 -13.945 -74.031 1.00 75.77 C \nANISOU 1721 C THR A 215 8988 8673 11127 199 920 -259 C \nATOM 1722 O THR A 215 13.293 -12.918 -73.402 1.00 76.49 O \nANISOU 1722 O THR A 215 9057 8796 11209 265 906 -234 O \nATOM 1723 CB THR A 215 14.167 -13.789 -76.290 1.00 72.94 C \nANISOU 1723 CB THR A 215 8678 8361 10675 260 976 -224 C \nATOM 1724 OG1 THR A 215 13.952 -13.903 -77.709 1.00 71.24 O \nANISOU 1724 OG1 THR A 215 8428 8186 10453 237 991 -235 O \nATOM 1725 CG2 THR A 215 15.150 -14.872 -75.844 1.00 74.93 C \nANISOU 1725 CG2 THR A 215 9081 8515 10874 255 1006 -208 C \nATOM 1726 N ARG A 216 12.952 -15.122 -73.439 1.00 83.59 N \nANISOU 1726 N ARG A 216 10038 9591 12130 133 924 -279 N \nATOM 1727 CA ARG A 216 13.155 -15.232 -71.994 1.00 92.17 C \nANISOU 1727 CA ARG A 216 11170 10629 13220 138 911 -272 C \nATOM 1728 C ARG A 216 14.029 -16.403 -71.626 1.00 87.39 C \nANISOU 1728 C ARG A 216 10706 9933 12564 113 942 -263 C \nATOM 1729 O ARG A 216 14.275 -17.292 -72.446 1.00 79.92 O \nANISOU 1729 O ARG A 216 9817 8960 11590 68 970 -270 O \nATOM 1730 CB ARG A 216 11.834 -15.403 -71.263 1.00 97.66 C \nANISOU 1730 CB ARG A 216 11774 11333 13999 68 869 -312 C \nATOM 1731 CG ARG A 216 10.934 -14.180 -71.272 1.00 96.93 C \nANISOU 1731 CG ARG A 216 11557 11315 13958 91 831 -320 C \nATOM 1732 CD ARG A 216 9.513 -14.573 -70.897 1.00 83.52 C \nANISOU 1732 CD ARG A 216 9773 9620 12339 15 794 -366 C \nATOM 1733 NE ARG A 216 8.498 -13.750 -71.515 1.00 74.63 N \nANISOU 1733 NE ARG A 216 8535 8561 11260 14 768 -387 N \nATOM 1734 CZ ARG A 216 7.746 -14.124 -72.546 1.00 77.97 C \nANISOU 1734 CZ ARG A 216 8904 9010 11712 -30 769 -421 C \nATOM 1735 NH1 ARG A 216 7.885 -15.317 -73.112 1.00 84.24 N \nANISOU 1735 NH1 ARG A 216 9737 9778 12491 -79 795 -439 N \nATOM 1736 NH2 ARG A 216 6.850 -13.288 -73.027 1.00 78.28 N \nANISOU 1736 NH2 ARG A 216 8849 9104 11788 -26 744 -439 N \nATOM 1737 N SER A 217 14.486 -16.360 -70.375 1.00 81.63 N \nANISOU 1737 N SER A 217 10035 9159 11820 138 937 -247 N \nATOM 1738 CA SER A 217 15.189 -17.469 -69.739 1.00 81.49 C \nANISOU 1738 CA SER A 217 10153 9050 11761 102 960 -244 C \nATOM 1739 C SER A 217 14.188 -18.562 -69.388 1.00 83.22 C \nANISOU 1739 C SER A 217 10336 9249 12033 -20 942 -289 C \nATOM 1740 O SER A 217 13.075 -18.302 -68.948 1.00 81.85 O \nANISOU 1740 O SER A 217 10050 9117 11932 -52 904 -316 O \nATOM 1741 CB SER A 217 15.922 -17.005 -68.471 1.00 81.21 C \nANISOU 1741 CB SER A 217 10182 8980 11695 170 958 -215 C \nATOM 1742 OG SER A 217 15.117 -16.125 -67.668 1.00 77.25 O \nANISOU 1742 OG SER A 217 9566 8532 11254 182 915 -224 O \nATOM 1743 N LYS A 218 14.589 -19.806 -69.595 1.00 91.05 N \nANISOU 1743 N LYS A 218 11429 10180 12985 -90 971 -298 N \nATOM 1744 CA LYS A 218 13.682 -20.934 -69.419 1.00 87.34 C \nANISOU 1744 CA LYS A 218 10923 9706 12555 -211 958 -342 C \nATOM 1745 C LYS A 218 13.503 -21.179 -67.935 1.00 84.18 C \nANISOU 1745 C LYS A 218 10537 9271 12175 -239 936 -348 C \nATOM 1746 O LYS A 218 14.469 -21.437 -67.239 1.00 95.58 O \nANISOU 1746 O LYS A 218 12107 10646 13564 -221 956 -325 O \nATOM 1747 CB LYS A 218 14.207 -22.180 -70.135 1.00 82.15 C \nANISOU 1747 CB LYS A 218 10370 9002 11839 -287 996 -347 C \nATOM 1748 CG LYS A 218 14.188 -22.022 -71.646 1.00 90.82 C \nANISOU 1748 CG LYS A 218 11437 10145 12926 -275 1014 -347 C \nATOM 1749 CD LYS A 218 14.615 -23.294 -72.372 1.00 97.53 C \nANISOU 1749 CD LYS A 218 12385 10954 13718 -363 1050 -355 C \nATOM 1750 CE LYS A 218 14.322 -23.249 -73.866 1.00101.99 C \nANISOU 1750 CE LYS A 218 12891 11575 14284 -373 1062 -364 C \nATOM 1751 NZ LYS A 218 15.258 -22.340 -74.569 1.00108.32 N \nANISOU 1751 NZ LYS A 218 13743 12375 15039 -262 1083 -321 N \nATOM 1752 N VAL A 219 12.260 -21.071 -67.471 1.00 81.49 N \nANISOU 1752 N VAL A 219 10072 8980 11912 -277 895 -380 N \nATOM 1753 CA VAL A 219 11.829 -21.502 -66.142 1.00 76.75 C \nANISOU 1753 CA VAL A 219 9465 8357 11339 -327 869 -395 C \nATOM 1754 C VAL A 219 11.020 -22.799 -66.278 1.00 81.85 C \nANISOU 1754 C VAL A 219 10078 9017 12005 -447 864 -438 C \nATOM 1755 O VAL A 219 9.959 -22.795 -66.897 1.00 81.97 O \nANISOU 1755 O VAL A 219 9975 9096 12073 -474 844 -468 O \nATOM 1756 CB VAL A 219 10.947 -20.409 -65.489 1.00 72.57 C \nANISOU 1756 CB VAL A 219 8815 7879 10880 -280 822 -398 C \nATOM 1757 CG1 VAL A 219 10.543 -20.787 -64.068 1.00 71.17 C \nANISOU 1757 CG1 VAL A 219 8633 7679 10728 -324 794 -410 C \nATOM 1758 CG2 VAL A 219 11.677 -19.088 -65.496 1.00 68.85 C \nANISOU 1758 CG2 VAL A 219 8358 7416 10385 -167 827 -358 C \nATOM 1759 N ASN A 220 11.488 -23.879 -65.641 1.00 98.59 N \nANISOU 1759 N ASN A 220 12298 11081 14081 -520 881 -441 N \nATOM 1760 CA ASN A 220 10.964 -25.261 -65.837 1.00103.14 C \nANISOU 1760 CA ASN A 220 12865 11671 14652 -646 886 -478 C \nATOM 1761 C ASN A 220 11.107 -25.734 -67.283 1.00100.26 C \nANISOU 1761 C ASN A 220 12512 11326 14255 -679 917 -486 C \nATOM 1762 O ASN A 220 10.211 -26.359 -67.841 1.00 99.18 O \nANISOU 1762 O ASN A 220 12289 11250 14146 -750 908 -523 O \nATOM 1763 CB ASN A 220 9.498 -25.385 -65.373 1.00112.72 C \nANISOU 1763 CB ASN A 220 13929 12954 15943 -688 839 -517 C \nATOM 1764 CG ASN A 220 9.339 -25.196 -63.875 1.00119.36 C \nANISOU 1764 CG ASN A 220 14769 13774 16808 -681 810 -511 C \nATOM 1765 OD1 ASN A 220 10.307 -25.330 -63.119 1.00124.55 O \nANISOU 1765 OD1 ASN A 220 15546 14363 17415 -677 828 -486 O \nATOM 1766 ND2 ASN A 220 8.116 -24.880 -63.434 1.00117.49 N \nANISOU 1766 ND2 ASN A 220 14402 13594 16645 -679 764 -534 N \nATOM 1767 N GLY A 221 12.236 -25.395 -67.891 1.00 98.07 N \nANISOU 1767 N GLY A 221 12342 11002 13920 -621 952 -452 N \nATOM 1768 CA GLY A 221 12.470 -25.675 -69.302 1.00 95.97 C \nANISOU 1768 CA GLY A 221 12094 10751 13620 -637 982 -453 C \nATOM 1769 C GLY A 221 11.481 -25.007 -70.239 1.00 93.61 C \nANISOU 1769 C GLY A 221 11641 10540 13385 -606 961 -473 C \nATOM 1770 O GLY A 221 11.296 -25.465 -71.362 1.00106.84 O \nANISOU 1770 O GLY A 221 13297 12249 15047 -649 978 -489 O \nATOM 1771 N GLN A 222 10.876 -23.902 -69.803 1.00 91.96 N \nANISOU 1771 N GLN A 222 11333 10369 13240 -531 925 -471 N \nATOM 1772 CA GLN A 222 9.873 -23.179 -70.611 1.00 90.14 C \nANISOU 1772 CA GLN A 222 10959 10218 13071 -500 902 -492 C \nATOM 1773 C GLN A 222 10.091 -21.646 -70.665 1.00 85.59 C \nANISOU 1773 C GLN A 222 10351 9658 12512 -383 890 -461 C \nATOM 1774 O GLN A 222 10.029 -20.934 -69.659 1.00 80.28 O \nANISOU 1774 O GLN A 222 9661 8976 11863 -336 865 -447 O \nATOM 1775 CB GLN A 222 8.473 -23.465 -70.094 1.00 86.34 C \nANISOU 1775 CB GLN A 222 10355 9788 12663 -551 861 -535 C \nATOM 1776 CG GLN A 222 7.376 -22.720 -70.863 1.00 89.90 C \nANISOU 1776 CG GLN A 222 10667 10314 13177 -518 835 -560 C \nATOM 1777 CD GLN A 222 7.489 -22.858 -72.388 1.00 89.03 C \nANISOU 1777 CD GLN A 222 10548 10238 13043 -527 864 -567 C \nATOM 1778 OE1 GLN A 222 7.535 -21.872 -73.123 1.00 85.21 O \nANISOU 1778 OE1 GLN A 222 10030 9779 12566 -460 865 -554 O \nATOM 1779 NE2 GLN A 222 7.537 -24.089 -72.859 1.00 93.89 N \nANISOU 1779 NE2 GLN A 222 11194 10857 13624 -615 888 -588 N \nATOM 1780 N SER A 223 10.343 -21.154 -71.867 1.00 79.44 N \nANISOU 1780 N SER A 223 9561 8909 11716 -342 908 -450 N \nATOM 1781 CA SER A 223 10.679 -19.753 -72.077 1.00 79.95 C \nANISOU 1781 CA SER A 223 9601 8998 11779 -237 903 -418 C \nATOM 1782 C SER A 223 9.438 -18.847 -72.105 1.00 78.27 C \nANISOU 1782 C SER A 223 9242 8855 11644 -219 861 -442 C \nATOM 1783 O SER A 223 9.545 -17.629 -72.015 1.00 86.57 O \nANISOU 1783 O SER A 223 10259 9932 12700 -144 848 -419 O \nATOM 1784 CB SER A 223 11.488 -19.621 -73.381 1.00 78.27 C \nANISOU 1784 CB SER A 223 9438 8793 11509 -203 941 -395 C \nATOM 1785 OG SER A 223 12.877 -19.488 -73.119 1.00 75.15 O \nANISOU 1785 OG SER A 223 9175 8340 11040 -141 970 -349 O \nATOM 1786 N GLY A 224 8.265 -19.449 -72.229 1.00 68.91 N \nANISOU 1786 N GLY A 224 7973 7699 10511 -288 840 -488 N \nATOM 1787 CA GLY A 224 7.002 -18.708 -72.277 1.00 53.20 C \nANISOU 1787 CA GLY A 224 5855 5765 8592 -276 800 -515 C \nATOM 1788 C GLY A 224 6.557 -18.328 -70.917 1.00 46.52 C \nANISOU 1788 C GLY A 224 4985 4905 7787 -264 762 -513 C \nATOM 1789 O GLY A 224 7.175 -18.730 -69.924 1.00 42.72 O \nANISOU 1789 O GLY A 224 4579 4373 7281 -272 767 -496 O \nATOM 1790 N ARG A 225 5.480 -17.546 -70.861 1.00 44.29 N \nANISOU 1790 N ARG A 225 4602 4664 7564 -246 724 -533 N \nATOM 1791 CA ARG A 225 4.900 -17.079 -69.594 1.00 41.24 C \nANISOU 1791 CA ARG A 225 4183 4268 7220 -236 682 -532 C \nATOM 1792 C ARG A 225 3.430 -17.071 -69.703 1.00 36.75 C \nANISOU 1792 C ARG A 225 3513 3735 6718 -260 645 -576 C \nATOM 1793 O ARG A 225 2.856 -17.023 -70.789 1.00 40.05 O \nANISOU 1793 O ARG A 225 3875 4193 7151 -266 648 -601 O \nATOM 1794 CB ARG A 225 5.388 -15.651 -69.217 1.00 49.95 C \nANISOU 1794 CB ARG A 225 5292 5378 8310 -162 672 -493 C \nATOM 1795 CG ARG A 225 6.365 -15.660 -68.081 1.00 67.45 C \nANISOU 1795 CG ARG A 225 7592 7548 10489 -139 680 -458 C \nATOM 1796 CD ARG A 225 7.775 -15.470 -68.536 1.00 77.28 C \nANISOU 1796 CD ARG A 225 8924 8779 11661 -89 723 -418 C \nATOM 1797 NE ARG A 225 8.747 -15.546 -67.432 1.00 82.06 N \nANISOU 1797 NE ARG A 225 9620 9334 12225 -63 733 -387 N \nATOM 1798 CZ ARG A 225 9.834 -16.315 -67.441 1.00 75.68 C \nANISOU 1798 CZ ARG A 225 8924 8474 11357 -64 771 -369 C \nATOM 1799 NH1 ARG A 225 10.136 -17.100 -68.471 1.00 66.84 N \nANISOU 1799 NH1 ARG A 225 7844 7344 10209 -95 804 -378 N \nATOM 1800 NH2 ARG A 225 10.641 -16.284 -66.424 1.00 80.53 N \nANISOU 1800 NH2 ARG A 225 9617 9044 11936 -35 778 -343 N \nATOM 1801 N MET A 226 2.775 -17.050 -68.561 1.00 40.22 N \nANISOU 1801 N MET A 226 3926 4160 7196 -269 607 -584 N \nATOM 1802 CA MET A 226 1.306 -17.099 -68.523 1.00 43.79 C \nANISOU 1802 CA MET A 226 4286 4640 7710 -286 567 -625 C \nATOM 1803 C MET A 226 0.826 -16.342 -67.304 1.00 45.61 C \nANISOU 1803 C MET A 226 4499 4854 7975 -262 523 -613 C \nATOM 1804 O MET A 226 1.106 -16.752 -66.186 1.00 54.95 O \nANISOU 1804 O MET A 226 5720 6005 9153 -278 515 -601 O \nATOM 1805 CB MET A 226 0.856 -18.559 -68.492 1.00 46.12 C \nANISOU 1805 CB MET A 226 4568 4942 8012 -350 572 -661 C \nATOM 1806 CG MET A 226 -0.598 -18.755 -68.809 1.00 52.90 C \nANISOU 1806 CG MET A 226 5332 5842 8925 -360 541 -709 C \nATOM 1807 SD MET A 226 -0.938 -20.486 -69.180 1.00 57.12 S \nANISOU 1807 SD MET A 226 5844 6411 9448 -435 559 -751 S \nATOM 1808 CE MET A 226 -0.361 -20.595 -70.865 1.00 44.87 C \nANISOU 1808 CE MET A 226 4306 4887 7857 -443 607 -756 C \nATOM 1809 N ASP A 227 0.124 -15.228 -67.497 1.00 46.53 N \nANISOU 1809 N ASP A 227 4564 4991 8122 -229 495 -617 N \nATOM 1810 CA ASP A 227 -0.370 -14.443 -66.379 1.00 47.22 C \nANISOU 1810 CA ASP A 227 4637 5064 8239 -211 451 -605 C \nATOM 1811 C ASP A 227 -1.860 -14.717 -66.157 1.00 46.52 C \nANISOU 1811 C ASP A 227 4483 4982 8209 -226 408 -646 C \nATOM 1812 O ASP A 227 -2.648 -14.934 -67.102 1.00 46.09 O \nANISOU 1812 O ASP A 227 4380 4955 8177 -230 407 -682 O \nATOM 1813 CB ASP A 227 -0.154 -12.957 -66.630 1.00 55.85 C \nANISOU 1813 CB ASP A 227 5724 6175 9319 -169 445 -578 C \nATOM 1814 CG ASP A 227 1.343 -12.574 -66.756 1.00 61.74 C \nANISOU 1814 CG ASP A 227 6534 6924 10002 -139 484 -533 C \nATOM 1815 OD1 ASP A 227 2.244 -13.412 -66.379 1.00 66.58 O \nANISOU 1815 OD1 ASP A 227 7209 7507 10582 -148 512 -519 O \nATOM 1816 OD2 ASP A 227 1.593 -11.426 -67.209 1.00 55.01 O \nANISOU 1816 OD2 ASP A 227 5668 6104 9128 -106 486 -513 O \nATOM 1817 N PHE A 228 -2.262 -14.702 -64.880 1.00 35.82 N \nANISOU 1817 N PHE A 228 3130 3602 6878 -230 372 -640 N \nATOM 1818 CA PHE A 228 -3.625 -14.914 -64.580 1.00 33.89 C \nANISOU 1818 CA PHE A 228 2831 3362 6685 -234 330 -674 C \nATOM 1819 C PHE A 228 -4.280 -13.754 -63.902 1.00 34.46 C \nANISOU 1819 C PHE A 228 2892 3418 6783 -209 284 -662 C \nATOM 1820 O PHE A 228 -3.611 -12.961 -63.284 1.00 46.57 O \nANISOU 1820 O PHE A 228 4462 4937 8295 -199 282 -624 O \nATOM 1821 CB PHE A 228 -3.763 -16.187 -63.747 1.00 33.96 C \nANISOU 1821 CB PHE A 228 2842 3363 6700 -270 324 -687 C \nATOM 1822 CG PHE A 228 -3.508 -17.414 -64.521 1.00 33.58 C \nANISOU 1822 CG PHE A 228 2789 3340 6631 -306 361 -711 C \nATOM 1823 CD1 PHE A 228 -4.484 -17.976 -65.293 1.00 34.04 C \nANISOU 1823 CD1 PHE A 228 2783 3437 6712 -312 355 -756 C \nATOM 1824 CD2 PHE A 228 -2.250 -17.960 -64.500 1.00 34.44 C \nANISOU 1824 CD2 PHE A 228 2962 3434 6690 -333 402 -688 C \nATOM 1825 CE1 PHE A 228 -4.195 -19.081 -66.070 1.00 38.03 C \nANISOU 1825 CE1 PHE A 228 3284 3975 7193 -351 391 -778 C \nATOM 1826 CE2 PHE A 228 -1.950 -19.056 -65.282 1.00 39.50 C \nANISOU 1826 CE2 PHE A 228 3607 4097 7304 -374 439 -708 C \nATOM 1827 CZ PHE A 228 -2.926 -19.631 -66.064 1.00 38.48 C \nANISOU 1827 CZ PHE A 228 3408 4015 7198 -387 433 -753 C \nATOM 1828 N PHE A 229 -5.619 -13.735 -63.922 1.00 34.85 N \nANISOU 1828 N PHE A 229 2896 3470 6878 -201 245 -695 N \nATOM 1829 CA PHE A 229 -6.352 -12.585 -63.412 1.00 38.39 C \nANISOU 1829 CA PHE A 229 3340 3898 7349 -181 201 -686 C \nATOM 1830 C PHE A 229 -7.655 -13.088 -62.817 1.00 36.13 C \nANISOU 1830 C PHE A 229 3021 3599 7107 -175 155 -716 C \nATOM 1831 O PHE A 229 -8.089 -14.151 -63.143 1.00 32.60 O \nANISOU 1831 O PHE A 229 2540 3172 6672 -180 162 -750 O \nATOM 1832 CB PHE A 229 -6.652 -11.616 -64.561 1.00 37.74 C \nANISOU 1832 CB PHE A 229 3242 3833 7263 -164 205 -696 C \nATOM 1833 CG PHE A 229 -5.456 -10.974 -65.114 1.00 38.94 C \nANISOU 1833 CG PHE A 229 3420 4005 7369 -162 244 -664 C \nATOM 1834 CD1 PHE A 229 -4.771 -11.534 -66.167 1.00 42.78 C \nANISOU 1834 CD1 PHE A 229 3906 4518 7830 -166 291 -671 C \nATOM 1835 CD2 PHE A 229 -5.012 -9.784 -64.584 1.00 41.12 C \nANISOU 1835 CD2 PHE A 229 3722 4278 7623 -156 232 -626 C \nATOM 1836 CE1 PHE A 229 -3.658 -10.886 -66.715 1.00 42.91 C \nANISOU 1836 CE1 PHE A 229 3948 4556 7799 -156 326 -639 C \nATOM 1837 CE2 PHE A 229 -3.903 -9.117 -65.104 1.00 36.75 C \nANISOU 1837 CE2 PHE A 229 3187 3755 7020 -147 267 -594 C \nATOM 1838 CZ PHE A 229 -3.236 -9.669 -66.174 1.00 39.67 C \nANISOU 1838 CZ PHE A 229 3557 4149 7366 -143 313 -601 C \nATOM 1839 N TRP A 230 -8.281 -12.267 -61.991 1.00 35.27 N \nANISOU 1839 N TRP A 230 2922 3461 7017 -163 110 -704 N \nATOM 1840 CA TRP A 230 -9.492 -12.662 -61.343 1.00 37.34 C \nANISOU 1840 CA TRP A 230 3162 3707 7317 -150 64 -727 C \nATOM 1841 C TRP A 230 -10.343 -11.436 -61.037 1.00 40.87 C \nANISOU 1841 C TRP A 230 3625 4121 7782 -131 18 -721 C \nATOM 1842 O TRP A 230 -9.774 -10.295 -60.865 1.00 37.01 O \nANISOU 1842 O TRP A 230 3170 3621 7269 -142 18 -686 O \nATOM 1843 CB TRP A 230 -9.171 -13.375 -60.070 1.00 34.42 C \nANISOU 1843 CB TRP A 230 2804 3328 6946 -169 53 -709 C \nATOM 1844 CG TRP A 230 -8.483 -12.560 -59.018 1.00 35.22 C \nANISOU 1844 CG TRP A 230 2951 3402 7029 -181 42 -662 C \nATOM 1845 CD1 TRP A 230 -7.137 -12.280 -58.945 1.00 35.60 C \nANISOU 1845 CD1 TRP A 230 3035 3453 7036 -196 79 -627 C \nATOM 1846 CD2 TRP A 230 -9.099 -11.912 -57.868 1.00 34.97 C \nANISOU 1846 CD2 TRP A 230 2936 3338 7015 -176 -9 -644 C \nATOM 1847 NE1 TRP A 230 -6.879 -11.498 -57.785 1.00 40.51 N \nANISOU 1847 NE1 TRP A 230 3690 4053 7650 -201 54 -590 N \nATOM 1848 CE2 TRP A 230 -8.059 -11.267 -57.123 1.00 34.46 C \nANISOU 1848 CE2 TRP A 230 2911 3263 6918 -194 0 -599 C \nATOM 1849 CE3 TRP A 230 -10.446 -11.742 -57.450 1.00 33.72 C \nANISOU 1849 CE3 TRP A 230 2764 3155 6892 -155 -63 -661 C \nATOM 1850 CZ2 TRP A 230 -8.307 -10.520 -56.014 1.00 30.11 C \nANISOU 1850 CZ2 TRP A 230 2384 2688 6370 -199 -40 -573 C \nATOM 1851 CZ3 TRP A 230 -10.720 -11.061 -56.263 1.00 29.67 C \nANISOU 1851 CZ3 TRP A 230 2281 2609 6384 -160 -106 -633 C \nATOM 1852 CH2 TRP A 230 -9.647 -10.430 -55.572 1.00 31.67 C \nANISOU 1852 CH2 TRP A 230 2570 2858 6604 -186 -94 -589 C \nATOM 1853 N THR A 231 -11.664 -11.664 -60.942 1.00 33.64 N \nANISOU 1853 N THR A 231 2689 3191 6901 -104 -22 -753 N \nATOM 1854 CA THR A 231 -12.571 -10.635 -60.453 1.00 37.51 C \nANISOU 1854 CA THR A 231 3207 3637 7406 -89 -72 -747 C \nATOM 1855 C THR A 231 -13.740 -11.268 -59.767 1.00 40.20 C \nANISOU 1855 C THR A 231 3533 3961 7781 -58 -117 -769 C \nATOM 1856 O THR A 231 -13.999 -12.473 -59.912 1.00 43.98 O \nANISOU 1856 O THR A 231 3968 4473 8272 -44 -108 -798 O \nATOM 1857 CB THR A 231 -13.059 -9.702 -61.563 1.00 38.54 C \nANISOU 1857 CB THR A 231 3347 3762 7535 -77 -71 -765 C \nATOM 1858 OG1 THR A 231 -13.908 -8.699 -61.023 1.00 52.41 O \nANISOU 1858 OG1 THR A 231 5143 5470 9300 -71 -120 -757 O \nATOM 1859 CG2 THR A 231 -13.832 -10.458 -62.593 1.00 38.26 C \nANISOU 1859 CG2 THR A 231 3271 3748 7519 -45 -61 -817 C \nATOM 1860 N ILE A 232 -14.441 -10.477 -58.977 1.00 41.75 N \nANISOU 1860 N ILE A 232 3765 4110 7988 -49 -166 -754 N \nATOM 1861 CA ILE A 232 -15.725 -10.929 -58.367 1.00 38.35 C \nANISOU 1861 CA ILE A 232 3328 3656 7588 -7 -216 -776 C \nATOM 1862 C ILE A 232 -16.851 -10.409 -59.237 1.00 39.17 C \nANISOU 1862 C ILE A 232 3443 3734 7704 34 -235 -811 C \nATOM 1863 O ILE A 232 -16.857 -9.227 -59.623 1.00 37.10 O \nANISOU 1863 O ILE A 232 3225 3442 7429 17 -238 -800 O \nATOM 1864 CB ILE A 232 -15.863 -10.407 -56.950 1.00 32.72 C \nANISOU 1864 CB ILE A 232 2656 2900 6876 -20 -261 -738 C \nATOM 1865 CG1 ILE A 232 -14.661 -10.869 -56.090 1.00 30.43 C \nANISOU 1865 CG1 ILE A 232 2360 2634 6568 -62 -238 -703 C \nATOM 1866 CG2 ILE A 232 -17.114 -10.840 -56.322 1.00 30.69 C \nANISOU 1866 CG2 ILE A 232 2396 2620 6645 27 -311 -755 C \nATOM 1867 CD1 ILE A 232 -14.343 -12.313 -56.129 1.00 30.00 C \nANISOU 1867 CD1 ILE A 232 2256 2628 6517 -63 -211 -722 C \nATOM 1868 N LEU A 233 -17.778 -11.281 -59.589 1.00 41.02 N \nANISOU 1868 N LEU A 233 3640 3986 7960 85 -245 -854 N \nATOM 1869 CA LEU A 233 -18.910 -10.883 -60.404 1.00 46.24 C \nANISOU 1869 CA LEU A 233 4316 4621 8633 133 -263 -892 C \nATOM 1870 C LEU A 233 -20.132 -10.842 -59.568 1.00 47.91 C \nANISOU 1870 C LEU A 233 4555 4785 8863 185 -323 -898 C \nATOM 1871 O LEU A 233 -20.598 -11.887 -59.125 1.00 58.04 O \nANISOU 1871 O LEU A 233 5794 6099 10160 223 -338 -914 O \nATOM 1872 CB LEU A 233 -19.095 -11.815 -61.548 1.00 51.00 C \nANISOU 1872 CB LEU A 233 4857 5282 9241 163 -229 -940 C \nATOM 1873 CG LEU A 233 -20.140 -11.421 -62.570 1.00 54.23 C \nANISOU 1873 CG LEU A 233 5279 5670 9656 213 -238 -984 C \nATOM 1874 CD1 LEU A 233 -19.752 -10.122 -63.262 1.00 58.68 C \nANISOU 1874 CD1 LEU A 233 5895 6200 10201 173 -223 -970 C \nATOM 1875 CD2 LEU A 233 -20.311 -12.536 -63.592 1.00 52.06 C \nANISOU 1875 CD2 LEU A 233 4930 5466 9384 243 -204 -1033 C \nATOM 1876 N LYS A 234 -20.647 -9.633 -59.322 1.00 50.07 N \nANISOU 1876 N LYS A 234 4904 4988 9132 182 -359 -882 N \nATOM 1877 CA LYS A 234 -21.809 -9.430 -58.434 1.00 51.88 C \nANISOU 1877 CA LYS A 234 5181 5156 9374 228 -421 -880 C \nATOM 1878 C LYS A 234 -23.078 -10.070 -59.033 1.00 52.72 C \nANISOU 1878 C LYS A 234 5267 5265 9497 318 -437 -934 C \nATOM 1879 O LYS A 234 -23.167 -10.273 -60.256 1.00 41.80 O \nANISOU 1879 O LYS A 234 3855 3912 8114 337 -404 -974 O \nATOM 1880 CB LYS A 234 -22.077 -7.952 -58.268 1.00 56.93 C \nANISOU 1880 CB LYS A 234 5914 5719 9998 198 -449 -857 C \nATOM 1881 CG LYS A 234 -20.945 -7.096 -57.739 1.00 57.51 C \nANISOU 1881 CG LYS A 234 6012 5793 10047 113 -437 -805 C \nATOM 1882 CD LYS A 234 -20.883 -7.120 -56.225 1.00 64.40 C \nANISOU 1882 CD LYS A 234 6905 6644 10922 99 -475 -764 C \nATOM 1883 CE LYS A 234 -19.921 -6.046 -55.719 1.00 71.43 C \nANISOU 1883 CE LYS A 234 7831 7528 11781 18 -469 -715 C \nATOM 1884 NZ LYS A 234 -19.554 -6.241 -54.281 1.00 86.13 N \nANISOU 1884 NZ LYS A 234 9695 9389 13642 -4 -492 -675 N \nATOM 1885 N PRO A 235 -24.067 -10.408 -58.169 1.00 65.80 N \nANISOU 1885 N PRO A 235 6939 6894 11168 379 -488 -937 N \nATOM 1886 CA PRO A 235 -25.315 -11.077 -58.534 1.00 62.23 C \nANISOU 1886 CA PRO A 235 6467 6450 10728 479 -510 -985 C \nATOM 1887 C PRO A 235 -25.839 -10.766 -59.916 1.00 65.71 C \nANISOU 1887 C PRO A 235 6921 6879 11165 514 -491 -1032 C \nATOM 1888 O PRO A 235 -25.680 -11.612 -60.791 1.00 66.57 O \nANISOU 1888 O PRO A 235 6954 7064 11277 532 -452 -1068 O \nATOM 1889 CB PRO A 235 -26.229 -10.622 -57.451 1.00 66.64 C \nANISOU 1889 CB PRO A 235 7098 6932 11290 518 -575 -965 C \nATOM 1890 CG PRO A 235 -25.333 -10.688 -56.228 1.00 68.25 C \nANISOU 1890 CG PRO A 235 7292 7149 11492 450 -580 -912 C \nATOM 1891 CD PRO A 235 -23.950 -10.342 -56.697 1.00 68.27 C \nANISOU 1891 CD PRO A 235 7275 7182 11481 358 -526 -892 C \nATOM 1892 N ASN A 236 -26.395 -9.587 -60.178 1.00 66.24 N \nANISOU 1892 N ASN A 236 7085 6860 11223 515 -513 -1032 N \nATOM 1893 CA ASN A 236 -26.961 -9.365 -61.533 1.00 70.64 C \nANISOU 1893 CA ASN A 236 7656 7408 11775 553 -494 -1082 C \nATOM 1894 C ASN A 236 -26.082 -8.634 -62.536 1.00 66.68 C \nANISOU 1894 C ASN A 236 7162 6918 11258 474 -447 -1079 C \nATOM 1895 O ASN A 236 -26.584 -7.970 -63.450 1.00 81.00 O \nANISOU 1895 O ASN A 236 9025 8692 13059 484 -442 -1108 O \nATOM 1896 CB ASN A 236 -28.363 -8.723 -61.451 1.00 78.46 C \nANISOU 1896 CB ASN A 236 8748 8302 12762 624 -546 -1102 C \nATOM 1897 CG ASN A 236 -29.442 -9.755 -61.196 1.00 79.28 C \nANISOU 1897 CG ASN A 236 8817 8428 12880 743 -575 -1136 C \nATOM 1898 OD1 ASN A 236 -30.139 -9.696 -60.189 1.00 86.90 O \nANISOU 1898 OD1 ASN A 236 9830 9341 13846 789 -627 -1118 O \nATOM 1899 ND2 ASN A 236 -29.542 -10.744 -62.078 1.00 76.88 N \nANISOU 1899 ND2 ASN A 236 8422 8209 12581 793 -541 -1183 N \nATOM 1900 N ASP A 237 -24.780 -8.787 -62.409 1.00 61.70 N \nANISOU 1900 N ASP A 237 6480 6342 10622 398 -410 -1047 N \nATOM 1901 CA ASP A 237 -23.848 -8.162 -63.356 1.00 55.44 C \nANISOU 1901 CA ASP A 237 5684 5572 9810 328 -362 -1041 C \nATOM 1902 C ASP A 237 -23.463 -9.216 -64.375 1.00 55.60 C \nANISOU 1902 C ASP A 237 5612 5680 9835 344 -312 -1077 C \nATOM 1903 O ASP A 237 -23.499 -10.407 -64.094 1.00 68.74 O \nANISOU 1903 O ASP A 237 7206 7398 11513 379 -307 -1090 O \nATOM 1904 CB ASP A 237 -22.632 -7.637 -62.594 1.00 55.39 C \nANISOU 1904 CB ASP A 237 5685 5572 9788 242 -353 -982 C \nATOM 1905 CG ASP A 237 -21.789 -6.636 -63.398 1.00 53.65 C \nANISOU 1905 CG ASP A 237 5485 5361 9539 171 -317 -966 C \nATOM 1906 OD1 ASP A 237 -21.890 -6.549 -64.633 1.00 51.68 O \nANISOU 1906 OD1 ASP A 237 5223 5131 9283 178 -288 -1001 O \nATOM 1907 OD2 ASP A 237 -20.919 -5.996 -62.757 1.00 51.65 O \nANISOU 1907 OD2 ASP A 237 5250 5107 9267 107 -315 -918 O \nATOM 1908 N ALA A 238 -23.098 -8.777 -65.561 1.00 54.10 N \nANISOU 1908 N ALA A 238 5420 5506 9629 315 -273 -1094 N \nATOM 1909 CA ALA A 238 -22.559 -9.654 -66.601 1.00 49.75 C \nANISOU 1909 CA ALA A 238 4786 5039 9077 313 -220 -1122 C \nATOM 1910 C ALA A 238 -21.081 -9.363 -66.885 1.00 51.02 C \nANISOU 1910 C ALA A 238 4929 5240 9217 230 -174 -1085 C \nATOM 1911 O ALA A 238 -20.622 -8.206 -66.714 1.00 45.36 O \nANISOU 1911 O ALA A 238 4267 4487 8481 178 -178 -1050 O \nATOM 1912 CB ALA A 238 -23.336 -9.458 -67.864 1.00 51.14 C \nANISOU 1912 CB ALA A 238 4972 5211 9249 353 -209 -1175 C \nATOM 1913 N ILE A 239 -20.330 -10.410 -67.296 1.00 45.63 N \nANISOU 1913 N ILE A 239 4171 4634 8534 218 -130 -1093 N \nATOM 1914 CA ILE A 239 -18.921 -10.253 -67.641 1.00 39.85 C \nANISOU 1914 CA ILE A 239 3423 3939 7777 151 -84 -1060 C \nATOM 1915 C ILE A 239 -18.750 -10.531 -69.089 1.00 43.78 C \nANISOU 1915 C ILE A 239 3882 4488 8264 150 -39 -1096 C \nATOM 1916 O ILE A 239 -19.319 -11.496 -69.550 1.00 46.63 O \nANISOU 1916 O ILE A 239 4193 4887 8637 192 -32 -1139 O \nATOM 1917 CB ILE A 239 -17.995 -11.114 -66.795 1.00 43.12 C \nANISOU 1917 CB ILE A 239 3803 4389 8192 124 -70 -1029 C \nATOM 1918 CG1 ILE A 239 -16.531 -10.986 -67.317 1.00 46.00 C \nANISOU 1918 CG1 ILE A 239 4158 4792 8527 65 -18 -999 C \nATOM 1919 CG2 ILE A 239 -18.414 -12.548 -66.830 1.00 44.21 C \nANISOU 1919 CG2 ILE A 239 3874 4579 8344 160 -65 -1065 C \nATOM 1920 CD1 ILE A 239 -15.506 -11.507 -66.367 1.00 44.54 C \nANISOU 1920 CD1 ILE A 239 3967 4622 8334 31 -6 -959 C \nATOM 1921 N ASN A 240 -17.985 -9.664 -69.819 1.00 45.25 N \nANISOU 1921 N ASN A 240 4089 4680 8424 103 -9 -1077 N \nATOM 1922 CA ASN A 240 -17.809 -9.804 -71.278 1.00 49.64 C \nANISOU 1922 CA ASN A 240 4613 5283 8966 99 34 -1109 C \nATOM 1923 C ASN A 240 -16.339 -10.095 -71.643 1.00 48.70 C \nANISOU 1923 C ASN A 240 4465 5219 8821 48 85 -1078 C \nATOM 1924 O ASN A 240 -15.433 -9.457 -71.161 1.00 50.16 O \nANISOU 1924 O ASN A 240 4678 5395 8987 10 90 -1030 O \nATOM 1925 CB ASN A 240 -18.237 -8.535 -72.008 1.00 58.76 C \nANISOU 1925 CB ASN A 240 5818 6404 10106 89 28 -1119 C \nATOM 1926 CG ASN A 240 -19.641 -8.064 -71.635 1.00 62.31 C \nANISOU 1926 CG ASN A 240 6319 6784 10573 134 -24 -1145 C \nATOM 1927 OD1 ASN A 240 -20.632 -8.406 -72.301 1.00 61.47 O \nANISOU 1927 OD1 ASN A 240 6204 6675 10477 186 -29 -1198 O \nATOM 1928 ND2 ASN A 240 -19.726 -7.281 -70.565 1.00 65.22 N \nANISOU 1928 ND2 ASN A 240 6746 7095 10941 117 -63 -1108 N \nATOM 1929 N PHE A 241 -16.109 -11.083 -72.475 1.00 46.56 N \nANISOU 1929 N PHE A 241 4140 5006 8546 51 123 -1106 N \nATOM 1930 CA PHE A 241 -14.771 -11.410 -72.916 1.00 38.07 C \nANISOU 1930 CA PHE A 241 3046 3977 7443 7 172 -1080 C \nATOM 1931 C PHE A 241 -14.710 -11.186 -74.400 1.00 41.17 C \nANISOU 1931 C PHE A 241 3421 4405 7816 0 207 -1106 C \nATOM 1932 O PHE A 241 -15.644 -11.575 -75.121 1.00 44.17 O \nANISOU 1932 O PHE A 241 3773 4801 8209 33 205 -1159 O \nATOM 1933 CB PHE A 241 -14.439 -12.895 -72.633 1.00 37.59 C \nANISOU 1933 CB PHE A 241 2939 3959 7385 3 190 -1087 C \nATOM 1934 CG PHE A 241 -14.320 -13.248 -71.167 1.00 37.37 C \nANISOU 1934 CG PHE A 241 2923 3905 7370 1 162 -1058 C \nATOM 1935 CD1 PHE A 241 -13.133 -12.995 -70.493 1.00 36.71 C \nANISOU 1935 CD1 PHE A 241 2873 3808 7267 -37 174 -1005 C \nATOM 1936 CD2 PHE A 241 -15.336 -13.825 -70.489 1.00 36.04 C \nANISOU 1936 CD2 PHE A 241 2735 3729 7229 39 125 -1083 C \nATOM 1937 CE1 PHE A 241 -13.020 -13.231 -69.165 1.00 35.93 C \nANISOU 1937 CE1 PHE A 241 2789 3684 7178 -41 149 -978 C \nATOM 1938 CE2 PHE A 241 -15.208 -14.152 -69.130 1.00 36.46 C \nANISOU 1938 CE2 PHE A 241 2799 3762 7293 33 99 -1055 C \nATOM 1939 CZ PHE A 241 -14.068 -13.834 -68.465 1.00 36.15 C \nANISOU 1939 CZ PHE A 241 2794 3704 7235 -9 110 -1003 C \nATOM 1940 N GLU A 242 -13.574 -10.669 -74.866 1.00 39.06 N \nANISOU 1940 N GLU A 242 3168 4158 7516 -38 240 -1071 N \nATOM 1941 CA GLU A 242 -13.317 -10.573 -76.259 1.00 42.07 C \nANISOU 1941 CA GLU A 242 3529 4582 7873 -51 279 -1090 C \nATOM 1942 C GLU A 242 -11.819 -10.776 -76.518 1.00 46.74 C \nANISOU 1942 C GLU A 242 4120 5210 8428 -87 323 -1048 C \nATOM 1943 O GLU A 242 -10.964 -10.143 -75.908 1.00 59.79 O \nANISOU 1943 O GLU A 242 5806 6849 10062 -104 323 -998 O \nATOM 1944 CB GLU A 242 -13.775 -9.185 -76.785 1.00 44.99 C \nANISOU 1944 CB GLU A 242 3932 4930 8232 -54 264 -1095 C \nATOM 1945 CG GLU A 242 -13.893 -9.135 -78.316 1.00 46.39 C \nANISOU 1945 CG GLU A 242 4085 5151 8392 -59 298 -1130 C \nATOM 1946 CD GLU A 242 -13.908 -7.759 -78.911 1.00 49.27 C \nANISOU 1946 CD GLU A 242 4482 5509 8730 -82 296 -1122 C \nATOM 1947 OE1 GLU A 242 -13.464 -7.649 -80.046 1.00 49.46 O \nANISOU 1947 OE1 GLU A 242 4486 5580 8726 -100 332 -1128 O \nATOM 1948 OE2 GLU A 242 -14.360 -6.808 -78.247 1.00 61.52 O \nANISOU 1948 OE2 GLU A 242 6078 7013 10285 -85 259 -1108 O \nATOM 1949 N SER A 243 -11.490 -11.605 -77.486 1.00 42.13 N \nANISOU 1949 N SER A 243 3502 4676 7830 -97 363 -1069 N \nATOM 1950 CA SER A 243 -10.104 -11.836 -77.807 1.00 38.21 C \nANISOU 1950 CA SER A 243 3014 4209 7295 -127 406 -1031 C \nATOM 1951 C SER A 243 -9.959 -12.519 -79.121 1.00 43.25 C \nANISOU 1951 C SER A 243 3617 4901 7915 -140 447 -1061 C \nATOM 1952 O SER A 243 -10.886 -13.286 -79.571 1.00 51.24 O \nANISOU 1952 O SER A 243 4587 5936 8947 -127 444 -1115 O \nATOM 1953 CB SER A 243 -9.460 -12.721 -76.769 1.00 35.93 C \nANISOU 1953 CB SER A 243 2737 3908 7007 -139 408 -1004 C \nATOM 1954 OG SER A 243 -8.095 -13.022 -77.110 1.00 32.44 O \nANISOU 1954 OG SER A 243 2315 3488 6522 -165 452 -969 O \nATOM 1955 N ASN A 244 -8.773 -12.283 -79.714 1.00 35.25 N \nANISOU 1955 N ASN A 244 2622 3911 6859 -162 484 -1026 N \nATOM 1956 CA ASN A 244 -8.436 -12.887 -80.976 1.00 38.02 C \nANISOU 1956 CA ASN A 244 2949 4313 7184 -180 527 -1045 C \nATOM 1957 C ASN A 244 -7.134 -13.576 -80.887 1.00 38.19 C \nANISOU 1957 C ASN A 244 2996 4344 7169 -206 562 -1006 C \nATOM 1958 O ASN A 244 -6.438 -13.821 -81.879 1.00 35.10 O \nANISOU 1958 O ASN A 244 2605 3988 6741 -224 601 -1000 O \nATOM 1959 CB ASN A 244 -8.443 -11.841 -82.064 1.00 38.34 C \nANISOU 1959 CB ASN A 244 2987 4378 7204 -180 538 -1048 C \nATOM 1960 CG ASN A 244 -7.328 -10.899 -81.932 1.00 32.83 C \nANISOU 1960 CG ASN A 244 2327 3678 6468 -185 549 -989 C \nATOM 1961 OD1 ASN A 244 -6.863 -10.605 -80.861 1.00 36.73 O \nANISOU 1961 OD1 ASN A 244 2853 4141 6962 -179 533 -949 O \nATOM 1962 ND2 ASN A 244 -6.856 -10.443 -83.050 1.00 33.11 N \nANISOU 1962 ND2 ASN A 244 2357 3755 6467 -195 578 -982 N \nATOM 1963 N GLY A 245 -6.794 -13.910 -79.660 1.00 41.56 N \nANISOU 1963 N GLY A 245 3451 4736 7605 -207 547 -980 N \nATOM 1964 CA GLY A 245 -5.561 -14.625 -79.450 1.00 53.88 C \nANISOU 1964 CA GLY A 245 5049 6295 9129 -231 580 -943 C \nATOM 1965 C GLY A 245 -5.043 -14.529 -78.032 1.00 53.82 C \nANISOU 1965 C GLY A 245 5086 6240 9124 -226 561 -902 C \nATOM 1966 O GLY A 245 -5.338 -13.620 -77.245 1.00 65.22 O \nANISOU 1966 O GLY A 245 6539 7655 10588 -203 527 -886 O \nATOM 1967 N ASN A 246 -4.223 -15.510 -77.752 1.00 50.95 N \nANISOU 1967 N ASN A 246 4754 5871 8735 -253 586 -886 N \nATOM 1968 CA ASN A 246 -3.601 -15.735 -76.467 1.00 43.44 C \nANISOU 1968 CA ASN A 246 3850 4877 7777 -257 578 -850 C \nATOM 1969 C ASN A 246 -4.447 -15.715 -75.260 1.00 38.67 C \nANISOU 1969 C ASN A 246 3229 4245 7218 -247 533 -861 C \nATOM 1970 O ASN A 246 -3.953 -15.451 -74.186 1.00 42.74 O \nANISOU 1970 O ASN A 246 3785 4724 7730 -240 520 -825 O \nATOM 1971 CB ASN A 246 -2.378 -14.837 -76.240 1.00 45.22 C \nANISOU 1971 CB ASN A 246 4136 5082 7964 -235 592 -792 C \nATOM 1972 CG ASN A 246 -1.609 -14.599 -77.490 1.00 47.18 C \nANISOU 1972 CG ASN A 246 4397 5361 8167 -232 632 -778 C \nATOM 1973 OD1 ASN A 246 -2.195 -14.492 -78.534 1.00 46.91 O \nANISOU 1973 OD1 ASN A 246 4319 5364 8141 -236 637 -809 O \nATOM 1974 ND2 ASN A 246 -0.289 -14.640 -77.403 1.00 49.47 N \nANISOU 1974 ND2 ASN A 246 4753 5637 8407 -226 662 -732 N \nATOM 1975 N PHE A 247 -5.707 -16.071 -75.399 1.00 42.85 N \nANISOU 1975 N PHE A 247 3701 4794 7787 -243 509 -910 N \nATOM 1976 CA PHE A 247 -6.674 -16.039 -74.322 1.00 44.25 C \nANISOU 1976 CA PHE A 247 3858 4947 8007 -226 462 -924 C \nATOM 1977 C PHE A 247 -6.724 -17.401 -73.626 1.00 49.11 C \nANISOU 1977 C PHE A 247 4464 5570 8624 -257 461 -937 C \nATOM 1978 O PHE A 247 -6.778 -18.466 -74.269 1.00 59.38 O \nANISOU 1978 O PHE A 247 5737 6915 9911 -288 486 -966 O \nATOM 1979 CB PHE A 247 -8.027 -15.785 -74.911 1.00 48.32 C \nANISOU 1979 CB PHE A 247 4320 5482 8558 -199 438 -974 C \nATOM 1980 CG PHE A 247 -9.135 -15.657 -73.882 1.00 52.93 C \nANISOU 1980 CG PHE A 247 4887 6038 9185 -171 386 -990 C \nATOM 1981 CD1 PHE A 247 -8.874 -15.211 -72.610 1.00 52.39 C \nANISOU 1981 CD1 PHE A 247 4857 5924 9126 -167 359 -952 C \nATOM 1982 CD2 PHE A 247 -10.436 -15.970 -74.208 1.00 49.30 C \nANISOU 1982 CD2 PHE A 247 4376 5600 8756 -144 364 -1042 C \nATOM 1983 CE1 PHE A 247 -9.893 -15.051 -71.705 1.00 53.39 C \nANISOU 1983 CE1 PHE A 247 4972 6024 9289 -140 311 -964 C \nATOM 1984 CE2 PHE A 247 -11.436 -15.845 -73.288 1.00 49.55 C \nANISOU 1984 CE2 PHE A 247 4399 5603 8823 -112 316 -1055 C \nATOM 1985 CZ PHE A 247 -11.173 -15.376 -72.039 1.00 50.46 C \nANISOU 1985 CZ PHE A 247 4555 5670 8947 -112 289 -1015 C \nATOM 1986 N ILE A 248 -6.679 -17.367 -72.311 1.00 41.62 N \nANISOU 1986 N ILE A 248 3540 4585 7689 -254 434 -914 N \nATOM 1987 CA ILE A 248 -6.776 -18.541 -71.522 1.00 39.00 C \nANISOU 1987 CA ILE A 248 3199 4261 7358 -285 429 -924 C \nATOM 1988 C ILE A 248 -8.146 -18.378 -70.881 1.00 39.66 C \nANISOU 1988 C ILE A 248 3237 4343 7491 -249 377 -952 C \nATOM 1989 O ILE A 248 -8.285 -17.807 -69.804 1.00 34.43 O \nANISOU 1989 O ILE A 248 2597 3638 6848 -231 343 -928 O \nATOM 1990 CB ILE A 248 -5.686 -18.644 -70.457 1.00 41.97 C \nANISOU 1990 CB ILE A 248 3642 4595 7709 -308 436 -876 C \nATOM 1991 CG1 ILE A 248 -4.289 -18.416 -71.016 1.00 48.08 C \nANISOU 1991 CG1 ILE A 248 4479 5355 8433 -321 482 -839 C \nATOM 1992 CG2 ILE A 248 -5.707 -20.005 -69.852 1.00 42.16 C \nANISOU 1992 CG2 ILE A 248 3658 4638 7724 -355 439 -890 C \nATOM 1993 CD1 ILE A 248 -3.914 -19.360 -72.144 1.00 52.08 C \nANISOU 1993 CD1 ILE A 248 4981 5901 8905 -361 525 -859 C \nATOM 1994 N ALA A 249 -9.176 -18.957 -71.549 1.00 41.78 N \nANISOU 1994 N ALA A 249 3439 4660 7776 -238 371 -1004 N \nATOM 1995 CA ALA A 249 -10.569 -18.780 -71.147 1.00 36.26 C \nANISOU 1995 CA ALA A 249 2697 3961 7120 -191 324 -1036 C \nATOM 1996 C ALA A 249 -10.965 -19.616 -69.948 1.00 41.65 C \nANISOU 1996 C ALA A 249 3361 4652 7814 -197 295 -1039 C \nATOM 1997 O ALA A 249 -10.430 -20.690 -69.725 1.00 42.35 O \nANISOU 1997 O ALA A 249 3444 4772 7875 -246 317 -1037 O \nATOM 1998 CB ALA A 249 -11.482 -19.134 -72.300 1.00 42.13 C \nANISOU 1998 CB ALA A 249 3378 4758 7869 -169 330 -1091 C \nATOM 1999 N PRO A 250 -11.932 -19.127 -69.174 1.00 39.14 N \nANISOU 1999 N PRO A 250 3035 4305 7532 -150 246 -1044 N \nATOM 2000 CA PRO A 250 -12.506 -19.848 -68.080 1.00 42.07 C \nANISOU 2000 CA PRO A 250 3379 4688 7916 -145 213 -1051 C \nATOM 2001 C PRO A 250 -13.527 -20.860 -68.522 1.00 49.15 C \nANISOU 2001 C PRO A 250 4197 5661 8818 -125 206 -1106 C \nATOM 2002 O PRO A 250 -14.063 -20.750 -69.597 1.00 46.91 O \nANISOU 2002 O PRO A 250 3881 5405 8537 -97 216 -1142 O \nATOM 2003 CB PRO A 250 -13.205 -18.762 -67.267 1.00 39.60 C \nANISOU 2003 CB PRO A 250 3095 4313 7639 -95 161 -1036 C \nATOM 2004 CG PRO A 250 -13.451 -17.663 -68.180 1.00 36.69 C \nANISOU 2004 CG PRO A 250 2744 3918 7279 -65 164 -1043 C \nATOM 2005 CD PRO A 250 -12.481 -17.778 -69.314 1.00 37.61 C \nANISOU 2005 CD PRO A 250 2865 4062 7364 -103 219 -1040 C \nATOM 2006 N GLU A 251 -13.689 -21.918 -67.727 1.00 62.69 N \nANISOU 2006 N GLU A 251 5877 7418 10524 -146 195 -1112 N \nATOM 2007 CA GLU A 251 -14.745 -22.903 -67.902 1.00 59.71 C \nANISOU 2007 CA GLU A 251 5415 7124 10148 -121 181 -1162 C \nATOM 2008 C GLU A 251 -15.501 -22.924 -66.620 1.00 56.47 C \nANISOU 2008 C GLU A 251 4996 6700 9762 -82 129 -1155 C \nATOM 2009 O GLU A 251 -16.708 -22.889 -66.627 1.00 60.79 O \nANISOU 2009 O GLU A 251 5500 7266 10330 -11 94 -1188 O \nATOM 2010 CB GLU A 251 -14.181 -24.285 -68.173 1.00 68.00 C \nANISOU 2010 CB GLU A 251 6425 8258 11153 -195 220 -1175 C \nATOM 2011 CG GLU A 251 -15.273 -25.335 -68.408 1.00 75.39 C \nANISOU 2011 CG GLU A 251 7261 9300 12082 -170 207 -1229 C \nATOM 2012 CD GLU A 251 -14.759 -26.679 -68.894 1.00 68.45 C \nANISOU 2012 CD GLU A 251 6338 8518 11151 -252 249 -1248 C \nATOM 2013 OE1 GLU A 251 -13.533 -26.851 -69.015 1.00 70.72 O \nANISOU 2013 OE1 GLU A 251 6682 8782 11408 -331 288 -1218 O \nATOM 2014 OE2 GLU A 251 -15.597 -27.539 -69.189 1.00 68.94 O \nANISOU 2014 OE2 GLU A 251 6313 8682 11201 -236 243 -1293 O \nATOM 2015 N TYR A 252 -14.780 -22.951 -65.508 1.00 51.10 N \nANISOU 2015 N TYR A 252 4358 5983 9074 -125 122 -1113 N \nATOM 2016 CA TYR A 252 -15.370 -23.029 -64.193 1.00 57.67 C \nANISOU 2016 CA TYR A 252 5185 6803 9924 -99 74 -1101 C \nATOM 2017 C TYR A 252 -15.126 -21.773 -63.343 1.00 59.95 C \nANISOU 2017 C TYR A 252 5551 6989 10237 -82 46 -1055 C \nATOM 2018 O TYR A 252 -14.056 -21.183 -63.379 1.00 66.96 O \nANISOU 2018 O TYR A 252 6501 7828 11115 -121 72 -1019 O \nATOM 2019 CB TYR A 252 -14.784 -24.219 -63.436 1.00 57.87 C \nANISOU 2019 CB TYR A 252 5191 6880 9916 -171 86 -1090 C \nATOM 2020 CG TYR A 252 -15.131 -25.533 -63.997 1.00 57.88 C \nANISOU 2020 CG TYR A 252 5110 6994 9887 -195 105 -1134 C \nATOM 2021 CD1 TYR A 252 -16.431 -26.057 -63.868 1.00 65.71 C \nANISOU 2021 CD1 TYR A 252 6020 8059 10890 -134 69 -1173 C \nATOM 2022 CD2 TYR A 252 -14.187 -26.283 -64.666 1.00 60.00 C \nANISOU 2022 CD2 TYR A 252 5381 7305 10113 -277 157 -1137 C \nATOM 2023 CE1 TYR A 252 -16.766 -27.288 -64.390 1.00 65.07 C \nANISOU 2023 CE1 TYR A 252 5851 8098 10774 -156 87 -1215 C \nATOM 2024 CE2 TYR A 252 -14.521 -27.510 -65.191 1.00 65.66 C \nANISOU 2024 CE2 TYR A 252 6018 8135 10796 -308 175 -1178 C \nATOM 2025 CZ TYR A 252 -15.805 -27.995 -65.051 1.00 68.28 C \nANISOU 2025 CZ TYR A 252 6259 8546 11137 -248 140 -1217 C \nATOM 2026 OH TYR A 252 -16.081 -29.221 -65.592 1.00 90.51 O \nANISOU 2026 OH TYR A 252 8990 11487 13912 -283 160 -1257 O \nATOM 2027 N ALA A 253 -16.143 -21.379 -62.595 1.00 58.13 N \nANISOU 2027 N ALA A 253 5317 6734 10037 -21 -7 -1056 N \nATOM 2028 CA ALA A 253 -16.053 -20.236 -61.712 1.00 57.79 C \nANISOU 2028 CA ALA A 253 5342 6601 10014 -7 -40 -1015 C \nATOM 2029 C ALA A 253 -16.433 -20.746 -60.361 1.00 52.62 C \nANISOU 2029 C ALA A 253 4673 5956 9364 -4 -79 -1002 C \nATOM 2030 O ALA A 253 -16.870 -21.849 -60.256 1.00 56.22 O \nANISOU 2030 O ALA A 253 5065 6487 9809 -2 -83 -1029 O \nATOM 2031 CB ALA A 253 -16.994 -19.125 -62.176 1.00 59.01 C \nANISOU 2031 CB ALA A 253 5519 6705 10197 63 -69 -1029 C \nATOM 2032 N TYR A 254 -16.319 -19.921 -59.352 1.00 51.59 N \nANISOU 2032 N TYR A 254 4600 5755 9247 -2 -110 -963 N \nATOM 2033 CA TYR A 254 -16.572 -20.311 -57.991 1.00 56.12 C \nANISOU 2033 CA TYR A 254 5169 6332 9823 -4 -148 -944 C \nATOM 2034 C TYR A 254 -17.611 -19.404 -57.354 1.00 62.18 C \nANISOU 2034 C TYR A 254 5965 7039 10621 62 -207 -935 C \nATOM 2035 O TYR A 254 -17.389 -18.210 -57.202 1.00 65.79 O \nANISOU 2035 O TYR A 254 6488 7421 11088 62 -217 -907 O \nATOM 2036 CB TYR A 254 -15.279 -20.214 -57.199 1.00 59.43 C \nANISOU 2036 CB TYR A 254 5639 6719 10222 -77 -127 -898 C \nATOM 2037 CG TYR A 254 -14.245 -21.218 -57.621 1.00 61.71 C \nANISOU 2037 CG TYR A 254 5912 7061 10474 -147 -73 -903 C \nATOM 2038 CD1 TYR A 254 -13.272 -20.891 -58.558 1.00 63.42 C \nANISOU 2038 CD1 TYR A 254 6163 7261 10674 -178 -23 -896 C \nATOM 2039 CD2 TYR A 254 -14.234 -22.497 -57.081 1.00 62.98 C \nANISOU 2039 CD2 TYR A 254 6029 7288 10613 -186 -71 -914 C \nATOM 2040 CE1 TYR A 254 -12.329 -21.814 -58.964 1.00 65.59 C \nANISOU 2040 CE1 TYR A 254 6435 7576 10911 -242 26 -900 C \nATOM 2041 CE2 TYR A 254 -13.296 -23.425 -57.466 1.00 63.16 C \nANISOU 2041 CE2 TYR A 254 6047 7354 10596 -259 -22 -918 C \nATOM 2042 CZ TYR A 254 -12.345 -23.083 -58.403 1.00 65.72 C \nANISOU 2042 CZ TYR A 254 6413 7653 10904 -286 27 -911 C \nATOM 2043 OH TYR A 254 -11.399 -23.987 -58.791 1.00 62.16 O \nANISOU 2043 OH TYR A 254 5971 7237 10410 -359 76 -914 O \nATOM 2044 N LYS A 255 -18.736 -19.982 -56.961 1.00 67.86 N \nANISOU 2044 N LYS A 255 6637 7795 11350 118 -247 -959 N \nATOM 2045 CA LYS A 255 -19.777 -19.262 -56.268 1.00 63.46 C \nANISOU 2045 CA LYS A 255 6113 7182 10818 184 -306 -950 C \nATOM 2046 C LYS A 255 -19.411 -19.134 -54.836 1.00 57.48 C \nANISOU 2046 C LYS A 255 5388 6393 10058 149 -333 -905 C \nATOM 2047 O LYS A 255 -19.010 -20.096 -54.240 1.00 61.55 O \nANISOU 2047 O LYS A 255 5866 6965 10557 109 -325 -900 O \nATOM 2048 CB LYS A 255 -21.026 -20.095 -56.297 1.00 68.69 C \nANISOU 2048 CB LYS A 255 6707 7908 11484 259 -337 -990 C \nATOM 2049 CG LYS A 255 -22.196 -19.441 -56.980 1.00 75.70 C \nANISOU 2049 CG LYS A 255 7613 8758 12392 351 -363 -1021 C \nATOM 2050 CD LYS A 255 -23.518 -20.052 -56.528 1.00 73.06 C \nANISOU 2050 CD LYS A 255 7233 8466 12062 442 -411 -1046 C \nATOM 2051 CE LYS A 255 -23.922 -21.251 -57.361 1.00 69.76 C \nANISOU 2051 CE LYS A 255 6715 8165 11627 473 -388 -1098 C \nATOM 2052 NZ LYS A 255 -25.139 -21.883 -56.789 1.00 67.71 N \nANISOU 2052 NZ LYS A 255 6405 7957 11364 564 -436 -1118 N \nATOM 2053 N ILE A 256 -19.587 -17.975 -54.247 1.00 57.07 N \nANISOU 2053 N ILE A 256 5407 6256 10021 162 -367 -874 N \nATOM 2054 CA ILE A 256 -19.239 -17.888 -52.850 1.00 61.63 C \nANISOU 2054 CA ILE A 256 6013 6809 10594 127 -393 -832 C \nATOM 2055 C ILE A 256 -20.413 -18.095 -51.872 1.00 71.73 C \nANISOU 2055 C ILE A 256 7282 8087 11886 187 -456 -831 C \nATOM 2056 O ILE A 256 -21.274 -17.237 -51.678 1.00 77.82 O \nANISOU 2056 O ILE A 256 8101 8794 12674 240 -500 -825 O \nATOM 2057 CB ILE A 256 -18.368 -16.668 -52.512 1.00 57.40 C \nANISOU 2057 CB ILE A 256 5556 6199 10056 79 -386 -787 C \nATOM 2058 CG1 ILE A 256 -18.972 -15.838 -51.404 1.00 57.83 C \nANISOU 2058 CG1 ILE A 256 5664 6189 10121 99 -444 -756 C \nATOM 2059 CG2 ILE A 256 -18.050 -15.871 -53.749 1.00 57.15 C \nANISOU 2059 CG2 ILE A 256 5549 6142 10023 76 -352 -798 C \nATOM 2060 CD1 ILE A 256 -18.569 -16.325 -50.044 1.00 57.48 C \nANISOU 2060 CD1 ILE A 256 5615 6158 10066 61 -460 -725 C \nATOM 2061 N VAL A 257 -20.372 -19.243 -51.222 1.00 80.33 N \nANISOU 2061 N VAL A 257 8314 9248 12962 171 -459 -834 N \nATOM 2062 CA VAL A 257 -21.277 -19.561 -50.130 1.00 83.26 C \nANISOU 2062 CA VAL A 257 8669 9629 13337 215 -516 -826 C \nATOM 2063 C VAL A 257 -20.553 -20.538 -49.221 1.00 88.38 C \nANISOU 2063 C VAL A 257 9280 10339 13961 146 -505 -808 C \nATOM 2064 O VAL A 257 -20.362 -21.694 -49.603 1.00104.19 O \nANISOU 2064 O VAL A 257 11211 12433 15944 123 -475 -836 O \nATOM 2065 CB VAL A 257 -22.623 -20.113 -50.648 1.00 80.34 C \nANISOU 2065 CB VAL A 257 8242 9310 12974 314 -543 -870 C \nATOM 2066 CG1 VAL A 257 -22.474 -21.407 -51.477 1.00 68.45 C \nANISOU 2066 CG1 VAL A 257 6641 7921 11448 303 -501 -913 C \nATOM 2067 CG2 VAL A 257 -23.592 -20.253 -49.477 1.00 79.74 C \nANISOU 2067 CG2 VAL A 257 8164 9233 12901 372 -607 -856 C \nATOM 2068 N LYS A 258 -20.120 -20.110 -48.038 1.00 87.02 N \nANISOU 2068 N LYS A 258 9156 10120 13786 106 -525 -765 N \nATOM 2069 CA LYS A 258 -20.544 -18.884 -47.395 1.00 86.21 C \nANISOU 2069 CA LYS A 258 9129 9925 13702 134 -571 -733 C \nATOM 2070 C LYS A 258 -19.381 -17.971 -47.013 1.00 81.73 C \nANISOU 2070 C LYS A 258 8632 9294 13129 61 -549 -691 C \nATOM 2071 O LYS A 258 -18.209 -18.327 -47.171 1.00 71.80 O \nANISOU 2071 O LYS A 258 7369 8061 11852 -7 -499 -686 O \nATOM 2072 CB LYS A 258 -21.289 -19.242 -46.127 1.00103.83 C \nANISOU 2072 CB LYS A 258 11347 12170 15933 163 -628 -716 C \nATOM 2073 CG LYS A 258 -20.374 -19.816 -45.058 1.00117.47 C \nANISOU 2073 CG LYS A 258 13065 13930 17638 81 -617 -687 C \nATOM 2074 CD LYS A 258 -21.139 -20.458 -43.920 1.00130.63 C \nANISOU 2074 CD LYS A 258 14696 15638 19298 109 -668 -678 C \nATOM 2075 CE LYS A 258 -21.647 -21.835 -44.323 1.00136.65 C \nANISOU 2075 CE LYS A 258 15358 16517 20046 137 -661 -719 C \nATOM 2076 NZ LYS A 258 -22.358 -22.529 -43.210 1.00137.33 N \nANISOU 2076 NZ LYS A 258 15400 16660 20119 163 -710 -710 N \nATOM 2077 N LYS A 259 -19.729 -16.778 -46.523 1.00 82.94 N \nANISOU 2077 N LYS A 259 8854 9366 13293 77 -588 -663 N \nATOM 2078 CA LYS A 259 -18.753 -15.806 -45.998 1.00 79.36 C \nANISOU 2078 CA LYS A 259 8466 8858 12829 14 -576 -620 C \nATOM 2079 C LYS A 259 -18.706 -15.786 -44.461 1.00 82.10 C \nANISOU 2079 C LYS A 259 8835 9193 13168 -13 -615 -582 C \nATOM 2080 O LYS A 259 -19.691 -15.423 -43.822 1.00 74.71 O \nANISOU 2080 O LYS A 259 7922 8222 12243 29 -672 -571 O \nATOM 2081 CB LYS A 259 -19.036 -14.393 -46.500 1.00 73.13 C \nANISOU 2081 CB LYS A 259 7743 7995 12049 31 -589 -611 C \nATOM 2082 CG LYS A 259 -18.521 -14.099 -47.880 1.00 75.57 C \nANISOU 2082 CG LYS A 259 8048 8308 12355 23 -538 -633 C \nATOM 2083 CD LYS A 259 -17.998 -12.677 -48.020 1.00 77.04 C \nANISOU 2083 CD LYS A 259 8302 8438 12532 -11 -531 -605 C \nATOM 2084 CE LYS A 259 -17.545 -12.356 -49.428 1.00 79.83 C \nANISOU 2084 CE LYS A 259 8650 8800 12880 -14 -483 -626 C \nATOM 2085 NZ LYS A 259 -18.702 -12.279 -50.377 1.00 89.80 N \nANISOU 2085 NZ LYS A 259 9907 10049 14162 49 -500 -665 N \nATOM 2086 N GLY A 260 -17.558 -16.163 -43.884 1.00 78.45 N \nANISOU 2086 N GLY A 260 8369 8754 12684 -83 -583 -562 N \nATOM 2087 CA GLY A 260 -17.359 -16.113 -42.431 1.00 78.02 C \nANISOU 2087 CA GLY A 260 8337 8688 12618 -117 -613 -525 C \nATOM 2088 C GLY A 260 -15.918 -15.835 -42.049 1.00 84.27 C \nANISOU 2088 C GLY A 260 9163 9471 13384 -192 -571 -497 C \nATOM 2089 O GLY A 260 -15.239 -15.060 -42.699 1.00 98.23 O \nANISOU 2089 O GLY A 260 10965 11213 15146 -207 -538 -491 O \nATOM 2090 N ASP A 261 -15.450 -16.462 -40.985 1.00 79.78 N \nANISOU 2090 N ASP A 261 8588 8928 12797 -235 -573 -480 N \nATOM 2091 CA ASP A 261 -14.109 -16.226 -40.519 1.00 79.06 C \nANISOU 2091 CA ASP A 261 8535 8827 12678 -299 -536 -454 C \nATOM 2092 C ASP A 261 -13.230 -17.330 -41.068 1.00 76.98 C \nANISOU 2092 C ASP A 261 8244 8612 12394 -336 -478 -477 C \nATOM 2093 O ASP A 261 -13.677 -18.460 -41.257 1.00 80.79 O \nANISOU 2093 O ASP A 261 8670 9148 12877 -331 -478 -505 O \nATOM 2094 CB ASP A 261 -14.050 -16.189 -38.981 1.00 83.16 C \nANISOU 2094 CB ASP A 261 9075 9338 13184 -331 -571 -420 C \nATOM 2095 CG ASP A 261 -14.497 -14.839 -38.382 1.00 87.72 C \nANISOU 2095 CG ASP A 261 9703 9857 13769 -318 -617 -387 C \nATOM 2096 OD1 ASP A 261 -14.271 -13.772 -39.013 1.00100.06 O \nANISOU 2096 OD1 ASP A 261 11302 11384 15333 -311 -605 -380 O \nATOM 2097 OD2 ASP A 261 -15.052 -14.837 -37.260 1.00 78.78 O \nANISOU 2097 OD2 ASP A 261 8578 8718 12638 -319 -666 -367 O \nATOM 2098 N SER A 262 -11.974 -16.996 -41.315 1.00 78.08 N \nANISOU 2098 N SER A 262 8423 8735 12509 -372 -428 -465 N \nATOM 2099 CA SER A 262 -10.982 -17.950 -41.746 1.00 76.25 C \nANISOU 2099 CA SER A 262 8186 8537 12250 -415 -370 -480 C \nATOM 2100 C SER A 262 -9.612 -17.259 -41.717 1.00 86.09 C \nANISOU 2100 C SER A 262 9495 9749 13465 -443 -327 -455 C \nATOM 2101 O SER A 262 -9.507 -16.039 -41.407 1.00 86.25 O \nANISOU 2101 O SER A 262 9551 9732 13487 -429 -343 -427 O \nATOM 2102 CB SER A 262 -11.305 -18.411 -43.179 1.00 75.29 C \nANISOU 2102 CB SER A 262 8023 8444 12140 -388 -344 -519 C \nATOM 2103 OG SER A 262 -10.160 -18.983 -43.798 1.00 92.70 O \nANISOU 2103 OG SER A 262 10244 10664 14314 -428 -281 -528 O \nATOM 2104 N ALA A 263 -8.565 -18.030 -42.028 1.00 76.62 N \nANISOU 2104 N ALA A 263 8313 8566 12234 -482 -272 -464 N \nATOM 2105 CA ALA A 263 -7.305 -17.440 -42.462 1.00 74.92 C \nANISOU 2105 CA ALA A 263 8152 8324 11990 -489 -222 -448 C \nATOM 2106 C ALA A 263 -6.552 -18.469 -43.245 1.00 65.56 C \nANISOU 2106 C ALA A 263 6972 7160 10777 -519 -166 -471 C \nATOM 2107 O ALA A 263 -7.095 -19.478 -43.614 1.00 57.73 O \nANISOU 2107 O ALA A 263 5934 6206 9793 -531 -167 -500 O \nATOM 2108 CB ALA A 263 -6.488 -16.906 -41.283 1.00 83.95 C \nANISOU 2108 CB ALA A 263 9350 9442 13105 -513 -223 -412 C \nATOM 2109 N ILE A 264 -5.289 -18.199 -43.512 1.00 70.16 N \nANISOU 2109 N ILE A 264 7613 7720 11325 -528 -117 -457 N \nATOM 2110 CA ILE A 264 -4.492 -19.112 -44.271 1.00 60.51 C \nANISOU 2110 CA ILE A 264 6412 6508 10071 -558 -62 -475 C \nATOM 2111 C ILE A 264 -3.210 -19.366 -43.475 1.00 63.34 C \nANISOU 2111 C ILE A 264 6847 6840 10379 -597 -28 -455 C \nATOM 2112 O ILE A 264 -2.294 -18.547 -43.444 1.00 80.47 O \nANISOU 2112 O ILE A 264 9071 8979 12524 -575 -4 -430 O \nATOM 2113 CB ILE A 264 -4.207 -18.557 -45.672 1.00 59.50 C \nANISOU 2113 CB ILE A 264 6286 6375 9946 -520 -29 -482 C \nATOM 2114 CG1 ILE A 264 -5.480 -18.595 -46.500 1.00 60.08 C \nANISOU 2114 CG1 ILE A 264 6286 6477 10064 -489 -57 -511 C \nATOM 2115 CG2 ILE A 264 -3.097 -19.360 -46.337 1.00 63.29 C \nANISOU 2115 CG2 ILE A 264 6812 6853 10381 -552 33 -491 C \nATOM 2116 CD1 ILE A 264 -5.396 -17.845 -47.808 1.00 56.13 C \nANISOU 2116 CD1 ILE A 264 5782 5973 9573 -448 -36 -516 C \nATOM 2117 N VAL A 265 -3.168 -20.528 -42.844 1.00 62.30 N \nANISOU 2117 N VAL A 265 6719 6726 10227 -655 -26 -466 N \nATOM 2118 CA VAL A 265 -2.062 -20.942 -42.000 1.00 57.68 C \nANISOU 2118 CA VAL A 265 6210 6116 9591 -702 3 -451 C \nATOM 2119 C VAL A 265 -0.969 -21.560 -42.842 1.00 55.21 C \nANISOU 2119 C VAL A 265 5959 5787 9232 -726 67 -461 C \nATOM 2120 O VAL A 265 -1.249 -22.319 -43.751 1.00 61.26 O \nANISOU 2120 O VAL A 265 6695 6581 10001 -746 83 -488 O \nATOM 2121 CB VAL A 265 -2.556 -21.941 -40.960 1.00 61.76 C \nANISOU 2121 CB VAL A 265 6703 6661 10102 -761 -25 -460 C \nATOM 2122 CG1 VAL A 265 -1.420 -22.400 -40.049 1.00 78.71 C \nANISOU 2122 CG1 VAL A 265 8936 8779 12193 -815 6 -447 C \nATOM 2123 CG2 VAL A 265 -3.658 -21.317 -40.128 1.00 46.03 C \nANISOU 2123 CG2 VAL A 265 4655 4682 8154 -732 -90 -448 C \nATOM 2124 N LYS A 266 0.270 -21.252 -42.501 1.00 58.51 N \nANISOU 2124 N LYS A 266 6466 6160 9605 -724 103 -440 N \nATOM 2125 CA LYS A 266 1.452 -21.787 -43.166 1.00 62.41 C \nANISOU 2125 CA LYS A 266 7041 6626 10046 -743 165 -444 C \nATOM 2126 C LYS A 266 2.050 -22.837 -42.282 1.00 67.29 C \nANISOU 2126 C LYS A 266 7725 7228 10615 -819 183 -447 C \nATOM 2127 O LYS A 266 3.161 -22.659 -41.777 1.00 80.18 O \nANISOU 2127 O LYS A 266 9451 8814 12200 -816 213 -429 O \nATOM 2128 CB LYS A 266 2.507 -20.682 -43.408 1.00 61.07 C \nANISOU 2128 CB LYS A 266 6937 6416 9851 -678 195 -416 C \nATOM 2129 CG LYS A 266 2.017 -19.484 -44.234 1.00 59.69 C \nANISOU 2129 CG LYS A 266 6703 6259 9717 -605 179 -409 C \nATOM 2130 CD LYS A 266 1.517 -19.920 -45.593 1.00 63.14 C \nANISOU 2130 CD LYS A 266 7094 6721 10176 -606 190 -435 C \nATOM 2131 CE LYS A 266 1.878 -18.947 -46.703 1.00 64.12 C \nANISOU 2131 CE LYS A 266 7219 6843 10301 -541 212 -425 C \nATOM 2132 NZ LYS A 266 2.112 -19.732 -47.983 1.00 72.18 N \nANISOU 2132 NZ LYS A 266 8249 7869 11306 -559 252 -448 N \nATOM 2133 N SER A 267 1.338 -23.955 -42.135 1.00 68.18 N \nANISOU 2133 N SER A 267 7790 7383 10733 -886 166 -472 N \nATOM 2134 CA SER A 267 1.812 -25.082 -41.307 1.00 70.62 C \nANISOU 2134 CA SER A 267 8156 7687 10990 -975 182 -480 C \nATOM 2135 C SER A 267 2.385 -26.205 -42.134 1.00 64.09 C \nANISOU 2135 C SER A 267 7379 6860 10114 -1040 231 -502 C \nATOM 2136 O SER A 267 1.987 -26.396 -43.259 1.00 62.87 O \nANISOU 2136 O SER A 267 7177 6735 9978 -1030 239 -519 O \nATOM 2137 CB SER A 267 0.666 -25.617 -40.446 1.00 77.06 C \nANISOU 2137 CB SER A 267 8886 8562 11833 -1017 129 -490 C \nATOM 2138 OG SER A 267 1.099 -26.724 -39.656 1.00 75.65 O \nANISOU 2138 OG SER A 267 8757 8387 11601 -1111 144 -498 O \nATOM 2139 N GLU A 268 3.317 -26.948 -41.554 1.00 76.69 N \nANISOU 2139 N GLU A 268 9075 8420 11645 -1108 264 -501 N \nATOM 2140 CA GLU A 268 3.776 -28.259 -42.102 1.00 78.90 C \nANISOU 2140 CA GLU A 268 9408 8704 11867 -1201 306 -524 C \nATOM 2141 C GLU A 268 3.167 -29.437 -41.313 1.00 65.46 C \nANISOU 2141 C GLU A 268 7663 7062 10146 -1306 283 -544 C \nATOM 2142 O GLU A 268 3.242 -30.575 -41.701 1.00 76.23 O \nANISOU 2142 O GLU A 268 9041 8457 11468 -1394 306 -567 O \nATOM 2143 CB GLU A 268 5.311 -28.337 -42.077 1.00 80.32 C \nANISOU 2143 CB GLU A 268 9747 8796 11974 -1213 364 -510 C \nATOM 2144 CG GLU A 268 5.884 -29.473 -42.923 1.00 93.52 C \nANISOU 2144 CG GLU A 268 11490 10458 13585 -1294 413 -530 C \nATOM 2145 CD GLU A 268 7.356 -29.787 -42.666 1.00104.33 C \nANISOU 2145 CD GLU A 268 13034 11736 14871 -1325 467 -519 C \nATOM 2146 OE1 GLU A 268 8.215 -29.196 -43.356 1.00115.65 O \nANISOU 2146 OE1 GLU A 268 14545 13110 16286 -1255 502 -503 O \nATOM 2147 OE2 GLU A 268 7.668 -30.656 -41.814 1.00101.80 O \nANISOU 2147 OE2 GLU A 268 12777 11403 14497 -1419 475 -526 O \nATOM 2148 N VAL A 269 2.573 -29.115 -40.188 1.00 58.68 N \nANISOU 2148 N VAL A 269 6754 6225 9317 -1295 237 -534 N \nATOM 2149 CA VAL A 269 2.003 -30.068 -39.267 1.00 52.79 C \nANISOU 2149 CA VAL A 269 5966 5539 8555 -1382 210 -547 C \nATOM 2150 C VAL A 269 0.796 -30.738 -39.906 1.00 58.31 C \nANISOU 2150 C VAL A 269 6536 6337 9282 -1404 183 -575 C \nATOM 2151 O VAL A 269 0.057 -30.151 -40.733 1.00 54.87 O \nANISOU 2151 O VAL A 269 6018 5926 8904 -1327 163 -579 O \nATOM 2152 CB VAL A 269 1.557 -29.346 -37.975 1.00 53.26 C \nANISOU 2152 CB VAL A 269 5991 5597 8648 -1344 161 -525 C \nATOM 2153 CG1 VAL A 269 0.755 -30.244 -37.069 1.00 53.55 C \nANISOU 2153 CG1 VAL A 269 5960 5710 8677 -1421 123 -537 C \nATOM 2154 CG2 VAL A 269 2.783 -28.791 -37.244 1.00 50.33 C \nANISOU 2154 CG2 VAL A 269 5747 5137 8238 -1330 189 -500 C \nATOM 2155 N GLU A 270 0.591 -31.992 -39.525 1.00 63.12 N \nANISOU 2155 N GLU A 270 7128 7010 9846 -1511 182 -595 N \nATOM 2156 CA GLU A 270 -0.495 -32.781 -40.080 1.00 64.78 C \nANISOU 2156 CA GLU A 270 7215 7329 10069 -1541 160 -624 C \nATOM 2157 C GLU A 270 -1.778 -32.662 -39.248 1.00 59.43 C \nANISOU 2157 C GLU A 270 6415 6726 9438 -1510 94 -623 C \nATOM 2158 O GLU A 270 -1.776 -32.179 -38.147 1.00 52.61 O \nANISOU 2158 O GLU A 270 5568 5834 8586 -1492 66 -601 O \nATOM 2159 CB GLU A 270 -0.069 -34.227 -40.197 1.00 78.85 C \nANISOU 2159 CB GLU A 270 9034 9155 11770 -1678 196 -648 C \nATOM 2160 CG GLU A 270 0.385 -34.853 -38.885 1.00 88.96 C \nANISOU 2160 CG GLU A 270 10377 10430 12993 -1774 196 -642 C \nATOM 2161 CD GLU A 270 0.715 -36.332 -39.032 1.00 96.21 C \nANISOU 2161 CD GLU A 270 11326 11404 13825 -1923 229 -668 C \nATOM 2162 OE1 GLU A 270 0.468 -36.889 -40.133 1.00 98.45 O \nANISOU 2162 OE1 GLU A 270 11566 11743 14097 -1950 246 -691 O \nATOM 2163 OE2 GLU A 270 1.206 -36.926 -38.043 1.00 97.59 O \nANISOU 2163 OE2 GLU A 270 11569 11570 13941 -2017 236 -665 O \nATOM 2164 N TYR A 271 -2.871 -33.121 -39.823 1.00 59.73 N \nANISOU 2164 N TYR A 271 6332 6862 9500 -1501 68 -648 N \nATOM 2165 CA TYR A 271 -4.164 -33.113 -39.163 1.00 64.96 C \nANISOU 2165 CA TYR A 271 6876 7605 10202 -1465 5 -650 C \nATOM 2166 C TYR A 271 -4.135 -34.170 -38.077 1.00 69.85 C \nANISOU 2166 C TYR A 271 7492 8286 10764 -1573 -4 -654 C \nATOM 2167 O TYR A 271 -3.299 -35.071 -38.108 1.00 84.65 O \nANISOU 2167 O TYR A 271 9436 10161 12566 -1684 40 -665 O \nATOM 2168 CB TYR A 271 -5.241 -33.428 -40.201 1.00 66.52 C \nANISOU 2168 CB TYR A 271 6953 7894 10428 -1425 -12 -679 C \nATOM 2169 CG TYR A 271 -6.650 -33.351 -39.708 1.00 68.43 C \nANISOU 2169 CG TYR A 271 7071 8216 10713 -1365 -77 -682 C \nATOM 2170 CD1 TYR A 271 -7.146 -32.203 -39.168 1.00 66.17 C \nANISOU 2170 CD1 TYR A 271 6776 7878 10488 -1267 -121 -657 C \nATOM 2171 CD2 TYR A 271 -7.501 -34.459 -39.801 1.00 81.40 C \nANISOU 2171 CD2 TYR A 271 8605 9993 12331 -1406 -95 -711 C \nATOM 2172 CE1 TYR A 271 -8.457 -32.129 -38.731 1.00 72.58 C \nANISOU 2172 CE1 TYR A 271 7484 8757 11337 -1206 -183 -659 C \nATOM 2173 CE2 TYR A 271 -8.821 -34.404 -39.353 1.00 81.95 C \nANISOU 2173 CE2 TYR A 271 8562 10140 12436 -1338 -157 -714 C \nATOM 2174 CZ TYR A 271 -9.297 -33.233 -38.826 1.00 78.09 C \nANISOU 2174 CZ TYR A 271 8076 9585 12010 -1236 -201 -687 C \nATOM 2175 OH TYR A 271 -10.598 -33.196 -38.384 1.00 79.93 O \nANISOU 2175 OH TYR A 271 8208 9887 12273 -1167 -262 -689 O \nATOM 2176 N GLY A 272 -5.032 -34.068 -37.114 1.00 73.80 N \nANISOU 2176 N GLY A 272 7915 8836 11289 -1547 -61 -645 N \nATOM 2177 CA GLY A 272 -5.002 -34.936 -35.928 1.00 69.27 C \nANISOU 2177 CA GLY A 272 7339 8318 10662 -1645 -74 -644 C \nATOM 2178 C GLY A 272 -6.353 -35.380 -35.412 1.00 70.02 C \nANISOU 2178 C GLY A 272 7296 8536 10773 -1628 -134 -653 C \nATOM 2179 O GLY A 272 -6.449 -35.877 -34.299 1.00 74.35 O \nANISOU 2179 O GLY A 272 7834 9129 11287 -1690 -156 -646 O \nATOM 2180 N ASN A 273 -7.408 -35.145 -36.187 1.00 70.57 N \nANISOU 2180 N ASN A 273 7262 8659 10892 -1538 -163 -666 N \nATOM 2181 CA ASN A 273 -8.790 -35.408 -35.748 1.00 75.95 C \nANISOU 2181 CA ASN A 273 7811 9451 11594 -1491 -225 -672 C \nATOM 2182 C ASN A 273 -9.156 -34.867 -34.350 1.00 84.47 C \nANISOU 2182 C ASN A 273 8891 10509 12697 -1459 -277 -640 C \nATOM 2183 O ASN A 273 -9.739 -35.581 -33.554 1.00 94.16 O \nANISOU 2183 O ASN A 273 10048 11833 13894 -1497 -311 -643 O \nATOM 2184 CB ASN A 273 -9.075 -36.889 -35.818 1.00 65.80 C \nANISOU 2184 CB ASN A 273 6448 8312 10241 -1592 -218 -703 C \nATOM 2185 CG ASN A 273 -8.754 -37.458 -37.182 1.00 69.52 C \nANISOU 2185 CG ASN A 273 6916 8814 10685 -1631 -168 -734 C \nATOM 2186 OD1 ASN A 273 -9.606 -37.531 -38.055 1.00 63.25 O \nANISOU 2186 OD1 ASN A 273 6026 8089 9917 -1565 -181 -756 O \nATOM 2187 ND2 ASN A 273 -7.498 -37.875 -37.373 1.00 73.34 N \nANISOU 2187 ND2 ASN A 273 7511 9243 11113 -1739 -109 -736 N \nATOM 2188 N CYS A 274 -8.852 -33.597 -34.095 1.00 95.11 N \nANISOU 2188 N CYS A 274 10309 11736 14093 -1387 -285 -611 N \nATOM 2189 CA CYS A 274 -9.098 -32.977 -32.787 1.00101.08 C \nANISOU 2189 CA CYS A 274 11078 12458 14869 -1360 -331 -578 C \nATOM 2190 C CYS A 274 -10.055 -31.799 -32.936 1.00100.52 C \nANISOU 2190 C CYS A 274 10968 12349 14875 -1224 -381 -563 C \nATOM 2191 O CYS A 274 -10.584 -31.574 -34.021 1.00 99.77 O \nANISOU 2191 O CYS A 274 10830 12264 14815 -1155 -380 -580 O \nATOM 2192 CB CYS A 274 -7.783 -32.544 -32.135 1.00 97.78 C \nANISOU 2192 CB CYS A 274 10791 11934 14426 -1413 -296 -555 C \nATOM 2193 SG CYS A 274 -6.427 -32.306 -33.293 1.00106.16 S \nANISOU 2193 SG CYS A 274 11964 12900 15472 -1433 -218 -564 S \nATOM 2194 N ASN A 275 -10.283 -31.085 -31.835 1.00105.51 N \nANISOU 2194 N ASN A 275 11619 12940 15529 -1192 -423 -530 N \nATOM 2195 CA ASN A 275 -11.075 -29.865 -31.834 1.00106.99 C \nANISOU 2195 CA ASN A 275 11794 13075 15782 -1076 -470 -510 C \nATOM 2196 C ASN A 275 -10.461 -28.800 -30.963 1.00110.59 C \nANISOU 2196 C ASN A 275 12338 13429 16250 -1071 -476 -473 C \nATOM 2197 O ASN A 275 -9.796 -29.117 -29.983 1.00115.54 O \nANISOU 2197 O ASN A 275 13011 14053 16838 -1147 -467 -460 O \nATOM 2198 CB ASN A 275 -12.469 -30.168 -31.285 1.00106.75 C \nANISOU 2198 CB ASN A 275 11664 13131 15766 -1026 -538 -509 C \nATOM 2199 CG ASN A 275 -13.392 -30.734 -32.332 1.00106.72 C \nANISOU 2199 CG ASN A 275 11563 13212 15773 -974 -545 -543 C \nATOM 2200 OD1 ASN A 275 -13.157 -30.588 -33.517 1.00114.55 O \nANISOU 2200 OD1 ASN A 275 12565 14181 16779 -953 -509 -563 O \nATOM 2201 ND2 ASN A 275 -14.448 -31.395 -31.895 1.00111.26 N \nANISOU 2201 ND2 ASN A 275 12044 13893 16337 -951 -592 -550 N \nATOM 2202 N THR A 276 -10.747 -27.547 -31.301 1.00106.71 N \nANISOU 2202 N THR A 276 11869 12865 15812 -982 -495 -457 N \nATOM 2203 CA THR A 276 -10.266 -26.395 -30.554 1.00110.92 C \nANISOU 2203 CA THR A 276 12477 13309 16358 -968 -504 -421 C \nATOM 2204 C THR A 276 -11.066 -25.157 -30.965 1.00119.45 C \nANISOU 2204 C THR A 276 13549 14341 17497 -865 -542 -407 C \nATOM 2205 O THR A 276 -11.732 -25.169 -31.991 1.00132.29 O \nANISOU 2205 O THR A 276 15128 15985 19151 -809 -546 -429 O \nATOM 2206 CB THR A 276 -8.763 -26.166 -30.790 1.00118.49 C \nANISOU 2206 CB THR A 276 13533 14202 17288 -1017 -438 -418 C \nATOM 2207 OG1 THR A 276 -8.327 -24.999 -30.086 1.00119.36 O \nANISOU 2207 OG1 THR A 276 13707 14237 17408 -996 -448 -384 O \nATOM 2208 CG2 THR A 276 -8.465 -25.968 -32.239 1.00121.37 C \nANISOU 2208 CG2 THR A 276 13906 14542 17667 -984 -396 -438 C \nATOM 2209 N LYS A 277 -11.031 -24.114 -30.146 1.00116.22 N \nANISOU 2209 N LYS A 277 13185 13872 17102 -846 -571 -373 N \nATOM 2210 CA LYS A 277 -11.515 -22.801 -30.548 1.00120.38 C \nANISOU 2210 CA LYS A 277 13728 14337 17674 -767 -596 -357 C \nATOM 2211 C LYS A 277 -10.305 -21.924 -30.814 1.00122.37 C \nANISOU 2211 C LYS A 277 14061 14518 17916 -780 -549 -344 C \nATOM 2212 O LYS A 277 -10.434 -20.765 -31.269 1.00141.67 O \nANISOU 2212 O LYS A 277 16529 16911 20389 -728 -557 -332 O \nATOM 2213 CB LYS A 277 -12.397 -22.181 -29.459 1.00131.30 C \nANISOU 2213 CB LYS A 277 15107 15708 19075 -735 -666 -326 C \nATOM 2214 CG LYS A 277 -13.143 -20.918 -29.894 1.00136.08 C \nANISOU 2214 CG LYS A 277 15725 16255 19723 -655 -701 -313 C \nATOM 2215 CD LYS A 277 -14.062 -20.289 -28.853 1.00134.46 C \nANISOU 2215 CD LYS A 277 15525 16032 19533 -625 -771 -281 C \nATOM 2216 CE LYS A 277 -14.674 -18.995 -29.362 1.00132.75 C \nANISOU 2216 CE LYS A 277 15339 15749 19350 -559 -799 -269 C \nATOM 2217 NZ LYS A 277 -15.210 -19.056 -30.756 1.00129.72 N \nANISOU 2217 NZ LYS A 277 14924 15369 18995 -499 -787 -301 N \nATOM 2218 N CYS A 278 -9.126 -22.474 -30.526 1.00102.99 N \nANISOU 2218 N CYS A 278 11650 12063 15417 -851 -500 -347 N \nATOM 2219 CA CYS A 278 -7.901 -21.769 -30.763 1.00110.57 C \nANISOU 2219 CA CYS A 278 12687 12965 16360 -859 -451 -336 C \nATOM 2220 C CYS A 278 -6.872 -22.678 -31.419 1.00106.15 C \nANISOU 2220 C CYS A 278 12158 12414 15762 -909 -384 -361 C \nATOM 2221 O CYS A 278 -6.509 -23.701 -30.845 1.00 96.51 O \nANISOU 2221 O CYS A 278 10943 11224 14501 -979 -370 -370 O \nATOM 2222 CB CYS A 278 -7.349 -21.221 -29.451 1.00112.60 C \nANISOU 2222 CB CYS A 278 12996 13192 16593 -889 -462 -304 C \nATOM 2223 SG CYS A 278 -5.847 -20.279 -29.757 1.00128.76 S \nANISOU 2223 SG CYS A 278 15133 15177 18613 -884 -403 -290 S \nATOM 2224 N GLN A 279 -6.375 -22.253 -32.590 1.00 90.49 N \nANISOU 2224 N GLN A 279 10197 10399 13785 -877 -343 -370 N \nATOM 2225 CA GLN A 279 -5.394 -23.014 -33.345 1.00 70.16 C \nANISOU 2225 CA GLN A 279 7660 7824 11173 -917 -279 -392 C \nATOM 2226 C GLN A 279 -4.196 -22.156 -33.716 1.00 70.50 C \nANISOU 2226 C GLN A 279 7784 7805 11198 -896 -232 -377 C \nATOM 2227 O GLN A 279 -4.352 -20.970 -34.005 1.00 70.87 O \nANISOU 2227 O GLN A 279 7831 7824 11274 -836 -246 -361 O \nATOM 2228 CB GLN A 279 -6.053 -23.547 -34.588 1.00 61.06 C \nANISOU 2228 CB GLN A 279 6446 6712 10044 -895 -274 -423 C \nATOM 2229 CG GLN A 279 -5.114 -24.275 -35.520 1.00 66.10 C \nANISOU 2229 CG GLN A 279 7122 7348 10645 -935 -208 -445 C \nATOM 2230 CD GLN A 279 -4.718 -25.662 -35.020 1.00 67.46 C \nANISOU 2230 CD GLN A 279 7307 7559 10765 -1030 -187 -461 C \nATOM 2231 OE1 GLN A 279 -5.573 -26.560 -34.897 1.00 57.52 O \nANISOU 2231 OE1 GLN A 279 5974 6374 9507 -1057 -214 -479 O \nATOM 2232 NE2 GLN A 279 -3.426 -25.861 -34.774 1.00 63.36 N \nANISOU 2232 NE2 GLN A 279 6883 6997 10195 -1080 -138 -455 N \nATOM 2233 N THR A 280 -3.005 -22.759 -33.708 1.00 67.94 N \nANISOU 2233 N THR A 280 7530 7461 10821 -947 -177 -384 N \nATOM 2234 CA THR A 280 -1.780 -22.059 -34.148 1.00 66.21 C \nANISOU 2234 CA THR A 280 7393 7188 10576 -920 -127 -372 C \nATOM 2235 C THR A 280 -1.168 -22.911 -35.223 1.00 65.95 C \nANISOU 2235 C THR A 280 7390 7153 10516 -946 -72 -397 C \nATOM 2236 O THR A 280 -1.597 -24.053 -35.410 1.00 68.56 O \nANISOU 2236 O THR A 280 7684 7527 10840 -998 -72 -422 O \nATOM 2237 CB THR A 280 -0.780 -21.773 -33.005 1.00 68.45 C \nANISOU 2237 CB THR A 280 7757 7435 10815 -942 -111 -349 C \nATOM 2238 OG1 THR A 280 0.358 -22.626 -33.103 1.00 78.64 O \nANISOU 2238 OG1 THR A 280 9130 8702 12047 -993 -54 -362 O \nATOM 2239 CG2 THR A 280 -1.418 -21.956 -31.644 1.00 67.25 C \nANISOU 2239 CG2 THR A 280 7575 7308 10668 -978 -162 -338 C \nATOM 2240 N PRO A 281 -0.176 -22.386 -35.946 1.00 67.43 N \nANISOU 2240 N PRO A 281 7641 7298 10682 -911 -24 -391 N \nATOM 2241 CA PRO A 281 0.483 -23.187 -36.982 1.00 76.31 C \nANISOU 2241 CA PRO A 281 8805 8413 11774 -937 30 -413 C \nATOM 2242 C PRO A 281 1.199 -24.448 -36.500 1.00 72.67 C \nANISOU 2242 C PRO A 281 8412 7946 11252 -1027 63 -426 C \nATOM 2243 O PRO A 281 1.245 -25.444 -37.230 1.00 77.93 O \nANISOU 2243 O PRO A 281 9080 8632 11899 -1076 90 -450 O \nATOM 2244 CB PRO A 281 1.531 -22.218 -37.555 1.00 79.36 C \nANISOU 2244 CB PRO A 281 9260 8750 12142 -875 71 -395 C \nATOM 2245 CG PRO A 281 0.960 -20.871 -37.314 1.00 75.33 C \nANISOU 2245 CG PRO A 281 8702 8246 11676 -807 29 -372 C \nATOM 2246 CD PRO A 281 0.320 -21.010 -35.953 1.00 72.37 C \nANISOU 2246 CD PRO A 281 8296 7888 11312 -843 -20 -364 C \nATOM 2247 N ILE A 282 1.743 -24.390 -35.290 1.00 62.42 N \nANISOU 2247 N ILE A 282 7172 6623 9922 -1053 62 -410 N \nATOM 2248 CA ILE A 282 2.472 -25.499 -34.740 1.00 59.39 C \nANISOU 2248 CA ILE A 282 6865 6225 9474 -1142 94 -421 C \nATOM 2249 C ILE A 282 1.639 -26.423 -33.816 1.00 66.02 C \nANISOU 2249 C ILE A 282 7647 7124 10315 -1221 54 -432 C \nATOM 2250 O ILE A 282 2.156 -27.429 -33.293 1.00 73.08 O \nANISOU 2250 O ILE A 282 8600 8016 11152 -1309 77 -443 O \nATOM 2251 CB ILE A 282 3.716 -25.019 -34.008 1.00 54.62 C \nANISOU 2251 CB ILE A 282 6375 5556 8821 -1129 126 -400 C \nATOM 2252 CG1 ILE A 282 3.369 -24.261 -32.753 1.00 58.19 C \nANISOU 2252 CG1 ILE A 282 6800 6016 9293 -1108 81 -378 C \nATOM 2253 CG2 ILE A 282 4.544 -24.171 -34.928 1.00 47.31 C \nANISOU 2253 CG2 ILE A 282 5503 4585 7888 -1048 165 -389 C \nATOM 2254 CD1 ILE A 282 4.570 -24.066 -31.842 1.00 59.57 C \nANISOU 2254 CD1 ILE A 282 7087 6138 9409 -1114 112 -363 C \nATOM 2255 N GLY A 283 0.370 -26.083 -33.615 1.00 59.19 N \nANISOU 2255 N GLY A 283 6671 6311 9508 -1189 -5 -429 N \nATOM 2256 CA GLY A 283 -0.527 -26.936 -32.861 1.00 63.79 C \nANISOU 2256 CA GLY A 283 7184 6960 10093 -1250 -46 -439 C \nATOM 2257 C GLY A 283 -1.716 -26.214 -32.271 1.00 60.97 C \nANISOU 2257 C GLY A 283 6737 6635 9795 -1197 -114 -423 C \nATOM 2258 O GLY A 283 -1.646 -25.043 -31.994 1.00 58.10 O \nANISOU 2258 O GLY A 283 6387 6232 9456 -1134 -130 -398 O \nATOM 2259 N ALA A 284 -2.793 -26.956 -32.044 1.00 58.75 N \nANISOU 2259 N ALA A 284 6367 6429 9528 -1225 -155 -437 N \nATOM 2260 CA ALA A 284 -3.955 -26.460 -31.356 1.00 62.80 C \nANISOU 2260 CA ALA A 284 6801 6974 10087 -1183 -222 -421 C \nATOM 2261 C ALA A 284 -3.724 -26.278 -29.840 1.00 68.65 C \nANISOU 2261 C ALA A 284 7576 7701 10806 -1216 -245 -397 C \nATOM 2262 O ALA A 284 -2.822 -26.869 -29.249 1.00 75.20 O \nANISOU 2262 O ALA A 284 8475 8516 11579 -1290 -213 -399 O \nATOM 2263 CB ALA A 284 -5.118 -27.398 -31.562 1.00 62.75 C \nANISOU 2263 CB ALA A 284 6691 7059 10094 -1199 -256 -444 C \nATOM 2264 N ILE A 285 -4.541 -25.435 -29.224 1.00 68.08 N \nANISOU 2264 N ILE A 285 7461 7630 10776 -1163 -302 -374 N \nATOM 2265 CA ILE A 285 -4.565 -25.346 -27.784 1.00 63.19 C \nANISOU 2265 CA ILE A 285 6856 7015 10141 -1196 -334 -352 C \nATOM 2266 C ILE A 285 -5.959 -25.299 -27.195 1.00 70.26 C \nANISOU 2266 C ILE A 285 7661 7962 11073 -1169 -406 -342 C \nATOM 2267 O ILE A 285 -6.659 -24.320 -27.334 1.00 75.74 O \nANISOU 2267 O ILE A 285 8327 8636 11813 -1095 -444 -326 O \nATOM 2268 CB ILE A 285 -3.649 -24.210 -27.213 1.00 61.11 C \nANISOU 2268 CB ILE A 285 6675 6678 9865 -1173 -318 -324 C \nATOM 2269 CG1 ILE A 285 -3.767 -24.190 -25.692 1.00 67.84 C \nANISOU 2269 CG1 ILE A 285 7533 7542 10700 -1212 -354 -303 C \nATOM 2270 CG2 ILE A 285 -3.913 -22.834 -27.756 1.00 53.13 C \nANISOU 2270 CG2 ILE A 285 5655 5630 8901 -1084 -334 -307 C \nATOM 2271 CD1 ILE A 285 -3.443 -25.539 -25.041 1.00 61.94 C \nANISOU 2271 CD1 ILE A 285 6802 6835 9899 -1311 -338 -320 C \nATOM 2272 N ASN A 286 -6.318 -26.376 -26.491 1.00 86.29 N \nANISOU 2272 N ASN A 286 9654 10059 13075 -1234 -425 -351 N \nATOM 2273 CA ASN A 286 -7.520 -26.457 -25.627 1.00 85.04 C \nANISOU 2273 CA ASN A 286 9420 9956 12936 -1219 -495 -337 C \nATOM 2274 C ASN A 286 -7.223 -26.058 -24.176 1.00 87.73 C \nANISOU 2274 C ASN A 286 9803 10274 13256 -1251 -518 -307 C \nATOM 2275 O ASN A 286 -6.992 -26.908 -23.334 1.00 85.43 O \nANISOU 2275 O ASN A 286 9515 10023 12920 -1330 -516 -310 O \nATOM 2276 CB ASN A 286 -8.086 -27.876 -25.654 1.00 87.31 C \nANISOU 2276 CB ASN A 286 9632 10344 13197 -1272 -504 -363 C \nATOM 2277 CG ASN A 286 -9.304 -28.043 -24.765 1.00 91.48 C \nANISOU 2277 CG ASN A 286 10082 10939 13739 -1253 -575 -349 C \nATOM 2278 OD1 ASN A 286 -9.930 -27.070 -24.337 1.00 99.33 O \nANISOU 2278 OD1 ASN A 286 11069 11899 14772 -1185 -623 -322 O \nATOM 2279 ND2 ASN A 286 -9.639 -29.289 -24.472 1.00 92.66 N \nANISOU 2279 ND2 ASN A 286 10171 11185 13849 -1314 -583 -366 N \nATOM 2280 N SER A 287 -7.228 -24.755 -23.899 1.00 97.61 N \nANISOU 2280 N SER A 287 11085 11464 14537 -1195 -538 -279 N \nATOM 2281 CA SER A 287 -6.993 -24.245 -22.542 1.00 98.51 C \nANISOU 2281 CA SER A 287 11237 11558 14633 -1219 -563 -249 C \nATOM 2282 C SER A 287 -7.959 -23.153 -22.147 1.00 93.21 C \nANISOU 2282 C SER A 287 10537 10870 14007 -1152 -627 -218 C \nATOM 2283 O SER A 287 -8.926 -22.883 -22.866 1.00 97.32 O \nANISOU 2283 O SER A 287 11007 11399 14573 -1086 -657 -222 O \nATOM 2284 CB SER A 287 -5.555 -23.759 -22.395 1.00100.23 C \nANISOU 2284 CB SER A 287 11554 11712 14816 -1244 -506 -243 C \nATOM 2285 OG SER A 287 -4.658 -24.861 -22.489 1.00102.60 O \nANISOU 2285 OG SER A 287 11895 12023 15064 -1320 -452 -268 O \nATOM 2286 N SER A 288 -7.726 -22.576 -20.970 1.00 90.86 N \nANISOU 2286 N SER A 288 10276 10553 13694 -1173 -648 -189 N \nATOM 2287 CA SER A 288 -8.536 -21.463 -20.477 1.00 90.14 C \nANISOU 2287 CA SER A 288 10173 10439 13636 -1121 -708 -157 C \nATOM 2288 C SER A 288 -7.709 -20.578 -19.569 1.00 86.64 C \nANISOU 2288 C SER A 288 9798 9955 13168 -1146 -699 -130 C \nATOM 2289 O SER A 288 -7.669 -20.805 -18.358 1.00 78.42 O \nANISOU 2289 O SER A 288 8765 8934 12099 -1194 -721 -114 O \nATOM 2290 CB SER A 288 -9.762 -21.970 -19.730 1.00 86.88 C \nANISOU 2290 CB SER A 288 9696 10081 13234 -1120 -775 -146 C \nATOM 2291 OG SER A 288 -10.593 -20.885 -19.380 1.00 90.75 O \nANISOU 2291 OG SER A 288 10185 10541 13756 -1066 -833 -115 O \nATOM 2292 N MET A 289 -7.062 -19.581 -20.178 1.00 84.63 N \nANISOU 2292 N MET A 289 9587 9649 12918 -1111 -667 -125 N \nATOM 2293 CA MET A 289 -6.124 -18.718 -19.488 1.00 92.29 C \nANISOU 2293 CA MET A 289 10621 10588 13857 -1127 -648 -105 C \nATOM 2294 C MET A 289 -5.928 -17.403 -20.245 1.00 88.04 C \nANISOU 2294 C MET A 289 10103 10010 13338 -1069 -637 -94 C \nATOM 2295 O MET A 289 -5.925 -17.365 -21.460 1.00 93.71 O \nANISOU 2295 O MET A 289 10810 10716 14078 -1029 -612 -111 O \nATOM 2296 CB MET A 289 -4.778 -19.448 -19.323 1.00 97.16 C \nANISOU 2296 CB MET A 289 11295 11201 14421 -1181 -581 -124 C \nATOM 2297 CG MET A 289 -4.666 -20.372 -18.111 1.00104.53 C \nANISOU 2297 CG MET A 289 12234 12167 15315 -1257 -591 -124 C \nATOM 2298 SD MET A 289 -2.963 -20.914 -17.759 1.00118.37 S \nANISOU 2298 SD MET A 289 14083 13896 16996 -1317 -513 -141 S \nATOM 2299 CE MET A 289 -3.299 -22.218 -16.592 1.00 84.04 C \nANISOU 2299 CE MET A 289 9715 9603 12615 -1410 -538 -147 C \nATOM 2300 N PRO A 290 -5.701 -16.314 -19.531 1.00 99.58 N \nANISOU 2300 N PRO A 290 11593 11457 14785 -1068 -653 -64 N \nATOM 2301 CA PRO A 290 -5.606 -15.011 -20.202 1.00101.79 C \nANISOU 2301 CA PRO A 290 11886 11712 15079 -1020 -648 -52 C \nATOM 2302 C PRO A 290 -4.386 -14.847 -21.091 1.00 93.72 C \nANISOU 2302 C PRO A 290 10902 10675 14034 -999 -576 -69 C \nATOM 2303 O PRO A 290 -4.354 -13.926 -21.936 1.00 90.07 O \nANISOU 2303 O PRO A 290 10439 10200 13585 -954 -567 -65 O \nATOM 2304 CB PRO A 290 -5.536 -14.015 -19.036 1.00 97.35 C \nANISOU 2304 CB PRO A 290 11347 11151 14493 -1040 -680 -17 C \nATOM 2305 CG PRO A 290 -4.977 -14.794 -17.914 1.00101.27 C \nANISOU 2305 CG PRO A 290 11864 11664 14949 -1097 -669 -18 C \nATOM 2306 CD PRO A 290 -5.469 -16.209 -18.085 1.00105.64 C \nANISOU 2306 CD PRO A 290 12383 12236 15518 -1117 -673 -42 C \nATOM 2307 N PHE A 291 -3.393 -15.714 -20.925 1.00 83.82 N \nANISOU 2307 N PHE A 291 9684 9422 12741 -1031 -525 -87 N \nATOM 2308 CA PHE A 291 -2.175 -15.582 -21.727 1.00 92.82 C \nANISOU 2308 CA PHE A 291 10872 10543 13853 -1006 -456 -101 C \nATOM 2309 C PHE A 291 -1.585 -16.905 -22.224 1.00 86.76 C \nANISOU 2309 C PHE A 291 10129 9770 13068 -1032 -406 -134 C \nATOM 2310 O PHE A 291 -1.903 -17.979 -21.712 1.00 79.72 O \nANISOU 2310 O PHE A 291 9225 8895 12171 -1084 -418 -145 O \nATOM 2311 CB PHE A 291 -1.129 -14.803 -20.945 1.00 95.55 C \nANISOU 2311 CB PHE A 291 11271 10886 14148 -1009 -432 -83 C \nATOM 2312 CG PHE A 291 -1.633 -13.485 -20.410 1.00100.24 C \nANISOU 2312 CG PHE A 291 11844 11494 14750 -996 -479 -51 C \nATOM 2313 CD1 PHE A 291 -2.119 -13.384 -19.120 1.00102.24 C \nANISOU 2313 CD1 PHE A 291 12088 11761 14996 -1037 -527 -30 C \nATOM 2314 CD2 PHE A 291 -1.639 -12.364 -21.203 1.00 98.70 C \nANISOU 2314 CD2 PHE A 291 11638 11299 14564 -948 -476 -41 C \nATOM 2315 CE1 PHE A 291 -2.573 -12.183 -18.611 1.00 99.30 C \nANISOU 2315 CE1 PHE A 291 11703 11401 14625 -1033 -571 1 C \nATOM 2316 CE2 PHE A 291 -2.092 -11.154 -20.709 1.00104.21 C \nANISOU 2316 CE2 PHE A 291 12321 12013 15262 -947 -519 -11 C \nATOM 2317 CZ PHE A 291 -2.560 -11.061 -19.411 1.00103.12 C \nANISOU 2317 CZ PHE A 291 12180 11886 15117 -991 -566 11 C \nATOM 2318 N HIS A 292 -0.760 -16.795 -23.269 1.00 85.13 N \nANISOU 2318 N HIS A 292 9955 9541 12848 -997 -350 -148 N \nATOM 2319 CA HIS A 292 0.023 -17.911 -23.794 1.00 74.70 C \nANISOU 2319 CA HIS A 292 8679 8206 11499 -1021 -293 -176 C \nATOM 2320 C HIS A 292 1.277 -17.376 -24.458 1.00 74.99 C \nANISOU 2320 C HIS A 292 8779 8213 11499 -975 -232 -178 C \nATOM 2321 O HIS A 292 1.379 -16.177 -24.731 1.00 92.07 O \nANISOU 2321 O HIS A 292 10933 10379 13669 -921 -235 -160 O \nATOM 2322 CB HIS A 292 -0.800 -18.772 -24.758 1.00 71.57 C \nANISOU 2322 CB HIS A 292 8227 7824 11141 -1026 -302 -200 C \nATOM 2323 CG HIS A 292 -0.938 -18.199 -26.137 1.00 80.33 C \nANISOU 2323 CG HIS A 292 9315 8925 12283 -963 -288 -206 C \nATOM 2324 ND1 HIS A 292 0.094 -18.181 -27.049 1.00 88.30 N \nANISOU 2324 ND1 HIS A 292 10376 9908 13266 -937 -227 -217 N \nATOM 2325 CD2 HIS A 292 -2.006 -17.674 -26.778 1.00 78.67 C \nANISOU 2325 CD2 HIS A 292 9040 8726 12126 -922 -328 -203 C \nATOM 2326 CE1 HIS A 292 -0.315 -17.638 -28.178 1.00 86.13 C \nANISOU 2326 CE1 HIS A 292 10063 9634 13027 -886 -229 -220 C \nATOM 2327 NE2 HIS A 292 -1.588 -17.320 -28.038 1.00 84.23 N \nANISOU 2327 NE2 HIS A 292 9753 9415 12835 -877 -289 -213 N \nATOM 2328 N ASN A 293 2.216 -18.272 -24.730 1.00 78.46 N \nANISOU 2328 N ASN A 293 9285 8629 11898 -999 -176 -199 N \nATOM 2329 CA ASN A 293 3.470 -17.935 -25.425 1.00 73.95 C \nANISOU 2329 CA ASN A 293 8786 8026 11287 -951 -113 -202 C \nATOM 2330 C ASN A 293 3.833 -18.940 -26.507 1.00 71.88 C \nANISOU 2330 C ASN A 293 8555 7741 11015 -963 -67 -230 C \nATOM 2331 O ASN A 293 5.004 -19.174 -26.781 1.00 76.37 O \nANISOU 2331 O ASN A 293 9211 8273 11532 -952 -10 -238 O \nATOM 2332 CB ASN A 293 4.600 -17.862 -24.431 1.00 78.74 C \nANISOU 2332 CB ASN A 293 9478 8613 11828 -961 -81 -196 C \nATOM 2333 CG ASN A 293 4.841 -19.180 -23.731 1.00 78.89 C \nANISOU 2333 CG ASN A 293 9546 8617 11812 -1043 -68 -214 C \nATOM 2334 OD1 ASN A 293 3.966 -20.053 -23.679 1.00 74.57 O \nANISOU 2334 OD1 ASN A 293 8950 8091 11293 -1101 -98 -226 O \nATOM 2335 ND2 ASN A 293 6.035 -19.323 -23.184 1.00 78.67 N \nANISOU 2335 ND2 ASN A 293 9617 8556 11718 -1049 -23 -217 N \nATOM 2336 N ILE A 294 2.810 -19.526 -27.115 1.00 66.79 N \nANISOU 2336 N ILE A 294 7841 7120 10418 -985 -94 -245 N \nATOM 2337 CA ILE A 294 2.960 -20.607 -28.065 1.00 67.29 C \nANISOU 2337 CA ILE A 294 7921 7174 10474 -1013 -59 -272 C \nATOM 2338 C ILE A 294 3.508 -20.122 -29.396 1.00 71.44 C \nANISOU 2338 C ILE A 294 8467 7678 11000 -948 -18 -275 C \nATOM 2339 O ILE A 294 4.574 -20.536 -29.835 1.00 75.26 O \nANISOU 2339 O ILE A 294 9034 8124 11436 -948 39 -285 O \nATOM 2340 CB ILE A 294 1.611 -21.292 -28.343 1.00 59.91 C \nANISOU 2340 CB ILE A 294 6890 6284 9589 -1045 -104 -287 C \nATOM 2341 CG1 ILE A 294 0.902 -21.715 -27.051 1.00 63.39 C \nANISOU 2341 CG1 ILE A 294 7295 6758 10034 -1102 -153 -281 C \nATOM 2342 CG2 ILE A 294 1.839 -22.500 -29.237 1.00 57.16 C \nANISOU 2342 CG2 ILE A 294 6560 5935 9222 -1088 -65 -317 C \nATOM 2343 CD1 ILE A 294 1.672 -22.713 -26.198 1.00 67.08 C \nANISOU 2343 CD1 ILE A 294 7835 7215 10439 -1183 -124 -291 C \nATOM 2344 N HIS A 295 2.748 -19.232 -30.023 1.00 75.43 N \nANISOU 2344 N HIS A 295 8899 8204 11557 -892 -49 -266 N \nATOM 2345 CA HIS A 295 3.066 -18.729 -31.358 1.00 75.63 C \nANISOU 2345 CA HIS A 295 8926 8219 11590 -832 -18 -269 C \nATOM 2346 C HIS A 295 2.308 -17.402 -31.618 1.00 65.51 C \nANISOU 2346 C HIS A 295 7573 6962 10355 -773 -59 -250 C \nATOM 2347 O HIS A 295 1.169 -17.265 -31.206 1.00 68.56 O \nANISOU 2347 O HIS A 295 7892 7372 10785 -787 -115 -245 O \nATOM 2348 CB HIS A 295 2.675 -19.795 -32.381 1.00 80.31 C \nANISOU 2348 CB HIS A 295 9495 8819 12200 -861 -4 -298 C \nATOM 2349 CG HIS A 295 3.227 -19.549 -33.753 1.00 81.22 C \nANISOU 2349 CG HIS A 295 9632 8917 12309 -812 40 -304 C \nATOM 2350 ND1 HIS A 295 2.532 -18.850 -34.715 1.00 79.21 N \nANISOU 2350 ND1 HIS A 295 9311 8684 12103 -761 21 -303 N \nATOM 2351 CD2 HIS A 295 4.412 -19.888 -34.310 1.00 83.84 C \nANISOU 2351 CD2 HIS A 295 10052 9212 12590 -804 101 -310 C \nATOM 2352 CE1 HIS A 295 3.269 -18.775 -35.808 1.00 85.33 C \nANISOU 2352 CE1 HIS A 295 10123 9440 12857 -726 69 -308 C \nATOM 2353 NE2 HIS A 295 4.417 -19.393 -35.588 1.00 83.03 N \nANISOU 2353 NE2 HIS A 295 9927 9113 12506 -749 118 -312 N \nATOM 2354 N PRO A 296 2.952 -16.429 -32.268 1.00 63.53 N \nANISOU 2354 N PRO A 296 7342 6706 10090 -710 -32 -237 N \nATOM 2355 CA PRO A 296 2.315 -15.135 -32.544 1.00 59.63 C \nANISOU 2355 CA PRO A 296 6789 6238 9631 -663 -67 -219 C \nATOM 2356 C PRO A 296 1.118 -15.270 -33.425 1.00 72.71 C \nANISOU 2356 C PRO A 296 8372 7907 11346 -661 -98 -234 C \nATOM 2357 O PRO A 296 0.039 -14.802 -33.079 1.00 63.59 O \nANISOU 2357 O PRO A 296 7161 6769 10232 -663 -153 -226 O \nATOM 2358 CB PRO A 296 3.406 -14.328 -33.263 1.00 59.87 C \nANISOU 2358 CB PRO A 296 6860 6267 9623 -600 -19 -209 C \nATOM 2359 CG PRO A 296 4.495 -15.303 -33.640 1.00 68.13 C \nANISOU 2359 CG PRO A 296 7985 7278 10623 -606 42 -225 C \nATOM 2360 CD PRO A 296 4.388 -16.449 -32.650 1.00 71.68 C \nANISOU 2360 CD PRO A 296 8462 7711 11064 -679 34 -237 C \nATOM 2361 N LEU A 297 1.329 -15.904 -34.577 1.00 93.56 N \nANISOU 2361 N LEU A 297 11019 10540 13989 -653 -62 -256 N \nATOM 2362 CA LEU A 297 0.274 -16.094 -35.584 1.00100.88 C \nANISOU 2362 CA LEU A 297 11880 11483 14969 -645 -83 -275 C \nATOM 2363 C LEU A 297 -0.768 -17.079 -35.115 1.00 95.42 C \nANISOU 2363 C LEU A 297 11142 10806 14308 -693 -123 -292 C \nATOM 2364 O LEU A 297 -0.686 -18.257 -35.391 1.00108.01 O \nANISOU 2364 O LEU A 297 12742 12404 15894 -730 -101 -315 O \nATOM 2365 CB LEU A 297 0.855 -16.568 -36.921 1.00106.16 C \nANISOU 2365 CB LEU A 297 12570 12143 15625 -629 -30 -294 C \nATOM 2366 CG LEU A 297 1.915 -15.664 -37.548 1.00104.81 C \nANISOU 2366 CG LEU A 297 12442 11962 15418 -573 12 -279 C \nATOM 2367 CD1 LEU A 297 2.692 -16.371 -38.656 1.00105.53 C \nANISOU 2367 CD1 LEU A 297 12577 12037 15484 -567 70 -297 C \nATOM 2368 CD2 LEU A 297 1.255 -14.404 -38.084 1.00105.71 C \nANISOU 2368 CD2 LEU A 297 12499 12100 15566 -527 -18 -267 C \nATOM 2369 N THR A 298 -1.755 -16.590 -34.399 1.00 88.42 N \nANISOU 2369 N THR A 298 10211 9932 13454 -692 -181 -279 N \nATOM 2370 CA THR A 298 -2.764 -17.453 -33.822 1.00 84.66 C \nANISOU 2370 CA THR A 298 9688 9476 13003 -729 -224 -291 C \nATOM 2371 C THR A 298 -4.057 -17.170 -34.520 1.00 76.19 C \nANISOU 2371 C THR A 298 8547 8418 11984 -694 -265 -300 C \nATOM 2372 O THR A 298 -4.187 -16.119 -35.129 1.00 92.79 O \nANISOU 2372 O THR A 298 10643 10509 14102 -649 -269 -291 O \nATOM 2373 CB THR A 298 -2.860 -17.145 -32.320 1.00 94.88 C \nANISOU 2373 CB THR A 298 10995 10770 14286 -755 -261 -266 C \nATOM 2374 OG1 THR A 298 -1.534 -17.192 -31.740 1.00 99.05 O \nANISOU 2374 OG1 THR A 298 11596 11280 14759 -776 -217 -256 O \nATOM 2375 CG2 THR A 298 -3.756 -18.125 -31.603 1.00 92.25 C \nANISOU 2375 CG2 THR A 298 10620 10463 13968 -796 -301 -275 C \nATOM 2376 N ILE A 299 -5.013 -18.090 -34.451 1.00 67.57 N \nANISOU 2376 N ILE A 299 7402 7354 10916 -711 -295 -319 N \nATOM 2377 CA ILE A 299 -6.295 -17.921 -35.125 1.00 67.16 C \nANISOU 2377 CA ILE A 299 7288 7316 10913 -670 -334 -332 C \nATOM 2378 C ILE A 299 -7.448 -18.445 -34.307 1.00 70.03 C \nANISOU 2378 C ILE A 299 7603 7708 11299 -679 -392 -334 C \nATOM 2379 O ILE A 299 -7.397 -19.545 -33.790 1.00 86.74 O \nANISOU 2379 O ILE A 299 9707 9856 13396 -724 -389 -345 O \nATOM 2380 CB ILE A 299 -6.310 -18.529 -36.571 1.00 79.67 C \nANISOU 2380 CB ILE A 299 8847 8918 12507 -655 -297 -366 C \nATOM 2381 CG1 ILE A 299 -6.969 -19.948 -36.656 1.00 80.81 C \nANISOU 2381 CG1 ILE A 299 8936 9111 12655 -683 -306 -396 C \nATOM 2382 CG2 ILE A 299 -4.904 -18.509 -37.209 1.00 80.12 C \nANISOU 2382 CG2 ILE A 299 8963 8954 12526 -665 -229 -367 C \nATOM 2383 CD1 ILE A 299 -8.342 -19.949 -37.288 1.00 79.81 C \nANISOU 2383 CD1 ILE A 299 8739 9011 12575 -634 -346 -415 C \nATOM 2384 N GLY A 300 -8.503 -17.660 -34.195 1.00 92.30 N \nANISOU 2384 N GLY A 300 10399 10518 14155 -636 -446 -322 N \nATOM 2385 CA GLY A 300 -9.695 -18.018 -33.409 1.00109.03 C \nANISOU 2385 CA GLY A 300 12474 12658 16293 -630 -508 -320 C \nATOM 2386 C GLY A 300 -9.876 -17.054 -32.240 1.00120.05 C \nANISOU 2386 C GLY A 300 13901 14024 17687 -634 -552 -282 C \nATOM 2387 O GLY A 300 -9.552 -15.866 -32.362 1.00112.54 O \nANISOU 2387 O GLY A 300 12986 13037 16735 -619 -548 -262 O \nATOM 2388 N GLU A 301 -10.412 -17.564 -31.126 1.00128.77 N \nANISOU 2388 N GLU A 301 14987 15151 18788 -655 -594 -272 N \nATOM 2389 CA GLU A 301 -10.445 -16.819 -29.854 1.00132.29 C \nANISOU 2389 CA GLU A 301 15466 15575 19224 -673 -632 -235 C \nATOM 2390 C GLU A 301 -9.419 -17.449 -28.911 1.00125.49 C \nANISOU 2390 C GLU A 301 14630 14731 18320 -739 -603 -229 C \nATOM 2391 O GLU A 301 -9.606 -18.528 -28.325 1.00 86.51 O \nANISOU 2391 O GLU A 301 9666 9834 13371 -773 -612 -237 O \nATOM 2392 CB GLU A 301 -11.833 -16.726 -29.202 1.00138.67 C \nANISOU 2392 CB GLU A 301 16245 16387 20057 -644 -706 -222 C \nATOM 2393 CG GLU A 301 -12.526 -15.380 -29.384 1.00129.17 C \nANISOU 2393 CG GLU A 301 15067 15135 18878 -601 -746 -202 C \nATOM 2394 CD GLU A 301 -13.875 -15.300 -28.681 1.00128.17 C \nANISOU 2394 CD GLU A 301 14926 15002 18770 -571 -821 -187 C \nATOM 2395 OE1 GLU A 301 -14.301 -16.286 -28.055 1.00126.39 O \nANISOU 2395 OE1 GLU A 301 14663 14818 18541 -578 -844 -192 O \nATOM 2396 OE2 GLU A 301 -14.526 -14.243 -28.755 1.00129.33 O \nANISOU 2396 OE2 GLU A 301 15104 15105 18932 -541 -858 -170 O \nATOM 2397 N CYS A 302 -8.323 -16.724 -28.783 1.00131.49 N \nANISOU 2397 N CYS A 302 15445 15463 19053 -755 -567 -213 N \nATOM 2398 CA CYS A 302 -7.128 -17.221 -28.159 1.00128.08 C \nANISOU 2398 CA CYS A 302 15053 15036 18575 -808 -524 -211 C \nATOM 2399 C CYS A 302 -6.589 -16.216 -27.158 1.00126.63 C \nANISOU 2399 C CYS A 302 14916 14832 18367 -822 -533 -178 C \nATOM 2400 O CYS A 302 -6.613 -14.999 -27.387 1.00138.89 O \nANISOU 2400 O CYS A 302 16483 16364 19927 -791 -542 -160 O \nATOM 2401 CB CYS A 302 -6.066 -17.458 -29.229 1.00123.06 C \nANISOU 2401 CB CYS A 302 14446 14391 17920 -805 -454 -232 C \nATOM 2402 SG CYS A 302 -6.661 -18.568 -30.492 1.00111.20 S \nANISOU 2402 SG CYS A 302 12889 12919 16444 -792 -440 -272 S \nATOM 2403 N PRO A 303 -6.084 -16.725 -26.041 1.00111.50 N \nANISOU 2403 N PRO A 303 13022 12926 16415 -873 -529 -170 N \nATOM 2404 CA PRO A 303 -5.336 -15.916 -25.102 1.00103.03 C \nANISOU 2404 CA PRO A 303 11997 11840 15308 -892 -525 -143 C \nATOM 2405 C PRO A 303 -4.352 -14.959 -25.754 1.00 91.01 C \nANISOU 2405 C PRO A 303 10515 10298 13766 -861 -479 -138 C \nATOM 2406 O PRO A 303 -3.849 -15.209 -26.846 1.00100.17 O \nANISOU 2406 O PRO A 303 11683 11451 14925 -839 -432 -158 O \nATOM 2407 CB PRO A 303 -4.566 -16.973 -24.280 1.00107.86 C \nANISOU 2407 CB PRO A 303 12639 12465 15877 -952 -497 -152 C \nATOM 2408 CG PRO A 303 -5.073 -18.317 -24.705 1.00101.31 C \nANISOU 2408 CG PRO A 303 11770 11663 15061 -972 -496 -180 C \nATOM 2409 CD PRO A 303 -6.284 -18.096 -25.548 1.00102.14 C \nANISOU 2409 CD PRO A 303 11815 11775 15220 -920 -534 -187 C \nATOM 2410 N LYS A 304 -4.035 -13.893 -25.055 1.00 95.49 N \nANISOU 2410 N LYS A 304 11108 10863 14312 -861 -491 -110 N \nATOM 2411 CA LYS A 304 -3.070 -12.950 -25.572 1.00101.37 C \nANISOU 2411 CA LYS A 304 11884 11602 15029 -830 -448 -102 C \nATOM 2412 C LYS A 304 -1.712 -13.603 -25.657 1.00 92.08 C \nANISOU 2412 C LYS A 304 10759 10420 13807 -838 -380 -118 C \nATOM 2413 O LYS A 304 -1.123 -13.955 -24.651 1.00 98.42 O \nANISOU 2413 O LYS A 304 11597 11224 14573 -873 -370 -113 O \nATOM 2414 CB LYS A 304 -2.969 -11.731 -24.655 1.00112.03 C \nANISOU 2414 CB LYS A 304 13247 12963 16355 -838 -475 -69 C \nATOM 2415 CG LYS A 304 -4.229 -10.895 -24.547 1.00119.17 C \nANISOU 2415 CG LYS A 304 14119 13867 17295 -833 -541 -49 C \nATOM 2416 CD LYS A 304 -3.872 -9.472 -24.157 1.00111.34 C \nANISOU 2416 CD LYS A 304 13142 12891 16269 -834 -548 -20 C \nATOM 2417 CE LYS A 304 -3.085 -8.787 -25.242 1.00108.28 C \nANISOU 2417 CE LYS A 304 12762 12515 15863 -793 -499 -26 C \nATOM 2418 NZ LYS A 304 -3.592 -8.995 -26.631 1.00103.98 N \nANISOU 2418 NZ LYS A 304 12193 11954 15361 -758 -492 -47 N \nATOM 2419 N TYR A 305 -1.213 -13.752 -26.865 1.00 89.80 N \nANISOU 2419 N TYR A 305 10480 10122 13519 -805 -334 -136 N \nATOM 2420 CA TYR A 305 0.165 -14.136 -27.036 1.00 90.75 C \nANISOU 2420 CA TYR A 305 10662 10229 13588 -801 -268 -146 C \nATOM 2421 C TYR A 305 1.089 -13.134 -26.317 1.00 88.28 C \nANISOU 2421 C TYR A 305 10391 9927 13226 -784 -252 -123 C \nATOM 2422 O TYR A 305 1.000 -11.911 -26.508 1.00 70.95 O \nANISOU 2422 O TYR A 305 8175 7751 11032 -751 -265 -103 O \nATOM 2423 CB TYR A 305 0.537 -14.232 -28.514 1.00 83.42 C \nANISOU 2423 CB TYR A 305 9739 9291 12667 -759 -224 -165 C \nATOM 2424 CG TYR A 305 1.994 -14.599 -28.743 1.00 94.26 C \nANISOU 2424 CG TYR A 305 11188 10644 13983 -747 -154 -173 C \nATOM 2425 CD1 TYR A 305 2.469 -15.862 -28.461 1.00 94.59 C \nANISOU 2425 CD1 TYR A 305 11276 10665 13999 -793 -125 -193 C \nATOM 2426 CD2 TYR A 305 2.904 -13.668 -29.221 1.00 93.00 C \nANISOU 2426 CD2 TYR A 305 11057 10488 13790 -691 -117 -162 C \nATOM 2427 CE1 TYR A 305 3.799 -16.186 -28.657 1.00 95.03 C \nANISOU 2427 CE1 TYR A 305 11416 10693 13998 -780 -62 -200 C \nATOM 2428 CE2 TYR A 305 4.230 -14.003 -29.424 1.00 93.58 C \nANISOU 2428 CE2 TYR A 305 11208 10540 13808 -670 -55 -169 C \nATOM 2429 CZ TYR A 305 4.671 -15.266 -29.135 1.00 91.25 C \nANISOU 2429 CZ TYR A 305 10969 10213 13489 -715 -27 -188 C \nATOM 2430 OH TYR A 305 5.990 -15.602 -29.328 1.00 98.63 O \nANISOU 2430 OH TYR A 305 11994 11116 14364 -693 35 -195 O \nATOM 2431 N VAL A 306 1.988 -13.666 -25.502 1.00 83.77 N \nANISOU 2431 N VAL A 306 9876 9344 12606 -809 -222 -125 N \nATOM 2432 CA VAL A 306 2.998 -12.830 -24.832 1.00 86.02 C \nANISOU 2432 CA VAL A 306 10205 9642 12835 -787 -199 -107 C \nATOM 2433 C VAL A 306 4.327 -13.523 -24.898 1.00 78.09 C \nANISOU 2433 C VAL A 306 9284 8610 11776 -778 -132 -123 C \nATOM 2434 O VAL A 306 4.339 -14.715 -25.029 1.00 70.10 O \nANISOU 2434 O VAL A 306 8298 7571 10767 -816 -117 -145 O \nATOM 2435 CB VAL A 306 2.620 -12.566 -23.373 1.00 82.01 C \nANISOU 2435 CB VAL A 306 9688 9153 12319 -831 -244 -87 C \nATOM 2436 CG1 VAL A 306 1.948 -11.210 -23.287 1.00 82.21 C \nANISOU 2436 CG1 VAL A 306 9661 9211 12362 -814 -290 -60 C \nATOM 2437 CG2 VAL A 306 1.700 -13.663 -22.857 1.00 74.92 C \nANISOU 2437 CG2 VAL A 306 8766 8244 11455 -893 -282 -98 C \nATOM 2438 N LYS A 307 5.429 -12.777 -24.826 1.00 85.48 N \nANISOU 2438 N LYS A 307 10265 9556 12658 -728 -94 -113 N \nATOM 2439 CA LYS A 307 6.756 -13.394 -24.882 1.00109.72 C \nANISOU 2439 CA LYS A 307 13429 12591 15668 -709 -28 -127 C \nATOM 2440 C LYS A 307 7.455 -13.578 -23.524 1.00115.46 C \nANISOU 2440 C LYS A 307 14217 13312 16339 -734 -17 -124 C \nATOM 2441 O LYS A 307 8.682 -13.614 -23.450 1.00128.40 O \nANISOU 2441 O LYS A 307 15938 14932 17916 -696 36 -129 O \nATOM 2442 CB LYS A 307 7.646 -12.663 -25.878 1.00119.75 C \nANISOU 2442 CB LYS A 307 14723 13870 16907 -624 18 -123 C \nATOM 2443 CG LYS A 307 8.104 -11.269 -25.491 1.00125.41 C \nANISOU 2443 CG LYS A 307 15424 14641 17587 -570 17 -98 C \nATOM 2444 CD LYS A 307 8.981 -10.688 -26.613 1.00128.83 C \nANISOU 2444 CD LYS A 307 15875 15087 17986 -483 65 -96 C \nATOM 2445 CE LYS A 307 8.657 -11.278 -27.993 1.00128.34 C \nANISOU 2445 CE LYS A 307 15804 14994 17966 -477 79 -113 C \nATOM 2446 NZ LYS A 307 9.478 -10.727 -29.097 1.00133.54 N \nANISOU 2446 NZ LYS A 307 16480 15667 18592 -393 124 -109 N \nATOM 2447 N SER A 308 6.661 -13.719 -22.466 1.00119.82 N \nANISOU 2447 N SER A 308 14733 13879 16913 -797 -68 -117 N \nATOM 2448 CA SER A 308 7.170 -14.063 -21.134 1.00118.98 C \nANISOU 2448 CA SER A 308 14681 13766 16760 -837 -63 -117 C \nATOM 2449 C SER A 308 7.286 -15.571 -21.012 1.00114.54 C \nANISOU 2449 C SER A 308 14173 13159 16190 -901 -43 -143 C \nATOM 2450 O SER A 308 6.573 -16.299 -21.699 1.00102.28 O \nANISOU 2450 O SER A 308 12584 11596 14681 -932 -56 -156 O \nATOM 2451 CB SER A 308 6.215 -13.577 -20.032 1.00116.36 C \nANISOU 2451 CB SER A 308 14284 13473 16453 -883 -129 -95 C \nATOM 2452 OG SER A 308 6.083 -12.163 -19.989 1.00113.72 O \nANISOU 2452 OG SER A 308 13905 13186 16119 -840 -151 -70 O \nATOM 2453 N ASN A 309 8.175 -16.027 -20.132 1.00111.05 N \nANISOU 2453 N ASN A 309 13815 12693 15686 -925 -12 -151 N \nATOM 2454 CA ASN A 309 8.284 -17.448 -19.804 1.00108.84 C \nANISOU 2454 CA ASN A 309 13591 12375 15387 -1004 4 -175 C \nATOM 2455 C ASN A 309 7.434 -17.839 -18.609 1.00106.84 C \nANISOU 2455 C ASN A 309 13293 12149 15152 -1086 -50 -169 C \nATOM 2456 O ASN A 309 7.103 -19.005 -18.442 1.00102.13 O \nANISOU 2456 O ASN A 309 12704 11542 14557 -1162 -55 -187 O \nATOM 2457 CB ASN A 309 9.735 -17.831 -19.538 1.00112.47 C \nANISOU 2457 CB ASN A 309 14182 12786 15766 -990 70 -189 C \nATOM 2458 CG ASN A 309 10.563 -17.856 -20.808 1.00117.97 C \nANISOU 2458 CG ASN A 309 14937 13444 16441 -922 126 -200 C \nATOM 2459 OD1 ASN A 309 10.080 -18.256 -21.868 1.00114.97 O \nANISOU 2459 OD1 ASN A 309 14524 13059 16103 -928 125 -209 O \nATOM 2460 ND2 ASN A 309 11.812 -17.425 -20.708 1.00119.27 N \nANISOU 2460 ND2 ASN A 309 15193 13585 16539 -854 176 -199 N \nATOM 2461 N LYS A 310 7.076 -16.850 -17.792 1.00106.86 N \nANISOU 2461 N LYS A 310 13248 12192 15163 -1073 -90 -144 N \nATOM 2462 CA LYS A 310 6.392 -17.094 -16.533 1.00 96.59 C \nANISOU 2462 CA LYS A 310 11914 10918 13868 -1144 -139 -135 C \nATOM 2463 C LYS A 310 5.407 -15.969 -16.201 1.00 92.84 C \nANISOU 2463 C LYS A 310 11347 10491 13438 -1127 -203 -104 C \nATOM 2464 O LYS A 310 5.783 -14.792 -16.123 1.00 99.10 O \nANISOU 2464 O LYS A 310 12136 11304 14214 -1073 -199 -86 O \nATOM 2465 CB LYS A 310 7.440 -17.224 -15.425 1.00 92.66 C \nANISOU 2465 CB LYS A 310 11506 10406 13297 -1164 -107 -139 C \nATOM 2466 CG LYS A 310 6.876 -17.598 -14.065 1.00 92.37 C \nANISOU 2466 CG LYS A 310 11447 10393 13255 -1246 -151 -132 C \nATOM 2467 CD LYS A 310 7.883 -17.328 -12.964 1.00 90.73 C \nANISOU 2467 CD LYS A 310 11315 10180 12976 -1247 -123 -132 C \nATOM 2468 CE LYS A 310 7.291 -17.636 -11.599 1.00 92.94 C \nANISOU 2468 CE LYS A 310 11569 10490 13252 -1330 -170 -122 C \nATOM 2469 NZ LYS A 310 8.365 -17.762 -10.577 1.00 99.72 N \nANISOU 2469 NZ LYS A 310 12521 11333 14033 -1347 -132 -132 N \nATOM 2470 N LEU A 311 4.146 -16.338 -16.008 1.00 82.10 N \nANISOU 2470 N LEU A 311 9914 9150 12129 -1174 -262 -98 N \nATOM 2471 CA LEU A 311 3.168 -15.436 -15.394 1.00 89.21 C \nANISOU 2471 CA LEU A 311 10745 10089 13063 -1176 -328 -68 C \nATOM 2472 C LEU A 311 2.412 -16.186 -14.318 1.00 83.57 C \nANISOU 2472 C LEU A 311 10006 9392 12356 -1253 -375 -64 C \nATOM 2473 O LEU A 311 1.434 -16.894 -14.621 1.00 80.67 O \nANISOU 2473 O LEU A 311 9586 9031 12032 -1278 -408 -70 O \nATOM 2474 CB LEU A 311 2.165 -14.865 -16.420 1.00 91.12 C \nANISOU 2474 CB LEU A 311 10913 10339 13369 -1134 -363 -58 C \nATOM 2475 CG LEU A 311 2.749 -13.921 -17.487 1.00 97.61 C \nANISOU 2475 CG LEU A 311 11744 11157 14188 -1058 -327 -56 C \nATOM 2476 CD1 LEU A 311 1.668 -13.494 -18.476 1.00 95.96 C \nANISOU 2476 CD1 LEU A 311 11466 10954 14043 -1029 -364 -50 C \nATOM 2477 CD2 LEU A 311 3.427 -12.695 -16.883 1.00 98.30 C \nANISOU 2477 CD2 LEU A 311 11849 11271 14229 -1029 -319 -35 C \nATOM 2478 N VAL A 312 2.837 -15.988 -13.066 1.00 77.68 N \nANISOU 2478 N VAL A 312 9291 8659 11565 -1286 -379 -53 N \nATOM 2479 CA VAL A 312 2.205 -16.662 -11.906 1.00 74.76 C \nANISOU 2479 CA VAL A 312 8902 8310 11193 -1362 -423 -47 C \nATOM 2480 C VAL A 312 1.733 -15.693 -10.799 1.00 73.97 C \nANISOU 2480 C VAL A 312 8771 8243 11090 -1374 -476 -13 C \nATOM 2481 O VAL A 312 2.517 -14.946 -10.218 1.00 75.48 O \nANISOU 2481 O VAL A 312 9000 8443 11237 -1361 -455 -4 O \nATOM 2482 CB VAL A 312 3.152 -17.706 -11.296 1.00 64.21 C \nANISOU 2482 CB VAL A 312 7644 6957 9796 -1418 -376 -71 C \nATOM 2483 CG1 VAL A 312 2.491 -18.404 -10.130 1.00 58.70 C \nANISOU 2483 CG1 VAL A 312 6920 6289 9094 -1500 -422 -65 C \nATOM 2484 CG2 VAL A 312 3.541 -18.723 -12.355 1.00 58.96 C \nANISOU 2484 CG2 VAL A 312 7013 6260 9130 -1420 -328 -104 C \nATOM 2485 N LEU A 313 0.447 -15.742 -10.505 1.00 69.16 N \nANISOU 2485 N LEU A 313 8095 7657 10526 -1397 -544 6 N \nATOM 2486 CA LEU A 313 -0.125 -14.851 -9.512 1.00 75.20 C \nANISOU 2486 CA LEU A 313 8833 8450 11291 -1412 -600 40 C \nATOM 2487 C LEU A 313 -0.113 -15.535 -8.155 1.00 82.79 C \nANISOU 2487 C LEU A 313 9808 9431 12217 -1486 -617 43 C \nATOM 2488 O LEU A 313 -0.660 -16.633 -7.992 1.00 82.38 O \nANISOU 2488 O LEU A 313 9734 9387 12178 -1530 -636 33 O \nATOM 2489 CB LEU A 313 -1.578 -14.474 -9.866 1.00 67.87 C \nANISOU 2489 CB LEU A 313 7833 7527 10425 -1394 -669 62 C \nATOM 2490 CG LEU A 313 -1.771 -13.612 -11.108 1.00 68.02 C \nANISOU 2490 CG LEU A 313 7833 7530 10480 -1327 -664 65 C \nATOM 2491 CD1 LEU A 313 -3.198 -13.759 -11.626 1.00 61.81 C \nANISOU 2491 CD1 LEU A 313 6988 6740 9756 -1311 -722 72 C \nATOM 2492 CD2 LEU A 313 -1.417 -12.149 -10.811 1.00 69.84 C \nANISOU 2492 CD2 LEU A 313 8075 7775 10684 -1307 -667 90 C \nATOM 2493 N ALA A 314 0.479 -14.878 -7.167 1.00 79.97 N \nANISOU 2493 N ALA A 314 9482 9088 11812 -1503 -613 57 N \nATOM 2494 CA ALA A 314 0.368 -15.357 -5.805 1.00 80.29 C \nANISOU 2494 CA ALA A 314 9530 9153 11822 -1574 -639 65 C \nATOM 2495 C ALA A 314 -1.072 -15.176 -5.364 1.00 73.20 C \nANISOU 2495 C ALA A 314 8565 8280 10968 -1594 -722 97 C \nATOM 2496 O ALA A 314 -1.655 -14.119 -5.557 1.00 78.31 O \nANISOU 2496 O ALA A 314 9183 8930 11642 -1560 -760 123 O \nATOM 2497 CB ALA A 314 1.289 -14.575 -4.898 1.00 87.59 C \nANISOU 2497 CB ALA A 314 10501 10093 12687 -1580 -616 74 C \nATOM 2498 N THR A 315 -1.635 -16.212 -4.767 1.00 65.04 N \nANISOU 2498 N THR A 315 7511 7266 9937 -1649 -752 94 N \nATOM 2499 CA THR A 315 -2.955 -16.139 -4.143 1.00 66.47 C \nANISOU 2499 CA THR A 315 7634 7473 10148 -1669 -833 126 C \nATOM 2500 C THR A 315 -2.868 -16.345 -2.617 1.00 75.21 C \nANISOU 2500 C THR A 315 8754 8613 11208 -1741 -857 141 C \nATOM 2501 O THR A 315 -3.563 -15.697 -1.844 1.00 81.53 O \nANISOU 2501 O THR A 315 9532 9432 12013 -1754 -915 176 O \nATOM 2502 CB THR A 315 -3.900 -17.198 -4.749 1.00 66.01 C \nANISOU 2502 CB THR A 315 7523 7424 10133 -1666 -859 114 C \nATOM 2503 OG1 THR A 315 -3.354 -18.539 -4.607 1.00 58.20 O \nANISOU 2503 OG1 THR A 315 6553 6449 9111 -1720 -819 82 O \nATOM 2504 CG2 THR A 315 -4.124 -16.884 -6.233 1.00 62.63 C \nANISOU 2504 CG2 THR A 315 7078 6965 9753 -1593 -844 103 C \nATOM 2505 N GLY A 316 -2.011 -17.259 -2.195 1.00 76.41 N \nANISOU 2505 N GLY A 316 8947 8770 11313 -1792 -810 114 N \nATOM 2506 CA GLY A 316 -1.841 -17.550 -0.792 1.00 75.02 C \nANISOU 2506 CA GLY A 316 8789 8626 11090 -1864 -826 123 C \nATOM 2507 C GLY A 316 -0.740 -16.727 -0.148 1.00 76.34 C \nANISOU 2507 C GLY A 316 9017 8788 11203 -1868 -788 124 C \nATOM 2508 O GLY A 316 -0.398 -15.638 -0.639 1.00 72.64 O \nANISOU 2508 O GLY A 316 8557 8302 10738 -1810 -772 132 O \nATOM 2509 N LEU A 317 -0.148 -17.302 0.909 1.00 71.69 N \nANISOU 2509 N LEU A 317 8467 8215 10556 -1935 -770 113 N \nATOM 2510 CA LEU A 317 0.766 -16.611 1.809 1.00 77.13 C \nANISOU 2510 CA LEU A 317 9208 8912 11186 -1949 -745 117 C \nATOM 2511 C LEU A 317 2.235 -16.975 1.629 1.00 73.94 C \nANISOU 2511 C LEU A 317 8891 8476 10726 -1943 -659 77 C \nATOM 2512 O LEU A 317 2.551 -18.056 1.209 1.00 84.65 O \nANISOU 2512 O LEU A 317 10277 9810 12074 -1966 -623 47 O \nATOM 2513 CB LEU A 317 0.380 -16.920 3.252 1.00 79.26 C \nANISOU 2513 CB LEU A 317 9466 9224 11425 -2030 -789 135 C \nATOM 2514 CG LEU A 317 -1.114 -16.790 3.554 1.00 86.56 C \nANISOU 2514 CG LEU A 317 10313 10180 12398 -2042 -878 175 C \nATOM 2515 CD1 LEU A 317 -1.802 -18.154 3.610 1.00 83.12 C \nANISOU 2515 CD1 LEU A 317 9841 9765 11976 -2089 -903 165 C \nATOM 2516 CD2 LEU A 317 -1.323 -16.028 4.853 1.00 87.19 C \nANISOU 2516 CD2 LEU A 317 10387 10294 12446 -2080 -922 209 C \nATOM 2517 N ARG A 318 3.123 -16.063 1.986 1.00 69.22 N \nANISOU 2517 N ARG A 318 8335 7881 10084 -1914 -627 78 N \nATOM 2518 CA ARG A 318 4.538 -16.375 2.092 1.00 72.83 C \nANISOU 2518 CA ARG A 318 8886 8310 10475 -1909 -549 43 C \nATOM 2519 C ARG A 318 4.712 -17.658 2.889 1.00 81.37 C \nANISOU 2519 C ARG A 318 10009 9391 11518 -2000 -540 22 C \nATOM 2520 O ARG A 318 4.239 -17.752 4.013 1.00 79.30 O \nANISOU 2520 O ARG A 318 9722 9168 11240 -2065 -584 40 O \nATOM 2521 CB ARG A 318 5.303 -15.247 2.787 1.00 65.19 C \nANISOU 2521 CB ARG A 318 7947 7369 9455 -1881 -531 52 C \nATOM 2522 CG ARG A 318 5.546 -14.033 1.915 1.00 62.76 C \nANISOU 2522 CG ARG A 318 7621 7064 9162 -1788 -516 63 C \nATOM 2523 CD ARG A 318 6.312 -12.971 2.686 1.00 69.89 C \nANISOU 2523 CD ARG A 318 8544 8007 10002 -1766 -498 71 C \nATOM 2524 NE ARG A 318 6.345 -11.671 2.031 1.00 74.20 N \nANISOU 2524 NE ARG A 318 9053 8581 10560 -1693 -499 89 N \nATOM 2525 CZ ARG A 318 7.290 -11.258 1.199 1.00 78.41 C \nANISOU 2525 CZ ARG A 318 9620 9102 11069 -1610 -440 71 C \nATOM 2526 NH1 ARG A 318 8.322 -12.025 0.909 1.00 86.92 N \nANISOU 2526 NH1 ARG A 318 10781 10134 12111 -1583 -372 34 N \nATOM 2527 NH2 ARG A 318 7.213 -10.057 0.670 1.00 84.42 N \nANISOU 2527 NH2 ARG A 318 10336 9901 11838 -1554 -448 91 N \nATOM 2528 N ASN A 319 5.409 -18.637 2.319 1.00 92.31 N \nANISOU 2528 N ASN A 319 11460 10732 12881 -2009 -482 -16 N \nATOM 2529 CA ASN A 319 5.553 -19.952 2.963 1.00 94.55 C \nANISOU 2529 CA ASN A 319 11785 11015 13124 -2106 -471 -39 C \nATOM 2530 C ASN A 319 6.994 -20.443 2.984 1.00 97.22 C \nANISOU 2530 C ASN A 319 12251 11301 13388 -2112 -388 -79 C \nATOM 2531 O ASN A 319 7.410 -21.243 2.152 1.00 92.62 O \nANISOU 2531 O ASN A 319 11720 10673 12799 -2114 -344 -108 O \nATOM 2532 CB ASN A 319 4.664 -20.958 2.248 1.00 92.53 C \nANISOU 2532 CB ASN A 319 11476 10765 12917 -2139 -497 -43 C \nATOM 2533 CG ASN A 319 4.809 -22.352 2.794 1.00 85.87 C \nANISOU 2533 CG ASN A 319 10671 9930 12027 -2245 -484 -68 C \nATOM 2534 OD1 ASN A 319 5.005 -22.547 3.987 1.00 96.72 O \nANISOU 2534 OD1 ASN A 319 12071 11328 13352 -2312 -491 -67 O \nATOM 2535 ND2 ASN A 319 4.740 -23.336 1.910 1.00 80.13 N \nANISOU 2535 ND2 ASN A 319 9949 9185 11311 -2266 -462 -92 N \nATOM 2536 N SER A 320 7.769 -19.903 3.914 1.00111.03 N \nANISOU 2536 N SER A 320 14055 13055 15077 -2109 -367 -81 N \nATOM 2537 CA SER A 320 9.104 -20.433 4.189 1.00120.46 C \nANISOU 2537 CA SER A 320 15380 14200 16190 -2123 -292 -120 C \nATOM 2538 C SER A 320 9.050 -21.324 5.439 1.00121.97 C \nANISOU 2538 C SER A 320 15600 14413 16331 -2242 -305 -130 C \nATOM 2539 O SER A 320 8.342 -20.993 6.405 1.00113.15 O \nANISOU 2539 O SER A 320 14414 13355 15222 -2284 -362 -102 O \nATOM 2540 CB SER A 320 10.123 -19.303 4.371 1.00119.85 C \nANISOU 2540 CB SER A 320 15355 14115 16067 -2034 -251 -122 C \nATOM 2541 OG SER A 320 11.328 -19.800 4.931 1.00122.59 O \nANISOU 2541 OG SER A 320 15831 14421 16328 -2055 -188 -158 O \nATOM 2542 N PRO A 321 9.757 -22.474 5.405 1.00123.58 N \nANISOU 2542 N PRO A 321 15906 14569 16480 -2302 -253 -168 N \nATOM 2543 CA PRO A 321 10.000 -23.281 6.617 1.00129.03 C \nANISOU 2543 CA PRO A 321 16652 15272 17103 -2414 -249 -184 C \nATOM 2544 C PRO A 321 11.194 -22.747 7.424 1.00120.80 C \nANISOU 2544 C PRO A 321 15713 14204 15981 -2386 -200 -201 C \nATOM 2545 O PRO A 321 12.075 -23.506 7.823 1.00121.71 O \nANISOU 2545 O PRO A 321 15948 14274 16020 -2439 -149 -237 O \nATOM 2546 CB PRO A 321 10.261 -24.702 6.065 1.00127.10 C \nANISOU 2546 CB PRO A 321 16476 14983 16831 -2489 -211 -220 C \nATOM 2547 CG PRO A 321 9.904 -24.644 4.611 1.00132.97 C \nANISOU 2547 CG PRO A 321 17175 15706 17642 -2421 -210 -216 C \nATOM 2548 CD PRO A 321 10.121 -23.219 4.191 1.00127.32 C \nANISOU 2548 CD PRO A 321 16434 14983 16960 -2289 -207 -196 C \nTER 2549 PRO A 321 \nATOM 2550 N ILE B 10 4.358 -14.450 12.775 1.00 98.50 N \nANISOU 2550 N ILE B 10 12185 11944 13298 -1318 -779 -14 N \nATOM 2551 CA ILE B 10 5.510 -13.491 12.661 1.00 96.54 C \nANISOU 2551 CA ILE B 10 11963 11743 12975 -1172 -805 -52 C \nATOM 2552 C ILE B 10 6.870 -14.214 12.671 1.00109.89 C \nANISOU 2552 C ILE B 10 13864 13327 14561 -1085 -863 -78 C \nATOM 2553 O ILE B 10 7.793 -13.838 11.945 1.00131.03 O \nANISOU 2553 O ILE B 10 16628 15995 17163 -964 -896 -111 O \nATOM 2554 CB ILE B 10 5.458 -12.358 13.718 1.00 86.39 C \nANISOU 2554 CB ILE B 10 10547 10605 11672 -1118 -796 -66 C \nATOM 2555 CG1 ILE B 10 6.852 -12.063 14.305 1.00 81.91 C \nANISOU 2555 CG1 ILE B 10 10043 10096 10984 -945 -840 -116 C \nATOM 2556 CG2 ILE B 10 4.462 -12.694 14.809 1.00 85.96 C \nANISOU 2556 CG2 ILE B 10 10433 10548 11681 -1221 -777 -37 C \nATOM 2557 CD1 ILE B 10 6.961 -10.758 15.069 1.00 79.19 C \nANISOU 2557 CD1 ILE B 10 9534 9975 10580 -884 -831 -139 C \nATOM 2558 N GLU B 11 6.988 -15.259 13.476 1.00107.55 N \nANISOU 2558 N GLU B 11 13676 12945 14246 -1145 -886 -66 N \nATOM 2559 CA GLU B 11 8.180 -16.102 13.460 1.00105.55 C \nANISOU 2559 CA GLU B 11 13687 12545 13872 -1103 -959 -81 C \nATOM 2560 C GLU B 11 8.141 -17.085 12.287 1.00101.41 C \nANISOU 2560 C GLU B 11 13298 11908 13326 -1248 -973 -50 C \nATOM 2561 O GLU B 11 9.082 -17.862 12.091 1.00110.87 O \nANISOU 2561 O GLU B 11 14765 12958 14403 -1261 -1046 -53 O \nATOM 2562 CB GLU B 11 8.304 -16.846 14.793 1.00112.40 C \nANISOU 2562 CB GLU B 11 14632 13365 14709 -1143 -984 -74 C \nATOM 2563 CG GLU B 11 8.406 -15.948 16.020 1.00119.89 C \nANISOU 2563 CG GLU B 11 15457 14435 15661 -1007 -975 -105 C \nATOM 2564 CD GLU B 11 9.574 -14.969 15.979 1.00121.49 C \nANISOU 2564 CD GLU B 11 15705 14707 15749 -756 -1022 -170 C \nATOM 2565 OE1 GLU B 11 10.701 -15.373 16.363 1.00120.68 O \nANISOU 2565 OE1 GLU B 11 15834 14507 15512 -621 -1103 -207 O \nATOM 2566 OE2 GLU B 11 9.366 -13.787 15.595 1.00120.50 O \nANISOU 2566 OE2 GLU B 11 15391 14749 15644 -689 -985 -187 O \nATOM 2567 N GLY B 12 7.064 -17.031 11.500 1.00 97.18 N \nANISOU 2567 N GLY B 12 12595 11444 12886 -1357 -912 -23 N \nATOM 2568 CA GLY B 12 6.806 -17.975 10.420 1.00 99.41 C \nANISOU 2568 CA GLY B 12 12943 11679 13147 -1518 -912 9 C \nATOM 2569 C GLY B 12 5.369 -18.468 10.483 1.00103.90 C \nANISOU 2569 C GLY B 12 13316 12364 13799 -1663 -851 39 C \nATOM 2570 O GLY B 12 4.634 -18.143 11.421 1.00 99.47 O \nANISOU 2570 O GLY B 12 12609 11878 13306 -1637 -820 38 O \nATOM 2571 N GLY B 13 4.975 -19.255 9.483 1.00102.21 N \nANISOU 2571 N GLY B 13 13101 12177 13557 -1803 -842 62 N \nATOM 2572 CA GLY B 13 3.611 -19.799 9.397 1.00100.43 C \nANISOU 2572 CA GLY B 13 12684 12103 13371 -1906 -793 78 C \nATOM 2573 C GLY B 13 3.390 -21.087 10.187 1.00 94.76 C \nANISOU 2573 C GLY B 13 11978 11448 12580 -2069 -802 100 C \nATOM 2574 O GLY B 13 4.338 -21.762 10.572 1.00 90.46 O \nANISOU 2574 O GLY B 13 11632 10804 11936 -2161 -852 116 O \nATOM 2575 N TRP B 14 2.124 -21.414 10.437 1.00 97.22 N \nANISOU 2575 N TRP B 14 12091 11928 12921 -2096 -762 99 N \nATOM 2576 CA TRP B 14 1.749 -22.609 11.225 1.00 87.73 C \nANISOU 2576 CA TRP B 14 10848 10846 11641 -2243 -763 115 C \nATOM 2577 C TRP B 14 1.546 -23.792 10.289 1.00 87.49 C \nANISOU 2577 C TRP B 14 10791 10971 11479 -2447 -763 135 C \nATOM 2578 O TRP B 14 0.446 -23.979 9.735 1.00 80.42 O \nANISOU 2578 O TRP B 14 9697 10281 10577 -2430 -728 118 O \nATOM 2579 CB TRP B 14 0.416 -22.449 11.988 1.00 81.86 C \nANISOU 2579 CB TRP B 14 9895 10246 10961 -2150 -727 93 C \nATOM 2580 CG TRP B 14 0.228 -21.430 13.070 1.00 79.70 C \nANISOU 2580 CG TRP B 14 9600 9887 10794 -1993 -724 78 C \nATOM 2581 CD1 TRP B 14 -0.989 -20.858 13.474 1.00 78.23 C \nANISOU 2581 CD1 TRP B 14 9278 9772 10674 -1870 -706 56 C \nATOM 2582 CD2 TRP B 14 1.227 -20.871 13.919 1.00 81.77 C \nANISOU 2582 CD2 TRP B 14 9989 9994 11085 -1943 -746 81 C \nATOM 2583 NE1 TRP B 14 -0.774 -19.988 14.511 1.00 80.69 N \nANISOU 2583 NE1 TRP B 14 9625 9981 11055 -1787 -713 54 N \nATOM 2584 CE2 TRP B 14 0.571 -19.957 14.792 1.00 85.22 C \nANISOU 2584 CE2 TRP B 14 10334 10436 11608 -1820 -732 66 C \nATOM 2585 CE3 TRP B 14 2.619 -21.015 14.010 1.00 79.31 C \nANISOU 2585 CE3 TRP B 14 9877 9541 10714 -1975 -787 89 C \nATOM 2586 CZ2 TRP B 14 1.266 -19.206 15.739 1.00 83.85 C \nANISOU 2586 CZ2 TRP B 14 10221 10173 11464 -1746 -746 61 C \nATOM 2587 CZ3 TRP B 14 3.304 -20.264 14.949 1.00 81.65 C \nANISOU 2587 CZ3 TRP B 14 10241 9743 11038 -1857 -807 75 C \nATOM 2588 CH2 TRP B 14 2.632 -19.378 15.809 1.00 82.52 C \nANISOU 2588 CH2 TRP B 14 10216 9902 11237 -1753 -781 62 C \nATOM 2589 N GLN B 15 2.581 -24.610 10.134 1.00 88.03 N \nANISOU 2589 N GLN B 15 11071 10959 11417 -2642 -811 168 N \nATOM 2590 CA GLN B 15 2.447 -25.850 9.387 1.00 90.13 C \nANISOU 2590 CA GLN B 15 11323 11404 11517 -2903 -818 197 C \nATOM 2591 C GLN B 15 1.205 -26.628 9.849 1.00 89.56 C \nANISOU 2591 C GLN B 15 10983 11654 11393 -2968 -777 187 C \nATOM 2592 O GLN B 15 0.597 -27.381 9.069 1.00 83.33 O \nANISOU 2592 O GLN B 15 10044 11131 10485 -3100 -758 189 O \nATOM 2593 CB GLN B 15 3.697 -26.700 9.556 1.00 98.24 C \nANISOU 2593 CB GLN B 15 12663 12281 12381 -3140 -894 242 C \nATOM 2594 CG GLN B 15 3.749 -27.907 8.617 1.00101.74 C \nANISOU 2594 CG GLN B 15 13147 12892 12620 -3465 -915 284 C \nATOM 2595 CD GLN B 15 3.821 -27.567 7.119 1.00108.69 C \nANISOU 2595 CD GLN B 15 14031 13764 13501 -3450 -908 281 C \nATOM 2596 OE1 GLN B 15 4.231 -26.472 6.701 1.00100.38 O \nANISOU 2596 OE1 GLN B 15 13057 12505 12577 -3225 -910 256 O \nATOM 2597 NE2 GLN B 15 3.401 -28.523 6.298 1.00115.48 N \nANISOU 2597 NE2 GLN B 15 14788 14886 14201 -3699 -898 305 N \nATOM 2598 N GLY B 16 0.838 -26.429 11.118 1.00 86.77 N \nANISOU 2598 N GLY B 16 10563 11294 11110 -2860 -766 172 N \nATOM 2599 CA GLY B 16 -0.250 -27.140 11.746 1.00 85.33 C \nANISOU 2599 CA GLY B 16 10153 11398 10869 -2889 -737 155 C \nATOM 2600 C GLY B 16 -1.637 -26.569 11.534 1.00 93.01 C \nANISOU 2600 C GLY B 16 10879 12538 11923 -2648 -696 102 C \nATOM 2601 O GLY B 16 -2.608 -27.209 11.924 1.00 94.95 O \nANISOU 2601 O GLY B 16 10929 13059 12089 -2638 -681 76 O \nATOM 2602 N MET B 17 -1.765 -25.385 10.931 1.00 96.92 N \nANISOU 2602 N MET B 17 11393 12880 12553 -2447 -688 81 N \nATOM 2603 CA MET B 17 -3.093 -24.817 10.731 1.00 91.64 C \nANISOU 2603 CA MET B 17 10551 12332 11938 -2218 -669 30 C \nATOM 2604 C MET B 17 -3.630 -25.135 9.353 1.00 89.71 C \nANISOU 2604 C MET B 17 10190 12290 11608 -2222 -657 10 C \nATOM 2605 O MET B 17 -3.318 -24.467 8.374 1.00 95.64 O \nANISOU 2605 O MET B 17 11010 12910 12418 -2179 -656 14 O \nATOM 2606 CB MET B 17 -3.147 -23.316 10.959 1.00 94.86 C \nANISOU 2606 CB MET B 17 11038 12489 12515 -2008 -673 18 C \nATOM 2607 CG MET B 17 -4.587 -22.814 10.827 1.00 94.43 C \nANISOU 2607 CG MET B 17 10862 12537 12479 -1789 -676 -31 C \nATOM 2608 SD MET B 17 -4.898 -21.225 11.545 1.00 83.59 S \nANISOU 2608 SD MET B 17 9588 10917 11254 -1601 -696 -39 S \nATOM 2609 CE MET B 17 -3.685 -20.281 10.611 1.00 93.12 C \nANISOU 2609 CE MET B 17 10926 11911 12545 -1650 -688 -7 C \nATOM 2610 N VAL B 18 -4.460 -26.156 9.302 1.00 97.10 N \nANISOU 2610 N VAL B 18 10932 13572 12390 -2262 -649 -16 N \nATOM 2611 CA VAL B 18 -5.032 -26.669 8.063 1.00106.11 C \nANISOU 2611 CA VAL B 18 11920 14997 13402 -2276 -639 -43 C \nATOM 2612 C VAL B 18 -6.437 -26.097 7.841 1.00111.64 C \nANISOU 2612 C VAL B 18 12485 15813 14118 -1952 -645 -117 C \nATOM 2613 O VAL B 18 -7.006 -26.231 6.761 1.00127.41 O \nANISOU 2613 O VAL B 18 14372 18007 16033 -1879 -643 -152 O \nATOM 2614 CB VAL B 18 -5.106 -28.226 8.102 1.00108.80 C \nANISOU 2614 CB VAL B 18 12103 15731 13505 -2530 -632 -34 C \nATOM 2615 CG1 VAL B 18 -3.741 -28.815 8.462 1.00106.16 C \nANISOU 2615 CG1 VAL B 18 11966 15242 13126 -2865 -647 43 C \nATOM 2616 CG2 VAL B 18 -6.170 -28.719 9.085 1.00105.72 C \nANISOU 2616 CG2 VAL B 18 11517 15620 13030 -2402 -632 -85 C \nATOM 2617 N ASP B 19 -6.985 -25.470 8.874 1.00110.47 N \nANISOU 2617 N ASP B 19 12373 15538 14062 -1757 -663 -141 N \nATOM 2618 CA ASP B 19 -8.379 -25.013 8.898 1.00114.42 C \nANISOU 2618 CA ASP B 19 12803 16131 14542 -1443 -693 -215 C \nATOM 2619 C ASP B 19 -8.641 -23.722 8.078 1.00119.32 C \nANISOU 2619 C ASP B 19 13552 16509 15276 -1263 -715 -227 C \nATOM 2620 O ASP B 19 -9.786 -23.413 7.719 1.00110.14 O \nANISOU 2620 O ASP B 19 12363 15431 14057 -1011 -754 -290 O \nATOM 2621 CB ASP B 19 -8.801 -24.769 10.361 1.00121.88 C \nANISOU 2621 CB ASP B 19 13789 16984 15534 -1331 -716 -227 C \nATOM 2622 CG ASP B 19 -8.740 -26.033 11.213 1.00123.38 C \nANISOU 2622 CG ASP B 19 13839 17442 15596 -1476 -700 -225 C \nATOM 2623 OD1 ASP B 19 -8.645 -27.140 10.636 1.00130.80 O \nANISOU 2623 OD1 ASP B 19 14620 18708 16371 -1638 -679 -226 O \nATOM 2624 OD2 ASP B 19 -8.796 -25.908 12.458 1.00120.99 O \nANISOU 2624 OD2 ASP B 19 13585 17038 15346 -1445 -711 -220 O \nATOM 2625 N GLY B 20 -7.588 -22.954 7.799 1.00112.74 N \nANISOU 2625 N GLY B 20 12872 15379 14584 -1381 -699 -171 N \nATOM 2626 CA GLY B 20 -7.747 -21.660 7.132 1.00101.22 C \nANISOU 2626 CA GLY B 20 11538 13690 13230 -1246 -719 -174 C \nATOM 2627 C GLY B 20 -6.444 -20.947 6.824 1.00 94.23 C \nANISOU 2627 C GLY B 20 10789 12545 12471 -1390 -697 -116 C \nATOM 2628 O GLY B 20 -5.362 -21.531 6.932 1.00 93.10 O \nANISOU 2628 O GLY B 20 10665 12389 12322 -1586 -673 -75 O \nATOM 2629 N TRP B 21 -6.553 -19.670 6.469 1.00 85.18 N \nANISOU 2629 N TRP B 21 9754 11194 11418 -1287 -716 -114 N \nATOM 2630 CA TRP B 21 -5.372 -18.864 6.121 1.00 88.66 C \nANISOU 2630 CA TRP B 21 10304 11423 11959 -1383 -700 -70 C \nATOM 2631 C TRP B 21 -4.789 -18.140 7.309 1.00 77.47 C \nANISOU 2631 C TRP B 21 8977 9832 10625 -1408 -704 -44 C \nATOM 2632 O TRP B 21 -3.578 -18.072 7.458 1.00 69.48 O \nANISOU 2632 O TRP B 21 8023 8728 9648 -1510 -689 -14 O \nATOM 2633 CB TRP B 21 -5.708 -17.848 5.027 1.00100.63 C \nANISOU 2633 CB TRP B 21 11875 12850 13511 -1288 -714 -80 C \nATOM 2634 CG TRP B 21 -5.663 -18.407 3.627 1.00111.53 C \nANISOU 2634 CG TRP B 21 13189 14353 14832 -1316 -698 -90 C \nATOM 2635 CD1 TRP B 21 -5.417 -19.695 3.259 1.00116.05 C \nANISOU 2635 CD1 TRP B 21 13660 15126 15309 -1432 -674 -90 C \nATOM 2636 CD2 TRP B 21 -5.903 -17.688 2.421 1.00114.58 C \nANISOU 2636 CD2 TRP B 21 13612 14687 15237 -1244 -707 -100 C \nATOM 2637 NE1 TRP B 21 -5.468 -19.817 1.902 1.00118.04 N \nANISOU 2637 NE1 TRP B 21 13874 15456 15519 -1436 -666 -99 N \nATOM 2638 CE2 TRP B 21 -5.773 -18.598 1.361 1.00114.79 C \nANISOU 2638 CE2 TRP B 21 13546 14885 15185 -1307 -685 -108 C \nATOM 2639 CE3 TRP B 21 -6.216 -16.354 2.132 1.00119.86 C \nANISOU 2639 CE3 TRP B 21 14388 15188 15967 -1153 -735 -99 C \nATOM 2640 CZ2 TRP B 21 -5.945 -18.223 0.029 1.00123.21 C \nANISOU 2640 CZ2 TRP B 21 14616 15951 16247 -1257 -686 -119 C \nATOM 2641 CZ3 TRP B 21 -6.385 -15.978 0.801 1.00123.94 C \nANISOU 2641 CZ3 TRP B 21 14918 15698 16476 -1110 -739 -109 C \nATOM 2642 CH2 TRP B 21 -6.245 -16.911 -0.232 1.00120.36 C \nANISOU 2642 CH2 TRP B 21 14364 15408 15959 -1149 -713 -121 C \nATOM 2643 N TYR B 22 -5.664 -17.581 8.133 1.00 75.47 N \nANISOU 2643 N TYR B 22 8751 9539 10385 -1302 -735 -59 N \nATOM 2644 CA TYR B 22 -5.240 -16.951 9.368 1.00 74.67 C \nANISOU 2644 CA TYR B 22 8714 9315 10341 -1333 -740 -36 C \nATOM 2645 C TYR B 22 -5.980 -17.555 10.537 1.00 73.58 C \nANISOU 2645 C TYR B 22 8540 9254 10165 -1290 -757 -53 C \nATOM 2646 O TYR B 22 -7.097 -18.064 10.380 1.00 77.57 O \nANISOU 2646 O TYR B 22 8996 9882 10595 -1179 -781 -92 O \nATOM 2647 CB TYR B 22 -5.535 -15.464 9.346 1.00 80.65 C \nANISOU 2647 CB TYR B 22 9571 9932 11140 -1286 -771 -27 C \nATOM 2648 CG TYR B 22 -5.420 -14.815 7.993 1.00 78.65 C \nANISOU 2648 CG TYR B 22 9348 9639 10897 -1276 -770 -25 C \nATOM 2649 CD1 TYR B 22 -6.541 -14.315 7.348 1.00 72.31 C \nANISOU 2649 CD1 TYR B 22 8605 8812 10056 -1176 -814 -45 C \nATOM 2650 CD2 TYR B 22 -4.175 -14.670 7.378 1.00 72.99 C \nANISOU 2650 CD2 TYR B 22 8623 8896 10215 -1354 -736 -5 C \nATOM 2651 CE1 TYR B 22 -6.433 -13.696 6.122 1.00 71.02 C \nANISOU 2651 CE1 TYR B 22 8475 8607 9902 -1174 -815 -42 C \nATOM 2652 CE2 TYR B 22 -4.056 -14.039 6.157 1.00 69.17 C \nANISOU 2652 CE2 TYR B 22 8163 8378 9740 -1343 -736 -4 C \nATOM 2653 CZ TYR B 22 -5.189 -13.560 5.526 1.00 68.58 C \nANISOU 2653 CZ TYR B 22 8129 8288 9639 -1263 -770 -20 C \nATOM 2654 OH TYR B 22 -5.065 -12.969 4.287 1.00 58.31 O \nANISOU 2654 OH TYR B 22 6854 6956 8346 -1259 -770 -18 O \nATOM 2655 N GLY B 23 -5.358 -17.491 11.710 1.00 67.41 N \nANISOU 2655 N GLY B 23 7780 8411 9421 -1357 -749 -30 N \nATOM 2656 CA GLY B 23 -5.993 -18.001 12.916 1.00 67.35 C \nANISOU 2656 CA GLY B 23 7745 8463 9383 -1322 -764 -43 C \nATOM 2657 C GLY B 23 -5.143 -17.956 14.149 1.00 65.58 C \nANISOU 2657 C GLY B 23 7545 8172 9202 -1407 -751 -16 C \nATOM 2658 O GLY B 23 -4.189 -17.176 14.238 1.00 57.40 O \nANISOU 2658 O GLY B 23 6565 7026 8217 -1456 -742 8 O \nATOM 2659 N TYR B 24 -5.460 -18.832 15.095 1.00 72.70 N \nANISOU 2659 N TYR B 24 8394 9163 10065 -1413 -751 -25 N \nATOM 2660 CA TYR B 24 -4.852 -18.767 16.436 1.00 73.56 C \nANISOU 2660 CA TYR B 24 8533 9208 10209 -1471 -747 -5 C \nATOM 2661 C TYR B 24 -4.198 -20.067 16.846 1.00 71.66 C \nANISOU 2661 C TYR B 24 8249 9057 9923 -1583 -726 5 C \nATOM 2662 O TYR B 24 -4.421 -21.112 16.234 1.00 85.61 O \nANISOU 2662 O TYR B 24 9940 10976 11612 -1631 -717 -6 O \nATOM 2663 CB TYR B 24 -5.912 -18.422 17.464 1.00 73.51 C \nANISOU 2663 CB TYR B 24 8543 9190 10196 -1381 -781 -19 C \nATOM 2664 CG TYR B 24 -6.800 -17.255 17.077 1.00 78.55 C \nANISOU 2664 CG TYR B 24 9273 9737 10835 -1286 -825 -28 C \nATOM 2665 CD1 TYR B 24 -7.976 -17.459 16.349 1.00 77.93 C \nANISOU 2665 CD1 TYR B 24 9201 9721 10689 -1155 -860 -66 C \nATOM 2666 CD2 TYR B 24 -6.469 -15.947 17.443 1.00 78.26 C \nANISOU 2666 CD2 TYR B 24 9326 9569 10840 -1333 -839 1 C \nATOM 2667 CE1 TYR B 24 -8.808 -16.399 16.014 1.00 75.74 C \nANISOU 2667 CE1 TYR B 24 9061 9327 10389 -1072 -919 -73 C \nATOM 2668 CE2 TYR B 24 -7.287 -14.883 17.113 1.00 80.81 C \nANISOU 2668 CE2 TYR B 24 9765 9802 11136 -1292 -890 2 C \nATOM 2669 CZ TYR B 24 -8.462 -15.116 16.397 1.00 84.60 C \nANISOU 2669 CZ TYR B 24 10295 10298 11553 -1161 -935 -34 C \nATOM 2670 OH TYR B 24 -9.297 -14.080 16.046 1.00 95.24 O \nANISOU 2670 OH TYR B 24 11810 11527 12851 -1121 -1004 -33 O \nATOM 2671 N HIS B 25 -3.368 -19.985 17.870 1.00 64.47 N \nANISOU 2671 N HIS B 25 7391 8063 9041 -1638 -725 25 N \nATOM 2672 CA HIS B 25 -2.875 -21.141 18.552 1.00 62.42 C \nANISOU 2672 CA HIS B 25 7125 7863 8727 -1747 -720 36 C \nATOM 2673 C HIS B 25 -2.822 -20.836 20.019 1.00 64.92 C \nANISOU 2673 C HIS B 25 7464 8121 9081 -1722 -728 40 C \nATOM 2674 O HIS B 25 -2.073 -19.954 20.446 1.00 67.87 O \nANISOU 2674 O HIS B 25 7910 8374 9504 -1700 -734 51 O \nATOM 2675 CB HIS B 25 -1.487 -21.559 18.103 1.00 66.88 C \nANISOU 2675 CB HIS B 25 7797 8357 9259 -1867 -722 60 C \nATOM 2676 CG HIS B 25 -0.971 -22.753 18.854 1.00 79.24 C \nANISOU 2676 CG HIS B 25 9403 9961 10744 -2008 -732 77 C \nATOM 2677 ND1 HIS B 25 -1.612 -23.976 18.851 1.00 89.42 N \nANISOU 2677 ND1 HIS B 25 10590 11448 11935 -2114 -724 76 N \nATOM 2678 CD2 HIS B 25 0.102 -22.894 19.667 1.00 82.86 C \nANISOU 2678 CD2 HIS B 25 9997 10300 11186 -2060 -755 93 C \nATOM 2679 CE1 HIS B 25 -0.939 -24.825 19.605 1.00 93.90 C \nANISOU 2679 CE1 HIS B 25 11237 12008 12433 -2259 -741 100 C \nATOM 2680 NE2 HIS B 25 0.110 -24.193 20.106 1.00 91.00 N \nANISOU 2680 NE2 HIS B 25 11031 11428 12116 -2220 -763 110 N \nATOM 2681 N HIS B 26 -3.602 -21.577 20.799 1.00 65.45 N \nANISOU 2681 N HIS B 26 7457 8302 9108 -1721 -731 29 N \nATOM 2682 CA HIS B 26 -3.591 -21.428 22.247 1.00 67.88 C \nANISOU 2682 CA HIS B 26 7783 8565 9444 -1708 -739 34 C \nATOM 2683 C HIS B 26 -2.845 -22.574 22.938 1.00 71.61 C \nANISOU 2683 C HIS B 26 8273 9077 9860 -1841 -736 51 C \nATOM 2684 O HIS B 26 -2.710 -23.675 22.421 1.00 72.38 O \nANISOU 2684 O HIS B 26 8344 9289 9869 -1957 -731 56 O \nATOM 2685 CB HIS B 26 -5.031 -21.318 22.777 1.00 71.12 C \nANISOU 2685 CB HIS B 26 8130 9049 9843 -1591 -757 6 C \nATOM 2686 CG HIS B 26 -5.763 -22.621 22.834 1.00 77.58 C \nANISOU 2686 CG HIS B 26 8833 10081 10562 -1597 -755 -19 C \nATOM 2687 ND1 HIS B 26 -6.356 -23.187 21.730 1.00 78.30 N \nANISOU 2687 ND1 HIS B 26 8836 10342 10574 -1567 -752 -45 N \nATOM 2688 CD2 HIS B 26 -5.999 -23.472 23.865 1.00 82.42 C \nANISOU 2688 CD2 HIS B 26 9386 10805 11124 -1628 -755 -24 C \nATOM 2689 CE1 HIS B 26 -6.915 -24.338 22.071 1.00 85.02 C \nANISOU 2689 CE1 HIS B 26 9563 11427 11315 -1581 -750 -69 C \nATOM 2690 NE2 HIS B 26 -6.721 -24.530 23.364 1.00 80.88 N \nANISOU 2690 NE2 HIS B 26 9056 10867 10809 -1621 -752 -56 N \nATOM 2691 N SER B 27 -2.368 -22.291 24.127 1.00 73.46 N \nANISOU 2691 N SER B 27 8561 9222 10128 -1837 -743 60 N \nATOM 2692 CA SER B 27 -1.873 -23.323 24.991 1.00 74.30 C \nANISOU 2692 CA SER B 27 8696 9359 10176 -1949 -749 74 C \nATOM 2693 C SER B 27 -2.248 -22.944 26.426 1.00 71.58 C \nANISOU 2693 C SER B 27 8329 8990 9878 -1882 -754 69 C \nATOM 2694 O SER B 27 -2.044 -21.808 26.849 1.00 68.20 O \nANISOU 2694 O SER B 27 7938 8458 9517 -1799 -759 68 O \nATOM 2695 CB SER B 27 -0.365 -23.515 24.815 1.00 71.04 C \nANISOU 2695 CB SER B 27 8449 8816 9727 -2036 -770 95 C \nATOM 2696 OG SER B 27 0.353 -22.421 25.348 1.00 78.57 O \nANISOU 2696 OG SER B 27 9479 9633 10740 -1929 -782 89 O \nATOM 2697 N ASN B 28 -2.820 -23.904 27.151 1.00 70.71 N \nANISOU 2697 N ASN B 28 8148 9004 9715 -1928 -752 65 N \nATOM 2698 CA ASN B 28 -3.231 -23.700 28.539 1.00 69.33 C \nANISOU 2698 CA ASN B 28 7953 8817 9573 -1874 -759 60 C \nATOM 2699 C ASN B 28 -3.214 -25.018 29.317 1.00 67.05 C \nANISOU 2699 C ASN B 28 7628 8647 9202 -1989 -759 66 C \nATOM 2700 O ASN B 28 -2.754 -26.020 28.795 1.00 68.41 O \nANISOU 2700 O ASN B 28 7811 8898 9282 -2137 -758 81 O \nATOM 2701 CB ASN B 28 -4.612 -23.032 28.601 1.00 71.75 C \nANISOU 2701 CB ASN B 28 8192 9161 9907 -1726 -768 33 C \nATOM 2702 CG ASN B 28 -5.705 -23.876 27.966 1.00 72.41 C \nANISOU 2702 CG ASN B 28 8162 9447 9905 -1684 -770 1 C \nATOM 2703 OD1 ASN B 28 -5.445 -24.942 27.414 1.00 72.76 O \nANISOU 2703 OD1 ASN B 28 8144 9635 9865 -1794 -754 4 O \nATOM 2704 ND2 ASN B 28 -6.936 -23.390 28.028 1.00 67.60 N \nANISOU 2704 ND2 ASN B 28 7535 8860 9288 -1524 -797 -32 N \nATOM 2705 N GLU B 29 -3.677 -24.995 30.570 1.00 62.94 N \nANISOU 2705 N GLU B 29 7075 8139 8701 -1941 -764 59 N \nATOM 2706 CA GLU B 29 -3.741 -26.192 31.435 1.00 69.03 C \nANISOU 2706 CA GLU B 29 7800 9037 9392 -2046 -764 64 C \nATOM 2707 C GLU B 29 -4.578 -27.344 30.793 1.00 69.58 C \nANISOU 2707 C GLU B 29 7718 9385 9333 -2101 -755 44 C \nATOM 2708 O GLU B 29 -4.225 -28.501 30.936 1.00 70.89 O \nANISOU 2708 O GLU B 29 7863 9683 9388 -2281 -754 61 O \nATOM 2709 CB GLU B 29 -4.238 -25.831 32.862 1.00 67.89 C \nANISOU 2709 CB GLU B 29 7639 8861 9296 -1956 -772 54 C \nATOM 2710 CG GLU B 29 -5.603 -25.111 32.875 1.00 80.65 C \nANISOU 2710 CG GLU B 29 9193 10510 10942 -1773 -784 20 C \nATOM 2711 CD GLU B 29 -5.582 -23.562 32.601 1.00 84.08 C \nANISOU 2711 CD GLU B 29 9717 10759 11470 -1679 -796 25 C \nATOM 2712 OE1 GLU B 29 -4.556 -22.851 32.757 1.00 70.69 O \nANISOU 2712 OE1 GLU B 29 8101 8927 9831 -1720 -791 49 O \nATOM 2713 OE2 GLU B 29 -6.638 -23.023 32.220 1.00 90.59 O \nANISOU 2713 OE2 GLU B 29 10539 11592 12288 -1558 -819 2 O \nATOM 2714 N GLN B 30 -5.615 -26.997 30.030 1.00 70.60 N \nANISOU 2714 N GLN B 30 7755 9612 9459 -1954 -755 8 N \nATOM 2715 CA GLN B 30 -6.437 -27.963 29.304 1.00 71.80 C \nANISOU 2715 CA GLN B 30 7742 10069 9470 -1960 -749 -25 C \nATOM 2716 C GLN B 30 -5.744 -28.489 28.023 1.00 82.63 C \nANISOU 2716 C GLN B 30 9119 11506 10772 -2133 -736 -1 C \nATOM 2717 O GLN B 30 -6.326 -29.313 27.290 1.00 79.12 O \nANISOU 2717 O GLN B 30 8522 11352 10189 -2168 -728 -25 O \nATOM 2718 CB GLN B 30 -7.817 -27.381 28.952 1.00 74.22 C \nANISOU 2718 CB GLN B 30 7979 10448 9773 -1699 -770 -82 C \nATOM 2719 CG GLN B 30 -8.695 -27.058 30.154 1.00 88.27 C \nANISOU 2719 CG GLN B 30 9765 12205 11570 -1530 -800 -112 C \nATOM 2720 CD GLN B 30 -8.492 -25.647 30.704 1.00101.23 C \nANISOU 2720 CD GLN B 30 11579 13524 13360 -1460 -819 -90 C \nATOM 2721 OE1 GLN B 30 -7.553 -24.935 30.329 1.00113.12 O \nANISOU 2721 OE1 GLN B 30 13183 14838 14959 -1543 -804 -51 O \nATOM 2722 NE2 GLN B 30 -9.377 -25.236 31.599 1.00106.08 N \nANISOU 2722 NE2 GLN B 30 12232 14098 13974 -1310 -857 -115 N \nATOM 2723 N GLY B 31 -4.494 -28.079 27.774 1.00 88.84 N \nANISOU 2723 N GLY B 31 10080 12048 11627 -2241 -738 43 N \nATOM 2724 CA GLY B 31 -3.763 -28.482 26.557 1.00 88.40 C \nANISOU 2724 CA GLY B 31 10080 12004 11504 -2403 -737 68 C \nATOM 2725 C GLY B 31 -3.649 -27.352 25.534 1.00 85.79 C \nANISOU 2725 C GLY B 31 9810 11508 11278 -2272 -733 61 C \nATOM 2726 O GLY B 31 -3.537 -26.197 25.891 1.00 87.55 O \nANISOU 2726 O GLY B 31 10107 11527 11629 -2129 -738 57 O \nATOM 2727 N SER B 32 -3.667 -27.711 24.255 1.00 84.37 N \nANISOU 2727 N SER B 32 9591 11441 11026 -2342 -727 61 N \nATOM 2728 CA SER B 32 -3.348 -26.801 23.181 1.00 75.56 C \nANISOU 2728 CA SER B 32 8550 10170 9989 -2266 -725 62 C \nATOM 2729 C SER B 32 -4.193 -27.076 21.943 1.00 79.42 C \nANISOU 2729 C SER B 32 8895 10876 10404 -2228 -712 33 C \nATOM 2730 O SER B 32 -4.942 -28.054 21.893 1.00 73.28 O \nANISOU 2730 O SER B 32 7951 10400 9492 -2271 -706 11 O \nATOM 2731 CB SER B 32 -1.865 -26.903 22.833 1.00 70.82 C \nANISOU 2731 CB SER B 32 8154 9381 9372 -2427 -744 105 C \nATOM 2732 OG SER B 32 -1.586 -28.025 22.062 1.00 71.92 O \nANISOU 2732 OG SER B 32 8297 9670 9359 -2650 -751 127 O \nATOM 2733 N GLY B 33 -4.097 -26.179 20.962 1.00 81.60 N \nANISOU 2733 N GLY B 33 9224 11023 10759 -2134 -710 29 N \nATOM 2734 CA GLY B 33 -4.844 -26.332 19.716 1.00 82.94 C \nANISOU 2734 CA GLY B 33 9275 11376 10865 -2079 -702 -1 C \nATOM 2735 C GLY B 33 -4.778 -25.158 18.750 1.00 81.83 C \nANISOU 2735 C GLY B 33 9208 11055 10828 -1955 -703 -5 C \nATOM 2736 O GLY B 33 -4.510 -24.034 19.150 1.00 82.18 O \nANISOU 2736 O GLY B 33 9359 10869 10997 -1860 -711 2 O \nATOM 2737 N TYR B 34 -5.014 -25.438 17.468 1.00 83.49 N \nANISOU 2737 N TYR B 34 9352 11400 10971 -1972 -695 -17 N \nATOM 2738 CA TYR B 34 -5.136 -24.407 16.433 1.00 82.30 C \nANISOU 2738 CA TYR B 34 9248 11121 10900 -1847 -697 -28 C \nATOM 2739 C TYR B 34 -6.598 -24.063 16.168 1.00 82.13 C \nANISOU 2739 C TYR B 34 9130 11222 10855 -1617 -715 -85 C \nATOM 2740 O TYR B 34 -7.493 -24.837 16.462 1.00 80.65 O \nANISOU 2740 O TYR B 34 8806 11283 10553 -1552 -723 -125 O \nATOM 2741 CB TYR B 34 -4.505 -24.860 15.125 1.00 80.80 C \nANISOU 2741 CB TYR B 34 9068 10984 10647 -1992 -685 -8 C \nATOM 2742 CG TYR B 34 -3.014 -25.142 15.189 1.00 80.54 C \nANISOU 2742 CG TYR B 34 9202 10790 10611 -2200 -691 44 C \nATOM 2743 CD1 TYR B 34 -2.536 -26.440 15.395 1.00 71.48 C \nANISOU 2743 CD1 TYR B 34 8061 9777 9319 -2441 -697 73 C \nATOM 2744 CD2 TYR B 34 -2.075 -24.116 15.025 1.00 74.21 C \nANISOU 2744 CD2 TYR B 34 8567 9710 9918 -2155 -701 62 C \nATOM 2745 CE1 TYR B 34 -1.175 -26.697 15.465 1.00 71.56 C \nANISOU 2745 CE1 TYR B 34 8289 9602 9300 -2621 -725 119 C \nATOM 2746 CE2 TYR B 34 -0.712 -24.379 15.090 1.00 73.18 C \nANISOU 2746 CE2 TYR B 34 8624 9426 9756 -2297 -724 98 C \nATOM 2747 CZ TYR B 34 -0.271 -25.665 15.315 1.00 74.34 C \nANISOU 2747 CZ TYR B 34 8821 9662 9762 -2525 -742 126 C \nATOM 2748 OH TYR B 34 1.075 -25.911 15.374 1.00 80.30 O \nANISOU 2748 OH TYR B 34 9823 10227 10461 -2654 -786 160 O \nATOM 2749 N ALA B 35 -6.824 -22.879 15.619 1.00 86.51 N \nANISOU 2749 N ALA B 35 9772 11600 11498 -1485 -730 -92 N \nATOM 2750 CA ALA B 35 -8.170 -22.395 15.350 1.00 91.39 C \nANISOU 2750 CA ALA B 35 10376 12266 12084 -1253 -768 -145 C \nATOM 2751 C ALA B 35 -8.115 -21.244 14.355 1.00 90.70 C \nANISOU 2751 C ALA B 35 10397 11995 12070 -1193 -781 -138 C \nATOM 2752 O ALA B 35 -7.568 -20.199 14.651 1.00 88.12 O \nANISOU 2752 O ALA B 35 10194 11438 11850 -1226 -783 -104 O \nATOM 2753 CB ALA B 35 -8.833 -21.947 16.643 1.00 93.20 C \nANISOU 2753 CB ALA B 35 10669 12408 12336 -1134 -805 -159 C \nATOM 2754 N ALA B 36 -8.661 -21.457 13.166 1.00100.81 N \nANISOU 2754 N ALA B 36 11617 13408 13277 -1112 -787 -171 N \nATOM 2755 CA ALA B 36 -8.621 -20.446 12.109 1.00104.68 C \nANISOU 2755 CA ALA B 36 12204 13743 13825 -1064 -799 -165 C \nATOM 2756 C ALA B 36 -9.735 -19.423 12.271 1.00104.40 C \nANISOU 2756 C ALA B 36 12305 13577 13787 -863 -867 -196 C \nATOM 2757 O ALA B 36 -10.811 -19.748 12.773 1.00106.63 O \nANISOU 2757 O ALA B 36 12581 13959 13973 -695 -914 -245 O \nATOM 2758 CB ALA B 36 -8.713 -21.110 10.744 1.00109.00 C \nANISOU 2758 CB ALA B 36 12640 14486 14288 -1069 -781 -187 C \nATOM 2759 N ASP B 37 -9.475 -18.188 11.850 1.00101.55 N \nANISOU 2759 N ASP B 37 12085 12995 13506 -884 -881 -167 N \nATOM 2760 CA ASP B 37 -10.506 -17.166 11.858 1.00105.12 C \nANISOU 2760 CA ASP B 37 12714 13300 13925 -736 -960 -186 C \nATOM 2761 C ASP B 37 -11.355 -17.306 10.594 1.00111.68 C \nANISOU 2761 C ASP B 37 13549 14222 14663 -567 -997 -238 C \nATOM 2762 O ASP B 37 -10.842 -17.242 9.479 1.00120.49 O \nANISOU 2762 O ASP B 37 14617 15354 15809 -629 -961 -225 O \nATOM 2763 CB ASP B 37 -9.882 -15.786 11.942 1.00104.54 C \nANISOU 2763 CB ASP B 37 12779 12995 13945 -863 -964 -130 C \nATOM 2764 CG ASP B 37 -10.867 -14.731 12.347 1.00107.99 C \nANISOU 2764 CG ASP B 37 13439 13262 14330 -786 -1056 -134 C \nATOM 2765 OD1 ASP B 37 -12.073 -14.872 12.056 1.00113.31 O \nANISOU 2765 OD1 ASP B 37 14211 13949 14894 -590 -1131 -186 O \nATOM 2766 OD2 ASP B 37 -10.428 -13.747 12.959 1.00114.80 O \nANISOU 2766 OD2 ASP B 37 14393 13988 15238 -922 -1061 -86 O \nATOM 2767 N LYS B 38 -12.658 -17.483 10.779 1.00104.59 N \nANISOU 2767 N LYS B 38 12720 13381 13637 -335 -1076 -302 N \nATOM 2768 CA LYS B 38 -13.565 -17.738 9.671 1.00102.36 C \nANISOU 2768 CA LYS B 38 12436 13227 13230 -119 -1123 -369 C \nATOM 2769 C LYS B 38 -13.757 -16.514 8.811 1.00100.41 C \nANISOU 2769 C LYS B 38 12400 12746 13003 -100 -1174 -352 C \nATOM 2770 O LYS B 38 -13.686 -16.591 7.585 1.00 92.28 O \nANISOU 2770 O LYS B 38 11315 11788 11960 -74 -1157 -366 O \nATOM 2771 CB LYS B 38 -14.925 -18.183 10.204 1.00108.44 C \nANISOU 2771 CB LYS B 38 13260 14113 13829 172 -1214 -453 C \nATOM 2772 CG LYS B 38 -15.947 -18.527 9.133 1.00112.09 C \nANISOU 2772 CG LYS B 38 13716 14754 14121 457 -1277 -542 C \nATOM 2773 CD LYS B 38 -17.191 -19.158 9.711 1.00110.79 C \nANISOU 2773 CD LYS B 38 13564 14775 13757 778 -1364 -640 C \nATOM 2774 CE LYS B 38 -18.011 -19.812 8.629 1.00112.25 C \nANISOU 2774 CE LYS B 38 13636 15264 13748 1061 -1403 -740 C \nATOM 2775 NZ LYS B 38 -19.293 -20.363 9.134 1.00115.45 N \nANISOU 2775 NZ LYS B 38 14070 15874 13922 1440 -1506 -853 N \nATOM 2776 N GLU B 39 -14.022 -15.389 9.470 1.00100.43 N \nANISOU 2776 N GLU B 39 12654 12482 13025 -131 -1241 -321 N \nATOM 2777 CA GLU B 39 -14.301 -14.140 8.775 1.00 97.99 C \nANISOU 2777 CA GLU B 39 12586 11941 12703 -142 -1308 -299 C \nATOM 2778 C GLU B 39 -13.066 -13.685 8.009 1.00 98.02 C \nANISOU 2778 C GLU B 39 12485 11915 12843 -371 -1218 -237 C \nATOM 2779 O GLU B 39 -13.136 -13.410 6.815 1.00 96.72 O \nANISOU 2779 O GLU B 39 12346 11738 12664 -337 -1225 -246 O \nATOM 2780 CB GLU B 39 -14.754 -13.046 9.755 1.00 96.52 C \nANISOU 2780 CB GLU B 39 12692 11497 12484 -197 -1399 -266 C \nATOM 2781 CG GLU B 39 -15.047 -11.710 9.079 1.00103.45 C \nANISOU 2781 CG GLU B 39 13848 12140 13319 -261 -1479 -234 C \nATOM 2782 CD GLU B 39 -15.671 -10.668 9.993 1.00105.10 C \nANISOU 2782 CD GLU B 39 14394 12102 13438 -330 -1595 -202 C \nATOM 2783 OE1 GLU B 39 -16.128 -11.025 11.099 1.00112.11 O \nANISOU 2783 OE1 GLU B 39 15335 12984 14276 -254 -1634 -221 O \nATOM 2784 OE2 GLU B 39 -15.705 -9.475 9.602 1.00101.29 O \nANISOU 2784 OE2 GLU B 39 14132 11435 12919 -481 -1651 -153 O \nATOM 2785 N SER B 40 -11.936 -13.635 8.706 1.00 96.83 N \nANISOU 2785 N SER B 40 12220 11760 12810 -583 -1139 -181 N \nATOM 2786 CA SER B 40 -10.700 -13.111 8.148 1.00 93.02 C \nANISOU 2786 CA SER B 40 11664 11243 12438 -777 -1066 -127 C \nATOM 2787 C SER B 40 -10.239 -13.929 6.932 1.00 87.78 C \nANISOU 2787 C SER B 40 10828 10733 11793 -758 -1004 -147 C \nATOM 2788 O SER B 40 -9.909 -13.372 5.884 1.00 97.28 O \nANISOU 2788 O SER B 40 12054 11887 13022 -800 -993 -132 O \nATOM 2789 CB SER B 40 -9.611 -13.088 9.230 1.00 91.12 C \nANISOU 2789 CB SER B 40 11333 11002 12285 -949 -1005 -82 C \nATOM 2790 OG SER B 40 -8.957 -11.832 9.249 1.00 90.50 O \nANISOU 2790 OG SER B 40 11327 10810 12248 -1102 -1002 -32 O \nATOM 2791 N THR B 41 -10.218 -15.244 7.075 1.00 90.53 N \nANISOU 2791 N THR B 41 11006 11280 12112 -714 -966 -177 N \nATOM 2792 CA THR B 41 -9.842 -16.147 5.980 1.00 87.82 C \nANISOU 2792 CA THR B 41 10499 11118 11751 -727 -913 -194 C \nATOM 2793 C THR B 41 -10.780 -15.945 4.785 1.00 93.01 C \nANISOU 2793 C THR B 41 11210 11804 12324 -555 -963 -240 C \nATOM 2794 O THR B 41 -10.336 -15.895 3.640 1.00102.18 O \nANISOU 2794 O THR B 41 12327 12988 13509 -602 -931 -231 O \nATOM 2795 CB THR B 41 -9.866 -17.620 6.444 1.00 86.57 C \nANISOU 2795 CB THR B 41 10157 11211 11526 -728 -879 -220 C \nATOM 2796 OG1 THR B 41 -8.873 -17.823 7.459 1.00 85.62 O \nANISOU 2796 OG1 THR B 41 10007 11043 11481 -900 -835 -174 O \nATOM 2797 CG2 THR B 41 -9.571 -18.564 5.286 1.00 92.59 C \nANISOU 2797 CG2 THR B 41 10760 12191 12231 -774 -835 -234 C \nATOM 2798 N GLN B 42 -12.074 -15.816 5.053 1.00 93.97 N \nANISOU 2798 N GLN B 42 11450 11917 12337 -340 -1050 -293 N \nATOM 2799 CA GLN B 42 -13.064 -15.595 3.997 1.00 89.64 C \nANISOU 2799 CA GLN B 42 10996 11384 11681 -131 -1120 -348 C \nATOM 2800 C GLN B 42 -12.818 -14.308 3.227 1.00 86.90 C \nANISOU 2800 C GLN B 42 10825 10798 11396 -213 -1141 -306 C \nATOM 2801 O GLN B 42 -12.738 -14.317 2.001 1.00 92.46 O \nANISOU 2801 O GLN B 42 11486 11551 12092 -189 -1126 -317 O \nATOM 2802 CB GLN B 42 -14.484 -15.581 4.571 1.00 85.13 C \nANISOU 2802 CB GLN B 42 10590 10799 10958 141 -1235 -416 C \nATOM 2803 CG GLN B 42 -15.566 -15.674 3.515 1.00 86.34 C \nANISOU 2803 CG GLN B 42 10816 11036 10954 423 -1315 -496 C \nATOM 2804 CD GLN B 42 -15.358 -16.873 2.597 1.00 87.32 C \nANISOU 2804 CD GLN B 42 10634 11520 11025 460 -1242 -538 C \nATOM 2805 OE1 GLN B 42 -15.069 -17.982 3.058 1.00 88.50 O \nANISOU 2805 OE1 GLN B 42 10540 11936 11150 408 -1179 -549 O \nATOM 2806 NE2 GLN B 42 -15.513 -16.659 1.292 1.00 88.52 N \nANISOU 2806 NE2 GLN B 42 10799 11691 11142 531 -1253 -559 N \nATOM 2807 N LYS B 43 -12.717 -13.206 3.965 1.00 86.52 N \nANISOU 2807 N LYS B 43 10966 10513 11393 -322 -1178 -257 N \nATOM 2808 CA LYS B 43 -12.446 -11.875 3.393 1.00 81.92 C \nANISOU 2808 CA LYS B 43 10550 9725 10850 -448 -1202 -208 C \nATOM 2809 C LYS B 43 -11.223 -11.887 2.456 1.00 84.55 C \nANISOU 2809 C LYS B 43 10710 10121 11293 -601 -1103 -173 C \nATOM 2810 O LYS B 43 -11.214 -11.242 1.417 1.00 89.98 O \nANISOU 2810 O LYS B 43 11468 10741 11979 -614 -1117 -165 O \nATOM 2811 CB LYS B 43 -12.228 -10.863 4.510 1.00 85.23 C \nANISOU 2811 CB LYS B 43 11118 9970 11295 -615 -1230 -151 C \nATOM 2812 CG LYS B 43 -13.477 -10.175 5.015 1.00102.70 C \nANISOU 2812 CG LYS B 43 13648 12000 13372 -521 -1366 -164 C \nATOM 2813 CD LYS B 43 -14.553 -11.157 5.468 1.00114.88 C \nANISOU 2813 CD LYS B 43 15218 13626 14804 -248 -1428 -242 C \nATOM 2814 CE LYS B 43 -15.863 -10.460 5.838 1.00124.34 C \nANISOU 2814 CE LYS B 43 16802 14608 15835 -112 -1591 -265 C \nATOM 2815 NZ LYS B 43 -16.958 -11.339 6.355 1.00129.14 N \nANISOU 2815 NZ LYS B 43 17466 15298 16305 197 -1669 -351 N \nATOM 2816 N ALA B 44 -10.209 -12.654 2.825 1.00 85.66 N \nANISOU 2816 N ALA B 44 10646 10385 11514 -709 -1012 -155 N \nATOM 2817 CA ALA B 44 -8.996 -12.750 2.039 1.00 82.73 C \nANISOU 2817 CA ALA B 44 10148 10059 11228 -841 -932 -125 C \nATOM 2818 C ALA B 44 -9.204 -13.500 0.746 1.00 82.88 C \nANISOU 2818 C ALA B 44 10070 10217 11204 -756 -915 -162 C \nATOM 2819 O ALA B 44 -8.603 -13.170 -0.261 1.00 92.30 O \nANISOU 2819 O ALA B 44 11247 11385 12438 -821 -886 -143 O \nATOM 2820 CB ALA B 44 -7.886 -13.391 2.852 1.00 75.78 C \nANISOU 2820 CB ALA B 44 9137 9243 10413 -970 -864 -99 C \nATOM 2821 N ILE B 45 -10.044 -14.516 0.777 1.00 86.15 N \nANISOU 2821 N ILE B 45 10407 10805 11520 -608 -934 -216 N \nATOM 2822 CA ILE B 45 -10.318 -15.335 -0.402 1.00 86.75 C \nANISOU 2822 CA ILE B 45 10359 11082 11522 -525 -919 -258 C \nATOM 2823 C ILE B 45 -11.212 -14.562 -1.359 1.00 81.51 C \nANISOU 2823 C ILE B 45 9842 10328 10799 -362 -989 -290 C \nATOM 2824 O ILE B 45 -10.970 -14.554 -2.558 1.00 83.89 O \nANISOU 2824 O ILE B 45 10098 10670 11105 -375 -966 -292 O \nATOM 2825 CB ILE B 45 -11.024 -16.665 -0.001 1.00 92.42 C \nANISOU 2825 CB ILE B 45 10922 12084 12111 -402 -924 -317 C \nATOM 2826 CG1 ILE B 45 -10.137 -17.526 0.898 1.00 93.92 C \nANISOU 2826 CG1 ILE B 45 10975 12371 12338 -589 -859 -282 C \nATOM 2827 CG2 ILE B 45 -11.435 -17.476 -1.221 1.00 94.88 C \nANISOU 2827 CG2 ILE B 45 11085 12660 12303 -304 -916 -369 C \nATOM 2828 CD1 ILE B 45 -10.924 -18.517 1.738 1.00100.16 C \nANISOU 2828 CD1 ILE B 45 11656 13393 13007 -474 -879 -333 C \nATOM 2829 N ASP B 46 -12.267 -13.957 -0.828 1.00 84.25 N \nANISOU 2829 N ASP B 46 10387 10549 11075 -206 -1084 -318 N \nATOM 2830 CA ASP B 46 -13.129 -13.067 -1.608 1.00 84.76 C \nANISOU 2830 CA ASP B 46 10672 10464 11067 -65 -1175 -342 C \nATOM 2831 C ASP B 46 -12.312 -11.991 -2.308 1.00 90.05 C \nANISOU 2831 C ASP B 46 11414 10959 11844 -257 -1146 -277 C \nATOM 2832 O ASP B 46 -12.482 -11.759 -3.510 1.00 95.59 O \nANISOU 2832 O ASP B 46 12144 11657 12520 -201 -1159 -292 O \nATOM 2833 CB ASP B 46 -14.198 -12.442 -0.719 1.00 85.98 C \nANISOU 2833 CB ASP B 46 11100 10441 11125 69 -1295 -362 C \nATOM 2834 CG ASP B 46 -15.323 -13.425 -0.394 1.00101.62 C \nANISOU 2834 CG ASP B 46 13054 12611 12944 367 -1357 -455 C \nATOM 2835 OD1 ASP B 46 -15.387 -14.501 -1.033 1.00108.06 O \nANISOU 2835 OD1 ASP B 46 13634 13722 13701 477 -1312 -508 O \nATOM 2836 OD2 ASP B 46 -16.135 -13.150 0.520 1.00108.95 O \nANISOU 2836 OD2 ASP B 46 14190 13421 13784 489 -1453 -477 O \nATOM 2837 N GLY B 47 -11.392 -11.369 -1.572 1.00 85.08 N \nANISOU 2837 N GLY B 47 10791 10216 11321 -475 -1104 -210 N \nATOM 2838 CA GLY B 47 -10.540 -10.344 -2.135 1.00 78.88 C \nANISOU 2838 CA GLY B 47 10040 9314 10615 -653 -1074 -155 C \nATOM 2839 C GLY B 47 -9.591 -10.892 -3.186 1.00 80.48 C \nANISOU 2839 C GLY B 47 10052 9640 10887 -710 -987 -150 C \nATOM 2840 O GLY B 47 -9.538 -10.404 -4.331 1.00 86.49 O \nANISOU 2840 O GLY B 47 10850 10362 11649 -711 -991 -147 O \nATOM 2841 N VAL B 48 -8.823 -11.901 -2.810 1.00 77.15 N \nANISOU 2841 N VAL B 48 9448 9354 10510 -772 -915 -146 N \nATOM 2842 CA VAL B 48 -7.763 -12.417 -3.695 1.00 83.17 C \nANISOU 2842 CA VAL B 48 10073 10204 11323 -867 -841 -132 C \nATOM 2843 C VAL B 48 -8.326 -13.031 -4.973 1.00 86.50 C \nANISOU 2843 C VAL B 48 10433 10757 11676 -757 -845 -174 C \nATOM 2844 O VAL B 48 -7.745 -12.891 -6.046 1.00 95.56 O \nANISOU 2844 O VAL B 48 11553 11902 12854 -814 -815 -160 O \nATOM 2845 CB VAL B 48 -6.837 -13.410 -2.947 1.00 80.95 C \nANISOU 2845 CB VAL B 48 9665 10019 11073 -977 -783 -115 C \nATOM 2846 CG1 VAL B 48 -6.335 -14.513 -3.860 1.00 81.04 C \nANISOU 2846 CG1 VAL B 48 9551 10188 11054 -1030 -737 -122 C \nATOM 2847 CG2 VAL B 48 -5.662 -12.655 -2.308 1.00 76.62 C \nANISOU 2847 CG2 VAL B 48 9157 9346 10608 -1109 -758 -69 C \nATOM 2848 N THR B 49 -9.465 -13.696 -4.871 1.00 91.80 N \nANISOU 2848 N THR B 49 11080 11560 12239 -585 -888 -230 N \nATOM 2849 CA THR B 49 -10.019 -14.393 -6.035 1.00 91.64 C \nANISOU 2849 CA THR B 49 10965 11731 12122 -463 -891 -280 C \nATOM 2850 C THR B 49 -10.522 -13.409 -7.087 1.00 96.99 C \nANISOU 2850 C THR B 49 11791 12273 12787 -366 -942 -291 C \nATOM 2851 O THR B 49 -10.279 -13.600 -8.274 1.00105.14 O \nANISOU 2851 O THR B 49 12752 13384 13813 -377 -914 -297 O \nATOM 2852 CB THR B 49 -11.163 -15.353 -5.678 1.00 91.32 C \nANISOU 2852 CB THR B 49 10843 11924 11930 -258 -932 -354 C \nATOM 2853 OG1 THR B 49 -11.940 -14.769 -4.637 1.00 99.60 O \nANISOU 2853 OG1 THR B 49 12064 12823 12955 -138 -1007 -368 O \nATOM 2854 CG2 THR B 49 -10.626 -16.705 -5.205 1.00 94.73 C \nANISOU 2854 CG2 THR B 49 11051 12611 12329 -382 -866 -350 C \nATOM 2855 N ASN B 50 -11.206 -12.351 -6.665 1.00 88.19 N \nANISOU 2855 N ASN B 50 10902 10950 11657 -291 -1023 -290 N \nATOM 2856 CA ASN B 50 -11.724 -11.368 -7.620 1.00 84.54 C \nANISOU 2856 CA ASN B 50 10622 10337 11161 -220 -1086 -296 C \nATOM 2857 C ASN B 50 -10.606 -10.533 -8.224 1.00 79.00 C \nANISOU 2857 C ASN B 50 9919 9519 10578 -431 -1031 -232 C \nATOM 2858 O ASN B 50 -10.728 -10.043 -9.347 1.00 83.21 O \nANISOU 2858 O ASN B 50 10514 10005 11099 -405 -1048 -235 O \nATOM 2859 CB ASN B 50 -12.726 -10.442 -6.936 1.00 87.27 C \nANISOU 2859 CB ASN B 50 11258 10472 11428 -128 -1203 -303 C \nATOM 2860 CG ASN B 50 -13.729 -11.186 -6.082 1.00 90.02 C \nANISOU 2860 CG ASN B 50 11632 10915 11658 85 -1265 -366 C \nATOM 2861 OD1 ASN B 50 -13.797 -12.416 -6.103 1.00 91.61 O \nANISOU 2861 OD1 ASN B 50 11610 11379 11817 185 -1221 -413 O \nATOM 2862 ND2 ASN B 50 -14.516 -10.440 -5.317 1.00 89.21 N \nANISOU 2862 ND2 ASN B 50 11808 10608 11480 145 -1372 -367 N \nATOM 2863 N LYS B 51 -9.521 -10.389 -7.482 1.00 72.37 N \nANISOU 2863 N LYS B 51 9008 8649 9839 -619 -970 -179 N \nATOM 2864 CA LYS B 51 -8.312 -9.825 -8.035 1.00 71.25 C \nANISOU 2864 CA LYS B 51 8820 8461 9791 -786 -910 -132 C \nATOM 2865 C LYS B 51 -7.855 -10.619 -9.236 1.00 80.68 C \nANISOU 2865 C LYS B 51 9874 9786 10995 -777 -857 -147 C \nATOM 2866 O LYS B 51 -7.647 -10.063 -10.323 1.00 89.43 O \nANISOU 2866 O LYS B 51 11013 10848 12118 -794 -854 -139 O \nATOM 2867 CB LYS B 51 -7.211 -9.841 -7.009 1.00 70.19 C \nANISOU 2867 CB LYS B 51 8612 8325 9732 -932 -858 -93 C \nATOM 2868 CG LYS B 51 -5.932 -9.197 -7.486 1.00 69.38 C \nANISOU 2868 CG LYS B 51 8475 8189 9697 -1062 -810 -56 C \nATOM 2869 CD LYS B 51 -4.779 -9.427 -6.523 1.00 67.45 C \nANISOU 2869 CD LYS B 51 8156 7970 9502 -1157 -764 -33 C \nATOM 2870 CE LYS B 51 -4.558 -8.198 -5.684 1.00 68.71 C \nANISOU 2870 CE LYS B 51 8380 8066 9663 -1236 -785 -5 C \nATOM 2871 NZ LYS B 51 -3.542 -8.300 -4.619 1.00 76.38 N \nANISOU 2871 NZ LYS B 51 9288 9071 10660 -1296 -753 9 N \nATOM 2872 N VAL B 52 -7.725 -11.925 -9.047 1.00 83.77 N \nANISOU 2872 N VAL B 52 10116 10352 11361 -768 -818 -168 N \nATOM 2873 CA VAL B 52 -7.406 -12.824 -10.148 1.00 83.34 C \nANISOU 2873 CA VAL B 52 9932 10458 11277 -785 -776 -182 C \nATOM 2874 C VAL B 52 -8.404 -12.678 -11.319 1.00 82.64 C \nANISOU 2874 C VAL B 52 9871 10418 11111 -623 -818 -227 C \nATOM 2875 O VAL B 52 -8.004 -12.610 -12.485 1.00 93.75 O \nANISOU 2875 O VAL B 52 11250 11840 12532 -661 -793 -220 O \nATOM 2876 CB VAL B 52 -7.380 -14.300 -9.670 1.00 81.08 C \nANISOU 2876 CB VAL B 52 9487 10397 10922 -816 -745 -199 C \nATOM 2877 CG1 VAL B 52 -7.384 -15.265 -10.852 1.00 74.10 C \nANISOU 2877 CG1 VAL B 52 8467 9736 9953 -831 -718 -222 C \nATOM 2878 CG2 VAL B 52 -6.155 -14.544 -8.801 1.00 82.69 C \nANISOU 2878 CG2 VAL B 52 9680 10542 11195 -999 -702 -151 C \nATOM 2879 N ASN B 53 -9.696 -12.688 -11.019 1.00 70.87 N \nANISOU 2879 N ASN B 53 8447 8958 9523 -426 -889 -278 N \nATOM 2880 CA ASN B 53 -10.694 -12.649 -12.078 1.00 74.63 C \nANISOU 2880 CA ASN B 53 8964 9497 9895 -228 -943 -335 C \nATOM 2881 C ASN B 53 -10.651 -11.300 -12.785 1.00 83.81 C \nANISOU 2881 C ASN B 53 10316 10420 11109 -253 -978 -306 C \nATOM 2882 O ASN B 53 -10.706 -11.223 -14.008 1.00 85.93 O \nANISOU 2882 O ASN B 53 10571 10721 11357 -212 -976 -320 O \nATOM 2883 CB ASN B 53 -12.106 -12.951 -11.548 1.00 75.56 C \nANISOU 2883 CB ASN B 53 9149 9695 9865 36 -1031 -408 C \nATOM 2884 CG ASN B 53 -12.198 -14.307 -10.862 1.00 82.70 C \nANISOU 2884 CG ASN B 53 9840 10888 10695 63 -996 -442 C \nATOM 2885 OD1 ASN B 53 -11.480 -15.248 -11.209 1.00 82.39 O \nANISOU 2885 OD1 ASN B 53 9585 11062 10659 -79 -916 -428 O \nATOM 2886 ND2 ASN B 53 -13.074 -14.405 -9.869 1.00 84.10 N \nANISOU 2886 ND2 ASN B 53 10093 11074 10789 229 -1062 -484 N \nATOM 2887 N SER B 54 -10.558 -10.226 -12.014 1.00 89.55 N \nANISOU 2887 N SER B 54 11215 10924 11887 -337 -1012 -264 N \nATOM 2888 CA SER B 54 -10.504 -8.898 -12.609 1.00 89.20 C \nANISOU 2888 CA SER B 54 11347 10678 11865 -404 -1049 -230 C \nATOM 2889 C SER B 54 -9.376 -8.813 -13.632 1.00 91.64 C \nANISOU 2889 C SER B 54 11531 11023 12265 -540 -968 -198 C \nATOM 2890 O SER B 54 -9.564 -8.303 -14.731 1.00 99.67 O \nANISOU 2890 O SER B 54 12614 11991 13264 -510 -990 -203 O \nATOM 2891 CB SER B 54 -10.336 -7.839 -11.524 1.00 93.46 C \nANISOU 2891 CB SER B 54 12038 11039 12433 -545 -1081 -179 C \nATOM 2892 OG SER B 54 -11.526 -7.734 -10.742 1.00 86.50 O \nANISOU 2892 OG SER B 54 11349 10075 11443 -412 -1182 -209 O \nATOM 2893 N ILE B 55 -8.202 -9.331 -13.277 1.00 92.37 N \nANISOU 2893 N ILE B 55 11463 11192 12442 -680 -885 -168 N \nATOM 2894 CA ILE B 55 -7.070 -9.395 -14.212 1.00 86.80 C \nANISOU 2894 CA ILE B 55 10659 10518 11802 -789 -818 -143 C \nATOM 2895 C ILE B 55 -7.431 -10.200 -15.451 1.00 95.11 C \nANISOU 2895 C ILE B 55 11627 11712 12800 -699 -808 -181 C \nATOM 2896 O ILE B 55 -7.175 -9.764 -16.565 1.00108.47 O \nANISOU 2896 O ILE B 55 13336 13368 14509 -716 -799 -174 O \nATOM 2897 CB ILE B 55 -5.830 -10.039 -13.538 1.00 82.84 C \nANISOU 2897 CB ILE B 55 10045 10070 11360 -922 -752 -115 C \nATOM 2898 CG1 ILE B 55 -5.214 -9.077 -12.511 1.00 82.60 C \nANISOU 2898 CG1 ILE B 55 10078 9923 11383 -1015 -754 -78 C \nATOM 2899 CG2 ILE B 55 -4.764 -10.479 -14.538 1.00 80.28 C \nANISOU 2899 CG2 ILE B 55 9646 9794 11062 -1006 -699 -102 C \nATOM 2900 CD1 ILE B 55 -4.336 -9.752 -11.481 1.00 75.84 C \nANISOU 2900 CD1 ILE B 55 9151 9108 10556 -1090 -716 -64 C \nATOM 2901 N ILE B 56 -8.027 -11.371 -15.234 1.00100.49 N \nANISOU 2901 N ILE B 56 12202 12579 13400 -608 -808 -223 N \nATOM 2902 CA ILE B 56 -8.437 -12.263 -16.321 1.00 99.19 C \nANISOU 2902 CA ILE B 56 11917 12624 13145 -524 -799 -266 C \nATOM 2903 C ILE B 56 -9.598 -11.704 -17.151 1.00 97.85 C \nANISOU 2903 C ILE B 56 11857 12424 12896 -316 -871 -315 C \nATOM 2904 O ILE B 56 -9.554 -11.766 -18.376 1.00102.20 O \nANISOU 2904 O ILE B 56 12368 13037 13427 -296 -859 -327 O \nATOM 2905 CB ILE B 56 -8.843 -13.664 -15.791 1.00100.04 C \nANISOU 2905 CB ILE B 56 11858 13007 13146 -481 -786 -305 C \nATOM 2906 CG1 ILE B 56 -7.626 -14.385 -15.221 1.00 98.42 C \nANISOU 2906 CG1 ILE B 56 11559 12845 12992 -713 -719 -255 C \nATOM 2907 CG2 ILE B 56 -9.462 -14.523 -16.897 1.00 95.87 C \nANISOU 2907 CG2 ILE B 56 11186 12759 12479 -371 -787 -361 C \nATOM 2908 CD1 ILE B 56 -7.956 -15.623 -14.419 1.00 99.84 C \nANISOU 2908 CD1 ILE B 56 11595 13270 13069 -718 -710 -280 C \nATOM 2909 N ASP B 57 -10.640 -11.215 -16.488 1.00 98.22 N \nANISOU 2909 N ASP B 57 12062 12375 12883 -157 -955 -345 N \nATOM 2910 CA ASP B 57 -11.876 -10.778 -17.170 1.00106.07 C \nANISOU 2910 CA ASP B 57 13215 13327 13759 81 -1051 -402 C \nATOM 2911 C ASP B 57 -11.721 -9.479 -17.970 1.00101.96 C \nANISOU 2911 C ASP B 57 12882 12568 13291 15 -1081 -365 C \nATOM 2912 O ASP B 57 -12.235 -9.368 -19.081 1.00104.31 O \nANISOU 2912 O ASP B 57 13225 12887 13520 144 -1117 -402 O \nATOM 2913 CB ASP B 57 -13.033 -10.622 -16.170 1.00113.19 C \nANISOU 2913 CB ASP B 57 14293 14160 14553 275 -1154 -446 C \nATOM 2914 CG ASP B 57 -13.377 -11.914 -15.466 1.00114.08 C \nANISOU 2914 CG ASP B 57 14216 14548 14579 386 -1136 -498 C \nATOM 2915 OD1 ASP B 57 -13.235 -12.988 -16.088 1.00119.04 O \nANISOU 2915 OD1 ASP B 57 14601 15477 15152 408 -1080 -531 O \nATOM 2916 OD2 ASP B 57 -13.767 -11.843 -14.282 1.00113.72 O \nANISOU 2916 OD2 ASP B 57 14264 14432 14511 430 -1180 -503 O \nATOM 2917 N LYS B 58 -11.022 -8.500 -17.407 1.00100.64 N \nANISOU 2917 N LYS B 58 12812 12201 13227 -185 -1067 -296 N \nATOM 2918 CA LYS B 58 -10.719 -7.251 -18.135 1.00102.71 C \nANISOU 2918 CA LYS B 58 13216 12282 13529 -296 -1085 -254 C \nATOM 2919 C LYS B 58 -10.039 -7.494 -19.474 1.00111.24 C \nANISOU 2919 C LYS B 58 14153 13455 14659 -336 -1017 -251 C \nATOM 2920 O LYS B 58 -10.129 -6.674 -20.387 1.00115.64 O \nANISOU 2920 O LYS B 58 14821 13908 15209 -348 -1046 -240 O \nATOM 2921 CB LYS B 58 -9.846 -6.329 -17.295 1.00 99.74 C \nANISOU 2921 CB LYS B 58 12878 11779 13240 -527 -1058 -183 C \nATOM 2922 CG LYS B 58 -10.587 -5.721 -16.121 1.00102.72 C \nANISOU 2922 CG LYS B 58 13462 12017 13550 -528 -1144 -174 C \nATOM 2923 CD LYS B 58 -11.403 -4.505 -16.559 1.00108.12 C \nANISOU 2923 CD LYS B 58 14448 12501 14132 -532 -1256 -163 C \nATOM 2924 CE LYS B 58 -12.615 -4.270 -15.663 1.00104.24 C \nANISOU 2924 CE LYS B 58 14232 11867 13505 -429 -1383 -183 C \nATOM 2925 NZ LYS B 58 -13.799 -5.061 -16.112 1.00102.02 N \nANISOU 2925 NZ LYS B 58 14033 11625 13102 -106 -1459 -270 N \nATOM 2926 N MET B 59 -9.400 -8.647 -19.600 1.00111.88 N \nANISOU 2926 N MET B 59 14005 13733 14773 -367 -936 -259 N \nATOM 2927 CA MET B 59 -8.761 -9.017 -20.836 1.00117.65 C \nANISOU 2927 CA MET B 59 14610 14561 15532 -417 -877 -256 C \nATOM 2928 C MET B 59 -9.755 -9.302 -21.971 1.00119.25 C \nANISOU 2928 C MET B 59 14821 14864 15624 -220 -922 -316 C \nATOM 2929 O MET B 59 -9.322 -9.523 -23.095 1.00118.27 O \nANISOU 2929 O MET B 59 14608 14816 15513 -257 -881 -315 O \nATOM 2930 CB MET B 59 -7.838 -10.225 -20.622 1.00126.47 C \nANISOU 2930 CB MET B 59 15522 15853 16676 -535 -795 -243 C \nATOM 2931 CG MET B 59 -6.656 -10.245 -21.571 1.00134.19 C \nANISOU 2931 CG MET B 59 16440 16828 17718 -682 -734 -208 C \nATOM 2932 SD MET B 59 -5.574 -8.820 -21.303 1.00148.53 S \nANISOU 2932 SD MET B 59 18371 18410 19652 -818 -723 -149 S \nATOM 2933 CE MET B 59 -6.106 -7.776 -22.668 1.00152.07 C \nANISOU 2933 CE MET B 59 18924 18770 20087 -749 -761 -158 C \nATOM 2934 N ASN B 60 -11.062 -9.255 -21.695 1.00124.29 N \nANISOU 2934 N ASN B 60 15585 15498 16142 1 -1014 -373 N \nATOM 2935 CA ASN B 60 -12.135 -9.478 -22.708 1.00137.08 C \nANISOU 2935 CA ASN B 60 17243 17219 17622 250 -1078 -447 C \nATOM 2936 C ASN B 60 -11.918 -8.893 -24.131 1.00141.67 C \nANISOU 2936 C ASN B 60 17867 17732 18227 226 -1073 -435 C \nATOM 2937 O ASN B 60 -12.744 -9.115 -25.040 1.00133.99 O \nANISOU 2937 O ASN B 60 16914 16860 17135 438 -1124 -499 O \nATOM 2938 CB ASN B 60 -13.465 -8.907 -22.162 1.00144.94 C \nANISOU 2938 CB ASN B 60 18516 18064 18490 478 -1214 -494 C \nATOM 2939 CG ASN B 60 -14.319 -9.940 -21.449 1.00148.59 C \nANISOU 2939 CG ASN B 60 18898 18746 18814 708 -1252 -571 C \nATOM 2940 OD1 ASN B 60 -14.333 -11.125 -21.802 1.00151.06 O \nANISOU 2940 OD1 ASN B 60 18948 19390 19058 784 -1200 -618 O \nATOM 2941 ND2 ASN B 60 -15.076 -9.485 -20.456 1.00150.01 N \nANISOU 2941 ND2 ASN B 60 19312 18759 18927 817 -1349 -586 N \nATOM 2942 N THR B 61 -10.815 -8.161 -24.312 1.00142.65 N \nANISOU 2942 N THR B 61 18000 17707 18492 -13 -1016 -361 N \nATOM 2943 CA THR B 61 -10.544 -7.397 -25.537 1.00149.85 C \nANISOU 2943 CA THR B 61 18979 18520 19439 -60 -1015 -341 C \nATOM 2944 C THR B 61 -10.450 -8.210 -26.842 1.00162.71 C \nANISOU 2944 C THR B 61 20436 20355 21032 1 -971 -375 C \nATOM 2945 O THR B 61 -11.188 -7.930 -27.791 1.00175.62 O \nANISOU 2945 O THR B 61 22161 21978 22586 156 -1028 -415 O \nATOM 2946 CB THR B 61 -9.269 -6.542 -25.384 1.00141.18 C \nANISOU 2946 CB THR B 61 17883 17281 18480 -317 -957 -262 C \nATOM 2947 OG1 THR B 61 -8.149 -7.381 -25.083 1.00134.67 O \nANISOU 2947 OG1 THR B 61 16854 16582 17732 -448 -863 -238 O \nATOM 2948 CG2 THR B 61 -9.436 -5.516 -24.282 1.00132.67 C \nANISOU 2948 CG2 THR B 61 16986 16015 17406 -396 -1010 -226 C \nATOM 2949 N GLN B 62 -9.531 -9.179 -26.893 1.00166.71 N \nANISOU 2949 N GLN B 62 20718 21040 21583 -134 -879 -357 N \nATOM 2950 CA GLN B 62 -9.295 -10.005 -28.101 1.00160.50 C \nANISOU 2950 CA GLN B 62 19762 20467 20752 -140 -832 -377 C \nATOM 2951 C GLN B 62 -10.540 -10.760 -28.637 1.00149.69 C \nANISOU 2951 C GLN B 62 18317 19354 19205 116 -880 -465 C \nATOM 2952 O GLN B 62 -11.333 -11.309 -27.859 1.00143.95 O \nANISOU 2952 O GLN B 62 17558 18762 18373 267 -919 -515 O \nATOM 2953 CB GLN B 62 -8.108 -10.979 -27.900 1.00162.16 C \nANISOU 2953 CB GLN B 62 19794 20814 21005 -364 -743 -336 C \nATOM 2954 CG GLN B 62 -8.343 -12.174 -26.981 1.00164.99 C \nANISOU 2954 CG GLN B 62 20009 21401 21277 -366 -729 -358 C \nATOM 2955 CD GLN B 62 -8.502 -11.785 -25.523 1.00176.48 C \nANISOU 2955 CD GLN B 62 21559 22712 22781 -349 -756 -346 C \nATOM 2956 OE1 GLN B 62 -8.387 -10.615 -25.163 1.00176.66 O \nANISOU 2956 OE1 GLN B 62 21753 22472 22896 -359 -784 -316 O \nATOM 2957 NE2 GLN B 62 -8.780 -12.765 -24.674 1.00195.70 N \nANISOU 2957 NE2 GLN B 62 23876 25342 25138 -335 -750 -369 N \nATOM 2958 N PHE B 63 -10.717 -10.730 -29.963 1.00141.25 N \nANISOU 2958 N PHE B 63 17223 18357 18090 183 -883 -489 N \nATOM 2959 CA PHE B 63 -11.701 -11.572 -30.672 1.00148.24 C \nANISOU 2959 CA PHE B 63 17979 19559 18786 415 -915 -578 C \nATOM 2960 C PHE B 63 -11.173 -12.147 -32.008 1.00140.16 C \nANISOU 2960 C PHE B 63 16778 18739 17736 311 -852 -573 C \nATOM 2961 O PHE B 63 -11.117 -13.362 -32.201 1.00126.47 O \nANISOU 2961 O PHE B 63 14805 17363 15886 264 -808 -597 O \nATOM 2962 CB PHE B 63 -12.986 -10.789 -30.986 1.00153.49 C \nANISOU 2962 CB PHE B 63 18871 20098 19349 728 -1034 -645 C \nATOM 2963 CG PHE B 63 -13.624 -10.111 -29.800 1.00156.68 C \nANISOU 2963 CG PHE B 63 19517 20267 19748 835 -1121 -650 C \nATOM 2964 CD1 PHE B 63 -14.451 -10.819 -28.925 1.00151.18 C \nANISOU 2964 CD1 PHE B 63 18777 19751 18912 1038 -1169 -717 C \nATOM 2965 CD2 PHE B 63 -13.437 -8.752 -29.586 1.00156.27 C \nANISOU 2965 CD2 PHE B 63 19738 19833 19803 731 -1163 -591 C \nATOM 2966 CE1 PHE B 63 -15.052 -10.193 -27.843 1.00147.02 C \nANISOU 2966 CE1 PHE B 63 18500 18992 18368 1135 -1258 -722 C \nATOM 2967 CE2 PHE B 63 -14.035 -8.120 -28.503 1.00159.63 C \nANISOU 2967 CE2 PHE B 63 20406 20047 20200 795 -1250 -590 C \nATOM 2968 CZ PHE B 63 -14.843 -8.842 -27.631 1.00151.50 C \nANISOU 2968 CZ PHE B 63 19355 19163 19043 1001 -1300 -655 C \nATOM 2969 N GLU B 64 -10.791 -11.251 -32.921 1.00141.10 N \nANISOU 2969 N GLU B 64 17020 18642 17951 258 -851 -539 N \nATOM 2970 CA GLU B 64 -10.365 -11.619 -34.281 1.00136.96 C \nANISOU 2970 CA GLU B 64 16371 18266 17403 180 -804 -536 C \nATOM 2971 C GLU B 64 -8.898 -11.990 -34.256 1.00130.56 C \nANISOU 2971 C GLU B 64 15477 17428 16701 -151 -714 -454 C \nATOM 2972 O GLU B 64 -8.199 -11.595 -33.334 1.00145.37 O \nANISOU 2972 O GLU B 64 17441 19097 18698 -287 -697 -400 O \nATOM 2973 CB GLU B 64 -10.531 -10.442 -35.257 1.00136.37 C \nANISOU 2973 CB GLU B 64 16482 17947 17385 259 -845 -532 C \nATOM 2974 CG GLU B 64 -11.968 -10.123 -35.659 1.00142.33 C \nANISOU 2974 CG GLU B 64 17358 18728 17993 600 -949 -619 C \nATOM 2975 CD GLU B 64 -12.616 -11.183 -36.560 1.00143.58 C \nANISOU 2975 CD GLU B 64 17303 19295 17957 779 -951 -703 C \nATOM 2976 OE1 GLU B 64 -12.266 -11.305 -37.765 1.00138.82 O \nANISOU 2976 OE1 GLU B 64 16611 18783 17350 715 -913 -696 O \nATOM 2977 OE2 GLU B 64 -13.506 -11.905 -36.057 1.00146.01 O \nANISOU 2977 OE2 GLU B 64 17521 19860 18095 996 -994 -780 O \nATOM 2978 N ALA B 65 -8.423 -12.697 -35.282 1.00112.18 N \nANISOU 2978 N ALA B 65 13009 15297 14317 -275 -667 -446 N \nATOM 2979 CA ALA B 65 -7.001 -13.023 -35.393 1.00102.36 C \nANISOU 2979 CA ALA B 65 11751 13991 13151 -583 -603 -369 C \nATOM 2980 C ALA B 65 -6.577 -13.090 -36.860 1.00 99.78 C \nANISOU 2980 C ALA B 65 11393 13716 12803 -664 -579 -358 C \nATOM 2981 O ALA B 65 -7.388 -13.465 -37.712 1.00105.79 O \nANISOU 2981 O ALA B 65 12038 14721 13434 -530 -593 -414 O \nATOM 2982 CB ALA B 65 -6.697 -14.326 -34.666 1.00 93.85 C \nANISOU 2982 CB ALA B 65 10526 13163 11972 -754 -572 -357 C \nATOM 2983 N VAL B 66 -5.340 -12.677 -37.172 1.00 91.56 N \nANISOU 2983 N VAL B 66 10462 12448 11878 -855 -550 -293 N \nATOM 2984 CA VAL B 66 -4.856 -12.671 -38.579 1.00 92.46 C \nANISOU 2984 CA VAL B 66 10573 12577 11980 -937 -531 -278 C \nATOM 2985 C VAL B 66 -3.317 -12.588 -38.626 1.00 90.61 C \nANISOU 2985 C VAL B 66 10464 12136 11828 -1174 -505 -207 C \nATOM 2986 O VAL B 66 -2.702 -12.096 -37.681 1.00 87.82 O \nANISOU 2986 O VAL B 66 10224 11567 11575 -1206 -509 -177 O \nATOM 2987 CB VAL B 66 -5.588 -11.586 -39.478 1.00 85.72 C \nANISOU 2987 CB VAL B 66 9787 11611 11171 -716 -563 -315 C \nATOM 2988 CG1 VAL B 66 -6.238 -10.469 -38.635 1.00 81.17 C \nANISOU 2988 CG1 VAL B 66 9351 10812 10680 -536 -612 -331 C \nATOM 2989 CG2 VAL B 66 -4.635 -10.977 -40.508 1.00 82.59 C \nANISOU 2989 CG2 VAL B 66 9485 11032 10863 -824 -543 -273 C \nATOM 2990 N GLY B 67 -2.725 -13.148 -39.693 1.00 93.25 N \nANISOU 2990 N GLY B 67 10781 12558 12093 -1332 -487 -185 N \nATOM 2991 CA GLY B 67 -1.316 -12.927 -40.065 1.00 89.04 C \nANISOU 2991 CA GLY B 67 10414 11802 11617 -1503 -482 -129 C \nATOM 2992 C GLY B 67 -1.216 -11.770 -41.042 1.00 85.97 C \nANISOU 2992 C GLY B 67 10102 11234 11330 -1382 -486 -135 C \nATOM 2993 O GLY B 67 -1.440 -10.645 -40.627 1.00 85.11 O \nANISOU 2993 O GLY B 67 10053 10948 11337 -1231 -498 -146 O \nATOM 2994 N ARG B 68 -0.869 -12.064 -42.314 1.00 83.64 N \nANISOU 2994 N ARG B 68 9805 10997 10976 -1472 -478 -125 N \nATOM 2995 CA ARG B 68 -1.009 -11.167 -43.526 1.00 71.04 C \nANISOU 2995 CA ARG B 68 8236 9314 9441 -1357 -479 -140 C \nATOM 2996 C ARG B 68 0.109 -11.388 -44.556 1.00 70.84 C \nANISOU 2996 C ARG B 68 8313 9219 9385 -1522 -475 -103 C \nATOM 2997 O ARG B 68 1.235 -11.738 -44.195 1.00 80.30 O \nANISOU 2997 O ARG B 68 9648 10298 10562 -1681 -487 -63 O \nATOM 2998 CB ARG B 68 -1.097 -9.701 -43.183 1.00 73.05 C \nANISOU 2998 CB ARG B 68 8584 9329 9844 -1189 -493 -147 C \nATOM 2999 CG ARG B 68 -1.689 -8.817 -44.284 1.00 77.98 C \nANISOU 2999 CG ARG B 68 9208 9917 10504 -1047 -501 -173 C \nATOM 3000 CD ARG B 68 -2.781 -7.878 -43.754 1.00 74.19 C \nANISOU 3000 CD ARG B 68 8749 9371 10071 -856 -533 -204 C \nATOM 3001 NE ARG B 68 -2.449 -7.412 -42.416 1.00 80.30 N \nANISOU 3001 NE ARG B 68 9589 10008 10913 -873 -541 -184 N \nATOM 3002 CZ ARG B 68 -3.300 -7.381 -41.392 1.00 93.23 C \nANISOU 3002 CZ ARG B 68 11218 11666 12538 -784 -566 -205 C \nATOM 3003 NH1 ARG B 68 -4.561 -7.767 -41.562 1.00102.62 N \nANISOU 3003 NH1 ARG B 68 12347 13004 13640 -640 -594 -253 N \nATOM 3004 NH2 ARG B 68 -2.881 -6.967 -40.207 1.00 84.68 N \nANISOU 3004 NH2 ARG B 68 10193 10466 11516 -823 -568 -182 N \nATOM 3005 N GLU B 69 -0.205 -11.194 -45.840 1.00 64.11 N \nANISOU 3005 N GLU B 69 7415 8430 8514 -1477 -469 -118 N \nATOM 3006 CA GLU B 69 0.660 -11.651 -46.928 1.00 63.27 C \nANISOU 3006 CA GLU B 69 7382 8321 8337 -1652 -468 -87 C \nATOM 3007 C GLU B 69 0.994 -10.557 -47.935 1.00 59.87 C \nANISOU 3007 C GLU B 69 7038 7706 8004 -1547 -471 -90 C \nATOM 3008 O GLU B 69 0.114 -9.857 -48.397 1.00 62.48 O \nANISOU 3008 O GLU B 69 7290 8064 8387 -1372 -466 -125 O \nATOM 3009 CB GLU B 69 -0.015 -12.819 -47.633 1.00 72.77 C \nANISOU 3009 CB GLU B 69 8410 9874 9366 -1759 -455 -100 C \nATOM 3010 CG GLU B 69 0.913 -13.775 -48.385 1.00 79.80 C \nANISOU 3010 CG GLU B 69 9382 10826 10113 -2054 -463 -52 C \nATOM 3011 CD GLU B 69 0.515 -15.253 -48.241 1.00 85.01 C \nANISOU 3011 CD GLU B 69 9883 11863 10553 -2275 -456 -45 C \nATOM 3012 OE1 GLU B 69 -0.491 -15.568 -47.546 1.00 80.19 O \nANISOU 3012 OE1 GLU B 69 9078 11487 9902 -2168 -442 -86 O \nATOM 3013 OE2 GLU B 69 1.208 -16.114 -48.842 1.00 93.98 O \nANISOU 3013 OE2 GLU B 69 11094 13080 11533 -2566 -470 2 O \nATOM 3014 N PHE B 70 2.267 -10.462 -48.324 1.00 59.85 N \nANISOU 3014 N PHE B 70 7213 7524 8003 -1655 -487 -55 N \nATOM 3015 CA PHE B 70 2.790 -9.364 -49.151 1.00 53.11 C \nANISOU 3015 CA PHE B 70 6455 6486 7237 -1553 -493 -58 C \nATOM 3016 C PHE B 70 3.776 -9.852 -50.168 1.00 50.44 C \nANISOU 3016 C PHE B 70 6256 6098 6812 -1706 -512 -30 C \nATOM 3017 O PHE B 70 4.473 -10.788 -49.911 1.00 64.43 O \nANISOU 3017 O PHE B 70 8144 7864 8473 -1894 -537 2 O \nATOM 3018 CB PHE B 70 3.503 -8.344 -48.279 1.00 53.80 C \nANISOU 3018 CB PHE B 70 6659 6355 7427 -1447 -509 -58 C \nATOM 3019 CG PHE B 70 2.617 -7.706 -47.229 1.00 50.17 C \nANISOU 3019 CG PHE B 70 6099 5911 7051 -1314 -498 -79 C \nATOM 3020 CD1 PHE B 70 2.697 -8.099 -45.945 1.00 46.68 C \nANISOU 3020 CD1 PHE B 70 5665 5469 6602 -1348 -504 -72 C \nATOM 3021 CD2 PHE B 70 1.672 -6.762 -47.589 1.00 45.99 C \nANISOU 3021 CD2 PHE B 70 5492 5394 6590 -1170 -492 -105 C \nATOM 3022 CE1 PHE B 70 1.882 -7.531 -44.999 1.00 46.28 C \nANISOU 3022 CE1 PHE B 70 5540 5427 6616 -1237 -501 -90 C \nATOM 3023 CE2 PHE B 70 0.820 -6.223 -46.685 1.00 43.67 C \nANISOU 3023 CE2 PHE B 70 5150 5101 6343 -1071 -498 -121 C \nATOM 3024 CZ PHE B 70 0.929 -6.601 -45.363 1.00 45.50 C \nANISOU 3024 CZ PHE B 70 5384 5332 6573 -1103 -501 -113 C \nATOM 3025 N ASN B 71 3.867 -9.190 -51.311 1.00 47.65 N \nANISOU 3025 N ASN B 71 5917 5690 6498 -1633 -507 -39 N \nATOM 3026 CA ASN B 71 4.766 -9.606 -52.354 1.00 48.28 C \nANISOU 3026 CA ASN B 71 6142 5713 6489 -1769 -531 -14 C \nATOM 3027 C ASN B 71 6.169 -8.982 -52.200 1.00 47.27 C \nANISOU 3027 C ASN B 71 6262 5316 6384 -1719 -576 -5 C \nATOM 3028 O ASN B 71 6.532 -8.533 -51.144 1.00 54.32 O \nANISOU 3028 O ASN B 71 7207 6105 7327 -1628 -589 -13 O \nATOM 3029 CB ASN B 71 4.147 -9.358 -53.745 1.00 49.15 C \nANISOU 3029 CB ASN B 71 6141 5929 6605 -1724 -506 -30 C \nATOM 3030 CG ASN B 71 4.232 -7.935 -54.186 1.00 50.04 C \nANISOU 3030 CG ASN B 71 6274 5890 6851 -1523 -502 -53 C \nATOM 3031 OD1 ASN B 71 4.877 -7.104 -53.557 1.00 66.48 O \nANISOU 3031 OD1 ASN B 71 8452 7804 9005 -1425 -518 -57 O \nATOM 3032 ND2 ASN B 71 3.559 -7.628 -55.242 1.00 52.51 N \nANISOU 3032 ND2 ASN B 71 6486 6286 7180 -1461 -482 -71 N \nATOM 3033 N ASN B 72 6.974 -9.040 -53.227 1.00 48.16 N \nANISOU 3033 N ASN B 72 6532 5334 6433 -1774 -606 7 N \nATOM 3034 CA ASN B 72 8.349 -8.651 -53.126 1.00 51.60 C \nANISOU 3034 CA ASN B 72 7232 5536 6838 -1715 -667 7 C \nATOM 3035 C ASN B 72 8.523 -7.133 -53.267 1.00 51.80 C \nANISOU 3035 C ASN B 72 7211 5482 6987 -1457 -655 -33 C \nATOM 3036 O ASN B 72 9.509 -6.601 -52.785 1.00 53.02 O \nANISOU 3036 O ASN B 72 7518 5499 7127 -1334 -698 -51 O \nATOM 3037 CB ASN B 72 9.146 -9.347 -54.210 1.00 55.67 C \nANISOU 3037 CB ASN B 72 7968 5975 7208 -1879 -718 35 C \nATOM 3038 CG ASN B 72 10.611 -9.389 -53.909 1.00 60.21 C \nANISOU 3038 CG ASN B 72 8897 6302 7679 -1856 -811 37 C \nATOM 3039 OD1 ASN B 72 11.015 -9.526 -52.742 1.00 68.46 O \nANISOU 3039 OD1 ASN B 72 10042 7269 8702 -1829 -844 35 O \nATOM 3040 ND2 ASN B 72 11.434 -9.342 -54.955 1.00 59.49 N \nANISOU 3040 ND2 ASN B 72 9023 6079 7503 -1862 -865 40 N \nATOM 3041 N LEU B 73 7.605 -6.462 -53.975 1.00 49.39 N \nANISOU 3041 N LEU B 73 6709 5280 6776 -1380 -604 -48 N \nATOM 3042 CA LEU B 73 7.593 -5.033 -54.084 1.00 44.71 C \nANISOU 3042 CA LEU B 73 6048 4656 6285 -1185 -589 -79 C \nATOM 3043 C LEU B 73 6.673 -4.358 -53.093 1.00 42.70 C \nANISOU 3043 C LEU B 73 5623 4475 6127 -1102 -556 -92 C \nATOM 3044 O LEU B 73 6.287 -3.215 -53.313 1.00 47.11 O \nANISOU 3044 O LEU B 73 6092 5053 6756 -995 -539 -108 O \nATOM 3045 CB LEU B 73 7.264 -4.608 -55.499 1.00 42.88 C \nANISOU 3045 CB LEU B 73 5758 4457 6076 -1162 -570 -84 C \nATOM 3046 CG LEU B 73 8.338 -4.995 -56.448 1.00 44.95 C \nANISOU 3046 CG LEU B 73 6219 4617 6243 -1213 -612 -75 C \nATOM 3047 CD1 LEU B 73 7.962 -4.567 -57.862 1.00 43.26 C \nANISOU 3047 CD1 LEU B 73 5933 4446 6060 -1190 -588 -81 C \nATOM 3048 CD2 LEU B 73 9.724 -4.430 -56.020 1.00 47.87 C \nANISOU 3048 CD2 LEU B 73 6786 4836 6566 -1077 -670 -98 C \nATOM 3049 N GLU B 74 6.398 -5.055 -51.994 1.00 45.15 N \nANISOU 3049 N GLU B 74 5914 4818 6422 -1167 -556 -81 N \nATOM 3050 CA GLU B 74 5.619 -4.502 -50.862 1.00 42.72 C \nANISOU 3050 CA GLU B 74 5483 4558 6190 -1097 -536 -91 C \nATOM 3051 C GLU B 74 6.352 -4.733 -49.555 1.00 43.41 C \nANISOU 3051 C GLU B 74 5657 4586 6250 -1099 -560 -89 C \nATOM 3052 O GLU B 74 5.743 -5.027 -48.550 1.00 42.94 O \nANISOU 3052 O GLU B 74 5526 4577 6212 -1123 -549 -85 O \nATOM 3053 CB GLU B 74 4.236 -5.147 -50.800 1.00 42.75 C \nANISOU 3053 CB GLU B 74 5344 4698 6200 -1147 -510 -90 C \nATOM 3054 CG GLU B 74 3.387 -4.912 -52.071 1.00 42.78 C \nANISOU 3054 CG GLU B 74 5263 4776 6217 -1112 -493 -102 C \nATOM 3055 CD GLU B 74 2.044 -5.627 -51.982 1.00 44.59 C \nANISOU 3055 CD GLU B 74 5358 5172 6414 -1115 -480 -115 C \nATOM 3056 OE1 GLU B 74 2.055 -6.840 -51.688 1.00 46.47 O \nANISOU 3056 OE1 GLU B 74 5568 5520 6569 -1230 -477 -106 O \nATOM 3057 OE2 GLU B 74 0.988 -4.984 -52.241 1.00 40.17 O \nANISOU 3057 OE2 GLU B 74 4732 4643 5887 -999 -482 -139 O \nATOM 3058 N ARG B 75 7.659 -4.491 -49.546 1.00 43.13 N \nANISOU 3058 N ARG B 75 5782 4443 6162 -1041 -601 -98 N \nATOM 3059 CA ARG B 75 8.462 -4.645 -48.346 1.00 42.90 C \nANISOU 3059 CA ARG B 75 5862 4349 6088 -1007 -636 -105 C \nATOM 3060 C ARG B 75 8.241 -3.527 -47.301 1.00 40.36 C \nANISOU 3060 C ARG B 75 5416 4086 5831 -884 -620 -126 C \nATOM 3061 O ARG B 75 8.376 -3.747 -46.104 1.00 39.02 O \nANISOU 3061 O ARG B 75 5262 3912 5653 -881 -630 -127 O \nATOM 3062 CB ARG B 75 9.937 -4.750 -48.737 1.00 46.85 C \nANISOU 3062 CB ARG B 75 6609 4715 6475 -946 -703 -119 C \nATOM 3063 CG ARG B 75 10.250 -5.919 -49.654 1.00 48.10 C \nANISOU 3063 CG ARG B 75 6942 4798 6537 -1112 -735 -89 C \nATOM 3064 CD ARG B 75 9.722 -7.172 -49.016 1.00 56.81 C \nANISOU 3064 CD ARG B 75 8037 5944 7604 -1315 -728 -52 C \nATOM 3065 NE ARG B 75 10.160 -8.392 -49.664 1.00 69.04 N \nANISOU 3065 NE ARG B 75 9783 7437 9011 -1527 -773 -16 N \nATOM 3066 CZ ARG B 75 9.639 -9.599 -49.394 1.00 80.78 C \nANISOU 3066 CZ ARG B 75 11241 9022 10431 -1760 -764 22 C \nATOM 3067 NH1 ARG B 75 8.648 -9.719 -48.508 1.00 85.19 N \nANISOU 3067 NH1 ARG B 75 11578 9728 11063 -1769 -711 21 N \nATOM 3068 NH2 ARG B 75 10.089 -10.689 -50.020 1.00 77.42 N \nANISOU 3068 NH2 ARG B 75 11008 8565 9843 -1996 -811 62 N \nATOM 3069 N ARG B 76 7.884 -2.333 -47.748 1.00 40.97 N \nANISOU 3069 N ARG B 76 5375 4230 5961 -805 -597 -141 N \nATOM 3070 CA ARG B 76 7.596 -1.232 -46.749 1.00 40.00 C \nANISOU 3070 CA ARG B 76 5132 4193 5873 -739 -585 -153 C \nATOM 3071 C ARG B 76 6.375 -1.522 -45.962 1.00 36.20 C \nANISOU 3071 C ARG B 76 4558 3744 5454 -821 -560 -132 C \nATOM 3072 O ARG B 76 6.406 -1.592 -44.737 1.00 32.64 O \nANISOU 3072 O ARG B 76 4094 3305 5001 -819 -565 -132 O \nATOM 3073 CB ARG B 76 7.428 0.084 -47.470 1.00 37.81 C \nANISOU 3073 CB ARG B 76 4763 3995 5609 -688 -572 -164 C \nATOM 3074 CG ARG B 76 8.697 0.590 -48.148 1.00 37.48 C \nANISOU 3074 CG ARG B 76 4791 3964 5488 -565 -600 -198 C \nATOM 3075 CD ARG B 76 8.395 1.764 -49.032 1.00 36.11 C \nANISOU 3075 CD ARG B 76 4514 3883 5324 -550 -583 -203 C \nATOM 3076 NE ARG B 76 7.508 1.335 -50.094 1.00 38.47 N \nANISOU 3076 NE ARG B 76 4813 4117 5687 -639 -562 -177 N \nATOM 3077 CZ ARG B 76 6.709 2.164 -50.737 1.00 42.96 C \nANISOU 3077 CZ ARG B 76 5298 4735 6288 -676 -545 -167 C \nATOM 3078 NH1 ARG B 76 6.657 3.467 -50.397 1.00 47.66 N \nANISOU 3078 NH1 ARG B 76 5805 5452 6853 -673 -546 -173 N \nATOM 3079 NH2 ARG B 76 5.979 1.727 -51.708 1.00 43.40 N \nANISOU 3079 NH2 ARG B 76 5365 4737 6386 -725 -533 -153 N \nATOM 3080 N ILE B 77 5.309 -1.874 -46.689 1.00 37.08 N \nANISOU 3080 N ILE B 77 4618 3868 5604 -882 -540 -118 N \nATOM 3081 CA ILE B 77 4.059 -2.308 -46.031 1.00 39.07 C \nANISOU 3081 CA ILE B 77 4798 4157 5890 -928 -529 -108 C \nATOM 3082 C ILE B 77 4.265 -3.510 -45.154 1.00 37.94 C \nANISOU 3082 C ILE B 77 4686 4010 5718 -987 -532 -100 C \nATOM 3083 O ILE B 77 3.715 -3.601 -44.042 1.00 47.77 O \nANISOU 3083 O ILE B 77 5888 5281 6981 -992 -530 -98 O \nATOM 3084 CB ILE B 77 2.997 -2.652 -47.104 1.00 46.75 C \nANISOU 3084 CB ILE B 77 5725 5167 6870 -943 -518 -109 C \nATOM 3085 CG1 ILE B 77 2.623 -1.438 -47.921 1.00 47.63 C \nANISOU 3085 CG1 ILE B 77 5822 5269 7006 -895 -522 -114 C \nATOM 3086 CG2 ILE B 77 1.705 -3.121 -46.440 1.00 56.98 C \nANISOU 3086 CG2 ILE B 77 6959 6522 8171 -940 -519 -113 C \nATOM 3087 CD1 ILE B 77 2.228 -0.251 -47.054 1.00 48.16 C \nANISOU 3087 CD1 ILE B 77 5875 5334 7087 -882 -537 -110 C \nATOM 3088 N GLU B 78 5.025 -4.478 -45.624 1.00 38.79 N \nANISOU 3088 N GLU B 78 4886 4087 5766 -1051 -542 -92 N \nATOM 3089 CA GLU B 78 5.227 -5.714 -44.846 1.00 43.94 C \nANISOU 3089 CA GLU B 78 5588 4742 6363 -1151 -552 -77 C \nATOM 3090 C GLU B 78 5.936 -5.441 -43.557 1.00 42.56 C \nANISOU 3090 C GLU B 78 5476 4508 6186 -1103 -573 -82 C \nATOM 3091 O GLU B 78 5.595 -5.963 -42.521 1.00 55.79 O \nANISOU 3091 O GLU B 78 7123 6212 7862 -1146 -570 -75 O \nATOM 3092 CB GLU B 78 6.021 -6.693 -45.714 1.00 53.36 C \nANISOU 3092 CB GLU B 78 6919 5895 7461 -1263 -575 -61 C \nATOM 3093 CG GLU B 78 6.302 -8.038 -45.054 1.00 65.60 C \nANISOU 3093 CG GLU B 78 8554 7453 8916 -1422 -596 -36 C \nATOM 3094 CD GLU B 78 7.121 -8.947 -45.952 1.00 76.54 C \nANISOU 3094 CD GLU B 78 10121 8785 10175 -1574 -634 -12 C \nATOM 3095 OE1 GLU B 78 6.715 -10.110 -46.167 1.00 96.28 O \nANISOU 3095 OE1 GLU B 78 12591 11406 12586 -1766 -628 14 O \nATOM 3096 OE2 GLU B 78 8.175 -8.504 -46.467 1.00 79.47 O \nANISOU 3096 OE2 GLU B 78 10670 9009 10514 -1507 -675 -20 O \nATOM 3097 N ASN B 79 6.914 -4.571 -43.620 1.00 46.13 N \nANISOU 3097 N ASN B 79 6000 4900 6625 -996 -595 -101 N \nATOM 3098 CA ASN B 79 7.707 -4.209 -42.458 1.00 52.11 C \nANISOU 3098 CA ASN B 79 6813 5630 7355 -914 -621 -117 C \nATOM 3099 C ASN B 79 6.812 -3.431 -41.515 1.00 48.89 C \nANISOU 3099 C ASN B 79 6246 5310 7020 -890 -592 -118 C \nATOM 3100 O ASN B 79 6.913 -3.581 -40.292 1.00 41.92 O \nANISOU 3100 O ASN B 79 5364 4432 6132 -886 -599 -119 O \nATOM 3101 CB ASN B 79 8.912 -3.348 -42.876 1.00 55.19 C \nANISOU 3101 CB ASN B 79 7289 5994 7685 -764 -655 -151 C \nATOM 3102 CG ASN B 79 9.911 -3.180 -41.764 1.00 62.44 C \nANISOU 3102 CG ASN B 79 8297 6897 8531 -649 -698 -179 C \nATOM 3103 OD1 ASN B 79 10.112 -2.092 -41.292 1.00 63.10 O \nANISOU 3103 OD1 ASN B 79 8280 7086 8607 -532 -694 -208 O \nATOM 3104 ND2 ASN B 79 10.545 -4.278 -41.339 1.00 70.89 N \nANISOU 3104 ND2 ASN B 79 9562 7847 9525 -691 -744 -172 N \nATOM 3105 N LEU B 80 5.978 -2.560 -42.099 1.00 44.48 N \nANISOU 3105 N LEU B 80 5576 4809 6514 -881 -568 -117 N \nATOM 3106 CA LEU B 80 4.984 -1.801 -41.322 1.00 44.89 C \nANISOU 3106 CA LEU B 80 5521 4922 6613 -890 -555 -112 C \nATOM 3107 C LEU B 80 4.062 -2.742 -40.576 1.00 42.77 C \nANISOU 3107 C LEU B 80 5230 4652 6369 -951 -548 -98 C \nATOM 3108 O LEU B 80 3.839 -2.600 -39.370 1.00 40.42 O \nANISOU 3108 O LEU B 80 4907 4371 6081 -954 -552 -96 O \nATOM 3109 CB LEU B 80 4.183 -0.884 -42.271 1.00 46.13 C \nANISOU 3109 CB LEU B 80 5624 5107 6795 -894 -548 -108 C \nATOM 3110 CG LEU B 80 3.008 -0.112 -41.713 1.00 48.20 C \nANISOU 3110 CG LEU B 80 5841 5395 7077 -928 -555 -97 C \nATOM 3111 CD1 LEU B 80 3.319 0.507 -40.383 1.00 56.08 C \nANISOU 3111 CD1 LEU B 80 6811 6445 8052 -939 -564 -95 C \nATOM 3112 CD2 LEU B 80 2.605 0.974 -42.631 1.00 49.46 C \nANISOU 3112 CD2 LEU B 80 5995 5571 7227 -940 -564 -93 C \nATOM 3113 N ASN B 81 3.516 -3.728 -41.297 1.00 44.52 N \nANISOU 3113 N ASN B 81 5449 4881 6587 -998 -539 -93 N \nATOM 3114 CA ASN B 81 2.741 -4.790 -40.636 1.00 50.36 C \nANISOU 3114 CA ASN B 81 6149 5669 7317 -1048 -534 -88 C \nATOM 3115 C ASN B 81 3.554 -5.502 -39.534 1.00 53.38 C \nANISOU 3115 C ASN B 81 6589 6024 7668 -1095 -543 -79 C \nATOM 3116 O ASN B 81 3.073 -5.702 -38.435 1.00 51.79 O \nANISOU 3116 O ASN B 81 6349 5850 7479 -1101 -542 -78 O \nATOM 3117 CB ASN B 81 2.336 -5.851 -41.651 1.00 55.20 C \nANISOU 3117 CB ASN B 81 6736 6352 7886 -1105 -524 -87 C \nATOM 3118 CG ASN B 81 1.268 -6.782 -41.124 1.00 59.04 C \nANISOU 3118 CG ASN B 81 7134 6960 8340 -1126 -518 -95 C \nATOM 3119 OD1 ASN B 81 0.107 -6.403 -41.027 1.00 61.43 O \nANISOU 3119 OD1 ASN B 81 7377 7305 8657 -1039 -525 -114 O \nATOM 3120 ND2 ASN B 81 1.661 -7.966 -40.729 1.00 58.60 N \nANISOU 3120 ND2 ASN B 81 7085 6961 8218 -1237 -515 -82 N \nATOM 3121 N LYS B 82 4.775 -5.921 -39.849 1.00 51.21 N \nANISOU 3121 N LYS B 82 6433 5684 7339 -1125 -561 -75 N \nATOM 3122 CA LYS B 82 5.582 -6.599 -38.851 1.00 64.17 C \nANISOU 3122 CA LYS B 82 8177 7275 8929 -1166 -585 -68 C \nATOM 3123 C LYS B 82 5.769 -5.746 -37.591 1.00 72.57 C \nANISOU 3123 C LYS B 82 9213 8332 10027 -1073 -590 -81 C \nATOM 3124 O LYS B 82 5.684 -6.255 -36.474 1.00 73.38 O \nANISOU 3124 O LYS B 82 9318 8438 10123 -1107 -594 -75 O \nATOM 3125 CB LYS B 82 6.929 -6.939 -39.431 1.00 75.20 C \nANISOU 3125 CB LYS B 82 9767 8566 10240 -1177 -626 -68 C \nATOM 3126 CG LYS B 82 7.894 -7.554 -38.445 1.00 81.84 C \nANISOU 3126 CG LYS B 82 10777 9318 11001 -1198 -673 -65 C \nATOM 3127 CD LYS B 82 7.482 -8.969 -38.076 1.00 93.67 C \nANISOU 3127 CD LYS B 82 12293 10853 12444 -1390 -673 -32 C \nATOM 3128 CE LYS B 82 8.623 -9.699 -37.380 1.00100.12 C \nANISOU 3128 CE LYS B 82 13357 11539 13145 -1446 -739 -22 C \nATOM 3129 NZ LYS B 82 9.242 -8.952 -36.240 1.00101.87 N \nANISOU 3129 NZ LYS B 82 13621 11699 13384 -1274 -763 -52 N \nATOM 3130 N LYS B 83 6.039 -4.448 -37.756 1.00 76.67 N \nANISOU 3130 N LYS B 83 9697 8865 10568 -968 -590 -99 N \nATOM 3131 CA LYS B 83 6.316 -3.575 -36.602 1.00 71.27 C \nANISOU 3131 CA LYS B 83 8973 8222 9886 -896 -597 -113 C \nATOM 3132 C LYS B 83 5.099 -3.260 -35.767 1.00 60.54 C \nANISOU 3132 C LYS B 83 7501 6918 8584 -939 -577 -100 C \nATOM 3133 O LYS B 83 5.189 -3.134 -34.526 1.00 57.23 O \nANISOU 3133 O LYS B 83 7064 6520 8160 -930 -582 -101 O \nATOM 3134 CB LYS B 83 6.952 -2.275 -37.034 1.00 82.26 C \nANISOU 3134 CB LYS B 83 10335 9675 11246 -794 -604 -138 C \nATOM 3135 CG LYS B 83 8.385 -2.436 -37.564 1.00 94.74 C \nANISOU 3135 CG LYS B 83 12057 11204 12737 -688 -643 -167 C \nATOM 3136 CD LYS B 83 9.086 -3.736 -37.114 1.00 97.08 C \nANISOU 3136 CD LYS B 83 12536 11374 12974 -709 -682 -163 C \nATOM 3137 CE LYS B 83 10.558 -3.849 -37.518 1.00 95.45 C \nANISOU 3137 CE LYS B 83 12540 11083 12645 -579 -747 -198 C \nATOM 3138 NZ LYS B 83 10.965 -5.252 -37.811 1.00 91.38 N \nANISOU 3138 NZ LYS B 83 12253 10403 12064 -688 -791 -174 N \nATOM 3139 N MET B 84 3.954 -3.179 -36.416 1.00 53.44 N \nANISOU 3139 N MET B 84 6547 6033 7726 -976 -562 -90 N \nATOM 3140 CA MET B 84 2.684 -3.149 -35.680 1.00 50.19 C \nANISOU 3140 CA MET B 84 6081 5642 7345 -1004 -562 -81 C \nATOM 3141 C MET B 84 2.521 -4.326 -34.747 1.00 51.61 C \nANISOU 3141 C MET B 84 6263 5825 7521 -1038 -559 -77 C \nATOM 3142 O MET B 84 2.131 -4.168 -33.579 1.00 55.99 O \nANISOU 3142 O MET B 84 6797 6391 8087 -1040 -565 -74 O \nATOM 3143 CB MET B 84 1.489 -3.138 -36.618 1.00 52.10 C \nANISOU 3143 CB MET B 84 6305 5890 7602 -1000 -563 -82 C \nATOM 3144 CG MET B 84 0.221 -2.761 -35.880 1.00 54.89 C \nANISOU 3144 CG MET B 84 6656 6242 7959 -992 -586 -80 C \nATOM 3145 SD MET B 84 -1.169 -2.761 -36.917 1.00 68.56 S \nANISOU 3145 SD MET B 84 8410 7968 9673 -936 -610 -95 S \nATOM 3146 CE MET B 84 -1.428 -4.547 -37.023 1.00 49.19 C \nANISOU 3146 CE MET B 84 5884 5615 7192 -917 -588 -114 C \nATOM 3147 N GLU B 85 2.817 -5.529 -35.229 1.00 56.11 N \nANISOU 3147 N GLU B 85 6862 6397 8059 -1085 -553 -74 N \nATOM 3148 CA GLU B 85 2.705 -6.743 -34.358 1.00 58.78 C \nANISOU 3148 CA GLU B 85 7199 6767 8368 -1151 -553 -67 C \nATOM 3149 C GLU B 85 3.724 -6.801 -33.264 1.00 56.66 C \nANISOU 3149 C GLU B 85 7006 6442 8082 -1155 -568 -63 C \nATOM 3150 O GLU B 85 3.375 -7.035 -32.118 1.00 65.16 O \nANISOU 3150 O GLU B 85 8051 7539 9168 -1166 -568 -61 O \nATOM 3151 CB GLU B 85 2.755 -8.030 -35.166 1.00 71.20 C \nANISOU 3151 CB GLU B 85 8784 8393 9874 -1250 -548 -59 C \nATOM 3152 CG GLU B 85 1.726 -8.133 -36.297 1.00 78.95 C \nANISOU 3152 CG GLU B 85 9675 9471 10849 -1231 -534 -70 C \nATOM 3153 CD GLU B 85 0.281 -7.900 -35.856 1.00 86.77 C \nANISOU 3153 CD GLU B 85 10568 10539 11860 -1143 -535 -92 C \nATOM 3154 OE1 GLU B 85 -0.020 -7.849 -34.635 1.00 91.61 O \nANISOU 3154 OE1 GLU B 85 11171 11146 12490 -1123 -543 -93 O \nATOM 3155 OE2 GLU B 85 -0.575 -7.781 -36.763 1.00 96.31 O \nANISOU 3155 OE2 GLU B 85 11728 11810 13054 -1080 -537 -111 O \nATOM 3156 N ASP B 86 4.979 -6.563 -33.577 1.00 63.95 N \nANISOU 3156 N ASP B 86 8036 7293 8967 -1123 -589 -69 N \nATOM 3157 CA ASP B 86 6.008 -6.438 -32.517 1.00 69.94 C \nANISOU 3157 CA ASP B 86 8882 8004 9690 -1073 -616 -78 C \nATOM 3158 C ASP B 86 5.639 -5.307 -31.568 1.00 73.52 C \nANISOU 3158 C ASP B 86 9228 8519 10188 -1003 -605 -89 C \nATOM 3159 O ASP B 86 5.827 -5.425 -30.373 1.00 80.98 O \nANISOU 3159 O ASP B 86 10178 9467 11123 -994 -614 -90 O \nATOM 3160 CB ASP B 86 7.395 -6.140 -33.104 1.00 78.80 C \nANISOU 3160 CB ASP B 86 10148 9053 10738 -986 -655 -99 C \nATOM 3161 CG ASP B 86 7.902 -7.251 -34.002 1.00 91.79 C \nANISOU 3161 CG ASP B 86 11955 10611 12310 -1080 -682 -83 C \nATOM 3162 OD1 ASP B 86 7.440 -8.405 -33.853 1.00105.51 O \nANISOU 3162 OD1 ASP B 86 13704 12359 14026 -1232 -677 -55 O \nATOM 3163 OD2 ASP B 86 8.770 -6.982 -34.867 1.00 99.79 O \nANISOU 3163 OD2 ASP B 86 13089 11560 13267 -1013 -714 -99 O \nATOM 3164 N GLY B 87 5.130 -4.208 -32.120 1.00 71.49 N \nANISOU 3164 N GLY B 87 8885 8313 9964 -973 -591 -92 N \nATOM 3165 CA GLY B 87 4.732 -3.054 -31.319 1.00 70.78 C \nANISOU 3165 CA GLY B 87 8708 8298 9888 -956 -588 -94 C \nATOM 3166 C GLY B 87 3.738 -3.419 -30.229 1.00 64.61 C \nANISOU 3166 C GLY B 87 7890 7516 9141 -1011 -584 -78 C \nATOM 3167 O GLY B 87 4.010 -3.168 -29.055 1.00 74.70 O \nANISOU 3167 O GLY B 87 9152 8827 10405 -1002 -591 -80 O \nATOM 3168 N PHE B 88 2.605 -4.008 -30.607 1.00 46.50 N \nANISOU 3168 N PHE B 88 5584 5204 6880 -1050 -578 -68 N \nATOM 3169 CA PHE B 88 1.580 -4.382 -29.638 1.00 49.54 C \nANISOU 3169 CA PHE B 88 5943 5597 7281 -1072 -583 -62 C \nATOM 3170 C PHE B 88 1.965 -5.518 -28.733 1.00 55.89 C \nANISOU 3170 C PHE B 88 6759 6403 8074 -1098 -578 -61 C \nATOM 3171 O PHE B 88 1.563 -5.574 -27.555 1.00 60.19 O \nANISOU 3171 O PHE B 88 7284 6958 8626 -1105 -583 -58 O \nATOM 3172 CB PHE B 88 0.274 -4.742 -30.334 1.00 47.37 C \nANISOU 3172 CB PHE B 88 5655 5332 7010 -1058 -588 -68 C \nATOM 3173 CG PHE B 88 -0.460 -3.565 -30.876 1.00 40.60 C \nANISOU 3173 CG PHE B 88 4826 4450 6152 -1041 -612 -66 C \nATOM 3174 CD1 PHE B 88 -0.866 -2.532 -30.037 1.00 43.85 C \nANISOU 3174 CD1 PHE B 88 5270 4841 6549 -1071 -640 -53 C \nATOM 3175 CD2 PHE B 88 -0.774 -3.507 -32.161 1.00 40.44 C \nANISOU 3175 CD2 PHE B 88 4815 4425 6127 -1015 -613 -73 C \nATOM 3176 CE1 PHE B 88 -1.575 -1.428 -30.513 1.00 44.49 C \nANISOU 3176 CE1 PHE B 88 5418 4887 6600 -1095 -676 -44 C \nATOM 3177 CE2 PHE B 88 -1.496 -2.407 -32.660 1.00 44.54 C \nANISOU 3177 CE2 PHE B 88 5392 4903 6629 -1010 -646 -69 C \nATOM 3178 CZ PHE B 88 -1.865 -1.362 -31.843 1.00 42.13 C \nANISOU 3178 CZ PHE B 88 5142 4568 6298 -1061 -680 -52 C \nATOM 3179 N LEU B 89 2.818 -6.385 -29.245 1.00 68.36 N \nANISOU 3179 N LEU B 89 8390 7962 9621 -1125 -575 -61 N \nATOM 3180 CA LEU B 89 3.330 -7.507 -28.456 1.00 76.68 C \nANISOU 3180 CA LEU B 89 9493 9004 10638 -1182 -581 -54 C \nATOM 3181 C LEU B 89 4.188 -7.001 -27.308 1.00 77.95 C \nANISOU 3181 C LEU B 89 9697 9130 10790 -1133 -598 -60 C \nATOM 3182 O LEU B 89 4.045 -7.453 -26.171 1.00 88.60 O \nANISOU 3182 O LEU B 89 11040 10487 12139 -1159 -600 -55 O \nATOM 3183 CB LEU B 89 4.142 -8.422 -29.360 1.00 89.00 C \nANISOU 3183 CB LEU B 89 11154 10529 12133 -1250 -592 -46 C \nATOM 3184 CG LEU B 89 4.868 -9.604 -28.717 1.00 99.12 C \nANISOU 3184 CG LEU B 89 12550 11773 13338 -1347 -616 -32 C \nATOM 3185 CD1 LEU B 89 5.061 -10.748 -29.697 1.00 93.64 C \nANISOU 3185 CD1 LEU B 89 11928 11096 12557 -1491 -626 -12 C \nATOM 3186 CD2 LEU B 89 6.222 -9.130 -28.218 1.00104.81 C \nANISOU 3186 CD2 LEU B 89 13420 12382 14022 -1263 -656 -45 C \nATOM 3187 N ASP B 90 5.086 -6.066 -27.615 1.00 78.85 N \nANISOU 3187 N ASP B 90 9845 9230 10884 -1051 -610 -76 N \nATOM 3188 CA ASP B 90 5.950 -5.442 -26.607 1.00 83.84 C \nANISOU 3188 CA ASP B 90 10495 9882 11479 -969 -629 -95 C \nATOM 3189 C ASP B 90 5.096 -4.828 -25.500 1.00 79.05 C \nANISOU 3189 C ASP B 90 9777 9346 10913 -992 -615 -86 C \nATOM 3190 O ASP B 90 5.309 -5.100 -24.332 1.00 85.98 O \nANISOU 3190 O ASP B 90 10664 10226 11777 -987 -623 -88 O \nATOM 3191 CB ASP B 90 6.852 -4.378 -27.234 1.00 95.93 C \nANISOU 3191 CB ASP B 90 12030 11458 12959 -858 -644 -123 C \nATOM 3192 CG ASP B 90 8.027 -4.975 -28.014 1.00111.70 C \nANISOU 3192 CG ASP B 90 14198 13363 14882 -796 -681 -141 C \nATOM 3193 OD1 ASP B 90 8.061 -6.213 -28.258 1.00115.01 O \nANISOU 3193 OD1 ASP B 90 14736 13676 15287 -886 -694 -121 O \nATOM 3194 OD2 ASP B 90 8.926 -4.179 -28.390 1.00135.78 O \nANISOU 3194 OD2 ASP B 90 17269 16458 17862 -662 -704 -176 O \nATOM 3195 N VAL B 91 4.113 -4.022 -25.888 1.00 71.83 N \nANISOU 3195 N VAL B 91 8784 8474 10035 -1024 -602 -76 N \nATOM 3196 CA VAL B 91 3.235 -3.324 -24.957 1.00 64.95 C \nANISOU 3196 CA VAL B 91 7852 7649 9178 -1067 -604 -63 C \nATOM 3197 C VAL B 91 2.481 -4.311 -24.099 1.00 69.51 C \nANISOU 3197 C VAL B 91 8439 8186 9788 -1102 -603 -53 C \nATOM 3198 O VAL B 91 2.512 -4.221 -22.873 1.00 74.62 O \nANISOU 3198 O VAL B 91 9070 8855 10428 -1111 -609 -50 O \nATOM 3199 CB VAL B 91 2.235 -2.475 -25.715 1.00 62.75 C \nANISOU 3199 CB VAL B 91 7557 7376 8909 -1110 -609 -50 C \nATOM 3200 CG1 VAL B 91 1.176 -1.915 -24.783 1.00 67.71 C \nANISOU 3200 CG1 VAL B 91 8188 8009 9531 -1175 -631 -31 C \nATOM 3201 CG2 VAL B 91 2.955 -1.339 -26.414 1.00 64.07 C \nANISOU 3201 CG2 VAL B 91 7692 7624 9028 -1096 -610 -58 C \nATOM 3202 N TRP B 92 1.839 -5.289 -24.732 1.00 69.44 N \nANISOU 3202 N TRP B 92 8442 8144 9798 -1117 -596 -51 N \nATOM 3203 CA TRP B 92 1.080 -6.328 -23.978 1.00 69.01 C \nANISOU 3203 CA TRP B 92 8372 8098 9750 -1141 -596 -48 C \nATOM 3204 C TRP B 92 1.907 -7.250 -23.109 1.00 74.33 C \nANISOU 3204 C TRP B 92 9074 8765 10404 -1170 -593 -46 C \nATOM 3205 O TRP B 92 1.485 -7.639 -22.022 1.00 85.43 O \nANISOU 3205 O TRP B 92 10459 10188 11814 -1186 -596 -43 O \nATOM 3206 CB TRP B 92 0.221 -7.182 -24.918 1.00 64.65 C \nANISOU 3206 CB TRP B 92 7795 7581 9186 -1141 -591 -56 C \nATOM 3207 CG TRP B 92 -0.995 -6.432 -25.370 1.00 60.85 C \nANISOU 3207 CG TRP B 92 7314 7095 8710 -1087 -612 -64 C \nATOM 3208 CD1 TRP B 92 -1.306 -6.037 -26.638 1.00 58.73 C \nANISOU 3208 CD1 TRP B 92 7058 6819 8438 -1058 -616 -70 C \nATOM 3209 CD2 TRP B 92 -2.040 -5.944 -24.531 1.00 53.48 C \nANISOU 3209 CD2 TRP B 92 6409 6142 7770 -1056 -644 -66 C \nATOM 3210 NE1 TRP B 92 -2.504 -5.349 -26.638 1.00 58.47 N \nANISOU 3210 NE1 TRP B 92 7074 6755 8388 -1008 -656 -77 N \nATOM 3211 CE2 TRP B 92 -2.969 -5.276 -25.352 1.00 57.97 C \nANISOU 3211 CE2 TRP B 92 7034 6676 8317 -1008 -678 -74 C \nATOM 3212 CE3 TRP B 92 -2.286 -6.021 -23.173 1.00 58.23 C \nANISOU 3212 CE3 TRP B 92 7016 6739 8371 -1066 -656 -62 C \nATOM 3213 CZ2 TRP B 92 -4.137 -4.684 -24.850 1.00 64.52 C \nANISOU 3213 CZ2 TRP B 92 7959 7447 9107 -969 -735 -78 C \nATOM 3214 CZ3 TRP B 92 -3.448 -5.411 -22.651 1.00 66.74 C \nANISOU 3214 CZ3 TRP B 92 8167 7771 9420 -1031 -706 -64 C \nATOM 3215 CH2 TRP B 92 -4.360 -4.761 -23.496 1.00 66.79 C \nANISOU 3215 CH2 TRP B 92 8262 7725 9389 -984 -750 -73 C \nATOM 3216 N THR B 93 3.102 -7.581 -23.562 1.00 80.46 N \nANISOU 3216 N THR B 93 9922 9504 11145 -1174 -598 -48 N \nATOM 3217 CA THR B 93 4.049 -8.335 -22.720 1.00 78.03 C \nANISOU 3217 CA THR B 93 9699 9156 10791 -1197 -615 -46 C \nATOM 3218 C THR B 93 4.376 -7.485 -21.496 1.00 72.93 C \nANISOU 3218 C THR B 93 9032 8524 10153 -1131 -623 -56 C \nATOM 3219 O THR B 93 4.216 -7.916 -20.368 1.00 74.98 O \nANISOU 3219 O THR B 93 9285 8788 10414 -1156 -625 -51 O \nATOM 3220 CB THR B 93 5.347 -8.699 -23.498 1.00 83.06 C \nANISOU 3220 CB THR B 93 10484 9716 11359 -1192 -642 -51 C \nATOM 3221 OG1 THR B 93 5.080 -9.750 -24.428 1.00 76.17 O \nANISOU 3221 OG1 THR B 93 9641 8847 10455 -1303 -638 -34 O \nATOM 3222 CG2 THR B 93 6.472 -9.132 -22.554 1.00 82.89 C \nANISOU 3222 CG2 THR B 93 10605 9623 11267 -1170 -682 -58 C \nATOM 3223 N TYR B 94 4.841 -6.269 -21.740 1.00 73.71 N \nANISOU 3223 N TYR B 94 9107 8657 10241 -1054 -627 -72 N \nATOM 3224 CA TYR B 94 5.176 -5.329 -20.679 1.00 72.02 C \nANISOU 3224 CA TYR B 94 8842 8517 10004 -1001 -634 -84 C \nATOM 3225 C TYR B 94 4.078 -5.173 -19.640 1.00 68.40 C \nANISOU 3225 C TYR B 94 8310 8090 9588 -1067 -624 -65 C \nATOM 3226 O TYR B 94 4.360 -5.168 -18.445 1.00 58.01 O \nANISOU 3226 O TYR B 94 6986 6802 8254 -1055 -631 -69 O \nATOM 3227 CB TYR B 94 5.470 -3.965 -21.274 1.00 75.37 C \nANISOU 3227 CB TYR B 94 9202 9040 10394 -951 -634 -99 C \nATOM 3228 CG TYR B 94 5.738 -2.905 -20.243 1.00 82.19 C \nANISOU 3228 CG TYR B 94 9978 10048 11203 -925 -639 -111 C \nATOM 3229 CD1 TYR B 94 7.040 -2.620 -19.843 1.00 80.71 C \nANISOU 3229 CD1 TYR B 94 9799 9950 10919 -790 -662 -153 C \nATOM 3230 CD2 TYR B 94 4.683 -2.187 -19.674 1.00 76.99 C \nANISOU 3230 CD2 TYR B 94 9240 9448 10563 -1033 -632 -84 C \nATOM 3231 CE1 TYR B 94 7.278 -1.649 -18.912 1.00 86.45 C \nANISOU 3231 CE1 TYR B 94 10414 10863 11571 -768 -665 -168 C \nATOM 3232 CE2 TYR B 94 4.917 -1.218 -18.750 1.00 84.83 C \nANISOU 3232 CE2 TYR B 94 10147 10602 11483 -1048 -638 -90 C \nATOM 3233 CZ TYR B 94 6.214 -0.957 -18.381 1.00 90.36 C \nANISOU 3233 CZ TYR B 94 10812 11430 12089 -917 -649 -133 C \nATOM 3234 OH TYR B 94 6.442 0.032 -17.463 1.00132.97 O \nANISOU 3234 OH TYR B 94 16091 17043 17389 -934 -654 -143 O \nATOM 3235 N ASN B 95 2.839 -5.001 -20.089 1.00 66.19 N \nANISOU 3235 N ASN B 95 7997 7802 9352 -1122 -616 -48 N \nATOM 3236 CA ASN B 95 1.746 -4.799 -19.151 1.00 63.99 C \nANISOU 3236 CA ASN B 95 7692 7530 9091 -1168 -624 -34 C \nATOM 3237 C ASN B 95 1.575 -6.016 -18.268 1.00 69.69 C \nANISOU 3237 C ASN B 95 8426 8224 9829 -1176 -620 -33 C \nATOM 3238 O ASN B 95 1.653 -5.919 -17.022 1.00 74.23 O \nANISOU 3238 O ASN B 95 8988 8817 10398 -1185 -626 -30 O \nATOM 3239 CB ASN B 95 0.428 -4.501 -19.872 1.00 65.51 C \nANISOU 3239 CB ASN B 95 7900 7691 9298 -1190 -637 -25 C \nATOM 3240 CG ASN B 95 0.389 -3.098 -20.481 1.00 66.87 C \nANISOU 3240 CG ASN B 95 8076 7895 9439 -1224 -650 -16 C \nATOM 3241 OD1 ASN B 95 1.062 -2.154 -20.019 1.00 73.12 O \nANISOU 3241 OD1 ASN B 95 8825 8772 10184 -1255 -651 -13 O \nATOM 3242 ND2 ASN B 95 -0.403 -2.954 -21.511 1.00 67.53 N \nANISOU 3242 ND2 ASN B 95 8199 7932 9526 -1222 -663 -14 N \nATOM 3243 N ALA B 96 1.377 -7.168 -18.890 1.00 64.41 N \nANISOU 3243 N ALA B 96 7771 7536 9165 -1187 -612 -35 N \nATOM 3244 CA ALA B 96 1.112 -8.386 -18.119 1.00 75.22 C \nANISOU 3244 CA ALA B 96 9134 8918 10526 -1221 -609 -33 C \nATOM 3245 C ALA B 96 2.183 -8.662 -17.036 1.00 84.92 C \nANISOU 3245 C ALA B 96 10407 10123 11734 -1230 -615 -32 C \nATOM 3246 O ALA B 96 1.865 -9.002 -15.893 1.00 82.79 O \nANISOU 3246 O ALA B 96 10120 9867 11470 -1247 -617 -28 O \nATOM 3247 CB ALA B 96 1.009 -9.563 -19.057 1.00 79.77 C \nANISOU 3247 CB ALA B 96 9710 9528 11073 -1264 -599 -34 C \nATOM 3248 N GLU B 97 3.455 -8.472 -17.385 1.00 92.75 N \nANISOU 3248 N GLU B 97 11472 11077 12691 -1198 -626 -40 N \nATOM 3249 CA GLU B 97 4.544 -8.692 -16.430 1.00 92.19 C \nANISOU 3249 CA GLU B 97 11479 10974 12574 -1168 -648 -48 C \nATOM 3250 C GLU B 97 4.541 -7.698 -15.275 1.00 88.97 C \nANISOU 3250 C GLU B 97 11003 10626 12174 -1115 -649 -57 C \nATOM 3251 O GLU B 97 4.758 -8.084 -14.136 1.00 79.21 O \nANISOU 3251 O GLU B 97 9787 9385 10924 -1117 -658 -58 O \nATOM 3252 CB GLU B 97 5.893 -8.655 -17.123 1.00 97.24 C \nANISOU 3252 CB GLU B 97 12246 11556 13144 -1102 -678 -67 C \nATOM 3253 CG GLU B 97 6.034 -9.687 -18.227 1.00 98.95 C \nANISOU 3253 CG GLU B 97 12562 11706 13327 -1186 -687 -52 C \nATOM 3254 CD GLU B 97 7.362 -10.397 -18.180 1.00 98.95 C \nANISOU 3254 CD GLU B 97 12785 11592 13220 -1179 -743 -59 C \nATOM 3255 OE1 GLU B 97 7.840 -10.687 -17.070 1.00107.38 O \nANISOU 3255 OE1 GLU B 97 13927 12625 14247 -1158 -771 -64 O \nATOM 3256 OE2 GLU B 97 7.909 -10.687 -19.246 1.00 97.81 O \nANISOU 3256 OE2 GLU B 97 12763 11381 13020 -1196 -768 -58 O \nATOM 3257 N LEU B 98 4.319 -6.417 -15.562 1.00 85.26 N \nANISOU 3257 N LEU B 98 10457 10229 11709 -1087 -642 -62 N \nATOM 3258 CA LEU B 98 4.261 -5.410 -14.475 1.00 80.87 C \nANISOU 3258 CA LEU B 98 9825 9771 11132 -1080 -645 -64 C \nATOM 3259 C LEU B 98 2.963 -5.440 -13.721 1.00 66.03 C \nANISOU 3259 C LEU B 98 7908 7881 9299 -1164 -640 -39 C \nATOM 3260 O LEU B 98 2.925 -5.123 -12.541 1.00 62.69 O \nANISOU 3260 O LEU B 98 7454 7506 8859 -1180 -646 -36 O \nATOM 3261 CB LEU B 98 4.521 -3.995 -14.974 1.00 89.12 C \nANISOU 3261 CB LEU B 98 10798 10937 12126 -1060 -646 -74 C \nATOM 3262 CG LEU B 98 5.979 -3.700 -15.377 1.00 96.70 C \nANISOU 3262 CG LEU B 98 11776 11964 13000 -923 -661 -115 C \nATOM 3263 CD1 LEU B 98 6.182 -2.198 -15.399 1.00104.89 C \nANISOU 3263 CD1 LEU B 98 12687 13211 13954 -917 -661 -128 C \nATOM 3264 CD2 LEU B 98 7.016 -4.310 -14.451 1.00 97.24 C \nANISOU 3264 CD2 LEU B 98 11918 12017 13013 -816 -687 -145 C \nATOM 3265 N LEU B 99 1.927 -5.915 -14.367 1.00 63.60 N \nANISOU 3265 N LEU B 99 7617 7515 9035 -1202 -636 -27 N \nATOM 3266 CA LEU B 99 0.699 -6.160 -13.640 1.00 65.42 C \nANISOU 3266 CA LEU B 99 7845 7724 9288 -1239 -646 -14 C \nATOM 3267 C LEU B 99 0.900 -7.218 -12.573 1.00 74.28 C \nANISOU 3267 C LEU B 99 8968 8837 10417 -1240 -641 -16 C \nATOM 3268 O LEU B 99 0.442 -7.057 -11.459 1.00 91.07 O \nANISOU 3268 O LEU B 99 11084 10974 12545 -1258 -651 -10 O \nATOM 3269 CB LEU B 99 -0.409 -6.606 -14.578 1.00 62.35 C \nANISOU 3269 CB LEU B 99 7474 7301 8916 -1229 -652 -16 C \nATOM 3270 CG LEU B 99 -1.744 -6.862 -13.870 1.00 70.61 C \nANISOU 3270 CG LEU B 99 8541 8331 9958 -1219 -678 -16 C \nATOM 3271 CD1 LEU B 99 -2.198 -5.631 -13.105 1.00 65.83 C \nANISOU 3271 CD1 LEU B 99 7984 7704 9326 -1266 -712 1 C \nATOM 3272 CD2 LEU B 99 -2.832 -7.283 -14.860 1.00 75.56 C \nANISOU 3272 CD2 LEU B 99 9187 8953 10569 -1159 -694 -33 C \nATOM 3273 N VAL B 100 1.586 -8.306 -12.916 1.00 81.29 N \nANISOU 3273 N VAL B 100 9887 9704 11297 -1237 -631 -22 N \nATOM 3274 CA VAL B 100 1.791 -9.423 -11.980 1.00 71.14 C \nANISOU 3274 CA VAL B 100 8620 8410 9998 -1268 -632 -20 C \nATOM 3275 C VAL B 100 2.692 -9.033 -10.817 1.00 71.93 C \nANISOU 3275 C VAL B 100 8744 8509 10079 -1238 -643 -25 C \nATOM 3276 O VAL B 100 2.333 -9.238 -9.663 1.00 84.90 O \nANISOU 3276 O VAL B 100 10363 10164 11730 -1256 -645 -20 O \nATOM 3277 CB VAL B 100 2.360 -10.646 -12.702 1.00 67.44 C \nANISOU 3277 CB VAL B 100 8213 7921 9490 -1319 -631 -17 C \nATOM 3278 CG1 VAL B 100 2.969 -11.633 -11.731 1.00 67.42 C \nANISOU 3278 CG1 VAL B 100 8277 7896 9445 -1372 -645 -11 C \nATOM 3279 CG2 VAL B 100 1.253 -11.333 -13.493 1.00 70.56 C \nANISOU 3279 CG2 VAL B 100 8544 8383 9884 -1358 -618 -16 C \nATOM 3280 N LEU B 101 3.852 -8.473 -11.117 1.00 68.89 N \nANISOU 3280 N LEU B 101 8400 8122 9652 -1174 -655 -41 N \nATOM 3281 CA LEU B 101 4.802 -8.054 -10.067 1.00 73.38 C \nANISOU 3281 CA LEU B 101 8986 8726 10171 -1103 -673 -60 C \nATOM 3282 C LEU B 101 4.142 -7.122 -9.069 1.00 75.13 C \nANISOU 3282 C LEU B 101 9100 9038 10407 -1125 -664 -53 C \nATOM 3283 O LEU B 101 4.187 -7.355 -7.880 1.00 77.99 O \nANISOU 3283 O LEU B 101 9458 9412 10764 -1129 -670 -52 O \nATOM 3284 CB LEU B 101 6.048 -7.358 -10.670 1.00 73.24 C \nANISOU 3284 CB LEU B 101 9007 8742 10077 -983 -695 -93 C \nATOM 3285 CG LEU B 101 6.920 -8.184 -11.640 1.00 75.17 C \nANISOU 3285 CG LEU B 101 9413 8874 10275 -949 -723 -104 C \nATOM 3286 CD1 LEU B 101 8.069 -7.374 -12.210 1.00 70.03 C \nANISOU 3286 CD1 LEU B 101 8804 8270 9535 -792 -752 -146 C \nATOM 3287 CD2 LEU B 101 7.449 -9.423 -10.943 1.00 80.59 C \nANISOU 3287 CD2 LEU B 101 10252 9451 10916 -976 -756 -100 C \nATOM 3288 N MET B 102 3.517 -6.067 -9.574 1.00 78.16 N \nANISOU 3288 N MET B 102 9417 9482 10798 -1159 -657 -43 N \nATOM 3289 CA MET B 102 2.892 -5.063 -8.720 1.00 75.38 C \nANISOU 3289 CA MET B 102 8997 9218 10428 -1223 -662 -29 C \nATOM 3290 C MET B 102 1.833 -5.711 -7.864 1.00 79.94 C \nANISOU 3290 C MET B 102 9597 9723 11054 -1280 -665 -9 C \nATOM 3291 O MET B 102 1.787 -5.507 -6.659 1.00 77.43 O \nANISOU 3291 O MET B 102 9255 9448 10718 -1305 -672 -4 O \nATOM 3292 CB MET B 102 2.276 -3.952 -9.577 1.00 73.44 C \nANISOU 3292 CB MET B 102 8725 9016 10163 -1290 -666 -13 C \nATOM 3293 CG MET B 102 3.294 -2.926 -10.079 1.00 76.01 C \nANISOU 3293 CG MET B 102 8982 9494 10404 -1249 -665 -34 C \nATOM 3294 SD MET B 102 2.649 -1.869 -11.373 1.00 79.55 S \nANISOU 3294 SD MET B 102 9423 9971 10830 -1339 -670 -14 S \nATOM 3295 CE MET B 102 0.935 -1.713 -10.917 1.00 72.27 C \nANISOU 3295 CE MET B 102 8586 8939 9934 -1484 -699 30 C \nATOM 3296 N GLU B 103 0.997 -6.526 -8.497 1.00 81.30 N \nANISOU 3296 N GLU B 103 9808 9807 11274 -1289 -663 -3 N \nATOM 3297 CA GLU B 103 -0.180 -7.068 -7.838 1.00 71.14 C \nANISOU 3297 CA GLU B 103 8539 8479 10011 -1312 -675 7 C \nATOM 3298 C GLU B 103 0.165 -8.210 -6.905 1.00 66.51 C \nANISOU 3298 C GLU B 103 7947 7887 9436 -1302 -665 1 C \nATOM 3299 O GLU B 103 -0.518 -8.440 -5.896 1.00 60.55 O \nANISOU 3299 O GLU B 103 7191 7130 8687 -1317 -675 6 O \nATOM 3300 CB GLU B 103 -1.193 -7.525 -8.887 1.00 69.09 C \nANISOU 3300 CB GLU B 103 8306 8180 9767 -1290 -682 2 C \nATOM 3301 CG GLU B 103 -2.618 -7.142 -8.534 1.00 81.75 C \nANISOU 3301 CG GLU B 103 9966 9744 11349 -1289 -723 6 C \nATOM 3302 CD GLU B 103 -2.850 -5.640 -8.449 1.00 87.92 C \nANISOU 3302 CD GLU B 103 10807 10511 12089 -1362 -756 29 C \nATOM 3303 OE1 GLU B 103 -3.890 -5.244 -7.887 1.00 89.68 O \nANISOU 3303 OE1 GLU B 103 11125 10678 12270 -1386 -806 38 O \nATOM 3304 OE2 GLU B 103 -1.999 -4.857 -8.916 1.00 99.70 O \nANISOU 3304 OE2 GLU B 103 12260 12056 13567 -1404 -740 36 O \nATOM 3305 N ASN B 104 1.211 -8.954 -7.243 1.00 66.22 N \nANISOU 3305 N ASN B 104 7932 7839 9390 -1284 -653 -8 N \nATOM 3306 CA ASN B 104 1.669 -10.012 -6.357 1.00 70.64 C \nANISOU 3306 CA ASN B 104 8519 8385 9938 -1300 -653 -9 C \nATOM 3307 C ASN B 104 2.183 -9.402 -5.068 1.00 73.75 C \nANISOU 3307 C ASN B 104 8903 8804 10316 -1276 -662 -12 C \nATOM 3308 O ASN B 104 1.877 -9.894 -3.982 1.00 84.87 O \nANISOU 3308 O ASN B 104 10304 10212 11732 -1299 -664 -7 O \nATOM 3309 CB ASN B 104 2.787 -10.820 -7.006 1.00 75.47 C \nANISOU 3309 CB ASN B 104 9217 8950 10507 -1304 -659 -14 C \nATOM 3310 CG ASN B 104 2.270 -11.962 -7.853 1.00 66.80 C \nANISOU 3310 CG ASN B 104 8122 7861 9398 -1379 -650 -5 C \nATOM 3311 OD1 ASN B 104 1.074 -12.286 -7.842 1.00 68.59 O \nANISOU 3311 OD1 ASN B 104 8269 8149 9643 -1397 -639 -4 O \nATOM 3312 ND2 ASN B 104 3.185 -12.620 -8.534 1.00 59.22 N \nANISOU 3312 ND2 ASN B 104 7264 6853 8383 -1419 -664 -2 N \nATOM 3313 N GLU B 105 2.964 -8.331 -5.167 1.00 70.10 N \nANISOU 3313 N GLU B 105 8425 8393 9816 -1225 -668 -25 N \nATOM 3314 CA GLU B 105 3.366 -7.602 -3.976 1.00 76.73 C \nANISOU 3314 CA GLU B 105 9220 9316 10616 -1202 -676 -33 C \nATOM 3315 C GLU B 105 2.180 -7.145 -3.101 1.00 82.84 C \nANISOU 3315 C GLU B 105 9945 10115 11414 -1286 -677 -9 C \nATOM 3316 O GLU B 105 2.178 -7.337 -1.881 1.00 82.66 O \nANISOU 3316 O GLU B 105 9912 10108 11386 -1295 -681 -7 O \nATOM 3317 CB GLU B 105 4.176 -6.379 -4.329 1.00 77.80 C \nANISOU 3317 CB GLU B 105 9304 9576 10680 -1142 -682 -54 C \nATOM 3318 CG GLU B 105 4.828 -5.804 -3.085 1.00 94.57 C \nANISOU 3318 CG GLU B 105 11370 11833 12729 -1095 -693 -74 C \nATOM 3319 CD GLU B 105 5.007 -4.315 -3.143 1.00108.23 C \nANISOU 3319 CD GLU B 105 12979 13773 14370 -1109 -693 -82 C \nATOM 3320 OE1 GLU B 105 6.175 -3.903 -3.056 1.00115.97 O \nANISOU 3320 OE1 GLU B 105 13920 14896 15247 -975 -706 -127 O \nATOM 3321 OE2 GLU B 105 4.012 -3.540 -3.277 1.00115.31 O \nANISOU 3321 OE2 GLU B 105 13830 14708 15272 -1251 -688 -47 O \nATOM 3322 N ARG B 106 1.161 -6.566 -3.722 1.00 79.35 N \nANISOU 3322 N ARG B 106 9502 9661 10987 -1344 -682 9 N \nATOM 3323 CA ARG B 106 0.024 -6.079 -2.956 1.00 75.48 C \nANISOU 3323 CA ARG B 106 9026 9163 10490 -1422 -704 32 C \nATOM 3324 C ARG B 106 -0.639 -7.258 -2.287 1.00 75.50 C \nANISOU 3324 C ARG B 106 9059 9092 10536 -1401 -706 30 C \nATOM 3325 O ARG B 106 -1.049 -7.184 -1.125 1.00 82.26 O \nANISOU 3325 O ARG B 106 9922 9952 11383 -1433 -721 40 O \nATOM 3326 CB ARG B 106 -0.954 -5.318 -3.846 1.00 77.60 C \nANISOU 3326 CB ARG B 106 9348 9396 10742 -1477 -729 48 C \nATOM 3327 CG ARG B 106 -0.368 -3.995 -4.393 1.00 83.28 C \nANISOU 3327 CG ARG B 106 10024 10226 11393 -1535 -730 55 C \nATOM 3328 CD ARG B 106 -1.208 -3.395 -5.507 1.00101.31 C \nANISOU 3328 CD ARG B 106 12383 12452 13660 -1587 -756 71 C \nATOM 3329 NE ARG B 106 -2.575 -3.186 -5.041 1.00120.35 N \nANISOU 3329 NE ARG B 106 14923 14762 16042 -1657 -810 94 N \nATOM 3330 CZ ARG B 106 -3.563 -4.086 -5.097 1.00133.79 C \nANISOU 3330 CZ ARG B 106 16711 16339 17784 -1574 -832 82 C \nATOM 3331 NH1 ARG B 106 -3.375 -5.298 -5.612 1.00128.56 N \nANISOU 3331 NH1 ARG B 106 15996 15661 17192 -1454 -797 53 N \nATOM 3332 NH2 ARG B 106 -4.757 -3.763 -4.630 1.00139.22 N \nANISOU 3332 NH2 ARG B 106 17549 16932 18415 -1614 -898 96 N \nATOM 3333 N THR B 107 -0.726 -8.376 -2.997 1.00 77.05 N \nANISOU 3333 N THR B 107 9264 9245 10765 -1357 -693 19 N \nATOM 3334 CA THR B 107 -1.343 -9.593 -2.418 1.00 71.91 C \nANISOU 3334 CA THR B 107 8613 8580 10130 -1344 -692 13 C \nATOM 3335 C THR B 107 -0.603 -10.025 -1.156 1.00 69.47 C \nANISOU 3335 C THR B 107 8290 8286 9819 -1358 -684 14 C \nATOM 3336 O THR B 107 -1.212 -10.371 -0.147 1.00 69.33 O \nANISOU 3336 O THR B 107 8268 8270 9804 -1365 -693 17 O \nATOM 3337 CB THR B 107 -1.350 -10.744 -3.423 1.00 73.80 C \nANISOU 3337 CB THR B 107 8839 8832 10370 -1329 -676 1 C \nATOM 3338 OG1 THR B 107 -2.207 -10.424 -4.523 1.00 74.69 O \nANISOU 3338 OG1 THR B 107 8962 8940 10478 -1295 -688 -6 O \nATOM 3339 CG2 THR B 107 -1.839 -12.027 -2.785 1.00 77.42 C \nANISOU 3339 CG2 THR B 107 9266 9338 10812 -1336 -673 -6 C \nATOM 3340 N LEU B 108 0.722 -10.005 -1.208 1.00 67.63 N \nANISOU 3340 N LEU B 108 8067 8060 9569 -1343 -675 8 N \nATOM 3341 CA LEU B 108 1.525 -10.508 -0.088 1.00 66.39 C \nANISOU 3341 CA LEU B 108 7929 7904 9393 -1335 -678 3 C \nATOM 3342 C LEU B 108 1.406 -9.641 1.152 1.00 69.65 C \nANISOU 3342 C LEU B 108 8301 8368 9796 -1339 -685 7 C \nATOM 3343 O LEU B 108 1.219 -10.163 2.254 1.00 86.09 O \nANISOU 3343 O LEU B 108 10383 10444 11885 -1354 -688 10 O \nATOM 3344 CB LEU B 108 2.993 -10.698 -0.483 1.00 62.18 C \nANISOU 3344 CB LEU B 108 7467 7347 8812 -1283 -687 -14 C \nATOM 3345 CG LEU B 108 3.277 -11.816 -1.519 1.00 62.88 C \nANISOU 3345 CG LEU B 108 7637 7371 8885 -1319 -690 -11 C \nATOM 3346 CD1 LEU B 108 4.791 -12.067 -1.646 1.00 61.34 C \nANISOU 3346 CD1 LEU B 108 7583 7111 8612 -1262 -724 -28 C \nATOM 3347 CD2 LEU B 108 2.557 -13.121 -1.193 1.00 57.55 C \nANISOU 3347 CD2 LEU B 108 6954 6698 8214 -1413 -682 5 C \nATOM 3348 N ASP B 109 1.494 -8.326 1.017 1.00 65.40 N \nANISOU 3348 N ASP B 109 7723 7900 9226 -1344 -690 8 N \nATOM 3349 CA ASP B 109 1.301 -7.522 2.208 1.00 72.19 C \nANISOU 3349 CA ASP B 109 8540 8837 10052 -1388 -701 17 C \nATOM 3350 C ASP B 109 -0.178 -7.218 2.533 1.00 64.65 C \nANISOU 3350 C ASP B 109 7617 7837 9111 -1474 -721 44 C \nATOM 3351 O ASP B 109 -0.492 -6.741 3.606 1.00 68.75 O \nANISOU 3351 O ASP B 109 8130 8393 9599 -1533 -737 58 O \nATOM 3352 CB ASP B 109 2.241 -6.318 2.241 1.00 80.62 C \nANISOU 3352 CB ASP B 109 9536 10062 11033 -1369 -702 3 C \nATOM 3353 CG ASP B 109 2.041 -5.411 1.137 1.00 84.28 C \nANISOU 3353 CG ASP B 109 9980 10572 11470 -1410 -704 10 C \nATOM 3354 OD1 ASP B 109 0.891 -5.358 0.651 1.00 99.27 O \nANISOU 3354 OD1 ASP B 109 11933 12379 13405 -1485 -714 36 O \nATOM 3355 OD2 ASP B 109 3.039 -4.738 0.773 1.00 84.63 O \nANISOU 3355 OD2 ASP B 109 9962 10754 11440 -1351 -701 -15 O \nATOM 3356 N PHE B 110 -1.084 -7.578 1.649 1.00 60.01 N \nANISOU 3356 N PHE B 110 7081 7165 8555 -1468 -730 48 N \nATOM 3357 CA PHE B 110 -2.479 -7.712 2.018 1.00 62.32 C \nANISOU 3357 CA PHE B 110 7445 7388 8848 -1485 -765 58 C \nATOM 3358 C PHE B 110 -2.585 -8.749 3.159 1.00 67.56 C \nANISOU 3358 C PHE B 110 8091 8044 9535 -1455 -758 50 C \nATOM 3359 O PHE B 110 -3.193 -8.476 4.184 1.00 81.07 O \nANISOU 3359 O PHE B 110 9839 9740 11224 -1488 -785 61 O \nATOM 3360 CB PHE B 110 -3.298 -8.182 0.828 1.00 61.36 C \nANISOU 3360 CB PHE B 110 7369 7206 8739 -1427 -776 45 C \nATOM 3361 CG PHE B 110 -4.751 -8.427 1.130 1.00 58.97 C \nANISOU 3361 CG PHE B 110 7159 6839 8408 -1383 -826 38 C \nATOM 3362 CD1 PHE B 110 -5.533 -7.426 1.687 1.00 60.32 C \nANISOU 3362 CD1 PHE B 110 7455 6948 8518 -1444 -886 59 C \nATOM 3363 CD2 PHE B 110 -5.356 -9.625 0.795 1.00 57.98 C \nANISOU 3363 CD2 PHE B 110 7013 6731 8288 -1278 -824 8 C \nATOM 3364 CE1 PHE B 110 -6.901 -7.604 1.916 1.00 60.95 C \nANISOU 3364 CE1 PHE B 110 7674 6941 8544 -1372 -953 45 C \nATOM 3365 CE2 PHE B 110 -6.730 -9.831 1.036 1.00 61.27 C \nANISOU 3365 CE2 PHE B 110 7521 7110 8648 -1185 -883 -14 C \nATOM 3366 CZ PHE B 110 -7.509 -8.814 1.583 1.00 61.46 C \nANISOU 3366 CZ PHE B 110 7708 7030 8614 -1215 -953 2 C \nATOM 3367 N HIS B 111 -1.972 -9.910 2.977 1.00 57.29 N \nANISOU 3367 N HIS B 111 6747 6754 8265 -1411 -727 34 N \nATOM 3368 CA HIS B 111 -1.944 -10.961 4.001 1.00 57.57 C \nANISOU 3368 CA HIS B 111 6764 6799 8311 -1404 -719 29 C \nATOM 3369 C HIS B 111 -1.281 -10.514 5.297 1.00 59.52 C \nANISOU 3369 C HIS B 111 6997 7070 8548 -1431 -719 37 C \nATOM 3370 O HIS B 111 -1.805 -10.746 6.408 1.00 56.98 O \nANISOU 3370 O HIS B 111 6678 6745 8226 -1443 -731 41 O \nATOM 3371 CB HIS B 111 -1.179 -12.198 3.496 1.00 54.22 C \nANISOU 3371 CB HIS B 111 6325 6388 7888 -1403 -694 20 C \nATOM 3372 CG HIS B 111 -1.866 -12.930 2.394 1.00 51.68 C \nANISOU 3372 CG HIS B 111 5986 6093 7556 -1390 -690 10 C \nATOM 3373 ND1 HIS B 111 -3.202 -13.260 2.448 1.00 57.23 N \nANISOU 3373 ND1 HIS B 111 6668 6836 8240 -1342 -708 -5 N \nATOM 3374 CD2 HIS B 111 -1.416 -13.402 1.212 1.00 54.50 C \nANISOU 3374 CD2 HIS B 111 6344 6463 7900 -1406 -676 7 C \nATOM 3375 CE1 HIS B 111 -3.546 -13.918 1.360 1.00 55.74 C \nANISOU 3375 CE1 HIS B 111 6445 6711 8024 -1323 -701 -20 C \nATOM 3376 NE2 HIS B 111 -2.481 -14.011 0.586 1.00 57.25 N \nANISOU 3376 NE2 HIS B 111 6646 6883 8222 -1379 -679 -8 N \nATOM 3377 N ASP B 112 -0.137 -9.844 5.169 1.00 58.12 N \nANISOU 3377 N ASP B 112 6801 6935 8348 -1425 -710 33 N \nATOM 3378 CA ASP B 112 0.520 -9.267 6.367 1.00 58.01 C \nANISOU 3378 CA ASP B 112 6754 6992 8297 -1430 -714 32 C \nATOM 3379 C ASP B 112 -0.400 -8.298 7.104 1.00 60.11 C \nANISOU 3379 C ASP B 112 7015 7290 8536 -1513 -736 54 C \nATOM 3380 O ASP B 112 -0.487 -8.319 8.333 1.00 65.11 O \nANISOU 3380 O ASP B 112 7638 7946 9157 -1538 -742 60 O \nATOM 3381 CB ASP B 112 1.839 -8.588 6.016 1.00 56.16 C \nANISOU 3381 CB ASP B 112 6487 6846 8005 -1373 -709 11 C \nATOM 3382 CG ASP B 112 2.911 -9.587 5.535 1.00 61.08 C \nANISOU 3382 CG ASP B 112 7177 7406 8623 -1286 -709 -13 C \nATOM 3383 OD1 ASP B 112 2.638 -10.803 5.592 1.00 67.04 O \nANISOU 3383 OD1 ASP B 112 7987 8069 9415 -1312 -707 -5 O \nATOM 3384 OD2 ASP B 112 3.999 -9.163 5.049 1.00 66.53 O \nANISOU 3384 OD2 ASP B 112 7878 8146 9254 -1199 -718 -40 O \nATOM 3385 N SER B 113 -1.106 -7.468 6.353 1.00 63.23 N \nANISOU 3385 N SER B 113 7441 7674 8908 -1569 -754 70 N \nATOM 3386 CA SER B 113 -2.013 -6.488 6.964 1.00 69.33 C \nANISOU 3386 CA SER B 113 8267 8453 9622 -1684 -795 99 C \nATOM 3387 C SER B 113 -3.155 -7.211 7.691 1.00 66.29 C \nANISOU 3387 C SER B 113 7970 7955 9263 -1667 -824 103 C \nATOM 3388 O SER B 113 -3.535 -6.840 8.793 1.00 70.94 O \nANISOU 3388 O SER B 113 8593 8550 9811 -1737 -851 120 O \nATOM 3389 CB SER B 113 -2.572 -5.505 5.922 1.00 73.91 C \nANISOU 3389 CB SER B 113 8913 9017 10153 -1761 -824 118 C \nATOM 3390 OG SER B 113 -3.991 -5.609 5.878 1.00 87.60 O \nANISOU 3390 OG SER B 113 10801 10608 11877 -1775 -878 130 O \nATOM 3391 N ASN B 114 -3.712 -8.232 7.071 1.00 60.31 N \nANISOU 3391 N ASN B 114 7242 7119 8554 -1572 -822 83 N \nATOM 3392 CA ASN B 114 -4.823 -8.972 7.691 1.00 60.84 C \nANISOU 3392 CA ASN B 114 7376 7120 8621 -1517 -855 74 C \nATOM 3393 C ASN B 114 -4.402 -9.716 8.945 1.00 61.02 C \nANISOU 3393 C ASN B 114 7332 7181 8670 -1508 -831 69 C \nATOM 3394 O ASN B 114 -5.138 -9.775 9.917 1.00 61.43 O \nANISOU 3394 O ASN B 114 7441 7201 8700 -1511 -864 73 O \nATOM 3395 CB ASN B 114 -5.415 -9.979 6.693 1.00 67.65 C \nANISOU 3395 CB ASN B 114 8239 7965 9502 -1402 -853 44 C \nATOM 3396 CG ASN B 114 -6.277 -9.325 5.623 1.00 67.86 C \nANISOU 3396 CG ASN B 114 8377 7925 9484 -1377 -900 41 C \nATOM 3397 OD1 ASN B 114 -6.902 -8.301 5.845 1.00 69.81 O \nANISOU 3397 OD1 ASN B 114 8761 8097 9669 -1438 -959 62 O \nATOM 3398 ND2 ASN B 114 -6.285 -9.914 4.449 1.00 74.13 N \nANISOU 3398 ND2 ASN B 114 9127 8745 10295 -1303 -880 19 N \nATOM 3399 N VAL B 115 -3.208 -10.309 8.920 1.00 63.50 N \nANISOU 3399 N VAL B 115 7553 7551 9022 -1494 -782 60 N \nATOM 3400 CA VAL B 115 -2.664 -10.972 10.116 1.00 57.32 C \nANISOU 3400 CA VAL B 115 6728 6797 8253 -1493 -765 57 C \nATOM 3401 C VAL B 115 -2.526 -9.944 11.232 1.00 58.84 C \nANISOU 3401 C VAL B 115 6921 7025 8409 -1560 -781 75 C \nATOM 3402 O VAL B 115 -2.973 -10.177 12.350 1.00 58.17 O \nANISOU 3402 O VAL B 115 6852 6929 8321 -1573 -795 80 O \nATOM 3403 CB VAL B 115 -1.286 -11.638 9.839 1.00 52.25 C \nANISOU 3403 CB VAL B 115 6047 6181 7625 -1470 -730 45 C \nATOM 3404 CG1 VAL B 115 -0.544 -11.972 11.127 1.00 53.75 C \nANISOU 3404 CG1 VAL B 115 6224 6393 7806 -1470 -726 43 C \nATOM 3405 CG2 VAL B 115 -1.465 -12.908 9.047 1.00 44.97 C \nANISOU 3405 CG2 VAL B 115 5126 5246 6716 -1452 -718 35 C \nATOM 3406 N LYS B 116 -1.884 -8.816 10.927 1.00 63.28 N \nANISOU 3406 N LYS B 116 7455 7660 8929 -1607 -778 83 N \nATOM 3407 CA LYS B 116 -1.757 -7.700 11.897 1.00 69.04 C \nANISOU 3407 CA LYS B 116 8161 8485 9587 -1703 -795 102 C \nATOM 3408 C LYS B 116 -3.100 -7.273 12.504 1.00 66.59 C \nANISOU 3408 C LYS B 116 7962 8101 9239 -1797 -846 131 C \nATOM 3409 O LYS B 116 -3.163 -6.882 13.658 1.00 70.46 O \nANISOU 3409 O LYS B 116 8450 8639 9684 -1873 -862 146 O \nATOM 3410 CB LYS B 116 -1.115 -6.462 11.246 1.00 78.25 C \nANISOU 3410 CB LYS B 116 9268 9784 10677 -1760 -791 106 C \nATOM 3411 CG LYS B 116 0.389 -6.342 11.386 1.00 85.08 C \nANISOU 3411 CG LYS B 116 10016 10805 11505 -1676 -761 75 C \nATOM 3412 CD LYS B 116 0.725 -5.968 12.809 1.00102.49 C \nANISOU 3412 CD LYS B 116 12156 13142 13645 -1712 -765 75 C \nATOM 3413 CE LYS B 116 2.218 -5.951 13.037 1.00114.46 C \nANISOU 3413 CE LYS B 116 13574 14813 15101 -1573 -749 28 C \nATOM 3414 NZ LYS B 116 2.500 -5.776 14.488 1.00122.45 N \nANISOU 3414 NZ LYS B 116 14524 15948 16054 -1584 -754 23 N \nATOM 3415 N ASN B 117 -4.168 -7.327 11.721 1.00 60.76 N \nANISOU 3415 N ASN B 117 7340 7244 8501 -1785 -883 135 N \nATOM 3416 CA ASN B 117 -5.487 -6.967 12.229 1.00 71.08 C \nANISOU 3416 CA ASN B 117 8816 8444 9747 -1842 -955 154 C \nATOM 3417 C ASN B 117 -6.007 -7.930 13.268 1.00 80.89 C \nANISOU 3417 C ASN B 117 10080 9634 11020 -1763 -965 139 C \nATOM 3418 O ASN B 117 -6.599 -7.512 14.273 1.00 98.56 O \nANISOU 3418 O ASN B 117 12418 11833 13197 -1837 -1014 159 O \nATOM 3419 CB ASN B 117 -6.496 -6.825 11.096 1.00 76.93 C \nANISOU 3419 CB ASN B 117 9706 9065 10459 -1803 -1007 151 C \nATOM 3420 CG ASN B 117 -6.498 -5.419 10.511 1.00 84.33 C \nANISOU 3420 CG ASN B 117 10719 10018 11303 -1967 -1041 186 C \nATOM 3421 OD1 ASN B 117 -6.436 -4.440 11.255 1.00 93.67 O \nANISOU 3421 OD1 ASN B 117 11937 11259 12393 -2145 -1070 224 O \nATOM 3422 ND2 ASN B 117 -6.584 -5.312 9.190 1.00 84.57 N \nANISOU 3422 ND2 ASN B 117 10774 10016 11343 -1925 -1042 178 N \nATOM 3423 N LEU B 118 -5.781 -9.217 13.048 1.00 75.45 N \nANISOU 3423 N LEU B 118 9303 8956 10409 -1630 -922 106 N \nATOM 3424 CA LEU B 118 -6.082 -10.204 14.070 1.00 66.83 C \nANISOU 3424 CA LEU B 118 8192 7861 9340 -1565 -920 90 C \nATOM 3425 C LEU B 118 -5.316 -9.955 15.355 1.00 67.58 C \nANISOU 3425 C LEU B 118 8222 8018 9438 -1645 -898 108 C \nATOM 3426 O LEU B 118 -5.901 -9.938 16.460 1.00 64.79 O \nANISOU 3426 O LEU B 118 7928 7634 9056 -1667 -932 116 O \nATOM 3427 CB LEU B 118 -5.796 -11.585 13.564 1.00 71.52 C \nANISOU 3427 CB LEU B 118 8684 8500 9988 -1463 -875 59 C \nATOM 3428 CG LEU B 118 -7.031 -12.409 13.227 1.00 72.78 C \nANISOU 3428 CG LEU B 118 8889 8649 10116 -1337 -910 26 C \nATOM 3429 CD1 LEU B 118 -8.004 -11.577 12.419 1.00 75.40 C \nANISOU 3429 CD1 LEU B 118 9370 8891 10387 -1300 -975 23 C \nATOM 3430 CD2 LEU B 118 -6.626 -13.671 12.475 1.00 69.08 C \nANISOU 3430 CD2 LEU B 118 8295 8280 9672 -1287 -860 1 C \nATOM 3431 N TYR B 119 -4.005 -9.750 15.218 1.00 66.47 N \nANISOU 3431 N TYR B 119 7970 7970 9317 -1670 -850 108 N \nATOM 3432 CA TYR B 119 -3.132 -9.448 16.390 1.00 65.15 C \nANISOU 3432 CA TYR B 119 7728 7895 9130 -1717 -832 115 C \nATOM 3433 C TYR B 119 -3.616 -8.263 17.172 1.00 70.15 C \nANISOU 3433 C TYR B 119 8413 8563 9680 -1851 -873 146 C \nATOM 3434 O TYR B 119 -3.559 -8.287 18.390 1.00 77.26 O \nANISOU 3434 O TYR B 119 9295 9498 10563 -1884 -877 152 O \nATOM 3435 CB TYR B 119 -1.693 -9.227 15.944 1.00 59.13 C \nANISOU 3435 CB TYR B 119 6867 7238 8361 -1684 -793 99 C \nATOM 3436 CG TYR B 119 -0.704 -9.068 17.072 1.00 64.54 C \nANISOU 3436 CG TYR B 119 7476 8037 9010 -1674 -780 89 C \nATOM 3437 CD1 TYR B 119 -0.096 -10.184 17.671 1.00 64.31 C \nANISOU 3437 CD1 TYR B 119 7442 7975 9020 -1590 -764 68 C \nATOM 3438 CD2 TYR B 119 -0.349 -7.796 17.537 1.00 70.52 C \nANISOU 3438 CD2 TYR B 119 8166 8958 9669 -1754 -788 98 C \nATOM 3439 CE1 TYR B 119 0.826 -10.032 18.703 1.00 69.64 C \nANISOU 3439 CE1 TYR B 119 8065 8747 9647 -1554 -761 53 C \nATOM 3440 CE2 TYR B 119 0.567 -7.630 18.572 1.00 68.71 C \nANISOU 3440 CE2 TYR B 119 7850 8871 9384 -1719 -779 79 C \nATOM 3441 CZ TYR B 119 1.149 -8.736 19.154 1.00 72.32 C \nANISOU 3441 CZ TYR B 119 8321 9266 9891 -1604 -768 54 C \nATOM 3442 OH TYR B 119 2.046 -8.547 20.174 1.00 70.44 O \nANISOU 3442 OH TYR B 119 8015 9164 9584 -1547 -768 30 O \nATOM 3443 N ASP B 120 -4.116 -7.239 16.469 1.00 79.40 N \nANISOU 3443 N ASP B 120 9661 9724 10785 -1948 -908 169 N \nATOM 3444 CA ASP B 120 -4.593 -5.995 17.119 1.00 86.98 C \nANISOU 3444 CA ASP B 120 10699 10725 11623 -2138 -961 210 C \nATOM 3445 C ASP B 120 -5.988 -6.152 17.779 1.00 87.02 C \nANISOU 3445 C ASP B 120 10909 10559 11595 -2165 -1035 227 C \nATOM 3446 O ASP B 120 -6.189 -5.700 18.884 1.00 84.60 O \nANISOU 3446 O ASP B 120 10645 10279 11219 -2282 -1065 252 O \nATOM 3447 CB ASP B 120 -4.606 -4.828 16.131 1.00 95.83 C \nANISOU 3447 CB ASP B 120 11854 11902 12655 -2266 -983 234 C \nATOM 3448 CG ASP B 120 -3.242 -4.166 15.971 1.00111.09 C \nANISOU 3448 CG ASP B 120 13583 14085 14541 -2298 -930 224 C \nATOM 3449 OD1 ASP B 120 -2.227 -4.690 16.497 1.00115.31 O \nANISOU 3449 OD1 ASP B 120 13970 14724 15117 -2183 -880 192 O \nATOM 3450 OD2 ASP B 120 -3.180 -3.107 15.294 1.00125.79 O \nANISOU 3450 OD2 ASP B 120 15441 16049 16305 -2430 -946 246 O \nATOM 3451 N LYS B 121 -6.939 -6.794 17.104 1.00 83.10 N \nANISOU 3451 N LYS B 121 10543 9901 11131 -2041 -1070 207 N \nATOM 3452 CA LYS B 121 -8.210 -7.164 17.732 1.00 89.35 C \nANISOU 3452 CA LYS B 121 11527 10539 11883 -1987 -1146 202 C \nATOM 3453 C LYS B 121 -8.025 -7.828 19.113 1.00 90.23 C \nANISOU 3453 C LYS B 121 11561 10689 12032 -1955 -1122 194 C \nATOM 3454 O LYS B 121 -8.779 -7.562 20.047 1.00 91.10 O \nANISOU 3454 O LYS B 121 11823 10722 12069 -2012 -1188 211 O \nATOM 3455 CB LYS B 121 -8.979 -8.128 16.846 1.00 96.92 C \nANISOU 3455 CB LYS B 121 12543 11401 12879 -1776 -1163 157 C \nATOM 3456 CG LYS B 121 -9.652 -7.530 15.619 1.00107.82 C \nANISOU 3456 CG LYS B 121 14091 12682 14193 -1772 -1224 159 C \nATOM 3457 CD LYS B 121 -10.311 -8.621 14.761 1.00110.20 C \nANISOU 3457 CD LYS B 121 14399 12948 14525 -1530 -1231 102 C \nATOM 3458 CE LYS B 121 -11.268 -9.516 15.559 1.00108.61 C \nANISOU 3458 CE LYS B 121 14273 12704 14288 -1359 -1280 61 C \nATOM 3459 NZ LYS B 121 -12.643 -8.986 15.624 1.00116.69 N \nANISOU 3459 NZ LYS B 121 15627 13548 15164 -1299 -1418 53 N \nATOM 3460 N VAL B 122 -7.033 -8.705 19.224 1.00 90.68 N \nANISOU 3460 N VAL B 122 11410 10851 12194 -1869 -1037 169 N \nATOM 3461 CA VAL B 122 -6.726 -9.383 20.482 1.00 90.34 C \nANISOU 3461 CA VAL B 122 11285 10851 12188 -1841 -1010 162 C \nATOM 3462 C VAL B 122 -6.064 -8.440 21.473 1.00 89.26 C \nANISOU 3462 C VAL B 122 11097 10821 11996 -1999 -1004 193 C \nATOM 3463 O VAL B 122 -6.542 -8.295 22.596 1.00 86.62 O \nANISOU 3463 O VAL B 122 10834 10461 11618 -2059 -1040 210 O \nATOM 3464 CB VAL B 122 -5.815 -10.603 20.267 1.00 91.94 C \nANISOU 3464 CB VAL B 122 11322 11121 12491 -1725 -935 129 C \nATOM 3465 CG1 VAL B 122 -5.507 -11.299 21.576 1.00 96.34 C \nANISOU 3465 CG1 VAL B 122 11817 11714 13076 -1708 -915 124 C \nATOM 3466 CG2 VAL B 122 -6.488 -11.589 19.334 1.00 93.18 C \nANISOU 3466 CG2 VAL B 122 11499 11229 12676 -1592 -939 98 C \nATOM 3467 N ARG B 123 -5.007 -7.760 21.037 1.00 87.28 N \nANISOU 3467 N ARG B 123 10723 10710 11727 -2061 -964 199 N \nATOM 3468 CA ARG B 123 -4.262 -6.829 21.901 1.00 84.14 C \nANISOU 3468 CA ARG B 123 10230 10493 11245 -2195 -953 219 C \nATOM 3469 C ARG B 123 -5.137 -5.791 22.563 1.00 82.14 C \nANISOU 3469 C ARG B 123 10120 10228 10863 -2402 -1024 266 C \nATOM 3470 O ARG B 123 -4.853 -5.397 23.685 1.00 92.49 O \nANISOU 3470 O ARG B 123 11374 11658 12109 -2502 -1025 282 O \nATOM 3471 CB ARG B 123 -3.179 -6.092 21.132 1.00 80.85 C \nANISOU 3471 CB ARG B 123 9676 10260 10785 -2217 -917 211 C \nATOM 3472 CG ARG B 123 -2.327 -5.191 21.995 1.00 81.75 C \nANISOU 3472 CG ARG B 123 9647 10631 10783 -2318 -903 216 C \nATOM 3473 CD ARG B 123 -1.126 -4.692 21.208 1.00 93.44 C \nANISOU 3473 CD ARG B 123 10969 12320 12216 -2260 -865 187 C \nATOM 3474 NE ARG B 123 -0.332 -3.708 21.963 1.00108.57 N \nANISOU 3474 NE ARG B 123 12720 14554 13977 -2344 -858 182 N \nATOM 3475 CZ ARG B 123 0.360 -2.707 21.412 1.00118.48 C \nANISOU 3475 CZ ARG B 123 13839 16076 15101 -2391 -848 171 C \nATOM 3476 NH1 ARG B 123 0.369 -2.521 20.092 1.00113.29 N \nANISOU 3476 NH1 ARG B 123 13206 15378 14463 -2371 -845 168 N \nATOM 3477 NH2 ARG B 123 1.051 -1.878 22.189 1.00120.83 N \nANISOU 3477 NH2 ARG B 123 13962 16715 15232 -2454 -843 159 N \nATOM 3478 N LEU B 124 -6.189 -5.347 21.885 1.00 81.03 N \nANISOU 3478 N LEU B 124 10181 9941 10665 -2474 -1093 290 N \nATOM 3479 CA LEU B 124 -7.099 -4.357 22.475 1.00 90.37 C \nANISOU 3479 CA LEU B 124 11574 11069 11692 -2699 -1185 342 C \nATOM 3480 C LEU B 124 -7.970 -4.936 23.573 1.00 88.70 C \nANISOU 3480 C LEU B 124 11514 10704 11484 -2654 -1236 342 C \nATOM 3481 O LEU B 124 -8.270 -4.239 24.546 1.00 83.10 O \nANISOU 3481 O LEU B 124 10903 10018 10654 -2848 -1288 382 O \nATOM 3482 CB LEU B 124 -7.995 -3.710 21.426 1.00 91.49 C \nANISOU 3482 CB LEU B 124 11951 11065 11747 -2784 -1264 366 C \nATOM 3483 CG LEU B 124 -7.286 -2.654 20.589 1.00100.15 C \nANISOU 3483 CG LEU B 124 12940 12347 12763 -2946 -1240 389 C \nATOM 3484 CD1 LEU B 124 -8.300 -1.868 19.759 1.00100.47 C \nANISOU 3484 CD1 LEU B 124 13270 12225 12678 -3090 -1341 427 C \nATOM 3485 CD2 LEU B 124 -6.427 -1.726 21.446 1.00 98.01 C \nANISOU 3485 CD2 LEU B 124 12492 12377 12372 -3163 -1212 418 C \nATOM 3486 N GLN B 125 -8.332 -6.212 23.439 1.00 89.81 N \nANISOU 3486 N GLN B 125 11660 10718 11747 -2409 -1221 295 N \nATOM 3487 CA GLN B 125 -9.195 -6.863 24.424 1.00 93.02 C \nANISOU 3487 CA GLN B 125 12198 10995 12152 -2327 -1270 284 C \nATOM 3488 C GLN B 125 -8.537 -7.205 25.754 1.00 85.48 C \nANISOU 3488 C GLN B 125 11083 10157 11237 -2345 -1219 284 C \nATOM 3489 O GLN B 125 -9.240 -7.358 26.733 1.00 98.96 O \nANISOU 3489 O GLN B 125 12921 11776 12903 -2353 -1272 291 O \nATOM 3490 CB GLN B 125 -9.840 -8.124 23.869 1.00 92.08 C \nANISOU 3490 CB GLN B 125 12109 10762 12115 -2059 -1274 229 C \nATOM 3491 CG GLN B 125 -10.966 -7.861 22.887 1.00 89.94 C \nANISOU 3491 CG GLN B 125 12090 10323 11760 -1996 -1367 220 C \nATOM 3492 CD GLN B 125 -11.579 -9.143 22.406 1.00 91.42 C \nANISOU 3492 CD GLN B 125 12265 10470 12002 -1713 -1368 154 C \nATOM 3493 OE1 GLN B 125 -12.717 -9.450 22.720 1.00 94.66 O \nANISOU 3493 OE1 GLN B 125 12876 10758 12330 -1579 -1458 126 O \nATOM 3494 NE2 GLN B 125 -10.805 -9.926 21.672 1.00 97.00 N \nANISOU 3494 NE2 GLN B 125 12732 11300 12825 -1619 -1271 127 N \nATOM 3495 N LEU B 126 -7.215 -7.250 25.833 1.00 86.21 N \nANISOU 3495 N LEU B 126 10923 10442 11391 -2350 -1128 275 N \nATOM 3496 CA LEU B 126 -6.585 -7.734 27.059 1.00 85.13 C \nANISOU 3496 CA LEU B 126 10648 10401 11296 -2323 -1084 265 C \nATOM 3497 C LEU B 126 -5.349 -6.965 27.506 1.00 83.40 C \nANISOU 3497 C LEU B 126 10239 10426 11022 -2433 -1036 276 C \nATOM 3498 O LEU B 126 -4.454 -7.506 28.125 1.00 93.36 O \nANISOU 3498 O LEU B 126 11347 11789 12338 -2342 -983 249 O \nATOM 3499 CB LEU B 126 -6.312 -9.235 26.914 1.00 87.49 C \nANISOU 3499 CB LEU B 126 10850 10657 11734 -2101 -1030 218 C \nATOM 3500 CG LEU B 126 -5.773 -9.782 25.596 1.00 80.90 C \nANISOU 3500 CG LEU B 126 9929 9832 10976 -1985 -982 189 C \nATOM 3501 CD1 LEU B 126 -4.286 -9.517 25.464 1.00 85.92 C \nANISOU 3501 CD1 LEU B 126 10392 10631 11622 -1991 -921 181 C \nATOM 3502 CD2 LEU B 126 -6.046 -11.254 25.491 1.00 74.43 C \nANISOU 3502 CD2 LEU B 126 9089 8949 10241 -1821 -962 154 C \nATOM 3503 N ARG B 127 -5.364 -5.673 27.250 1.00 93.37 N \nANISOU 3503 N ARG B 127 11528 11798 12151 -2635 -1067 312 N \nATOM 3504 CA ARG B 127 -4.250 -4.731 27.537 1.00 96.98 C \nANISOU 3504 CA ARG B 127 11783 12562 12501 -2752 -1030 317 C \nATOM 3505 C ARG B 127 -3.203 -5.240 28.534 1.00 95.72 C \nANISOU 3505 C ARG B 127 11431 12559 12380 -2631 -974 281 C \nATOM 3506 O ARG B 127 -2.102 -5.642 28.141 1.00 95.85 O \nANISOU 3506 O ARG B 127 11294 12675 12449 -2460 -919 235 O \nATOM 3507 CB ARG B 127 -4.775 -3.335 27.982 1.00 97.52 C \nANISOU 3507 CB ARG B 127 11944 12744 12365 -3073 -1096 379 C \nATOM 3508 CG ARG B 127 -6.181 -2.981 27.487 1.00 99.35 C \nANISOU 3508 CG ARG B 127 12493 12720 12535 -3209 -1193 424 C \nATOM 3509 CD ARG B 127 -7.198 -3.038 28.628 1.00103.58 C \nANISOU 3509 CD ARG B 127 13252 13092 13012 -3308 -1271 456 C \nATOM 3510 NE ARG B 127 -8.487 -3.571 28.223 1.00109.25 N \nANISOU 3510 NE ARG B 127 14272 13473 13765 -3204 -1352 453 N \nATOM 3511 CZ ARG B 127 -9.405 -2.926 27.517 1.00117.68 C \nANISOU 3511 CZ ARG B 127 15619 14377 14716 -3327 -1448 487 C \nATOM 3512 NH1 ARG B 127 -9.176 -1.694 27.088 1.00127.54 N \nANISOU 3512 NH1 ARG B 127 16879 15771 15808 -3602 -1472 535 N \nATOM 3513 NH2 ARG B 127 -10.554 -3.525 27.219 1.00120.91 N \nANISOU 3513 NH2 ARG B 127 16301 14491 15147 -3164 -1527 466 N \nATOM 3514 N ASP B 128 -3.547 -5.192 29.814 1.00 96.99 N \nANISOU 3514 N ASP B 128 11625 12730 12497 -2720 -997 301 N \nATOM 3515 CA ASP B 128 -2.618 -5.560 30.881 1.00101.05 C \nANISOU 3515 CA ASP B 128 11972 13400 13021 -2624 -954 270 C \nATOM 3516 C ASP B 128 -2.957 -6.932 31.498 1.00 99.41 C \nANISOU 3516 C ASP B 128 11837 12972 12962 -2464 -947 250 C \nATOM 3517 O ASP B 128 -2.278 -7.386 32.417 1.00105.10 O \nANISOU 3517 O ASP B 128 12457 13773 13702 -2377 -918 225 O \nATOM 3518 CB ASP B 128 -2.527 -4.463 31.958 1.00100.40 C \nANISOU 3518 CB ASP B 128 11819 13569 12758 -2847 -977 301 C \nATOM 3519 CG ASP B 128 -3.900 -3.989 32.460 1.00104.97 C \nANISOU 3519 CG ASP B 128 12630 13994 13258 -3091 -1056 367 C \nATOM 3520 OD1 ASP B 128 -4.935 -4.599 32.120 1.00 97.53 O \nANISOU 3520 OD1 ASP B 128 11907 12743 12407 -3036 -1097 376 O \nATOM 3521 OD2 ASP B 128 -3.927 -2.975 33.189 1.00108.64 O \nANISOU 3521 OD2 ASP B 128 13067 14667 13544 -3337 -1085 405 O \nATOM 3522 N ASN B 129 -3.979 -7.589 30.960 1.00 85.98 N \nANISOU 3522 N ASN B 129 10302 11019 11347 -2415 -975 257 N \nATOM 3523 CA ASN B 129 -4.250 -8.959 31.299 1.00 85.19 C \nANISOU 3523 CA ASN B 129 10237 10760 11372 -2252 -962 231 C \nATOM 3524 C ASN B 129 -3.263 -9.964 30.657 1.00 85.14 C \nANISOU 3524 C ASN B 129 10122 10760 11468 -2067 -903 187 C \nATOM 3525 O ASN B 129 -3.236 -11.123 31.056 1.00 76.91 O \nANISOU 3525 O ASN B 129 9079 9639 10505 -1961 -886 167 O \nATOM 3526 CB ASN B 129 -5.685 -9.299 30.919 1.00 87.76 C \nANISOU 3526 CB ASN B 129 10763 10867 11715 -2238 -1019 242 C \nATOM 3527 CG ASN B 129 -6.682 -8.730 31.917 1.00 96.60 C \nANISOU 3527 CG ASN B 129 12047 11918 12737 -2377 -1093 278 C \nATOM 3528 OD1 ASN B 129 -6.328 -7.885 32.750 1.00101.98 O \nANISOU 3528 OD1 ASN B 129 12687 12737 13326 -2540 -1099 307 O \nATOM 3529 ND2 ASN B 129 -7.923 -9.209 31.864 1.00 92.63 N \nANISOU 3529 ND2 ASN B 129 11739 11219 12236 -2304 -1156 273 N \nATOM 3530 N ALA B 130 -2.462 -9.512 29.686 1.00 78.13 N \nANISOU 3530 N ALA B 130 9160 9968 10560 -2044 -879 174 N \nATOM 3531 CA ALA B 130 -1.421 -10.321 29.052 1.00 73.69 C \nANISOU 3531 CA ALA B 130 8534 9407 10060 -1887 -838 135 C \nATOM 3532 C ALA B 130 -0.140 -9.556 28.715 1.00 74.59 C \nANISOU 3532 C ALA B 130 8532 9717 10091 -1846 -820 110 C \nATOM 3533 O ALA B 130 -0.166 -8.336 28.531 1.00 73.33 O \nANISOU 3533 O ALA B 130 8320 9711 9831 -1956 -830 125 O \nATOM 3534 CB ALA B 130 -1.966 -10.958 27.772 1.00 76.88 C \nANISOU 3534 CB ALA B 130 9011 9664 10537 -1837 -837 132 C \nATOM 3535 N LYS B 131 0.958 -10.311 28.577 1.00 77.01 N \nANISOU 3535 N LYS B 131 8818 10020 10421 -1687 -802 69 N \nATOM 3536 CA LYS B 131 2.282 -9.793 28.175 1.00 82.90 C \nANISOU 3536 CA LYS B 131 9486 10936 11077 -1573 -796 27 C \nATOM 3537 C LYS B 131 2.451 -9.998 26.670 1.00 85.56 C \nANISOU 3537 C LYS B 131 9870 11186 11453 -1520 -790 18 C \nATOM 3538 O LYS B 131 2.313 -11.104 26.193 1.00 67.77 O \nANISOU 3538 O LYS B 131 7713 8747 9288 -1479 -787 19 O \nATOM 3539 CB LYS B 131 3.459 -10.535 28.845 1.00 91.50 C \nANISOU 3539 CB LYS B 131 10594 12033 12141 -1400 -804 -20 C \nATOM 3540 CG LYS B 131 3.879 -10.075 30.234 1.00102.40 C \nANISOU 3540 CG LYS B 131 11885 13595 13429 -1380 -812 -37 C \nATOM 3541 CD LYS B 131 5.144 -10.799 30.735 1.00103.18 C \nANISOU 3541 CD LYS B 131 12042 13683 13479 -1169 -834 -93 C \nATOM 3542 CE LYS B 131 5.474 -10.524 32.232 1.00104.49 C \nANISOU 3542 CE LYS B 131 12130 14010 13561 -1136 -844 -112 C \nATOM 3543 NZ LYS B 131 5.171 -9.128 32.681 1.00103.77 N \nANISOU 3543 NZ LYS B 131 11853 14215 13361 -1257 -832 -99 N \nATOM 3544 N GLU B 132 2.761 -8.923 25.935 1.00 96.43 N \nANISOU 3544 N GLU B 132 11169 12723 12746 -1534 -789 11 N \nATOM 3545 CA GLU B 132 3.172 -9.034 24.534 1.00 93.28 C \nANISOU 3545 CA GLU B 132 10804 12273 12365 -1456 -784 -7 C \nATOM 3546 C GLU B 132 4.599 -9.558 24.462 1.00 93.86 C \nANISOU 3546 C GLU B 132 10910 12364 12387 -1243 -797 -65 C \nATOM 3547 O GLU B 132 5.548 -8.827 24.765 1.00 96.34 O \nANISOU 3547 O GLU B 132 11134 12902 12568 -1131 -810 -110 O \nATOM 3548 CB GLU B 132 3.099 -7.683 23.829 1.00 93.00 C \nANISOU 3548 CB GLU B 132 10673 12426 12238 -1539 -783 1 C \nATOM 3549 CG GLU B 132 1.706 -7.097 23.720 1.00 93.84 C \nANISOU 3549 CG GLU B 132 10811 12480 12363 -1759 -791 60 C \nATOM 3550 CD GLU B 132 1.682 -5.817 22.904 1.00 96.89 C \nANISOU 3550 CD GLU B 132 11129 13041 12644 -1867 -796 73 C \nATOM 3551 OE1 GLU B 132 1.867 -5.882 21.678 1.00 91.07 O \nANISOU 3551 OE1 GLU B 132 10414 12250 11938 -1807 -789 62 O \nATOM 3552 OE2 GLU B 132 1.477 -4.738 23.495 1.00102.08 O \nANISOU 3552 OE2 GLU B 132 11710 13904 13173 -2032 -810 97 O \nATOM 3553 N LEU B 133 4.743 -10.813 24.055 1.00 88.37 N \nANISOU 3553 N LEU B 133 10358 11448 11772 -1187 -804 -68 N \nATOM 3554 CA LEU B 133 6.056 -11.469 24.013 1.00 90.50 C \nANISOU 3554 CA LEU B 133 10741 11667 11977 -1002 -838 -117 C \nATOM 3555 C LEU B 133 6.933 -10.901 22.902 1.00 93.14 C \nANISOU 3555 C LEU B 133 11081 12083 12225 -869 -855 -158 C \nATOM 3556 O LEU B 133 8.168 -11.131 22.889 1.00 88.93 O \nANISOU 3556 O LEU B 133 10653 11552 11586 -669 -902 -214 O \nATOM 3557 CB LEU B 133 5.926 -12.988 23.851 1.00 82.07 C \nANISOU 3557 CB LEU B 133 9846 10348 10989 -1038 -848 -97 C \nATOM 3558 CG LEU B 133 5.578 -13.848 25.036 1.00 79.92 C \nANISOU 3558 CG LEU B 133 9614 9996 10758 -1099 -850 -79 C \nATOM 3559 CD1 LEU B 133 4.885 -13.033 26.083 1.00 81.43 C \nANISOU 3559 CD1 LEU B 133 9655 10327 10959 -1165 -828 -63 C \nATOM 3560 CD2 LEU B 133 4.728 -15.029 24.600 1.00 81.16 C \nANISOU 3560 CD2 LEU B 133 9838 9990 11010 -1234 -835 -38 C \nATOM 3561 N GLY B 134 6.301 -10.158 21.987 1.00 82.52 N \nANISOU 3561 N GLY B 134 9645 10799 10910 -968 -827 -133 N \nATOM 3562 CA GLY B 134 7.004 -9.559 20.854 1.00 81.29 C \nANISOU 3562 CA GLY B 134 9474 10734 10678 -860 -837 -168 C \nATOM 3563 C GLY B 134 7.292 -10.576 19.785 1.00 82.46 C \nANISOU 3563 C GLY B 134 9803 10648 10880 -816 -854 -169 C \nATOM 3564 O GLY B 134 8.292 -10.476 19.077 1.00 90.47 O \nANISOU 3564 O GLY B 134 10890 11679 11805 -655 -887 -214 O \nATOM 3565 N ASN B 135 6.397 -11.554 19.667 1.00 86.16 N \nANISOU 3565 N ASN B 135 10345 10919 11475 -961 -835 -120 N \nATOM 3566 CA ASN B 135 6.624 -12.741 18.829 1.00 84.07 C \nANISOU 3566 CA ASN B 135 10255 10445 11242 -968 -853 -113 C \nATOM 3567 C ASN B 135 5.340 -13.198 18.109 1.00 82.76 C \nANISOU 3567 C ASN B 135 10059 10191 11196 -1139 -815 -62 C \nATOM 3568 O ASN B 135 5.350 -14.182 17.368 1.00 76.32 O \nANISOU 3568 O ASN B 135 9352 9246 10399 -1184 -822 -50 O \nATOM 3569 CB ASN B 135 7.195 -13.884 19.670 1.00 83.17 C \nANISOU 3569 CB ASN B 135 10304 10202 11093 -939 -892 -120 C \nATOM 3570 CG ASN B 135 6.155 -14.533 20.531 1.00 85.67 C \nANISOU 3570 CG ASN B 135 10572 10477 11501 -1091 -863 -77 C \nATOM 3571 OD1 ASN B 135 5.165 -13.893 20.931 1.00 95.67 O \nANISOU 3571 OD1 ASN B 135 11683 11837 12830 -1167 -825 -55 O \nATOM 3572 ND2 ASN B 135 6.348 -15.816 20.807 1.00 78.52 N \nANISOU 3572 ND2 ASN B 135 9816 9432 10586 -1146 -888 -65 N \nATOM 3573 N GLY B 136 4.239 -12.485 18.332 1.00 77.23 N \nANISOU 3573 N GLY B 136 9224 9569 10550 -1231 -783 -36 N \nATOM 3574 CA GLY B 136 2.977 -12.857 17.749 1.00 67.41 C \nANISOU 3574 CA GLY B 136 7966 8255 9394 -1345 -761 -1 C \nATOM 3575 C GLY B 136 2.065 -13.396 18.800 1.00 68.87 C \nANISOU 3575 C GLY B 136 8132 8413 9623 -1417 -756 20 C \nATOM 3576 O GLY B 136 0.862 -13.508 18.570 1.00 58.83 O \nANISOU 3576 O GLY B 136 6838 7116 8399 -1480 -748 40 O \nATOM 3577 N CYS B 137 2.642 -13.713 19.961 1.00 78.61 N \nANISOU 3577 N CYS B 137 9386 9656 10827 -1385 -767 9 N \nATOM 3578 CA CYS B 137 1.922 -14.368 21.046 1.00 79.96 C \nANISOU 3578 CA CYS B 137 9548 9800 11033 -1444 -764 26 C \nATOM 3579 C CYS B 137 1.803 -13.489 22.240 1.00 78.43 C \nANISOU 3579 C CYS B 137 9287 9697 10818 -1447 -768 27 C \nATOM 3580 O CYS B 137 2.680 -12.673 22.494 1.00 83.35 O \nANISOU 3580 O CYS B 137 9874 10423 11372 -1383 -775 6 O \nATOM 3581 CB CYS B 137 2.667 -15.613 21.497 1.00 73.98 C \nANISOU 3581 CB CYS B 137 8889 8971 10250 -1434 -780 18 C \nATOM 3582 SG CYS B 137 2.993 -16.750 20.168 1.00 81.40 S \nANISOU 3582 SG CYS B 137 9938 9819 11171 -1478 -788 23 S \nATOM 3583 N PHE B 138 0.727 -13.686 22.989 1.00 74.17 N \nANISOU 3583 N PHE B 138 8728 9138 10316 -1515 -766 48 N \nATOM 3584 CA PHE B 138 0.567 -13.038 24.257 1.00 73.67 C \nANISOU 3584 CA PHE B 138 8620 9146 10226 -1543 -773 55 C \nATOM 3585 C PHE B 138 0.672 -14.101 25.358 1.00 75.73 C \nANISOU 3585 C PHE B 138 8909 9361 10505 -1532 -775 52 C \nATOM 3586 O PHE B 138 0.014 -15.139 25.295 1.00 64.93 O \nANISOU 3586 O PHE B 138 7570 7921 9179 -1558 -772 60 O \nATOM 3587 CB PHE B 138 -0.800 -12.363 24.359 1.00 83.44 C \nANISOU 3587 CB PHE B 138 9857 10376 11472 -1635 -787 83 C \nATOM 3588 CG PHE B 138 -1.105 -11.379 23.256 1.00 81.92 C \nANISOU 3588 CG PHE B 138 9667 10205 11254 -1677 -794 94 C \nATOM 3589 CD1 PHE B 138 -0.727 -10.058 23.367 1.00 78.11 C \nANISOU 3589 CD1 PHE B 138 9129 9860 10689 -1738 -800 101 C \nATOM 3590 CD2 PHE B 138 -1.820 -11.780 22.132 1.00 80.21 C \nANISOU 3590 CD2 PHE B 138 9501 9896 11078 -1663 -797 96 C \nATOM 3591 CE1 PHE B 138 -1.031 -9.157 22.375 1.00 83.79 C \nANISOU 3591 CE1 PHE B 138 9858 10608 11372 -1801 -810 115 C \nATOM 3592 CE2 PHE B 138 -2.125 -10.885 21.134 1.00 78.56 C \nANISOU 3592 CE2 PHE B 138 9312 9696 10843 -1703 -809 106 C \nATOM 3593 CZ PHE B 138 -1.733 -9.571 21.258 1.00 86.03 C \nANISOU 3593 CZ PHE B 138 10216 10760 11710 -1781 -816 118 C \nATOM 3594 N GLU B 139 1.500 -13.839 26.368 1.00 75.49 N \nANISOU 3594 N GLU B 139 8859 9398 10425 -1489 -783 37 N \nATOM 3595 CA GLU B 139 1.472 -14.626 27.590 1.00 78.03 C \nANISOU 3595 CA GLU B 139 9202 9686 10758 -1495 -787 39 C \nATOM 3596 C GLU B 139 0.461 -13.979 28.510 1.00 76.81 C \nANISOU 3596 C GLU B 139 8993 9578 10612 -1572 -789 61 C \nATOM 3597 O GLU B 139 0.687 -12.882 29.046 1.00 64.44 O \nANISOU 3597 O GLU B 139 7365 8133 8986 -1591 -794 61 O \nATOM 3598 CB GLU B 139 2.846 -14.709 28.275 1.00 86.26 C \nANISOU 3598 CB GLU B 139 10278 10767 11730 -1393 -806 7 C \nATOM 3599 CG GLU B 139 2.827 -15.570 29.533 1.00 86.14 C \nANISOU 3599 CG GLU B 139 10300 10706 11724 -1407 -814 10 C \nATOM 3600 CD GLU B 139 4.198 -15.990 30.042 1.00 89.00 C \nANISOU 3600 CD GLU B 139 10763 11048 12005 -1292 -848 -24 C \nATOM 3601 OE1 GLU B 139 5.213 -15.873 29.327 1.00 89.94 O \nANISOU 3601 OE1 GLU B 139 10961 11157 12055 -1186 -874 -55 O \nATOM 3602 OE2 GLU B 139 4.259 -16.470 31.186 1.00 96.17 O \nANISOU 3602 OE2 GLU B 139 11694 11940 12907 -1297 -858 -23 O \nATOM 3603 N PHE B 140 -0.657 -14.674 28.702 1.00 81.16 N \nANISOU 3603 N PHE B 140 9571 10051 11214 -1617 -791 78 N \nATOM 3604 CA PHE B 140 -1.714 -14.201 29.566 1.00 77.99 C \nANISOU 3604 CA PHE B 140 9169 9653 10809 -1679 -809 98 C \nATOM 3605 C PHE B 140 -1.124 -14.070 30.940 1.00 85.81 C \nANISOU 3605 C PHE B 140 10125 10708 11770 -1681 -809 95 C \nATOM 3606 O PHE B 140 -0.277 -14.858 31.370 1.00 91.72 O \nANISOU 3606 O PHE B 140 10878 11449 12522 -1623 -801 77 O \nATOM 3607 CB PHE B 140 -2.842 -15.200 29.680 1.00 74.18 C \nANISOU 3607 CB PHE B 140 8725 9095 10365 -1670 -819 99 C \nATOM 3608 CG PHE B 140 -3.730 -15.237 28.502 1.00 80.26 C \nANISOU 3608 CG PHE B 140 9531 9823 11142 -1652 -830 97 C \nATOM 3609 CD1 PHE B 140 -3.348 -15.897 27.347 1.00 74.42 C \nANISOU 3609 CD1 PHE B 140 8774 9082 10421 -1619 -809 84 C \nATOM 3610 CD2 PHE B 140 -4.971 -14.630 28.551 1.00 79.78 C \nANISOU 3610 CD2 PHE B 140 9545 9715 11051 -1665 -874 107 C \nATOM 3611 CE1 PHE B 140 -4.181 -15.915 26.257 1.00 80.62 C \nANISOU 3611 CE1 PHE B 140 9582 9847 11203 -1590 -821 78 C \nATOM 3612 CE2 PHE B 140 -5.816 -14.666 27.460 1.00 81.52 C \nANISOU 3612 CE2 PHE B 140 9820 9893 11262 -1617 -896 97 C \nATOM 3613 CZ PHE B 140 -5.420 -15.304 26.307 1.00 78.03 C \nANISOU 3613 CZ PHE B 140 9325 9475 10846 -1575 -865 81 C \nATOM 3614 N TYR B 141 -1.563 -13.064 31.660 1.00 96.01 N \nANISOU 3614 N TYR B 141 11401 12063 13016 -1759 -826 114 N \nATOM 3615 CA TYR B 141 -1.150 -12.984 33.032 1.00 97.97 C \nANISOU 3615 CA TYR B 141 11608 12384 13231 -1766 -827 111 C \nATOM 3616 C TYR B 141 -1.947 -14.096 33.670 1.00106.16 C \nANISOU 3616 C TYR B 141 12699 13307 14330 -1757 -833 116 C \nATOM 3617 O TYR B 141 -1.386 -15.098 34.134 1.00124.83 O \nANISOU 3617 O TYR B 141 15060 15649 16720 -1700 -820 100 O \nATOM 3618 CB TYR B 141 -1.412 -11.598 33.619 1.00 93.55 C \nANISOU 3618 CB TYR B 141 11013 11953 12580 -1888 -847 135 C \nATOM 3619 CG TYR B 141 -0.297 -10.636 33.276 1.00 86.89 C \nANISOU 3619 CG TYR B 141 10061 11310 11643 -1871 -834 116 C \nATOM 3620 CD1 TYR B 141 1.021 -10.978 33.543 1.00 82.08 C \nANISOU 3620 CD1 TYR B 141 9391 10789 11008 -1725 -819 72 C \nATOM 3621 CD2 TYR B 141 -0.544 -9.403 32.681 1.00 92.74 C \nANISOU 3621 CD2 TYR B 141 10774 12163 12299 -1991 -847 137 C \nATOM 3622 CE1 TYR B 141 2.052 -10.137 33.224 1.00 82.56 C \nANISOU 3622 CE1 TYR B 141 9350 11059 10958 -1660 -817 40 C \nATOM 3623 CE2 TYR B 141 0.492 -8.536 32.373 1.00 91.87 C \nANISOU 3623 CE2 TYR B 141 10536 12290 12080 -1964 -835 112 C \nATOM 3624 CZ TYR B 141 1.784 -8.919 32.652 1.00 92.52 C \nANISOU 3624 CZ TYR B 141 10545 12473 12137 -1779 -819 59 C \nATOM 3625 OH TYR B 141 2.833 -8.077 32.363 1.00115.92 O \nANISOU 3625 OH TYR B 141 13378 15700 14966 -1703 -816 19 O \nATOM 3626 N HIS B 142 -3.263 -13.983 33.565 1.00 96.95 N \nANISOU 3626 N HIS B 142 11600 12066 13170 -1803 -861 134 N \nATOM 3627 CA HIS B 142 -4.157 -14.984 34.153 1.00 89.34 C \nANISOU 3627 CA HIS B 142 10678 11028 12239 -1769 -874 130 C \nATOM 3628 C HIS B 142 -4.238 -16.379 33.515 1.00 90.55 C \nANISOU 3628 C HIS B 142 10815 11152 12436 -1692 -855 108 C \nATOM 3629 O HIS B 142 -3.634 -16.696 32.486 1.00 99.44 O \nANISOU 3629 O HIS B 142 11920 12286 13577 -1671 -832 98 O \nATOM 3630 CB HIS B 142 -5.565 -14.404 34.343 1.00 83.69 C \nANISOU 3630 CB HIS B 142 10077 10242 11481 -1808 -931 147 C \nATOM 3631 CG HIS B 142 -6.250 -13.982 33.095 1.00 80.13 C \nANISOU 3631 CG HIS B 142 9706 9733 11009 -1798 -959 148 C \nATOM 3632 ND1 HIS B 142 -6.053 -12.732 32.545 1.00 89.83 N \nANISOU 3632 ND1 HIS B 142 10962 10983 12186 -1897 -972 171 N \nATOM 3633 CD2 HIS B 142 -7.199 -14.585 32.344 1.00 75.66 C \nANISOU 3633 CD2 HIS B 142 9202 9102 10443 -1701 -984 126 C \nATOM 3634 CE1 HIS B 142 -6.817 -12.603 31.476 1.00 92.07 C \nANISOU 3634 CE1 HIS B 142 11341 11188 12454 -1865 -1005 168 C \nATOM 3635 NE2 HIS B 142 -7.517 -13.715 31.329 1.00 88.59 N \nANISOU 3635 NE2 HIS B 142 10921 10695 12043 -1733 -1013 137 N \nATOM 3636 N LYS B 143 -4.965 -17.222 34.227 1.00 88.60 N \nANISOU 3636 N LYS B 143 10576 10897 12193 -1664 -866 100 N \nATOM 3637 CA LYS B 143 -5.390 -18.510 33.752 1.00 86.41 C \nANISOU 3637 CA LYS B 143 10266 10648 11917 -1611 -857 78 C \nATOM 3638 C LYS B 143 -6.521 -18.273 32.791 1.00 85.78 C \nANISOU 3638 C LYS B 143 10233 10550 11809 -1546 -889 64 C \nATOM 3639 O LYS B 143 -7.496 -17.591 33.136 1.00 89.76 O \nANISOU 3639 O LYS B 143 10832 10994 12278 -1519 -940 66 O \nATOM 3640 CB LYS B 143 -5.917 -19.320 34.926 1.00 88.04 C \nANISOU 3640 CB LYS B 143 10454 10886 12109 -1592 -867 69 C \nATOM 3641 CG LYS B 143 -6.516 -20.666 34.552 1.00 96.26 C \nANISOU 3641 CG LYS B 143 11433 12025 13115 -1542 -862 41 C \nATOM 3642 CD LYS B 143 -7.297 -21.267 35.708 1.00104.21 C \nANISOU 3642 CD LYS B 143 12423 13083 14088 -1498 -882 26 C \nATOM 3643 CE LYS B 143 -6.383 -21.556 36.893 1.00106.43 C \nANISOU 3643 CE LYS B 143 12685 13354 14398 -1582 -859 46 C \nATOM 3644 NZ LYS B 143 -7.095 -22.237 37.999 1.00102.39 N \nANISOU 3644 NZ LYS B 143 12145 12905 13853 -1546 -875 31 N \nATOM 3645 N CYS B 144 -6.405 -18.865 31.608 1.00 82.12 N \nANISOU 3645 N CYS B 144 9726 10132 11345 -1521 -869 50 N \nATOM 3646 CA CYS B 144 -7.378 -18.668 30.554 1.00 74.82 C \nANISOU 3646 CA CYS B 144 8841 9202 10386 -1440 -899 30 C \nATOM 3647 C CYS B 144 -7.850 -20.011 30.040 1.00 76.00 C \nANISOU 3647 C CYS B 144 8900 9489 10489 -1372 -889 -5 C \nATOM 3648 O CYS B 144 -7.255 -20.591 29.122 1.00 65.00 O \nANISOU 3648 O CYS B 144 7438 8162 9096 -1416 -853 -5 O \nATOM 3649 CB CYS B 144 -6.793 -17.829 29.421 1.00 70.38 C \nANISOU 3649 CB CYS B 144 8302 8591 9848 -1481 -886 46 C \nATOM 3650 SG CYS B 144 -7.972 -17.069 28.253 1.00 77.47 S \nANISOU 3650 SG CYS B 144 9308 9427 10698 -1399 -941 32 S \nATOM 3651 N ASP B 145 -8.937 -20.502 30.641 1.00 87.83 N \nANISOU 3651 N ASP B 145 10398 11050 11924 -1266 -925 -37 N \nATOM 3652 CA ASP B 145 -9.545 -21.784 30.226 1.00 91.70 C \nANISOU 3652 CA ASP B 145 10768 11744 12328 -1182 -921 -81 C \nATOM 3653 C ASP B 145 -10.017 -21.731 28.774 1.00 87.20 C \nANISOU 3653 C ASP B 145 10192 11228 11713 -1096 -934 -109 C \nATOM 3654 O ASP B 145 -10.046 -20.677 28.155 1.00 88.85 O \nANISOU 3654 O ASP B 145 10512 11290 11956 -1084 -955 -95 O \nATOM 3655 CB ASP B 145 -10.685 -22.229 31.178 1.00 99.75 C \nANISOU 3655 CB ASP B 145 11791 12845 13265 -1040 -969 -123 C \nATOM 3656 CG ASP B 145 -11.785 -21.173 31.354 1.00102.08 C \nANISOU 3656 CG ASP B 145 12282 12982 13522 -893 -1055 -140 C \nATOM 3657 OD1 ASP B 145 -12.052 -20.391 30.432 1.00107.40 O \nANISOU 3657 OD1 ASP B 145 13062 13555 14189 -853 -1087 -140 O \nATOM 3658 OD2 ASP B 145 -12.409 -21.140 32.433 1.00106.54 O \nANISOU 3658 OD2 ASP B 145 12919 13513 14047 -822 -1101 -154 O \nATOM 3659 N ASN B 146 -10.372 -22.881 28.230 1.00 90.67 N \nANISOU 3659 N ASN B 146 10489 11902 12059 -1047 -920 -147 N \nATOM 3660 CA ASN B 146 -10.813 -22.958 26.847 1.00 89.98 C \nANISOU 3660 CA ASN B 146 10369 11908 11912 -959 -929 -179 C \nATOM 3661 C ASN B 146 -11.893 -21.941 26.500 1.00 89.65 C \nANISOU 3661 C ASN B 146 10495 11730 11839 -762 -1007 -210 C \nATOM 3662 O ASN B 146 -11.862 -21.362 25.425 1.00 87.69 O \nANISOU 3662 O ASN B 146 10303 11408 11606 -749 -1014 -206 O \nATOM 3663 CB ASN B 146 -11.289 -24.377 26.516 1.00 90.44 C \nANISOU 3663 CB ASN B 146 10229 12310 11826 -909 -916 -229 C \nATOM 3664 CG ASN B 146 -10.175 -25.386 26.583 1.00 98.98 C \nANISOU 3664 CG ASN B 146 11182 13519 12907 -1156 -850 -189 C \nATOM 3665 OD1 ASN B 146 -10.332 -26.461 27.161 1.00116.04 O \nANISOU 3665 OD1 ASN B 146 13209 15911 14970 -1198 -839 -205 O \nATOM 3666 ND2 ASN B 146 -9.025 -25.040 26.019 1.00105.22 N \nANISOU 3666 ND2 ASN B 146 12033 14157 13790 -1325 -815 -136 N \nATOM 3667 N GLU B 147 -12.843 -21.730 27.405 1.00 96.57 N \nANISOU 3667 N GLU B 147 11477 12560 12656 -615 -1075 -240 N \nATOM 3668 CA GLU B 147 -13.921 -20.772 27.157 1.00102.26 C \nANISOU 3668 CA GLU B 147 12426 13116 13311 -433 -1174 -269 C \nATOM 3669 C GLU B 147 -13.412 -19.339 27.183 1.00100.66 C \nANISOU 3669 C GLU B 147 12411 12627 13210 -588 -1186 -202 C \nATOM 3670 O GLU B 147 -13.898 -18.503 26.430 1.00102.73 O \nANISOU 3670 O GLU B 147 12841 12758 13435 -529 -1245 -206 O \nATOM 3671 CB GLU B 147 -15.093 -20.974 28.126 1.00106.22 C \nANISOU 3671 CB GLU B 147 13031 13636 13692 -223 -1261 -323 C \nATOM 3672 CG GLU B 147 -15.865 -22.253 27.846 1.00115.37 C \nANISOU 3672 CG GLU B 147 14012 15129 14693 0 -1273 -411 C \nATOM 3673 CD GLU B 147 -17.122 -22.396 28.687 1.00126.22 C \nANISOU 3673 CD GLU B 147 15514 16528 15916 273 -1378 -481 C \nATOM 3674 OE1 GLU B 147 -17.034 -22.998 29.778 1.00128.24 O \nANISOU 3674 OE1 GLU B 147 15672 16883 16169 241 -1356 -482 O \nATOM 3675 OE2 GLU B 147 -18.196 -21.901 28.272 1.00134.93 O \nANISOU 3675 OE2 GLU B 147 16838 17539 16891 527 -1492 -538 O \nATOM 3676 N CYS B 148 -12.440 -19.057 28.047 1.00 98.79 N \nANISOU 3676 N CYS B 148 12141 12316 13077 -786 -1134 -144 N \nATOM 3677 CA CYS B 148 -11.773 -17.754 28.066 1.00 91.41 C \nANISOU 3677 CA CYS B 148 11320 11193 12218 -955 -1130 -83 C \nATOM 3678 C CYS B 148 -11.041 -17.528 26.743 1.00 96.00 C \nANISOU 3678 C CYS B 148 11834 11788 12852 -1025 -1082 -67 C \nATOM 3679 O CYS B 148 -11.034 -16.424 26.210 1.00107.10 O \nANISOU 3679 O CYS B 148 13365 13068 14261 -1079 -1110 -41 O \nATOM 3680 CB CYS B 148 -10.788 -17.661 29.250 1.00 93.48 C \nANISOU 3680 CB CYS B 148 11516 11441 12563 -1120 -1080 -38 C \nATOM 3681 SG CYS B 148 -9.582 -16.307 29.285 1.00 96.93 S \nANISOU 3681 SG CYS B 148 11980 11774 13074 -1332 -1046 27 S \nATOM 3682 N MET B 149 -10.458 -18.588 26.199 1.00 90.10 N \nANISOU 3682 N MET B 149 10903 11201 12129 -1036 -1015 -81 N \nATOM 3683 CA MET B 149 -9.778 -18.520 24.928 1.00 83.48 C \nANISOU 3683 CA MET B 149 10007 10383 11329 -1094 -973 -69 C \nATOM 3684 C MET B 149 -10.771 -18.336 23.792 1.00 82.94 C \nANISOU 3684 C MET B 149 10006 10320 11186 -945 -1023 -108 C \nATOM 3685 O MET B 149 -10.561 -17.496 22.907 1.00 84.45 O \nANISOU 3685 O MET B 149 10270 10414 11403 -984 -1028 -89 O \nATOM 3686 CB MET B 149 -8.945 -19.787 24.684 1.00 87.12 C \nANISOU 3686 CB MET B 149 10290 11010 11802 -1170 -903 -71 C \nATOM 3687 CG MET B 149 -7.462 -19.531 24.520 1.00 87.79 C \nANISOU 3687 CG MET B 149 10358 11028 11969 -1331 -851 -26 C \nATOM 3688 SD MET B 149 -6.650 -19.579 26.100 1.00104.44 S \nANISOU 3688 SD MET B 149 12469 13090 14122 -1426 -833 2 S \nATOM 3689 CE MET B 149 -4.971 -19.138 25.699 1.00 76.04 C \nANISOU 3689 CE MET B 149 8891 9420 10582 -1538 -795 35 C \nATOM 3690 N GLU B 150 -11.839 -19.129 23.772 1.00 85.41 N \nANISOU 3690 N GLU B 150 10294 10768 11391 -761 -1064 -168 N \nATOM 3691 CA GLU B 150 -12.857 -18.954 22.731 1.00 93.42 C \nANISOU 3691 CA GLU B 150 11393 11794 12308 -572 -1128 -217 C \nATOM 3692 C GLU B 150 -13.313 -17.502 22.745 1.00 92.55 C \nANISOU 3692 C GLU B 150 11556 11418 12191 -571 -1208 -193 C \nATOM 3693 O GLU B 150 -13.560 -16.921 21.680 1.00 99.66 O \nANISOU 3693 O GLU B 150 12554 12246 13067 -533 -1239 -197 O \nATOM 3694 CB GLU B 150 -14.043 -19.905 22.903 1.00 99.77 C \nANISOU 3694 CB GLU B 150 12152 12798 12959 -323 -1181 -299 C \nATOM 3695 CG GLU B 150 -15.111 -19.822 21.805 1.00109.41 C \nANISOU 3695 CG GLU B 150 13458 14065 14047 -77 -1256 -367 C \nATOM 3696 CD GLU B 150 -14.584 -20.167 20.412 1.00116.33 C \nANISOU 3696 CD GLU B 150 14177 15078 14945 -133 -1193 -366 C \nATOM 3697 OE1 GLU B 150 -13.960 -21.244 20.257 1.00128.78 O \nANISOU 3697 OE1 GLU B 150 15505 16900 16527 -237 -1111 -364 O \nATOM 3698 OE2 GLU B 150 -14.798 -19.378 19.469 1.00109.97 O \nANISOU 3698 OE2 GLU B 150 13509 14137 14138 -90 -1230 -365 O \nATOM 3699 N SER B 151 -13.394 -16.938 23.953 1.00 88.47 N \nANISOU 3699 N SER B 151 11165 10766 11683 -638 -1243 -163 N \nATOM 3700 CA SER B 151 -13.940 -15.602 24.162 1.00 91.95 C \nANISOU 3700 CA SER B 151 11895 10968 12074 -675 -1336 -135 C \nATOM 3701 C SER B 151 -13.063 -14.537 23.526 1.00 95.03 C \nANISOU 3701 C SER B 151 12303 11264 12539 -886 -1299 -73 C \nATOM 3702 O SER B 151 -13.585 -13.580 22.950 1.00106.14 O \nANISOU 3702 O SER B 151 13924 12526 13878 -896 -1374 -62 O \nATOM 3703 CB SER B 151 -14.159 -15.273 25.649 1.00 93.74 C \nANISOU 3703 CB SER B 151 12240 11097 12279 -735 -1378 -112 C \nATOM 3704 OG SER B 151 -13.011 -14.717 26.241 1.00100.11 O \nANISOU 3704 OG SER B 151 12962 11884 13193 -983 -1308 -44 O \nATOM 3705 N VAL B 152 -11.746 -14.709 23.607 1.00 90.07 N \nANISOU 3705 N VAL B 152 11465 10725 12031 -1044 -1194 -38 N \nATOM 3706 CA VAL B 152 -10.832 -13.742 22.990 1.00 93.14 C \nANISOU 3706 CA VAL B 152 11841 11072 12476 -1215 -1156 10 C \nATOM 3707 C VAL B 152 -10.804 -13.852 21.458 1.00 93.11 C \nANISOU 3707 C VAL B 152 11801 11098 12478 -1153 -1141 -9 C \nATOM 3708 O VAL B 152 -10.457 -12.895 20.773 1.00104.73 O \nANISOU 3708 O VAL B 152 13327 12508 13956 -1254 -1142 22 O \nATOM 3709 CB VAL B 152 -9.383 -13.818 23.537 1.00 94.23 C \nANISOU 3709 CB VAL B 152 11798 11293 12713 -1362 -1065 44 C \nATOM 3710 CG1 VAL B 152 -9.365 -13.727 25.048 1.00 93.55 C \nANISOU 3710 CG1 VAL B 152 11731 11193 12620 -1421 -1076 61 C \nATOM 3711 CG2 VAL B 152 -8.667 -15.067 23.077 1.00 97.72 C \nANISOU 3711 CG2 VAL B 152 12048 11865 13216 -1317 -989 21 C \nATOM 3712 N ARG B 153 -11.171 -15.015 20.932 1.00 91.08 N \nANISOU 3712 N ARG B 153 11441 10961 12203 -996 -1125 -60 N \nATOM 3713 CA ARG B 153 -11.210 -15.222 19.484 1.00 90.87 C \nANISOU 3713 CA ARG B 153 11369 10988 12169 -929 -1112 -83 C \nATOM 3714 C ARG B 153 -12.406 -14.552 18.838 1.00 98.16 C \nANISOU 3714 C ARG B 153 12517 11794 12987 -797 -1214 -108 C \nATOM 3715 O ARG B 153 -12.278 -13.965 17.775 1.00 89.39 O \nANISOU 3715 O ARG B 153 11452 10631 11881 -828 -1217 -97 O \nATOM 3716 CB ARG B 153 -11.243 -16.717 19.133 1.00 85.91 C \nANISOU 3716 CB ARG B 153 10542 10578 11521 -825 -1066 -130 C \nATOM 3717 CG ARG B 153 -9.978 -17.482 19.506 1.00 78.37 C \nANISOU 3717 CG ARG B 153 9401 9727 10649 -977 -974 -102 C \nATOM 3718 CD ARG B 153 -9.933 -18.821 18.802 1.00 79.98 C \nANISOU 3718 CD ARG B 153 9430 10154 10805 -941 -933 -135 C \nATOM 3719 NE ARG B 153 -9.436 -19.905 19.647 1.00 83.23 N \nANISOU 3719 NE ARG B 153 9710 10699 11213 -1025 -890 -130 N \nATOM 3720 CZ ARG B 153 -10.199 -20.843 20.207 1.00 89.55 C \nANISOU 3720 CZ ARG B 153 10427 11678 11919 -928 -907 -172 C \nATOM 3721 NH1 ARG B 153 -11.511 -20.870 20.003 1.00 90.36 N \nANISOU 3721 NH1 ARG B 153 10563 11855 11914 -707 -971 -232 N \nATOM 3722 NH2 ARG B 153 -9.646 -21.780 20.959 1.00 95.05 N \nANISOU 3722 NH2 ARG B 153 11013 12491 12610 -1043 -867 -159 N \nATOM 3723 N ASN B 154 -13.568 -14.659 19.480 1.00111.76 N \nANISOU 3723 N ASN B 154 14397 13467 14598 -639 -1306 -146 N \nATOM 3724 CA ASN B 154 -14.827 -14.126 18.920 1.00116.70 C \nANISOU 3724 CA ASN B 154 15297 13960 15083 -465 -1432 -184 C \nATOM 3725 C ASN B 154 -15.148 -12.699 19.371 1.00111.68 C \nANISOU 3725 C ASN B 154 14977 13065 14390 -607 -1526 -131 C \nATOM 3726 O ASN B 154 -16.257 -12.226 19.152 1.00113.71 O \nANISOU 3726 O ASN B 154 15538 13164 14500 -476 -1657 -157 O \nATOM 3727 CB ASN B 154 -16.003 -15.056 19.264 1.00123.89 C \nANISOU 3727 CB ASN B 154 16247 14970 15857 -164 -1505 -270 C \nATOM 3728 CG ASN B 154 -16.075 -15.375 20.742 1.00131.45 C \nANISOU 3728 CG ASN B 154 17196 15935 16814 -181 -1510 -265 C \nATOM 3729 OD1 ASN B 154 -15.293 -14.833 21.515 1.00131.56 O \nANISOU 3729 OD1 ASN B 154 17196 15863 16926 -419 -1465 -196 O \nATOM 3730 ND2 ASN B 154 -16.972 -16.287 21.150 1.00146.28 N \nANISOU 3730 ND2 ASN B 154 19058 17947 18574 78 -1561 -342 N \nATOM 3731 N GLY B 155 -14.193 -12.036 20.025 1.00107.30 N \nANISOU 3731 N GLY B 155 14364 12480 13924 -874 -1468 -59 N \nATOM 3732 CA GLY B 155 -14.387 -10.670 20.500 1.00102.99 C \nANISOU 3732 CA GLY B 155 14081 11747 13304 -1072 -1548 1 C \nATOM 3733 C GLY B 155 -15.168 -10.567 21.804 1.00107.43 C \nANISOU 3733 C GLY B 155 14855 12197 13766 -1052 -1641 1 C \nATOM 3734 O GLY B 155 -15.118 -9.548 22.491 1.00110.30 O \nANISOU 3734 O GLY B 155 15385 12450 14074 -1277 -1687 62 O \nATOM 3735 N THR B 156 -15.878 -11.625 22.167 1.00106.71 N \nANISOU 3735 N THR B 156 14749 12158 13637 -792 -1669 -67 N \nATOM 3736 CA THR B 156 -16.738 -11.608 23.326 1.00113.84 C \nANISOU 3736 CA THR B 156 15878 12948 14429 -720 -1771 -81 C \nATOM 3737 C THR B 156 -15.977 -11.963 24.591 1.00104.06 C \nANISOU 3737 C THR B 156 14428 11815 13296 -853 -1683 -50 C \nATOM 3738 O THR B 156 -16.392 -12.842 25.329 1.00 99.47 O \nANISOU 3738 O THR B 156 13797 11303 12694 -685 -1692 -96 O \nATOM 3739 CB THR B 156 -17.878 -12.615 23.142 1.00125.14 C \nANISOU 3739 CB THR B 156 17375 14428 15744 -338 -1848 -182 C \nATOM 3740 OG1 THR B 156 -17.337 -13.938 23.126 1.00126.62 O \nANISOU 3740 OG1 THR B 156 17173 14898 16038 -235 -1723 -223 O \nATOM 3741 CG2 THR B 156 -18.621 -12.359 21.840 1.00125.91 C \nANISOU 3741 CG2 THR B 156 17669 14444 15727 -161 -1936 -225 C \nATOM 3742 N TYR B 157 -14.883 -11.252 24.850 1.00105.53 N \nANISOU 3742 N TYR B 157 14494 12027 13574 -1142 -1605 23 N \nATOM 3743 CA TYR B 157 -14.033 -11.510 26.017 1.00103.47 C \nANISOU 3743 CA TYR B 157 14032 11874 13409 -1270 -1520 52 C \nATOM 3744 C TYR B 157 -14.259 -10.462 27.081 1.00109.24 C \nANISOU 3744 C TYR B 157 14981 12478 14048 -1475 -1595 108 C \nATOM 3745 O TYR B 157 -14.176 -9.266 26.805 1.00126.83 O \nANISOU 3745 O TYR B 157 17357 14629 16205 -1689 -1636 163 O \nATOM 3746 CB TYR B 157 -12.555 -11.513 25.614 1.00102.57 C \nANISOU 3746 CB TYR B 157 13617 11918 13439 -1416 -1385 82 C \nATOM 3747 CG TYR B 157 -11.555 -11.363 26.766 1.00 93.08 C \nANISOU 3747 CG TYR B 157 12259 10804 12302 -1585 -1316 121 C \nATOM 3748 CD1 TYR B 157 -11.199 -12.449 27.571 1.00 94.40 C \nANISOU 3748 CD1 TYR B 157 12252 11072 12545 -1504 -1256 97 C \nATOM 3749 CD2 TYR B 157 -10.957 -10.146 27.030 1.00 87.90 C \nANISOU 3749 CD2 TYR B 157 11622 10160 11614 -1824 -1313 179 C \nATOM 3750 CE1 TYR B 157 -10.279 -12.320 28.605 1.00 89.91 C \nANISOU 3750 CE1 TYR B 157 11556 10579 12026 -1636 -1201 127 C \nATOM 3751 CE2 TYR B 157 -10.036 -9.999 28.063 1.00 88.90 C \nANISOU 3751 CE2 TYR B 157 11595 10402 11780 -1949 -1254 205 C \nATOM 3752 CZ TYR B 157 -9.700 -11.094 28.848 1.00 92.77 C \nANISOU 3752 CZ TYR B 157 11935 10958 12354 -1843 -1200 177 C \nATOM 3753 OH TYR B 157 -8.795 -10.946 29.868 1.00 82.10 O \nANISOU 3753 OH TYR B 157 10451 9715 11031 -1947 -1150 198 O \nATOM 3754 N ASP B 158 -14.524 -10.911 28.305 1.00115.78 N \nANISOU 3754 N ASP B 158 15822 13305 14866 -1433 -1611 99 N \nATOM 3755 CA ASP B 158 -14.772 -10.011 29.440 1.00117.31 C \nANISOU 3755 CA ASP B 158 16223 13389 14960 -1635 -1684 152 C \nATOM 3756 C ASP B 158 -13.471 -9.674 30.170 1.00111.28 C \nANISOU 3756 C ASP B 158 15201 12788 14291 -1872 -1575 204 C \nATOM 3757 O ASP B 158 -12.932 -10.494 30.904 1.00104.85 O \nANISOU 3757 O ASP B 158 14168 12092 13578 -1809 -1496 186 O \nATOM 3758 CB ASP B 158 -15.766 -10.642 30.425 1.00120.05 C \nANISOU 3758 CB ASP B 158 16735 13647 15231 -1452 -1768 111 C \nATOM 3759 CG ASP B 158 -16.128 -9.712 31.563 1.00121.57 C \nANISOU 3759 CG ASP B 158 17192 13702 15298 -1667 -1862 168 C \nATOM 3760 OD1 ASP B 158 -16.609 -8.595 31.271 1.00131.89 O \nANISOU 3760 OD1 ASP B 158 18813 14844 16456 -1837 -1970 213 O \nATOM 3761 OD2 ASP B 158 -15.932 -10.100 32.733 1.00104.31 O \nANISOU 3761 OD2 ASP B 158 14909 11574 13151 -1682 -1830 171 O \nATOM 3762 N TYR B 159 -12.984 -8.453 29.970 1.00115.67 N \nANISOU 3762 N TYR B 159 15790 13368 14791 -2138 -1577 265 N \nATOM 3763 CA TYR B 159 -11.761 -7.979 30.631 1.00110.72 C \nANISOU 3763 CA TYR B 159 14923 12937 14210 -2348 -1487 306 C \nATOM 3764 C TYR B 159 -11.863 -7.907 32.153 1.00114.36 C \nANISOU 3764 C TYR B 159 15421 13406 14626 -2445 -1510 329 C \nATOM 3765 O TYR B 159 -10.959 -8.385 32.841 1.00109.13 O \nANISOU 3765 O TYR B 159 14501 12900 14062 -2427 -1416 319 O \nATOM 3766 CB TYR B 159 -11.330 -6.610 30.061 1.00107.82 C \nANISOU 3766 CB TYR B 159 14581 12642 13743 -2618 -1497 362 C \nATOM 3767 CG TYR B 159 -10.154 -5.979 30.795 1.00102.70 C \nANISOU 3767 CG TYR B 159 13693 12244 13084 -2826 -1422 397 C \nATOM 3768 CD1 TYR B 159 -8.832 -6.264 30.413 1.00104.73 C \nANISOU 3768 CD1 TYR B 159 13623 12713 13458 -2755 -1302 371 C \nATOM 3769 CD2 TYR B 159 -10.356 -5.122 31.868 1.00 99.74 C \nANISOU 3769 CD2 TYR B 159 13429 11905 12562 -3078 -1479 449 C \nATOM 3770 CE1 TYR B 159 -7.750 -5.707 31.075 1.00100.82 C \nANISOU 3770 CE1 TYR B 159 12909 12471 12927 -2891 -1243 387 C \nATOM 3771 CE2 TYR B 159 -9.288 -4.557 32.541 1.00100.39 C \nANISOU 3771 CE2 TYR B 159 13267 12267 12611 -3247 -1412 472 C \nATOM 3772 CZ TYR B 159 -7.989 -4.851 32.145 1.00108.22 C \nANISOU 3772 CZ TYR B 159 13926 13478 13714 -3133 -1295 436 C \nATOM 3773 OH TYR B 159 -6.927 -4.306 32.828 1.00102.80 O \nANISOU 3773 OH TYR B 159 13000 13090 12969 -3249 -1238 443 O \nATOM 3774 N PRO B 160 -12.947 -7.290 32.687 1.00125.57 N \nANISOU 3774 N PRO B 160 17185 14646 15880 -2551 -1643 359 N \nATOM 3775 CA PRO B 160 -12.971 -7.035 34.137 1.00123.16 C \nANISOU 3775 CA PRO B 160 16920 14362 15511 -2699 -1667 392 C \nATOM 3776 C PRO B 160 -12.977 -8.260 35.031 1.00114.62 C \nANISOU 3776 C PRO B 160 15708 13296 14545 -2479 -1622 344 C \nATOM 3777 O PRO B 160 -12.574 -8.153 36.192 1.00124.45 O \nANISOU 3777 O PRO B 160 16865 14631 15788 -2595 -1596 367 O \nATOM 3778 CB PRO B 160 -14.254 -6.213 34.345 1.00135.26 C \nANISOU 3778 CB PRO B 160 18920 15650 16824 -2838 -1841 430 C \nATOM 3779 CG PRO B 160 -15.079 -6.443 33.128 1.00135.33 C \nANISOU 3779 CG PRO B 160 19140 15474 16804 -2637 -1914 391 C \nATOM 3780 CD PRO B 160 -14.108 -6.680 32.010 1.00126.46 C \nANISOU 3780 CD PRO B 160 17689 14527 15832 -2575 -1786 371 C \nATOM 3781 N GLN B 161 -13.398 -9.408 34.511 1.00108.02 N \nANISOU 3781 N GLN B 161 14843 12405 13795 -2179 -1611 278 N \nATOM 3782 CA GLN B 161 -13.377 -10.647 35.312 1.00100.95 C \nANISOU 3782 CA GLN B 161 13797 11563 12995 -1983 -1564 231 C \nATOM 3783 C GLN B 161 -11.996 -10.925 35.854 1.00 88.80 C \nANISOU 3783 C GLN B 161 11922 10232 11586 -2064 -1432 243 C \nATOM 3784 O GLN B 161 -11.841 -11.227 37.017 1.00 81.01 O \nANISOU 3784 O GLN B 161 10877 9284 10617 -2080 -1416 246 O \nATOM 3785 CB GLN B 161 -13.825 -11.859 34.490 1.00103.56 C \nANISOU 3785 CB GLN B 161 14066 11898 13385 -1678 -1550 158 C \nATOM 3786 CG GLN B 161 -14.863 -12.720 35.172 1.00113.51 C \nANISOU 3786 CG GLN B 161 15445 13095 14589 -1452 -1619 105 C \nATOM 3787 CD GLN B 161 -15.104 -13.996 34.410 1.00124.40 C \nANISOU 3787 CD GLN B 161 16669 14584 16014 -1173 -1583 29 C \nATOM 3788 OE1 GLN B 161 -14.505 -14.223 33.363 1.00126.26 O \nANISOU 3788 OE1 GLN B 161 16730 14915 16326 -1166 -1509 22 O \nATOM 3789 NE2 GLN B 161 -15.986 -14.843 34.932 1.00138.44 N \nANISOU 3789 NE2 GLN B 161 18504 16372 17725 -944 -1637 -30 N \nATOM 3790 N TYR B 162 -10.996 -10.812 34.983 1.00 90.04 N \nANISOU 3790 N TYR B 162 11878 10513 11821 -2098 -1348 246 N \nATOM 3791 CA TYR B 162 -9.626 -11.212 35.317 1.00 92.00 C \nANISOU 3791 CA TYR B 162 11833 10945 12180 -2111 -1234 241 C \nATOM 3792 C TYR B 162 -8.787 -10.019 35.713 1.00 91.93 C \nANISOU 3792 C TYR B 162 11750 11071 12107 -2338 -1214 287 C \nATOM 3793 O TYR B 162 -7.573 -10.148 35.887 1.00 91.05 O \nANISOU 3793 O TYR B 162 11416 11125 12055 -2335 -1133 277 O \nATOM 3794 CB TYR B 162 -8.968 -11.947 34.127 1.00 87.66 C \nANISOU 3794 CB TYR B 162 11117 10456 11734 -1979 -1160 206 C \nATOM 3795 CG TYR B 162 -9.874 -12.965 33.482 1.00 82.13 C \nANISOU 3795 CG TYR B 162 10478 9674 11053 -1778 -1186 161 C \nATOM 3796 CD1 TYR B 162 -10.665 -12.605 32.394 1.00 79.70 C \nANISOU 3796 CD1 TYR B 162 10325 9272 10687 -1730 -1245 153 C \nATOM 3797 CD2 TYR B 162 -9.984 -14.272 33.975 1.00 76.02 C \nANISOU 3797 CD2 TYR B 162 9609 8944 10330 -1636 -1157 123 C \nATOM 3798 CE1 TYR B 162 -11.515 -13.510 31.803 1.00 81.70 C \nANISOU 3798 CE1 TYR B 162 10620 9493 10929 -1520 -1274 102 C \nATOM 3799 CE2 TYR B 162 -10.848 -15.182 33.388 1.00 71.71 C \nANISOU 3799 CE2 TYR B 162 9090 8390 9765 -1450 -1184 75 C \nATOM 3800 CZ TYR B 162 -11.599 -14.791 32.306 1.00 77.27 C \nANISOU 3800 CZ TYR B 162 9933 9017 10407 -1380 -1241 61 C \nATOM 3801 OH TYR B 162 -12.452 -15.658 31.686 1.00 87.56 O \nANISOU 3801 OH TYR B 162 11249 10352 11667 -1170 -1271 4 O \nATOM 3802 N SER B 163 -9.448 -8.875 35.882 1.00 97.10 N \nANISOU 3802 N SER B 163 12607 11670 12616 -2535 -1299 333 N \nATOM 3803 CA SER B 163 -8.765 -7.613 36.146 1.00101.40 C \nANISOU 3803 CA SER B 163 13079 12396 13052 -2791 -1290 379 C \nATOM 3804 C SER B 163 -7.748 -7.657 37.270 1.00 98.66 C \nANISOU 3804 C SER B 163 12504 12259 12722 -2826 -1223 377 C \nATOM 3805 O SER B 163 -6.553 -7.490 37.015 1.00 96.90 O \nANISOU 3805 O SER B 163 12049 12246 12523 -2810 -1148 360 O \nATOM 3806 CB SER B 163 -9.776 -6.522 36.405 1.00114.14 C \nANISOU 3806 CB SER B 163 14989 13903 14476 -3034 -1408 437 C \nATOM 3807 OG SER B 163 -10.524 -6.313 35.232 1.00124.34 O \nANISOU 3807 OG SER B 163 16488 15026 15729 -3008 -1472 438 O \nATOM 3808 N GLU B 164 -8.211 -7.882 38.500 1.00101.48 N \nANISOU 3808 N GLU B 164 12940 12561 13056 -2854 -1257 387 N \nATOM 3809 CA GLU B 164 -7.313 -7.817 39.661 1.00104.22 C \nANISOU 3809 CA GLU B 164 13091 13113 13397 -2903 -1204 387 C \nATOM 3810 C GLU B 164 -6.455 -9.054 39.775 1.00 94.06 C \nANISOU 3810 C GLU B 164 11606 11860 12272 -2658 -1119 332 C \nATOM 3811 O GLU B 164 -5.315 -8.988 40.232 1.00 81.75 O \nANISOU 3811 O GLU B 164 9845 10503 10713 -2640 -1061 315 O \nATOM 3812 CB GLU B 164 -8.061 -7.543 40.969 1.00111.34 C \nANISOU 3812 CB GLU B 164 14148 13954 14201 -3045 -1272 422 C \nATOM 3813 CG GLU B 164 -9.009 -8.618 41.458 1.00110.60 C \nANISOU 3813 CG GLU B 164 14213 13622 14187 -2871 -1311 399 C \nATOM 3814 CD GLU B 164 -9.769 -8.161 42.694 1.00110.77 C \nANISOU 3814 CD GLU B 164 14427 13577 14085 -3036 -1393 439 C \nATOM 3815 OE1 GLU B 164 -9.624 -6.989 43.098 1.00104.47 O \nANISOU 3815 OE1 GLU B 164 13655 12909 13128 -3317 -1424 492 O \nATOM 3816 OE2 GLU B 164 -10.521 -8.968 43.264 1.00119.28 O \nANISOU 3816 OE2 GLU B 164 15629 14487 15203 -2895 -1430 417 O \nATOM 3817 N GLU B 165 -7.008 -10.181 39.344 1.00 96.92 N \nANISOU 3817 N GLU B 165 12040 12039 12747 -2471 -1120 301 N \nATOM 3818 CA GLU B 165 -6.218 -11.402 39.154 1.00 89.62 C \nANISOU 3818 CA GLU B 165 10958 11137 11956 -2274 -1047 255 C \nATOM 3819 C GLU B 165 -4.973 -11.084 38.338 1.00 89.16 C \nANISOU 3819 C GLU B 165 10742 11227 11907 -2253 -991 240 C \nATOM 3820 O GLU B 165 -3.861 -11.436 38.746 1.00 88.52 O \nANISOU 3820 O GLU B 165 10520 11260 11854 -2179 -943 214 O \nATOM 3821 CB GLU B 165 -7.038 -12.473 38.446 1.00 87.19 C \nANISOU 3821 CB GLU B 165 10736 10670 11724 -2116 -1061 227 C \nATOM 3822 CG GLU B 165 -6.295 -13.798 38.308 1.00 86.71 C \nANISOU 3822 CG GLU B 165 10535 10641 11770 -1968 -995 189 C \nATOM 3823 CD GLU B 165 -7.215 -14.938 37.901 1.00 82.35 C \nANISOU 3823 CD GLU B 165 10036 9997 11255 -1833 -1011 160 C \nATOM 3824 OE1 GLU B 165 -8.463 -14.740 38.025 1.00 85.48 O \nANISOU 3824 OE1 GLU B 165 10588 10297 11594 -1814 -1080 162 O \nATOM 3825 OE2 GLU B 165 -6.690 -15.999 37.436 1.00 70.91 O \nANISOU 3825 OE2 GLU B 165 8487 8588 9868 -1750 -963 135 O \nATOM 3826 N ALA B 166 -5.169 -10.385 37.209 1.00 85.87 N \nANISOU 3826 N ALA B 166 10370 10805 11450 -2311 -1007 252 N \nATOM 3827 CA ALA B 166 -4.061 -9.997 36.338 1.00 82.20 C \nANISOU 3827 CA ALA B 166 9769 10486 10978 -2284 -962 235 C \nATOM 3828 C ALA B 166 -3.137 -9.039 37.046 1.00 93.58 C \nANISOU 3828 C ALA B 166 11068 12183 12307 -2378 -947 239 C \nATOM 3829 O ALA B 166 -1.911 -9.147 36.904 1.00 80.36 O \nANISOU 3829 O ALA B 166 9247 10654 10632 -2262 -903 201 O \nATOM 3830 CB ALA B 166 -4.571 -9.371 35.061 1.00 94.15 C \nANISOU 3830 CB ALA B 166 11368 11947 12459 -2346 -988 252 C \nATOM 3831 N ARG B 167 -3.735 -8.107 37.806 1.00105.09 N \nANISOU 3831 N ARG B 167 12580 13704 13643 -2584 -991 283 N \nATOM 3832 CA ARG B 167 -2.995 -7.061 38.508 1.00111.52 C \nANISOU 3832 CA ARG B 167 13243 14823 14306 -2717 -983 291 C \nATOM 3833 C ARG B 167 -2.198 -7.672 39.647 1.00105.14 C \nANISOU 3833 C ARG B 167 12310 14110 13529 -2586 -948 255 C \nATOM 3834 O ARG B 167 -1.007 -7.393 39.836 1.00 98.24 O \nANISOU 3834 O ARG B 167 11252 13487 12587 -2503 -914 216 O \nATOM 3835 CB ARG B 167 -3.982 -5.967 39.017 1.00125.47 C \nANISOU 3835 CB ARG B 167 15145 16614 15915 -3022 -1052 357 C \nATOM 3836 CG ARG B 167 -3.793 -5.457 40.451 1.00128.64 C \nANISOU 3836 CG ARG B 167 15469 17217 16193 -3168 -1062 376 C \nATOM 3837 CD ARG B 167 -4.925 -4.517 40.882 1.00133.01 C \nANISOU 3837 CD ARG B 167 16231 17722 16583 -3494 -1149 450 C \nATOM 3838 NE ARG B 167 -5.818 -5.075 41.913 1.00137.27 N \nANISOU 3838 NE ARG B 167 16957 18036 17164 -3502 -1196 469 N \nATOM 3839 CZ ARG B 167 -7.073 -4.679 42.150 1.00134.83 C \nANISOU 3839 CZ ARG B 167 16947 17523 16758 -3696 -1295 524 C \nATOM 3840 NH1 ARG B 167 -7.656 -3.749 41.402 1.00132.96 N \nANISOU 3840 NH1 ARG B 167 16890 17248 16381 -3917 -1364 572 N \nATOM 3841 NH2 ARG B 167 -7.772 -5.250 43.130 1.00135.91 N \nANISOU 3841 NH2 ARG B 167 17234 17475 16929 -3660 -1335 529 N \nATOM 3842 N LEU B 168 -2.875 -8.526 40.392 1.00101.37 N \nANISOU 3842 N LEU B 168 11943 13431 13142 -2549 -963 262 N \nATOM 3843 CA LEU B 168 -2.273 -9.127 41.575 1.00112.46 C \nANISOU 3843 CA LEU B 168 13260 14894 14573 -2449 -938 236 C \nATOM 3844 C LEU B 168 -1.137 -10.082 41.204 1.00112.53 C \nANISOU 3844 C LEU B 168 13186 14898 14672 -2205 -893 178 C \nATOM 3845 O LEU B 168 -0.126 -10.162 41.897 1.00105.93 O \nANISOU 3845 O LEU B 168 12240 14214 13792 -2105 -875 142 O \nATOM 3846 CB LEU B 168 -3.329 -9.856 42.408 1.00110.49 C \nANISOU 3846 CB LEU B 168 13157 14428 14395 -2467 -968 257 C \nATOM 3847 CG LEU B 168 -2.966 -10.134 43.861 1.00109.42 C \nANISOU 3847 CG LEU B 168 12954 14374 14247 -2450 -959 248 C \nATOM 3848 CD1 LEU B 168 -2.425 -8.895 44.579 1.00105.70 C \nANISOU 3848 CD1 LEU B 168 12352 14206 13603 -2603 -962 261 C \nATOM 3849 CD2 LEU B 168 -4.195 -10.693 44.571 1.00112.51 C \nANISOU 3849 CD2 LEU B 168 13511 14552 14687 -2487 -1000 273 C \nATOM 3850 N LYS B 169 -1.298 -10.785 40.089 1.00113.05 N \nANISOU 3850 N LYS B 169 13324 14789 14840 -2112 -884 168 N \nATOM 3851 CA LYS B 169 -0.281 -11.728 39.670 1.00111.73 C \nANISOU 3851 CA LYS B 169 13130 14584 14736 -1918 -855 122 C \nATOM 3852 C LYS B 169 0.778 -11.061 38.818 1.00 98.81 C \nANISOU 3852 C LYS B 169 11405 13116 13023 -1845 -844 90 C \nATOM 3853 O LYS B 169 1.784 -11.681 38.482 1.00 78.70 O \nANISOU 3853 O LYS B 169 8862 10552 10489 -1675 -835 47 O \nATOM 3854 CB LYS B 169 -0.921 -12.870 38.926 1.00129.65 C \nANISOU 3854 CB LYS B 169 15509 16623 17129 -1869 -853 125 C \nATOM 3855 CG LYS B 169 -0.100 -14.165 38.877 1.00135.70 C \nANISOU 3855 CG LYS B 169 16298 17307 17953 -1728 -836 92 C \nATOM 3856 CD LYS B 169 -0.134 -14.717 37.455 1.00136.78 C \nANISOU 3856 CD LYS B 169 16486 17341 18143 -1688 -828 87 C \nATOM 3857 CE LYS B 169 -1.256 -14.068 36.613 1.00149.44 C \nANISOU 3857 CE LYS B 169 18112 18911 19757 -1775 -837 114 C \nATOM 3858 NZ LYS B 169 -2.713 -14.339 36.897 1.00152.65 N \nANISOU 3858 NZ LYS B 169 18592 19212 20196 -1832 -861 137 N \nATOM 3859 N ARG B 170 0.537 -9.795 38.477 1.00108.66 N \nANISOU 3859 N ARG B 170 12591 14527 14169 -1980 -852 112 N \nATOM 3860 CA ARG B 170 1.548 -8.931 37.866 1.00110.81 C \nANISOU 3860 CA ARG B 170 12734 15046 14321 -1924 -843 78 C \nATOM 3861 C ARG B 170 2.450 -8.553 39.024 1.00113.36 C \nANISOU 3861 C ARG B 170 12921 15634 14518 -1857 -843 42 C \nATOM 3862 O ARG B 170 3.663 -8.744 39.002 1.00 97.24 O \nANISOU 3862 O ARG B 170 10821 13706 12419 -1641 -841 -21 O \nATOM 3863 CB ARG B 170 0.887 -7.683 37.311 1.00116.30 C \nANISOU 3863 CB ARG B 170 13404 15862 14922 -2141 -857 122 C \nATOM 3864 CG ARG B 170 1.619 -6.951 36.198 1.00122.90 C \nANISOU 3864 CG ARG B 170 14139 16887 15669 -2096 -846 95 C \nATOM 3865 CD ARG B 170 0.748 -5.784 35.718 1.00120.96 C \nANISOU 3865 CD ARG B 170 13909 16721 15329 -2368 -869 153 C \nATOM 3866 NE ARG B 170 -0.585 -6.257 35.302 1.00114.11 N \nANISOU 3866 NE ARG B 170 13257 15513 14586 -2463 -895 202 N \nATOM 3867 CZ ARG B 170 -1.711 -5.539 35.333 1.00106.97 C \nANISOU 3867 CZ ARG B 170 12478 14552 13613 -2711 -942 263 C \nATOM 3868 NH1 ARG B 170 -1.699 -4.272 35.738 1.00118.29 N \nANISOU 3868 NH1 ARG B 170 13840 16255 14851 -2949 -965 296 N \nATOM 3869 NH2 ARG B 170 -2.858 -6.082 34.940 1.00 89.09 N \nANISOU 3869 NH2 ARG B 170 10426 11973 11450 -2723 -976 289 N \nATOM 3870 N GLU B 171 1.801 -8.077 40.082 1.00121.18 N \nANISOU 3870 N GLU B 171 13886 16703 15455 -2036 -854 81 N \nATOM 3871 CA GLU B 171 2.468 -7.622 41.299 1.00124.58 C \nANISOU 3871 CA GLU B 171 14172 17415 15748 -2014 -855 54 C \nATOM 3872 C GLU B 171 3.312 -8.683 42.013 1.00119.60 C \nANISOU 3872 C GLU B 171 13565 16707 15171 -1767 -852 -1 C \nATOM 3873 O GLU B 171 4.093 -8.342 42.905 1.00117.57 O \nANISOU 3873 O GLU B 171 13183 16704 14783 -1679 -857 -42 O \nATOM 3874 CB GLU B 171 1.439 -6.999 42.250 1.00124.14 C \nANISOU 3874 CB GLU B 171 14130 17405 15633 -2293 -874 118 C \nATOM 3875 CG GLU B 171 0.896 -5.671 41.729 1.00123.69 C \nANISOU 3875 CG GLU B 171 14038 17529 15431 -2565 -893 167 C \nATOM 3876 CD GLU B 171 -0.431 -5.266 42.347 1.00127.80 C \nANISOU 3876 CD GLU B 171 14703 17934 15920 -2866 -936 246 C \nATOM 3877 OE1 GLU B 171 -1.173 -4.494 41.702 1.00120.67 O \nANISOU 3877 OE1 GLU B 171 13894 17012 14944 -3092 -970 298 O \nATOM 3878 OE2 GLU B 171 -0.731 -5.715 43.479 1.00134.50 O \nANISOU 3878 OE2 GLU B 171 15598 18701 16805 -2875 -945 256 O \nATOM 3879 N GLU B 172 3.183 -9.948 41.620 1.00114.44 N \nANISOU 3879 N GLU B 172 13071 15727 14683 -1662 -850 -2 N \nATOM 3880 CA GLU B 172 4.195 -10.945 42.004 1.00120.28 C \nANISOU 3880 CA GLU B 172 13871 16388 15441 -1426 -860 -57 C \nATOM 3881 C GLU B 172 5.584 -10.610 41.445 1.00130.81 C \nANISOU 3881 C GLU B 172 15154 17906 16642 -1193 -877 -132 C \nATOM 3882 O GLU B 172 6.587 -10.954 42.069 1.00140.19 O \nANISOU 3882 O GLU B 172 16363 19152 17752 -986 -904 -191 O \nATOM 3883 CB GLU B 172 3.829 -12.365 41.599 1.00120.43 C \nANISOU 3883 CB GLU B 172 14073 16058 15628 -1399 -860 -40 C \nATOM 3884 CG GLU B 172 4.749 -13.400 42.250 1.00115.79 C \nANISOU 3884 CG GLU B 172 13584 15378 15035 -1222 -883 -82 C \nATOM 3885 CD GLU B 172 4.261 -14.832 42.141 1.00115.78 C \nANISOU 3885 CD GLU B 172 13741 15081 15169 -1264 -883 -55 C \nATOM 3886 OE1 GLU B 172 3.104 -15.104 42.518 1.00117.91 O \nANISOU 3886 OE1 GLU B 172 14006 15265 15530 -1412 -865 -8 O \nATOM 3887 OE2 GLU B 172 5.046 -15.697 41.707 1.00109.89 O \nANISOU 3887 OE2 GLU B 172 13134 14204 14416 -1150 -908 -81 O \nATOM 3888 N ILE B 173 5.643 -9.968 40.274 1.00135.17 N \nANISOU 3888 N ILE B 173 15660 18540 17159 -1208 -870 -134 N \nATOM 3889 CA ILE B 173 6.926 -9.502 39.713 1.00139.98 C \nANISOU 3889 CA ILE B 173 16206 19366 17613 -973 -891 -212 C \nATOM 3890 C ILE B 173 7.345 -8.163 40.337 1.00135.43 C \nANISOU 3890 C ILE B 173 15382 19258 16817 -976 -891 -245 C \nATOM 3891 O ILE B 173 8.125 -8.119 41.296 1.00130.50 O \nANISOU 3891 O ILE B 173 14693 18823 16066 -807 -913 -302 O \nATOM 3892 CB ILE B 173 6.926 -9.407 38.160 1.00136.68 C \nANISOU 3892 CB ILE B 173 15836 18861 17235 -965 -886 -208 C \nATOM 3893 CG1 ILE B 173 8.354 -9.203 37.623 1.00137.36 C \nANISOU 3893 CG1 ILE B 173 15916 19111 17165 -662 -923 -300 C \nATOM 3894 CG2 ILE B 173 6.051 -8.282 37.640 1.00140.38 C \nANISOU 3894 CG2 ILE B 173 16173 19486 17680 -1212 -858 -155 C \nATOM 3895 CD1 ILE B 173 9.311 -10.323 37.977 1.00135.00 C \nANISOU 3895 CD1 ILE B 173 15823 18615 16856 -405 -975 -355 C \nTER 3896 ILE B 173 \nHETATM 3897 C1 NAG A 401 -28.687 -9.969 -66.680 1.00 83.68 C \nHETATM 3898 C2 NAG A 401 -30.138 -9.504 -66.364 1.00 90.43 C \nHETATM 3899 C3 NAG A 401 -30.386 -7.974 -66.439 1.00 98.70 C \nHETATM 3900 C4 NAG A 401 -29.175 -7.104 -66.142 1.00 98.24 C \nHETATM 3901 C5 NAG A 401 -27.985 -7.750 -66.848 1.00 96.14 C \nHETATM 3902 C6 NAG A 401 -26.679 -6.984 -66.749 1.00 96.77 C \nHETATM 3903 C7 NAG A 401 -32.342 -9.889 -67.433 1.00 96.37 C \nHETATM 3904 C8 NAG A 401 -33.091 -10.665 -68.484 1.00 91.89 C \nHETATM 3905 N2 NAG A 401 -31.027 -10.155 -67.319 1.00 98.43 N \nHETATM 3906 O3 NAG A 401 -31.417 -7.558 -65.565 1.00109.88 O \nHETATM 3907 O4 NAG A 401 -29.456 -5.807 -66.614 1.00 88.78 O \nHETATM 3908 O5 NAG A 401 -27.786 -8.991 -66.215 1.00 93.39 O \nHETATM 3909 O6 NAG A 401 -26.188 -7.060 -68.069 1.00 86.27 O \nHETATM 3910 O7 NAG A 401 -32.941 -9.070 -66.729 1.00 82.71 O \nHETATM 3911 C1 NAG B 201 -18.050 -16.983 20.478 1.00139.78 C \nHETATM 3912 C2 NAG B 201 -18.659 -17.928 19.448 1.00152.91 C \nHETATM 3913 C3 NAG B 201 -19.983 -17.329 18.949 1.00145.45 C \nHETATM 3914 C4 NAG B 201 -20.902 -16.925 20.111 1.00144.30 C \nHETATM 3915 C5 NAG B 201 -20.129 -16.115 21.154 1.00151.00 C \nHETATM 3916 C6 NAG B 201 -20.923 -15.790 22.425 1.00150.19 C \nHETATM 3917 C7 NAG B 201 -17.545 -19.317 17.716 1.00154.15 C \nHETATM 3918 C8 NAG B 201 -16.533 -19.330 16.601 1.00138.57 C \nHETATM 3919 N2 NAG B 201 -17.730 -18.141 18.344 1.00167.86 N \nHETATM 3920 O3 NAG B 201 -20.636 -18.247 18.095 1.00132.58 O \nHETATM 3921 O4 NAG B 201 -22.029 -16.209 19.647 1.00138.55 O \nHETATM 3922 O5 NAG B 201 -19.043 -16.957 21.495 1.00150.86 O \nHETATM 3923 O6 NAG B 201 -20.074 -15.278 23.442 1.00134.09 O \nHETATM 3924 O7 NAG B 201 -18.141 -20.360 17.996 1.00142.23 O \nHETATM 3925 O HOH A 501 -2.071 -8.558 -54.237 1.00 31.99 O \nHETATM 3926 O HOH A 502 -6.316 -9.976 -60.932 1.00 31.51 O \nHETATM 3927 O HOH A 503 0.031 -8.805 -68.956 1.00 32.53 O \nHETATM 3928 O HOH A 504 -7.524 -10.804 -86.140 1.00 46.03 O \nHETATM 3929 O HOH A 505 -11.988 -13.919 -41.933 1.00 48.80 O \nHETATM 3930 O HOH A 506 -1.024 -23.518 -6.059 1.00 55.30 O \nHETATM 3931 O HOH A 507 -10.844 -27.096 -58.123 1.00 53.39 O \nHETATM 3932 O HOH A 508 -18.961 -8.116 -53.601 1.00 57.16 O \nHETATM 3933 O HOH A 509 -3.978 -3.758 -49.620 1.00 19.76 O \nHETATM 3934 O HOH A 510 -9.098 -8.570 -51.498 1.00 30.40 O \nHETATM 3935 O HOH A 511 -15.518 -21.376 -80.663 1.00 46.19 O \nHETATM 3936 O HOH A 512 -1.028 -5.511 -71.495 1.00 53.73 O \nHETATM 3937 O HOH A 513 -12.845 -8.368 -43.271 1.00 49.29 O \nHETATM 3938 O HOH A 514 -3.306 -9.634 -85.354 1.00 45.37 O \nHETATM 3939 O HOH A 515 1.739 -6.912 -83.670 1.00 31.59 O \nHETATM 3940 O HOH A 516 -19.424 -7.281 -60.468 1.00 24.07 O \nHETATM 3941 O HOH A 517 0.227 -7.857 -70.839 1.00 33.39 O \nHETATM 3942 O HOH A 518 3.652 -9.741 -66.919 1.00 48.02 O \nHETATM 3943 O HOH A 519 1.552 -8.470 -79.177 1.00 30.05 O \nHETATM 3944 O HOH A 520 5.039 -22.650 -54.297 1.00 59.15 O \nHETATM 3945 O HOH A 521 -7.309 -8.160 -59.558 1.00 31.17 O \nHETATM 3946 O HOH A 522 -0.499 -8.076 -58.475 1.00 62.33 O \nHETATM 3947 O HOH A 523 5.403 -7.356 -77.759 1.00 39.73 O \nHETATM 3948 O HOH A 524 -3.274 -5.353 -79.745 1.00 39.76 O \nHETATM 3949 O HOH A 525 0.575 -10.602 -56.488 1.00 54.88 O \nHETATM 3950 O HOH A 526 -12.449 -3.836 -72.184 1.00 56.61 O \nHETATM 3951 O HOH A 527 -9.068 -30.258 -46.407 1.00 59.63 O \nHETATM 3952 O HOH A 528 -0.183 -10.476 -80.075 1.00 69.83 O \nHETATM 3953 O HOH A 529 1.105 -19.725 -52.670 1.00 62.21 O \nHETATM 3954 O HOH A 530 1.076 -17.614 35.056 1.00 54.80 O \nHETATM 3955 O HOH A 531 6.590 -25.900 -57.881 1.00 80.59 O \nHETATM 3956 O HOH A 532 -13.195 -28.701 -44.042 1.00 54.44 O \nHETATM 3957 O HOH A 533 -18.474 -28.732 -70.831 1.00 64.06 O \nHETATM 3958 O HOH A 534 -10.437 -1.889 -65.090 1.00 49.74 O \nHETATM 3959 O HOH A 535 -25.265 -15.342 -68.898 1.00 76.55 O \nHETATM 3960 O HOH A 536 -14.598 -7.415 -73.586 1.00 57.63 O \nHETATM 3961 O HOH A 537 -9.433 -8.502 -58.992 1.00 52.13 O \nHETATM 3962 O HOH A 538 4.687 -10.622 -64.661 1.00 59.98 O \nHETATM 3963 O HOH A 539 -6.680 -22.084 -16.014 1.00 57.50 O \nHETATM 3964 O HOH B 301 9.836 -7.213 -42.737 1.00 32.60 O \nHETATM 3965 O HOH B 302 4.631 -11.678 -46.582 1.00 29.21 O \nHETATM 3966 O HOH B 303 4.069 -10.136 21.045 1.00 46.54 O \nHETATM 3967 O HOH B 304 2.054 -18.298 11.821 1.00 48.88 O \nHETATM 3968 O HOH B 305 9.947 -6.355 -44.863 1.00 42.66 O \nHETATM 3969 O HOH B 306 4.081 -11.498 -44.178 1.00 37.94 O \nHETATM 3970 O HOH B 307 4.700 -8.517 2.088 1.00 36.93 O \nHETATM 3971 O HOH B 308 0.621 -2.174 -52.116 1.00 23.26 O \nHETATM 3972 O HOH B 309 4.076 -9.477 -42.204 1.00 55.67 O \nHETATM 3973 O HOH B 310 -14.427 -15.267 12.617 1.00 58.09 O \nHETATM 3974 O HOH B 311 0.000 0.000 -21.930 0.33 55.81 O \nHETATM 3975 O HOH B 312 -7.358 -26.394 25.208 1.00 76.02 O \nHETATM 3976 O HOH B 313 -10.256 -9.911 38.528 1.00 74.49 O \nHETATM 3977 O HOH B 314 -15.219 -7.586 7.576 1.00 67.10 O \nHETATM 3978 O HOH B 315 -5.856 -22.480 19.677 1.00 66.83 O \nHETATM 3979 O HOH B 316 11.983 -6.176 -46.099 1.00 84.95 O \nHETATM 3980 O HOH B 317 8.046 -9.034 -42.559 1.00 51.73 O \nHETATM 3981 O HOH B 318 0.000 0.000 -18.054 0.33 75.84 O \nENDMDL \nMASTER 0 0 0 28 111 0 0 15 3979 2 0 120 \nEND \n", "sitemap": {"-1": {"chains": "A", "protein_site": -11, "sequential_site": 6}, "-2": {"chains": "A", "protein_site": -12, "sequential_site": 5}, "-3": {"chains": "A", "protein_site": -13, "sequential_site": 4}, "-4": {"chains": "A", "protein_site": -14, "sequential_site": 3}, "-5": {"chains": "A", "protein_site": -15, "sequential_site": 2}, "-6": {"chains": "A", "protein_site": -16, "sequential_site": 1}, "1": {"chains": "A", "protein_site": -10, "sequential_site": 7}, "10": {"chains": "A", "protein_site": -1, "sequential_site": 16}, "100": {"chains": "A", "protein_site": 93, "sequential_site": 109}, "101": {"chains": "A", "protein_site": 94, "sequential_site": 110}, "102": {"chains": "A", "protein_site": 95, "sequential_site": 111}, "103": {"chains": "A", "protein_site": 96, "sequential_site": 112}, "104": {"chains": "A", "protein_site": 97, "sequential_site": 113}, "105": {"chains": "A", "protein_site": 98, "sequential_site": 114}, "106": {"chains": "A", "protein_site": 99, "sequential_site": 115}, "107": {"chains": "A", "protein_site": 100, "sequential_site": 116}, "108": {"chains": "A", "protein_site": 101, "sequential_site": 117}, "109": {"chains": "A", "protein_site": 102, "sequential_site": 118}, "11": {"chains": "A", "protein_site": 1, "sequential_site": 17}, "110": {"chains": "A", "protein_site": 103, "sequential_site": 119}, "111": {"chains": "A", "protein_site": 104, "sequential_site": 120}, "112": {"chains": "A", "protein_site": 105, "sequential_site": 121}, "113": {"chains": "A", "protein_site": 106, "sequential_site": 122}, "114": {"chains": "A", "protein_site": 107, "sequential_site": 123}, "115": {"chains": "A", "protein_site": 108, "sequential_site": 124}, "116": {"chains": "A", "protein_site": 109, "sequential_site": 125}, "117": {"chains": "A", "protein_site": 110, "sequential_site": 126}, "118": {"chains": "A", "protein_site": 111, "sequential_site": 127}, "119": {"chains": "A", "protein_site": 112, "sequential_site": 128}, "12": {"chains": "A", "protein_site": 2, "sequential_site": 18}, "120": {"chains": "A", "protein_site": 113, "sequential_site": 129}, "121": {"chains": "A", "protein_site": 114, "sequential_site": 130}, "122": {"chains": "A", "protein_site": 115, "sequential_site": 131}, "123": {"chains": "A", "protein_site": 116, "sequential_site": 132}, "124": {"chains": "A", "protein_site": 117, "sequential_site": 133}, "125": {"chains": "A", "protein_site": 118, "sequential_site": 134}, "125a": {"chains": "A", "protein_site": 119, "sequential_site": 135}, "125b": {"chains": "A", "protein_site": 120, "sequential_site": 136}, "126": {"chains": "A", "protein_site": 121, "sequential_site": 137}, "127": {"chains": "A", "protein_site": 122, "sequential_site": 138}, "128": {"chains": "A", "protein_site": 123, "sequential_site": 139}, "129": {"chains": "A", "protein_site": 124, "sequential_site": 140}, "13": {"chains": "A", "protein_site": 3, "sequential_site": 19}, "130": {"chains": "A", "protein_site": 125, "sequential_site": 141}, "131": {"chains": "A", "protein_site": 126, "sequential_site": 142}, "132": {"chains": "A", "protein_site": 127, "sequential_site": 143}, "133": {"chains": "A", "protein_site": 128, "sequential_site": 144}, "133a": {"chains": "A", "protein_site": 129, "sequential_site": 145}, "134": {"chains": "A", "protein_site": 130, "sequential_site": 146}, "135": {"chains": "A", "protein_site": 131, "sequential_site": 147}, "136": {"chains": "A", "protein_site": 132, "sequential_site": 148}, "137": {"chains": "A", "protein_site": 133, "sequential_site": 149}, "138": {"chains": "A", "protein_site": 134, "sequential_site": 150}, "139": {"chains": "A", "protein_site": 135, "sequential_site": 151}, "14": {"chains": "A", "protein_site": 4, "sequential_site": 20}, "140": {"chains": "A", "protein_site": 136, "sequential_site": 152}, "141": {"chains": "A", "protein_site": 137, "sequential_site": 153}, "142": {"chains": "A", "protein_site": 138, "sequential_site": 154}, "143": {"chains": "A", "protein_site": 139, "sequential_site": 155}, "144": {"chains": "A", "protein_site": 140, "sequential_site": 156}, "145": {"chains": "A", "protein_site": 141, "sequential_site": 157}, "146": {"chains": "A", "protein_site": 142, "sequential_site": 158}, "147": {"chains": "A", "protein_site": 143, "sequential_site": 159}, "148": {"chains": "A", "protein_site": 144, "sequential_site": 160}, "149": {"chains": "A", "protein_site": 145, "sequential_site": 161}, "15": {"chains": "A", "protein_site": 5, "sequential_site": 21}, "150": {"chains": "A", "protein_site": 146, "sequential_site": 162}, "151": {"chains": "A", "protein_site": 147, "sequential_site": 163}, "152": {"chains": "A", "protein_site": 148, "sequential_site": 164}, "153": {"chains": "A", "protein_site": 149, "sequential_site": 165}, "154": {"chains": "A", "protein_site": 150, "sequential_site": 166}, "155": {"chains": "A", "protein_site": 151, "sequential_site": 167}, "156": {"chains": "A", "protein_site": 152, "sequential_site": 168}, "157": {"chains": "A", "protein_site": 153, "sequential_site": 169}, "158": {"chains": "A", "protein_site": 154, "sequential_site": 170}, "159": {"chains": "A", "protein_site": 155, "sequential_site": 171}, "16": {"chains": "A", "protein_site": 6, "sequential_site": 22}, "160": {"chains": "A", "protein_site": 156, "sequential_site": 172}, "161": {"chains": "A", "protein_site": 157, "sequential_site": 173}, "162": {"chains": "A", "protein_site": 158, "sequential_site": 174}, "163": {"chains": "A", "protein_site": 159, "sequential_site": 175}, "164": {"chains": "A", "protein_site": 160, "sequential_site": 176}, "165": {"chains": "A", "protein_site": 161, "sequential_site": 177}, "166": {"chains": "A", "protein_site": 162, "sequential_site": 178}, "167": {"chains": "A", "protein_site": 163, "sequential_site": 179}, "168": {"chains": "A", "protein_site": 164, "sequential_site": 180}, "169": {"chains": "A", "protein_site": 165, "sequential_site": 181}, "17": {"chains": "A", "protein_site": 7, "sequential_site": 23}, "170": {"chains": "A", "protein_site": 166, "sequential_site": 182}, "171": {"chains": "A", "protein_site": 167, "sequential_site": 183}, "172": {"chains": "A", "protein_site": 168, "sequential_site": 184}, "173": {"chains": "A", "protein_site": 169, "sequential_site": 185}, "174": {"chains": "A", "protein_site": 170, "sequential_site": 186}, "175": {"chains": "A", "protein_site": 171, "sequential_site": 187}, "176": {"chains": "A", "protein_site": 172, "sequential_site": 188}, "177": {"chains": "A", "protein_site": 173, "sequential_site": 189}, "178": {"chains": "A", "protein_site": 174, "sequential_site": 190}, "179": {"chains": "A", "protein_site": 175, "sequential_site": 191}, "18": {"chains": "A", "protein_site": 8, "sequential_site": 24}, "180": {"chains": "A", "protein_site": 176, "sequential_site": 192}, "181": {"chains": "A", "protein_site": 177, "sequential_site": 193}, "182": {"chains": "A", "protein_site": 178, "sequential_site": 194}, "183": {"chains": "A", "protein_site": 179, "sequential_site": 195}, "184": {"chains": "A", "protein_site": 180, "sequential_site": 196}, "185": {"chains": "A", "protein_site": 181, "sequential_site": 197}, "186": {"chains": "A", "protein_site": 182, "sequential_site": 198}, "187": {"chains": "A", "protein_site": 183, "sequential_site": 199}, "188": {"chains": "A", "protein_site": 184, "sequential_site": 200}, "189": {"chains": "A", "protein_site": 185, "sequential_site": 201}, "19": {"chains": "A", "protein_site": 9, "sequential_site": 25}, "190": {"chains": "A", "protein_site": 186, "sequential_site": 202}, "191": {"chains": "A", "protein_site": 187, "sequential_site": 203}, "192": {"chains": "A", "protein_site": 188, "sequential_site": 204}, "193": {"chains": "A", "protein_site": 189, "sequential_site": 205}, "194": {"chains": "A", "protein_site": 190, "sequential_site": 206}, "195": {"chains": "A", "protein_site": 191, "sequential_site": 207}, "196": {"chains": "A", "protein_site": 192, "sequential_site": 208}, "197": {"chains": "A", "protein_site": 193, "sequential_site": 209}, "198": {"chains": "A", "protein_site": 194, "sequential_site": 210}, "199": {"chains": "A", "protein_site": 195, "sequential_site": 211}, "2": {"chains": "A", "protein_site": -9, "sequential_site": 8}, "20": {"chains": "A", "protein_site": 10, "sequential_site": 26}, "200": {"chains": "A", "protein_site": 196, "sequential_site": 212}, "201": {"chains": "A", "protein_site": 197, "sequential_site": 213}, "202": {"chains": "A", "protein_site": 198, "sequential_site": 214}, "203": {"chains": "A", "protein_site": 199, "sequential_site": 215}, "204": {"chains": "A", "protein_site": 200, "sequential_site": 216}, "205": {"chains": "A", "protein_site": 201, "sequential_site": 217}, "206": {"chains": "A", "protein_site": 202, "sequential_site": 218}, "207": {"chains": "A", "protein_site": 203, "sequential_site": 219}, "208": {"chains": "A", "protein_site": 204, "sequential_site": 220}, "209": {"chains": "A", "protein_site": 205, "sequential_site": 221}, "21": {"chains": "A", "protein_site": 11, "sequential_site": 27}, "210": {"chains": "A", "protein_site": 206, "sequential_site": 222}, "211": {"chains": "A", "protein_site": 207, "sequential_site": 223}, "212": {"chains": "A", "protein_site": 208, "sequential_site": 224}, "213": {"chains": "A", "protein_site": 209, "sequential_site": 225}, "214": {"chains": "A", "protein_site": 210, "sequential_site": 226}, "215": {"chains": "A", "protein_site": 211, "sequential_site": 227}, "216": {"chains": "A", "protein_site": 212, "sequential_site": 228}, "217": {"chains": "A", "protein_site": 213, "sequential_site": 229}, "218": {"chains": "A", "protein_site": 214, "sequential_site": 230}, "219": {"chains": "A", "protein_site": 215, "sequential_site": 231}, "22": {"chains": "A", "protein_site": 12, "sequential_site": 28}, "220": {"chains": "A", "protein_site": 216, "sequential_site": 232}, "221": {"chains": "A", "protein_site": 217, "sequential_site": 233}, "222": {"chains": "A", "protein_site": 218, "sequential_site": 234}, "223": {"chains": "A", "protein_site": 219, "sequential_site": 235}, "224": {"chains": "A", "protein_site": 220, "sequential_site": 236}, "225": {"chains": "A", "protein_site": 221, "sequential_site": 237}, "226": {"chains": "A", "protein_site": 222, "sequential_site": 238}, "227": {"chains": "A", "protein_site": 223, "sequential_site": 239}, "228": {"chains": "A", "protein_site": 224, "sequential_site": 240}, "229": {"chains": "A", "protein_site": 225, "sequential_site": 241}, "23": {"chains": "A", "protein_site": 13, "sequential_site": 29}, "230": {"chains": "A", "protein_site": 226, "sequential_site": 242}, "231": {"chains": "A", "protein_site": 227, "sequential_site": 243}, "232": {"chains": "A", "protein_site": 228, "sequential_site": 244}, "233": {"chains": "A", "protein_site": 229, "sequential_site": 245}, "234": {"chains": "A", "protein_site": 230, "sequential_site": 246}, "235": {"chains": "A", "protein_site": 231, "sequential_site": 247}, "236": {"chains": "A", "protein_site": 232, "sequential_site": 248}, "237": {"chains": "A", "protein_site": 233, "sequential_site": 249}, "238": {"chains": "A", "protein_site": 234, "sequential_site": 250}, "239": {"chains": "A", "protein_site": 235, "sequential_site": 251}, "24": {"chains": "A", "protein_site": 14, "sequential_site": 30}, "240": {"chains": "A", "protein_site": 236, "sequential_site": 252}, "241": {"chains": "A", "protein_site": 237, "sequential_site": 253}, "242": {"chains": "A", "protein_site": 238, "sequential_site": 254}, "243": {"chains": "A", "protein_site": 239, "sequential_site": 255}, "244": {"chains": "A", "protein_site": 240, "sequential_site": 256}, "245": {"chains": "A", "protein_site": 241, "sequential_site": 257}, "246": {"chains": "A", "protein_site": 242, "sequential_site": 258}, "247": {"chains": "A", "protein_site": 243, "sequential_site": 259}, "248": {"chains": "A", "protein_site": 244, "sequential_site": 260}, "249": {"chains": "A", "protein_site": 245, "sequential_site": 261}, "25": {"chains": "A", "protein_site": 15, "sequential_site": 31}, "250": {"chains": "A", "protein_site": 246, "sequential_site": 262}, "251": {"chains": "A", "protein_site": 247, "sequential_site": 263}, "252": {"chains": "A", "protein_site": 248, "sequential_site": 264}, "253": {"chains": "A", "protein_site": 249, "sequential_site": 265}, "254": {"chains": "A", "protein_site": 250, "sequential_site": 266}, "255": {"chains": "A", "protein_site": 251, "sequential_site": 267}, "256": {"chains": "A", "protein_site": 252, "sequential_site": 268}, "257": {"chains": "A", "protein_site": 253, "sequential_site": 269}, "258": {"chains": "A", "protein_site": 254, "sequential_site": 270}, "259": {"chains": "A", "protein_site": 255, "sequential_site": 271}, "26": {"chains": "A", "protein_site": 16, "sequential_site": 32}, "260": {"chains": "A", "protein_site": 256, "sequential_site": 272}, "261": {"chains": "A", "protein_site": 257, "sequential_site": 273}, "262": {"chains": "A", "protein_site": 258, "sequential_site": 274}, "262a": {"chains": "A", "protein_site": 259, "sequential_site": 275}, "263": {"chains": "A", "protein_site": 260, "sequential_site": 276}, "264": {"chains": "A", "protein_site": 261, "sequential_site": 277}, "265": {"chains": "A", "protein_site": 262, "sequential_site": 278}, "266": {"chains": "A", "protein_site": 263, "sequential_site": 279}, "267": {"chains": "A", "protein_site": 264, "sequential_site": 280}, "268": {"chains": "A", "protein_site": 265, "sequential_site": 281}, "269": {"chains": "A", "protein_site": 266, "sequential_site": 282}, "27": {"chains": "A", "protein_site": 17, "sequential_site": 33}, "270": {"chains": "A", "protein_site": 267, "sequential_site": 283}, "271": {"chains": "A", "protein_site": 268, "sequential_site": 284}, "272": {"chains": "A", "protein_site": 269, "sequential_site": 285}, "273": {"chains": "A", "protein_site": 270, "sequential_site": 286}, "274": {"chains": "A", "protein_site": 271, "sequential_site": 287}, "275": {"chains": "A", "protein_site": 272, "sequential_site": 288}, "276": {"chains": "A", "protein_site": 273, "sequential_site": 289}, "277": {"chains": "A", "protein_site": 274, "sequential_site": 290}, "278": {"chains": "A", "protein_site": 275, "sequential_site": 291}, "279": {"chains": "A", "protein_site": 276, "sequential_site": 292}, "28": {"chains": "A", "protein_site": 18, "sequential_site": 34}, "280": {"chains": "A", "protein_site": 277, "sequential_site": 293}, "281": {"chains": "A", "protein_site": 278, "sequential_site": 294}, "282": {"chains": "A", "protein_site": 279, "sequential_site": 295}, "283": {"chains": "A", "protein_site": 280, "sequential_site": 296}, "284": {"chains": "A", "protein_site": 281, "sequential_site": 297}, "285": {"chains": "A", "protein_site": 282, "sequential_site": 298}, "286": {"chains": "A", "protein_site": 283, "sequential_site": 299}, "287": {"chains": "A", "protein_site": 284, "sequential_site": 300}, "288": {"chains": "A", "protein_site": 285, "sequential_site": 301}, "289": {"chains": "A", "protein_site": 286, "sequential_site": 302}, "29": {"chains": "A", "protein_site": 19, "sequential_site": 35}, "290": {"chains": "A", "protein_site": 287, "sequential_site": 303}, "291": {"chains": "A", "protein_site": 288, "sequential_site": 304}, "292": {"chains": "A", "protein_site": 289, "sequential_site": 305}, "293": {"chains": "A", "protein_site": 290, "sequential_site": 306}, "294": {"chains": "A", "protein_site": 291, "sequential_site": 307}, "295": {"chains": "A", "protein_site": 292, "sequential_site": 308}, "296": {"chains": "A", "protein_site": 293, "sequential_site": 309}, "297": {"chains": "A", "protein_site": 294, "sequential_site": 310}, "298": {"chains": "A", "protein_site": 295, "sequential_site": 311}, "299": {"chains": "A", "protein_site": 296, "sequential_site": 312}, "3": {"chains": "A", "protein_site": -8, "sequential_site": 9}, "30": {"chains": "A", "protein_site": 20, "sequential_site": 36}, "300": {"chains": "A", "protein_site": 297, "sequential_site": 313}, "301": {"chains": "A", "protein_site": 298, "sequential_site": 314}, "302": {"chains": "A", "protein_site": 299, "sequential_site": 315}, "303": {"chains": "A", "protein_site": 300, "sequential_site": 316}, "304": {"chains": "A", "protein_site": 301, "sequential_site": 317}, "305": {"chains": "A", "protein_site": 302, "sequential_site": 318}, "306": {"chains": "A", "protein_site": 303, "sequential_site": 319}, "307": {"chains": "A", "protein_site": 304, "sequential_site": 320}, "308": {"chains": "A", "protein_site": 305, "sequential_site": 321}, "309": {"chains": "A", "protein_site": 306, "sequential_site": 322}, "31": {"chains": "A", "protein_site": 21, "sequential_site": 37}, "310": {"chains": "A", "protein_site": 307, "sequential_site": 323}, "311": {"chains": "A", "protein_site": 308, "sequential_site": 324}, "312": {"chains": "A", "protein_site": 309, "sequential_site": 325}, "313": {"chains": "A", "protein_site": 310, "sequential_site": 326}, "314": {"chains": "A", "protein_site": 311, "sequential_site": 327}, "315": {"chains": "A", "protein_site": 312, "sequential_site": 328}, "316": {"chains": "A", "protein_site": 313, "sequential_site": 329}, "317": {"chains": "A", "protein_site": 314, "sequential_site": 330}, "318": {"chains": "A", "protein_site": 315, "sequential_site": 331}, "319": {"chains": "A", "protein_site": 316, "sequential_site": 332}, "32": {"chains": "A", "protein_site": 22, "sequential_site": 38}, "320": {"chains": "A", "protein_site": 317, "sequential_site": 333}, "321": {"chains": "A", "protein_site": 318, "sequential_site": 334}, "322": {"chains": "A", "protein_site": 319, "sequential_site": 335}, "323": {"chains": "A", "protein_site": 320, "sequential_site": 336}, "324": {"chains": "A", "protein_site": 321, "sequential_site": 337}, "325": {"chains": "A", "protein_site": 322, "sequential_site": 338}, "326": {"chains": "A", "protein_site": 323, "sequential_site": 339}, "327": {"chains": "A", "protein_site": 324, "sequential_site": 340}, "328": {"chains": "A", "protein_site": 325, "sequential_site": 341}, "328a": {"chains": "A", "protein_site": 326, "sequential_site": 342}, "328b": {"chains": "A", "protein_site": 327, "sequential_site": 343}, "328c": {"chains": "A", "protein_site": 328, "sequential_site": 344}, "329": {"chains": "A", "protein_site": 329, "sequential_site": 345}, "33": {"chains": "A", "protein_site": 23, "sequential_site": 39}, "330": {"chains": "B", "protein_site": 1, "sequential_site": 346}, "331": {"chains": "B", "protein_site": 2, "sequential_site": 347}, "332": {"chains": "B", "protein_site": 3, "sequential_site": 348}, "333": {"chains": "B", "protein_site": 4, "sequential_site": 349}, "334": {"chains": "B", "protein_site": 5, "sequential_site": 350}, "335": {"chains": "B", "protein_site": 6, "sequential_site": 351}, "336": {"chains": "B", "protein_site": 7, "sequential_site": 352}, "337": {"chains": "B", "protein_site": 8, "sequential_site": 353}, "338": {"chains": "B", "protein_site": 9, "sequential_site": 354}, "339": {"chains": "B", "protein_site": 10, "sequential_site": 355}, "34": {"chains": "A", "protein_site": 24, "sequential_site": 40}, "340": {"chains": "B", "protein_site": 11, "sequential_site": 356}, "341": {"chains": "B", "protein_site": 12, "sequential_site": 357}, "342": {"chains": "B", "protein_site": 13, "sequential_site": 358}, "343": {"chains": "B", "protein_site": 14, "sequential_site": 359}, "344": {"chains": "B", "protein_site": 15, "sequential_site": 360}, "345": {"chains": "B", "protein_site": 16, "sequential_site": 361}, "346": {"chains": "B", "protein_site": 17, "sequential_site": 362}, "347": {"chains": "B", "protein_site": 18, "sequential_site": 363}, "348": {"chains": "B", "protein_site": 19, "sequential_site": 364}, "349": {"chains": "B", "protein_site": 20, "sequential_site": 365}, "35": {"chains": "A", "protein_site": 25, "sequential_site": 41}, "350": {"chains": "B", "protein_site": 21, "sequential_site": 366}, "351": {"chains": "B", "protein_site": 22, "sequential_site": 367}, "352": {"chains": "B", "protein_site": 23, "sequential_site": 368}, "353": {"chains": "B", "protein_site": 24, "sequential_site": 369}, "354": {"chains": "B", "protein_site": 25, "sequential_site": 370}, "355": {"chains": "B", "protein_site": 26, "sequential_site": 371}, "356": {"chains": "B", "protein_site": 27, "sequential_site": 372}, "357": {"chains": "B", "protein_site": 28, "sequential_site": 373}, "358": {"chains": "B", "protein_site": 29, "sequential_site": 374}, "359": {"chains": "B", "protein_site": 30, "sequential_site": 375}, "36": {"chains": "A", "protein_site": 26, "sequential_site": 42}, "360": {"chains": "B", "protein_site": 31, "sequential_site": 376}, "361": {"chains": "B", "protein_site": 32, "sequential_site": 377}, "362": {"chains": "B", "protein_site": 33, "sequential_site": 378}, "363": {"chains": "B", "protein_site": 34, "sequential_site": 379}, "364": {"chains": "B", "protein_site": 35, "sequential_site": 380}, "365": {"chains": "B", "protein_site": 36, "sequential_site": 381}, "366": {"chains": "B", "protein_site": 37, "sequential_site": 382}, "367": {"chains": "B", "protein_site": 38, "sequential_site": 383}, "368": {"chains": "B", "protein_site": 39, "sequential_site": 384}, "369": {"chains": "B", "protein_site": 40, "sequential_site": 385}, "37": {"chains": "A", "protein_site": 27, "sequential_site": 43}, "370": {"chains": "B", "protein_site": 41, "sequential_site": 386}, "371": {"chains": "B", "protein_site": 42, "sequential_site": 387}, "372": {"chains": "B", "protein_site": 43, "sequential_site": 388}, "373": {"chains": "B", "protein_site": 44, "sequential_site": 389}, "374": {"chains": "B", "protein_site": 45, "sequential_site": 390}, "375": {"chains": "B", "protein_site": 46, "sequential_site": 391}, "376": {"chains": "B", "protein_site": 47, "sequential_site": 392}, "377": {"chains": "B", "protein_site": 48, "sequential_site": 393}, "378": {"chains": "B", "protein_site": 49, "sequential_site": 394}, "379": {"chains": "B", "protein_site": 50, "sequential_site": 395}, "38": {"chains": "A", "protein_site": 28, "sequential_site": 44}, "380": {"chains": "B", "protein_site": 51, "sequential_site": 396}, "381": {"chains": "B", "protein_site": 52, "sequential_site": 397}, "382": {"chains": "B", "protein_site": 53, "sequential_site": 398}, "383": {"chains": "B", "protein_site": 54, "sequential_site": 399}, "384": {"chains": "B", "protein_site": 55, "sequential_site": 400}, "385": {"chains": "B", "protein_site": 56, "sequential_site": 401}, "386": {"chains": "B", "protein_site": 57, "sequential_site": 402}, "387": {"chains": "B", "protein_site": 58, "sequential_site": 403}, "388": {"chains": "B", "protein_site": 59, "sequential_site": 404}, "389": {"chains": "B", "protein_site": 60, "sequential_site": 405}, "39": {"chains": "A", "protein_site": 29, "sequential_site": 45}, "390": {"chains": "B", "protein_site": 61, "sequential_site": 406}, "391": {"chains": "B", "protein_site": 62, "sequential_site": 407}, "392": {"chains": "B", "protein_site": 63, "sequential_site": 408}, "393": {"chains": "B", "protein_site": 64, "sequential_site": 409}, "394": {"chains": "B", "protein_site": 65, "sequential_site": 410}, "395": {"chains": "B", "protein_site": 66, "sequential_site": 411}, "396": {"chains": "B", "protein_site": 67, "sequential_site": 412}, "397": {"chains": "B", "protein_site": 68, "sequential_site": 413}, "398": {"chains": "B", "protein_site": 69, "sequential_site": 414}, "399": {"chains": "B", "protein_site": 70, "sequential_site": 415}, "4": {"chains": "A", "protein_site": -7, "sequential_site": 10}, "40": {"chains": "A", "protein_site": 30, "sequential_site": 46}, "400": {"chains": "B", "protein_site": 71, "sequential_site": 416}, "401": {"chains": "B", "protein_site": 72, "sequential_site": 417}, "402": {"chains": "B", "protein_site": 73, "sequential_site": 418}, "403": {"chains": "B", "protein_site": 74, "sequential_site": 419}, "404": {"chains": "B", "protein_site": 75, "sequential_site": 420}, "405": {"chains": "B", "protein_site": 76, "sequential_site": 421}, "406": {"chains": "B", "protein_site": 77, "sequential_site": 422}, "407": {"chains": "B", "protein_site": 78, "sequential_site": 423}, "408": {"chains": "B", "protein_site": 79, "sequential_site": 424}, "409": {"chains": "B", "protein_site": 80, "sequential_site": 425}, "41": {"chains": "A", "protein_site": 31, "sequential_site": 47}, "410": {"chains": "B", "protein_site": 81, "sequential_site": 426}, "411": {"chains": "B", "protein_site": 82, "sequential_site": 427}, "412": {"chains": "B", "protein_site": 83, "sequential_site": 428}, "413": {"chains": "B", "protein_site": 84, "sequential_site": 429}, "414": {"chains": "B", "protein_site": 85, "sequential_site": 430}, "415": {"chains": "B", "protein_site": 86, "sequential_site": 431}, "416": {"chains": "B", "protein_site": 87, "sequential_site": 432}, "417": {"chains": "B", "protein_site": 88, "sequential_site": 433}, "418": {"chains": "B", "protein_site": 89, "sequential_site": 434}, "419": {"chains": "B", "protein_site": 90, "sequential_site": 435}, "42": {"chains": "A", "protein_site": 32, "sequential_site": 48}, "420": {"chains": "B", "protein_site": 91, "sequential_site": 436}, "421": {"chains": "B", "protein_site": 92, "sequential_site": 437}, "422": {"chains": "B", "protein_site": 93, "sequential_site": 438}, "423": {"chains": "B", "protein_site": 94, "sequential_site": 439}, "424": {"chains": "B", "protein_site": 95, "sequential_site": 440}, "425": {"chains": "B", "protein_site": 96, "sequential_site": 441}, "426": {"chains": "B", "protein_site": 97, "sequential_site": 442}, "427": {"chains": "B", "protein_site": 98, "sequential_site": 443}, "428": {"chains": "B", "protein_site": 99, "sequential_site": 444}, "429": {"chains": "B", "protein_site": 100, "sequential_site": 445}, "43": {"chains": "A", "protein_site": 33, "sequential_site": 49}, "430": {"chains": "B", "protein_site": 101, "sequential_site": 446}, "431": {"chains": "B", "protein_site": 102, "sequential_site": 447}, "432": {"chains": "B", "protein_site": 103, "sequential_site": 448}, "433": {"chains": "B", "protein_site": 104, "sequential_site": 449}, "434": {"chains": "B", "protein_site": 105, "sequential_site": 450}, "435": {"chains": "B", "protein_site": 106, "sequential_site": 451}, "436": {"chains": "B", "protein_site": 107, "sequential_site": 452}, "437": {"chains": "B", "protein_site": 108, "sequential_site": 453}, "438": {"chains": "B", "protein_site": 109, "sequential_site": 454}, "439": {"chains": "B", "protein_site": 110, "sequential_site": 455}, "44": {"chains": "A", "protein_site": 34, "sequential_site": 50}, "440": {"chains": "B", "protein_site": 111, "sequential_site": 456}, "441": {"chains": "B", "protein_site": 112, "sequential_site": 457}, "442": {"chains": "B", "protein_site": 113, "sequential_site": 458}, "443": {"chains": "B", "protein_site": 114, "sequential_site": 459}, "444": {"chains": "B", "protein_site": 115, "sequential_site": 460}, "445": {"chains": "B", "protein_site": 116, "sequential_site": 461}, "446": {"chains": "B", "protein_site": 117, "sequential_site": 462}, "447": {"chains": "B", "protein_site": 118, "sequential_site": 463}, "448": {"chains": "B", "protein_site": 119, "sequential_site": 464}, "449": {"chains": "B", "protein_site": 120, "sequential_site": 465}, "45": {"chains": "A", "protein_site": 35, "sequential_site": 51}, "450": {"chains": "B", "protein_site": 121, "sequential_site": 466}, "451": {"chains": "B", "protein_site": 122, "sequential_site": 467}, "452": {"chains": "B", "protein_site": 123, "sequential_site": 468}, "453": {"chains": "B", "protein_site": 124, "sequential_site": 469}, "454": {"chains": "B", "protein_site": 125, "sequential_site": 470}, "455": {"chains": "B", "protein_site": 126, "sequential_site": 471}, "456": {"chains": "B", "protein_site": 127, "sequential_site": 472}, "457": {"chains": "B", "protein_site": 128, "sequential_site": 473}, "458": {"chains": "B", "protein_site": 129, "sequential_site": 474}, "459": {"chains": "B", "protein_site": 130, "sequential_site": 475}, "46": {"chains": "A", "protein_site": 36, "sequential_site": 52}, "460": {"chains": "B", "protein_site": 131, "sequential_site": 476}, "461": {"chains": "B", "protein_site": 132, "sequential_site": 477}, "462": {"chains": "B", "protein_site": 133, "sequential_site": 478}, "463": {"chains": "B", "protein_site": 134, "sequential_site": 479}, "464": {"chains": "B", "protein_site": 135, "sequential_site": 480}, "465": {"chains": "B", "protein_site": 136, "sequential_site": 481}, "466": {"chains": "B", "protein_site": 137, "sequential_site": 482}, "467": {"chains": "B", "protein_site": 138, "sequential_site": 483}, "468": {"chains": "B", "protein_site": 139, "sequential_site": 484}, "469": {"chains": "B", "protein_site": 140, "sequential_site": 485}, "47": {"chains": "A", "protein_site": 37, "sequential_site": 53}, "470": {"chains": "B", "protein_site": 141, "sequential_site": 486}, "471": {"chains": "B", "protein_site": 142, "sequential_site": 487}, "472": {"chains": "B", "protein_site": 143, "sequential_site": 488}, "473": {"chains": "B", "protein_site": 144, "sequential_site": 489}, "474": {"chains": "B", "protein_site": 145, "sequential_site": 490}, "475": {"chains": "B", "protein_site": 146, "sequential_site": 491}, "476": {"chains": "B", "protein_site": 147, "sequential_site": 492}, "477": {"chains": "B", "protein_site": 148, "sequential_site": 493}, "478": {"chains": "B", "protein_site": 149, "sequential_site": 494}, "479": {"chains": "B", "protein_site": 150, "sequential_site": 495}, "48": {"chains": "A", "protein_site": 38, "sequential_site": 54}, "480": {"chains": "B", "protein_site": 151, "sequential_site": 496}, "481": {"chains": "B", "protein_site": 152, "sequential_site": 497}, "482": {"chains": "B", "protein_site": 153, "sequential_site": 498}, "483": {"chains": "B", "protein_site": 154, "sequential_site": 499}, "484": {"chains": "B", "protein_site": 155, "sequential_site": 500}, "485": {"chains": "B", "protein_site": 156, "sequential_site": 501}, "486": {"chains": "B", "protein_site": 157, "sequential_site": 502}, "487": {"chains": "B", "protein_site": 158, "sequential_site": 503}, "488": {"chains": "B", "protein_site": 159, "sequential_site": 504}, "489": {"chains": "B", "protein_site": 160, "sequential_site": 505}, "49": {"chains": "A", "protein_site": 39, "sequential_site": 55}, "490": {"chains": "B", "protein_site": 161, "sequential_site": 506}, "491": {"chains": "B", "protein_site": 162, "sequential_site": 507}, "492": {"chains": "B", "protein_site": 163, "sequential_site": 508}, "493": {"chains": "B", "protein_site": 164, "sequential_site": 509}, "494": {"chains": "B", "protein_site": 165, "sequential_site": 510}, "495": {"chains": "B", "protein_site": 166, "sequential_site": 511}, "496": {"chains": "B", "protein_site": 167, "sequential_site": 512}, "497": {"chains": "B", "protein_site": 168, "sequential_site": 513}, "498": {"chains": "B", "protein_site": 169, "sequential_site": 514}, "499": {"chains": "B", "protein_site": 170, "sequential_site": 515}, "5": {"chains": "A", "protein_site": -6, "sequential_site": 11}, "50": {"chains": "A", "protein_site": 40, "sequential_site": 56}, "500": {"chains": "B", "protein_site": 171, "sequential_site": 516}, "501": {"chains": "B", "protein_site": 172, "sequential_site": 517}, "502": {"chains": "B", "protein_site": 173, "sequential_site": 518}, "503": {"chains": "B", "protein_site": 174, "sequential_site": 519}, "504": {"chains": "B", "protein_site": 175, "sequential_site": 520}, "505": {"chains": "B", "protein_site": 176, "sequential_site": 521}, "506": {"chains": "B", "protein_site": 177, "sequential_site": 522}, "507": {"chains": "B", "protein_site": 178, "sequential_site": 523}, "508": {"chains": "B", "protein_site": 179, "sequential_site": 524}, "509": {"chains": "B", "protein_site": 180, "sequential_site": 525}, "51": {"chains": "A", "protein_site": 41, "sequential_site": 57}, "510": {"chains": "B", "protein_site": 181, "sequential_site": 526}, "510a": {"chains": "B", "protein_site": 182, "sequential_site": 527}, "511": {"chains": "B", "protein_site": 183, "sequential_site": 528}, "512": {"chains": "B", "protein_site": 184, "sequential_site": 529}, "513": {"chains": "B", "protein_site": 185, "sequential_site": 530}, "514": {"chains": "B", "protein_site": 186, "sequential_site": 531}, "515": {"chains": "B", "protein_site": 187, "sequential_site": 532}, "516": {"chains": "B", "protein_site": 188, "sequential_site": 533}, "517": {"chains": "B", "protein_site": 189, "sequential_site": 534}, "518": {"chains": "B", "protein_site": 190, "sequential_site": 535}, "519": {"chains": "B", "protein_site": 191, "sequential_site": 536}, "52": {"chains": "A", "protein_site": 42, "sequential_site": 58}, "520": {"chains": "B", "protein_site": 192, "sequential_site": 537}, "521": {"chains": "B", "protein_site": 193, "sequential_site": 538}, "522": {"chains": "B", "protein_site": 194, "sequential_site": 539}, "523": {"chains": "B", "protein_site": 195, "sequential_site": 540}, "524": {"chains": "B", "protein_site": 196, "sequential_site": 541}, "525": {"chains": "B", "protein_site": 197, "sequential_site": 542}, "526": {"chains": "B", "protein_site": 198, "sequential_site": 543}, "527": {"chains": "B", "protein_site": 199, "sequential_site": 544}, "528": {"chains": "B", "protein_site": 200, "sequential_site": 545}, "529": {"chains": "B", "protein_site": 201, "sequential_site": 546}, "53": {"chains": "A", "protein_site": 43, "sequential_site": 59}, "530": {"chains": "B", "protein_site": 202, "sequential_site": 547}, "531": {"chains": "B", "protein_site": 203, "sequential_site": 548}, "532": {"chains": "B", "protein_site": 204, "sequential_site": 549}, "533": {"chains": "B", "protein_site": 205, "sequential_site": 550}, "534": {"chains": "B", "protein_site": 206, "sequential_site": 551}, "535": {"chains": "B", "protein_site": 207, "sequential_site": 552}, "536": {"chains": "B", "protein_site": 208, "sequential_site": 553}, "537": {"chains": "B", "protein_site": 209, "sequential_site": 554}, "538": {"chains": "B", "protein_site": 210, "sequential_site": 555}, "539": {"chains": "B", "protein_site": 211, "sequential_site": 556}, "54": {"chains": "A", "protein_site": 44, "sequential_site": 60}, "541": {"chains": "B", "protein_site": 213, "sequential_site": 558}, "542": {"chains": "B", "protein_site": 214, "sequential_site": 559}, "543": {"chains": "B", "protein_site": 215, "sequential_site": 560}, "544": {"chains": "B", "protein_site": 216, "sequential_site": 561}, "545": {"chains": "B", "protein_site": 217, "sequential_site": 562}, "546": {"chains": "B", "protein_site": 218, "sequential_site": 563}, "547": {"chains": "B", "protein_site": 219, "sequential_site": 564}, "548": {"chains": "B", "protein_site": 220, "sequential_site": 565}, "549": {"chains": "B", "protein_site": 221, "sequential_site": 566}, "54a": {"chains": "A", "protein_site": 45, "sequential_site": 61}, "55": {"chains": "A", "protein_site": 46, "sequential_site": 62}, "550": {"chains": "B", "protein_site": 222, "sequential_site": 567}, "56": {"chains": "A", "protein_site": 47, "sequential_site": 63}, "57": {"chains": "A", "protein_site": 48, "sequential_site": 64}, "58": {"chains": "A", "protein_site": 49, "sequential_site": 65}, "59": {"chains": "A", "protein_site": 50, "sequential_site": 66}, "6": {"chains": "A", "protein_site": -5, "sequential_site": 12}, "60": {"chains": "A", "protein_site": 51, "sequential_site": 67}, "61": {"chains": "A", "protein_site": 52, "sequential_site": 68}, "62": {"chains": "A", "protein_site": 53, "sequential_site": 69}, "63": {"chains": "A", "protein_site": 54, "sequential_site": 70}, "64": {"chains": "A", "protein_site": 55, "sequential_site": 71}, "65": {"chains": "A", "protein_site": 56, "sequential_site": 72}, "66": {"chains": "A", "protein_site": 57, "sequential_site": 73}, "67": {"chains": "A", "protein_site": 58, "sequential_site": 74}, "68": {"chains": "A", "protein_site": 59, "sequential_site": 75}, "69": {"chains": "A", "protein_site": 60, "sequential_site": 76}, "7": {"chains": "A", "protein_site": -4, "sequential_site": 13}, "70": {"chains": "A", "protein_site": 61, "sequential_site": 77}, "71": {"chains": "A", "protein_site": 62, "sequential_site": 78}, "72": {"chains": "A", "protein_site": 63, "sequential_site": 79}, "73": {"chains": "A", "protein_site": 64, "sequential_site": 80}, "74": {"chains": "A", "protein_site": 65, "sequential_site": 81}, "75": {"chains": "A", "protein_site": 66, "sequential_site": 82}, "76": {"chains": "A", "protein_site": 67, "sequential_site": 83}, "77": {"chains": "A", "protein_site": 68, "sequential_site": 84}, "78": {"chains": "A", "protein_site": 69, "sequential_site": 85}, "79": {"chains": "A", "protein_site": 70, "sequential_site": 86}, "8": {"chains": "A", "protein_site": -3, "sequential_site": 14}, "80": {"chains": "A", "protein_site": 71, "sequential_site": 87}, "81": {"chains": "A", "protein_site": 72, "sequential_site": 88}, "82": {"chains": "A", "protein_site": 73, "sequential_site": 89}, "82a": {"chains": "A", "protein_site": 74, "sequential_site": 90}, "83": {"chains": "A", "protein_site": 75, "sequential_site": 91}, "84": {"chains": "A", "protein_site": 76, "sequential_site": 92}, "85": {"chains": "A", "protein_site": 77, "sequential_site": 93}, "86": {"chains": "A", "protein_site": 78, "sequential_site": 94}, "87": {"chains": "A", "protein_site": 79, "sequential_site": 95}, "88": {"chains": "A", "protein_site": 80, "sequential_site": 96}, "89": {"chains": "A", "protein_site": 81, "sequential_site": 97}, "9": {"chains": "A", "protein_site": -2, "sequential_site": 15}, "90": {"chains": "A", "protein_site": 82, "sequential_site": 98}, "91": {"chains": "A", "protein_site": 83, "sequential_site": 99}, "92": {"chains": "A", "protein_site": 84, "sequential_site": 100}, "92a": {"chains": "A", "protein_site": 85, "sequential_site": 101}, "93": {"chains": "A", "protein_site": 86, "sequential_site": 102}, "94": {"chains": "A", "protein_site": 87, "sequential_site": 103}, "95": {"chains": "A", "protein_site": 88, "sequential_site": 104}, "96": {"chains": "A", "protein_site": 89, "sequential_site": 105}, "97": {"chains": "A", "protein_site": 90, "sequential_site": 106}, "98": {"chains": "A", "protein_site": 91, "sequential_site": 107}, "99": {"chains": "A", "protein_site": 92, "sequential_site": 108}}, "summary_stat": "mean", "title": "Effects of mutations to an influenza H5 HA (clade 2.3.4.4b) on cell entry", "tooltip_cols": {"a26_usage": "a26 usage", "ferret_sera_escape": "ferret sera escape", "mature_H5_site": "mature H5 site", "mouse_sera_escape": "mouse sera escape", "mutation": "mutation", "region": "region", "sequential_site": "sequential site", "stability": "stability"}}}
\ No newline at end of file
diff --git a/results/dms-viz/dms-viz_vrc_mabs.json b/results/dms-viz/dms-viz_vrc_mabs.json
new file mode 100644
index 0000000..cf8bd2f
--- /dev/null
+++ b/results/dms-viz/dms-viz_vrc_mabs.json
@@ -0,0 +1 @@
+{"VRC antibodies": {"alphabet": ["R", "K", "H", "D", "E", "Q", "N", "S", "T", "Y", "W", "F", "A", "I", "L", "M", "V", "G", "P", "C"], "condition_col": "antibody", "condition_colors": {"310-018-13-7D11": "#5784db", "310-054-13-12D03": "#57db94", "310-33-06C-1H02": "#c957db", "S2002-c289-74": "#db5f57", "S2002-c366-26": "#b9db57"}, "conditions": ["S2002-c289-74", "S2002-c366-26", "310-054-13-12D03", "310-018-13-7D11", "310-33-06C-1H02"], "dataChains": ["polymer"], "description": "H5 HA escape from VRC antibodies as measured by pseudovirus deep mutational scanning", "excludeChains": ["none"], "excludedAminoAcids": null, "filter_cols": {"cell_entry": "cell entry"}, "filter_limits": {"cell_entry": [-6.04, -3, 0]}, "floor": true, "heatmap_limits": null, "metric_col": "escape", "mut_metric_df": [{"antibody": "310-018-13-7D11", "cell_entry": 0.03853, "escape": 0.4646, "mature_H5_site": -11.0, "mutant": "C", "mutation": "L-1C", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07267, "escape": 0.1604, "mature_H5_site": -11.0, "mutant": "F", "mutation": "L-1F", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3239, "escape": -0.07928, "mature_H5_site": -11.0, "mutant": "G", "mutation": "L-1G", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9294, "escape": -0.1501, "mature_H5_site": -11.0, "mutant": "H", "mutation": "L-1H", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04745, "escape": -0.02344, "mature_H5_site": -11.0, "mutant": "I", "mutation": "L-1I", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1128, "escape": -0.2901, "mature_H5_site": -11.0, "mutant": "K", "mutation": "L-1K", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2653, "escape": -0.05067, "mature_H5_site": -11.0, "mutant": "Q", "mutation": "L-1Q", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4204, "escape": -0.3686, "mature_H5_site": -11.0, "mutant": "R", "mutation": "L-1R", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.324, "escape": 0.1924, "mature_H5_site": -11.0, "mutant": "S", "mutation": "L-1S", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.451, "escape": 0.0291, "mature_H5_site": -11.0, "mutant": "T", "mutation": "L-1T", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3508, "escape": -0.04889, "mature_H5_site": -11.0, "mutant": "V", "mutation": "L-1V", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00238, "escape": 0.1385, "mature_H5_site": -11.0, "mutant": "W", "mutation": "L-1W", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1909, "escape": -0.02205, "mature_H5_site": -11.0, "mutant": "Y", "mutation": "L-1Y", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4358, "escape": 0.0095, "mature_H5_site": -12.0, "mutant": "A", "mutation": "V-2A", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01653, "escape": 0.1504, "mature_H5_site": -12.0, "mutant": "F", "mutation": "V-2F", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05354, "escape": -0.2473, "mature_H5_site": -12.0, "mutant": "G", "mutation": "V-2G", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1321, "escape": -0.1229, "mature_H5_site": -12.0, "mutant": "H", "mutation": "V-2H", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06828, "escape": -0.08024, "mature_H5_site": -12.0, "mutant": "I", "mutation": "V-2I", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.523, "escape": 0.1076, "mature_H5_site": -12.0, "mutant": "K", "mutation": "V-2K", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6403, "escape": 0.174, "mature_H5_site": -12.0, "mutant": "M", "mutation": "V-2M", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2955, "escape": 0.2125, "mature_H5_site": -12.0, "mutant": "N", "mutation": "V-2N", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.437, "escape": -0.04321, "mature_H5_site": -12.0, "mutant": "P", "mutation": "V-2P", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7976, "escape": -0.2523, "mature_H5_site": -12.0, "mutant": "Q", "mutation": "V-2Q", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5964, "escape": 0.1272, "mature_H5_site": -12.0, "mutant": "R", "mutation": "V-2R", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.278, "escape": -0.04826, "mature_H5_site": -12.0, "mutant": "S", "mutation": "V-2S", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.236, "escape": -0.2888, "mature_H5_site": -12.0, "mutant": "T", "mutation": "V-2T", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02014, "escape": 0.07527, "mature_H5_site": -12.0, "mutant": "W", "mutation": "V-2W", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2677, "escape": 0.00505, "mature_H5_site": -12.0, "mutant": "Y", "mutation": "V-2Y", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.694, "escape": -0.2855, "mature_H5_site": -13.0, "mutant": "E", "mutation": "I-3E", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2824, "escape": 0.02164, "mature_H5_site": -13.0, "mutant": "F", "mutation": "I-3F", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5239, "escape": 0.2516, "mature_H5_site": -13.0, "mutant": "K", "mutation": "I-3K", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.347, "escape": -0.1057, "mature_H5_site": -13.0, "mutant": "M", "mutation": "I-3M", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4002, "escape": 0.09757, "mature_H5_site": -13.0, "mutant": "N", "mutation": "I-3N", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08928, "escape": 0.2009, "mature_H5_site": -13.0, "mutant": "P", "mutation": "I-3P", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.24, "escape": -0.1715, "mature_H5_site": -13.0, "mutant": "Q", "mutation": "I-3Q", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3754, "escape": -0.0153, "mature_H5_site": -13.0, "mutant": "R", "mutation": "I-3R", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04928, "escape": -0.03154, "mature_H5_site": -13.0, "mutant": "S", "mutation": "I-3S", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.228, "escape": -0.2108, "mature_H5_site": -13.0, "mutant": "T", "mutation": "I-3T", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.216, "escape": 0.09521, "mature_H5_site": -13.0, "mutant": "V", "mutation": "I-3V", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05539, "escape": -0.00449, "mature_H5_site": -13.0, "mutant": "W", "mutation": "I-3W", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06426, "escape": -0.2756, "mature_H5_site": -13.0, "mutant": "Y", "mutation": "I-3Y", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05586, "escape": -0.1555, "mature_H5_site": -14.0, "mutant": "A", "mutation": "N-4A", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.003655, "escape": -0.02549, "mature_H5_site": -14.0, "mutant": "C", "mutation": "N-4C", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08413, "escape": -0.06051, "mature_H5_site": -14.0, "mutant": "D", "mutation": "N-4D", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04051, "escape": 0.01947, "mature_H5_site": -14.0, "mutant": "E", "mutation": "N-4E", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06012, "escape": 0.2408, "mature_H5_site": -14.0, "mutant": "F", "mutation": "N-4F", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.586, "escape": 0.2072, "mature_H5_site": -14.0, "mutant": "G", "mutation": "N-4G", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05198, "escape": 0.165, "mature_H5_site": -14.0, "mutant": "H", "mutation": "N-4H", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01491, "escape": 0.02732, "mature_H5_site": -14.0, "mutant": "I", "mutation": "N-4I", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1131, "escape": 0.1696, "mature_H5_site": -14.0, "mutant": "K", "mutation": "N-4K", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02193, "escape": -0.03425, "mature_H5_site": -14.0, "mutant": "L", "mutation": "N-4L", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4973, "escape": -0.05672, "mature_H5_site": -14.0, "mutant": "M", "mutation": "N-4M", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05024, "escape": 0.09311, "mature_H5_site": -14.0, "mutant": "Q", "mutation": "N-4Q", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2761, "escape": 0.4795, "mature_H5_site": -14.0, "mutant": "R", "mutation": "N-4R", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.25, "escape": -0.1979, "mature_H5_site": -14.0, "mutant": "T", "mutation": "N-4T", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07004, "escape": 0.01254, "mature_H5_site": -14.0, "mutant": "V", "mutation": "N-4V", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0767, "escape": 0.03193, "mature_H5_site": -14.0, "mutant": "W", "mutation": "N-4W", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2561, "escape": -0.08584, "mature_H5_site": -15.0, "mutant": "A", "mutation": "E-5A", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06022, "escape": 0.03571, "mature_H5_site": -15.0, "mutant": "C", "mutation": "E-5C", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09452, "escape": -0.2137, "mature_H5_site": -15.0, "mutant": "F", "mutation": "E-5F", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1468, "escape": -0.3645, "mature_H5_site": -15.0, "mutant": "G", "mutation": "E-5G", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01327, "escape": 0.09166, "mature_H5_site": -15.0, "mutant": "H", "mutation": "E-5H", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0358, "escape": -0.1307, "mature_H5_site": -15.0, "mutant": "I", "mutation": "E-5I", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07079, "escape": -0.2934, "mature_H5_site": -15.0, "mutant": "K", "mutation": "E-5K", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07343, "escape": -0.2391, "mature_H5_site": -15.0, "mutant": "L", "mutation": "E-5L", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.166, "escape": 0.1385, "mature_H5_site": -15.0, "mutant": "M", "mutation": "E-5M", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1724, "escape": 0.01011, "mature_H5_site": -15.0, "mutant": "N", "mutation": "E-5N", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02672, "escape": 0.05277, "mature_H5_site": -15.0, "mutant": "P", "mutation": "E-5P", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02099, "escape": -0.2023, "mature_H5_site": -15.0, "mutant": "Q", "mutation": "E-5Q", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02275, "escape": -0.03999, "mature_H5_site": -15.0, "mutant": "R", "mutation": "E-5R", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05347, "escape": 0.06786, "mature_H5_site": -15.0, "mutant": "S", "mutation": "E-5S", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05712, "escape": 0.1984, "mature_H5_site": -15.0, "mutant": "T", "mutation": "E-5T", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.000975, "escape": 0.02582, "mature_H5_site": -15.0, "mutant": "V", "mutation": "E-5V", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03492, "escape": -0.6216, "mature_H5_site": -15.0, "mutant": "W", "mutation": "E-5W", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3705, "escape": 0.03453, "mature_H5_site": -15.0, "mutant": "Y", "mutation": "E-5Y", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2586, "escape": -0.1656, "mature_H5_site": -10.0, "mutant": "C", "mutation": "L1C", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.003785, "escape": 0.1155, "mature_H5_site": -10.0, "mutant": "G", "mutation": "L1G", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.514, "escape": -0.2954, "mature_H5_site": -10.0, "mutant": "H", "mutation": "L1H", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.001975, "escape": 0.08455, "mature_H5_site": -10.0, "mutant": "I", "mutation": "L1I", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.755, "escape": -0.1794, "mature_H5_site": -10.0, "mutant": "M", "mutation": "L1M", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5069, "escape": -0.1456, "mature_H5_site": -10.0, "mutant": "S", "mutation": "L1S", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3497, "escape": -0.1532, "mature_H5_site": -10.0, "mutant": "T", "mutation": "L1T", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06815, "escape": 0.01719, "mature_H5_site": -10.0, "mutant": "V", "mutation": "L1V", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06074, "escape": -0.1409, "mature_H5_site": -10.0, "mutant": "W", "mutation": "L1W", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.239, "escape": -0.1452, "mature_H5_site": -10.0, "mutant": "Y", "mutation": "L1Y", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.179, "escape": -0.2076, "mature_H5_site": -1.0, "mutant": "A", "mutation": "S10A", "reference_site": "10", "sequential_site": 16.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01148, "escape": -0.04838, "mature_H5_site": -1.0, "mutant": "C", "mutation": "S10C", "reference_site": "10", "sequential_site": 16.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2729, "escape": 0.07038, "mature_H5_site": -1.0, "mutant": "G", "mutation": "S10G", "reference_site": "10", "sequential_site": 16.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.337, "escape": 0.03847, "mature_H5_site": -1.0, "mutant": "N", "mutation": "S10N", "reference_site": "10", "sequential_site": 16.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.418, "escape": -0.1573, "mature_H5_site": -1.0, "mutant": "P", "mutation": "S10P", "reference_site": "10", "sequential_site": 16.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6802, "escape": 0.06483, "mature_H5_site": -1.0, "mutant": "T", "mutation": "S10T", "reference_site": "10", "sequential_site": 16.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3704, "escape": 1.817, "mature_H5_site": 93.0, "mutant": "A", "mutation": "G100A", "reference_site": "100", "sequential_site": 109.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.103, "escape": 1.354, "mature_H5_site": 93.0, "mutant": "S", "mutation": "G100S", "reference_site": "100", "sequential_site": 109.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0956, "escape": -0.1421, "mature_H5_site": 94.0, "mutant": "C", "mutation": "S101C", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02678, "escape": 0.05098, "mature_H5_site": 94.0, "mutant": "D", "mutation": "S101D", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02001, "escape": 0.05291, "mature_H5_site": 94.0, "mutant": "F", "mutation": "S101F", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.088, "escape": 0.09767, "mature_H5_site": 94.0, "mutant": "G", "mutation": "S101G", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02848, "escape": 0.1206, "mature_H5_site": 94.0, "mutant": "H", "mutation": "S101H", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2838, "escape": -0.2116, "mature_H5_site": 94.0, "mutant": "L", "mutation": "S101L", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0626, "escape": 0.08588, "mature_H5_site": 94.0, "mutant": "M", "mutation": "S101M", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05616, "escape": 0.09925, "mature_H5_site": 94.0, "mutant": "N", "mutation": "S101N", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06219, "escape": 0.4008, "mature_H5_site": 94.0, "mutant": "Q", "mutation": "S101Q", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06874, "escape": 0.1414, "mature_H5_site": 94.0, "mutant": "R", "mutation": "S101R", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7448, "escape": 0.07575, "mature_H5_site": 94.0, "mutant": "T", "mutation": "S101T", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3681, "escape": 0.1402, "mature_H5_site": 95.0, "mutant": "C", "mutation": "L102C", "reference_site": "102", "sequential_site": 111.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4405, "escape": 0.2263, "mature_H5_site": 95.0, "mutant": "F", "mutation": "L102F", "reference_site": "102", "sequential_site": 111.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04134, "escape": 0.0694, "mature_H5_site": 95.0, "mutant": "M", "mutation": "L102M", "reference_site": "102", "sequential_site": 111.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3189, "escape": 0.06456, "mature_H5_site": 96.0, "mutant": "A", "mutation": "N103A", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.084, "escape": -0.01635, "mature_H5_site": 96.0, "mutant": "D", "mutation": "N103D", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02871, "escape": 0.1289, "mature_H5_site": 96.0, "mutant": "E", "mutation": "N103E", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7171, "escape": 0.08708, "mature_H5_site": 96.0, "mutant": "H", "mutation": "N103H", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4207, "escape": 0.1696, "mature_H5_site": 96.0, "mutant": "I", "mutation": "N103I", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9121, "escape": 0.1088, "mature_H5_site": 96.0, "mutant": "K", "mutation": "N103K", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1763, "escape": 0.1006, "mature_H5_site": 96.0, "mutant": "M", "mutation": "N103M", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02512, "escape": -0.07544, "mature_H5_site": 96.0, "mutant": "P", "mutation": "N103P", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9675, "escape": 0.07516, "mature_H5_site": 96.0, "mutant": "Q", "mutation": "N103Q", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.003446, "escape": 0.0109, "mature_H5_site": 96.0, "mutant": "R", "mutation": "N103R", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3932, "escape": -0.0911, "mature_H5_site": 96.0, "mutant": "T", "mutation": "N103T", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02977, "escape": -0.6709, "mature_H5_site": 96.0, "mutant": "V", "mutation": "N103V", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01744, "escape": -0.1148, "mature_H5_site": 96.0, "mutant": "W", "mutation": "N103W", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2094, "escape": 0.1558, "mature_H5_site": 96.0, "mutant": "Y", "mutation": "N103Y", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2377, "escape": -0.09797, "mature_H5_site": 97.0, "mutant": "C", "mutation": "D104C", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01429, "escape": 0.1638, "mature_H5_site": 97.0, "mutant": "E", "mutation": "D104E", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.251, "escape": -0.04703, "mature_H5_site": 97.0, "mutant": "F", "mutation": "D104F", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2573, "escape": -0.4415, "mature_H5_site": 97.0, "mutant": "G", "mutation": "D104G", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7358, "escape": -0.1362, "mature_H5_site": 97.0, "mutant": "H", "mutation": "D104H", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7713, "escape": -0.05341, "mature_H5_site": 97.0, "mutant": "I", "mutation": "D104I", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4873, "escape": 0.1575, "mature_H5_site": 97.0, "mutant": "N", "mutation": "D104N", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.051, "escape": -0.39, "mature_H5_site": 97.0, "mutant": "P", "mutation": "D104P", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07743, "escape": 0.2118, "mature_H5_site": 97.0, "mutant": "Q", "mutation": "D104Q", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.084, "escape": -0.0124, "mature_H5_site": 97.0, "mutant": "S", "mutation": "D104S", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5111, "escape": -0.009956, "mature_H5_site": 97.0, "mutant": "V", "mutation": "D104V", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2975, "escape": -0.09031, "mature_H5_site": 97.0, "mutant": "W", "mutation": "D104W", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.177, "escape": 0.009723, "mature_H5_site": 97.0, "mutant": "Y", "mutation": "D104Y", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3245, "escape": -0.05431, "mature_H5_site": 98.0, "mutant": "E", "mutation": "Y105E", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05183, "escape": -0.00777, "mature_H5_site": 98.0, "mutant": "H", "mutation": "Y105H", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09787, "escape": -0.2735, "mature_H5_site": 98.0, "mutant": "I", "mutation": "Y105I", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1983, "escape": 0.01129, "mature_H5_site": 98.0, "mutant": "L", "mutation": "Y105L", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06217, "escape": -0.008644, "mature_H5_site": 98.0, "mutant": "N", "mutation": "Y105N", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6564, "escape": -0.06483, "mature_H5_site": 98.0, "mutant": "Q", "mutation": "Y105Q", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4109, "escape": -0.0436, "mature_H5_site": 98.0, "mutant": "R", "mutation": "Y105R", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07614, "escape": -0.09815, "mature_H5_site": 98.0, "mutant": "V", "mutation": "Y105V", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01433, "escape": 0.0005683, "mature_H5_site": 98.0, "mutant": "W", "mutation": "Y105W", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6726, "escape": 0.001824, "mature_H5_site": 99.0, "mutant": "D", "mutation": "E106D", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7146, "escape": 0.1084, "mature_H5_site": 99.0, "mutant": "F", "mutation": "E106F", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3959, "escape": 0.02302, "mature_H5_site": 99.0, "mutant": "G", "mutation": "E106G", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3512, "escape": 0.0326, "mature_H5_site": 99.0, "mutant": "H", "mutation": "E106H", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5907, "escape": 0.3622, "mature_H5_site": 99.0, "mutant": "L", "mutation": "E106L", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09538, "escape": 0.006736, "mature_H5_site": 99.0, "mutant": "M", "mutation": "E106M", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.649, "escape": -0.02806, "mature_H5_site": 99.0, "mutant": "N", "mutation": "E106N", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1303, "escape": -0.1527, "mature_H5_site": 99.0, "mutant": "Q", "mutation": "E106Q", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.537, "escape": -1.405, "mature_H5_site": 99.0, "mutant": "Y", "mutation": "E106Y", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2334, "escape": 0.1949, "mature_H5_site": 101.0, "mutant": "M", "mutation": "L108M", "reference_site": "108", "sequential_site": 117.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07599, "escape": 0.182, "mature_H5_site": 102.0, "mutant": "A", "mutation": "K109A", "reference_site": "109", "sequential_site": 118.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6565, "escape": -0.1715, "mature_H5_site": 102.0, "mutant": "C", "mutation": "K109C", "reference_site": "109", "sequential_site": 118.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1584, "escape": 0.1833, "mature_H5_site": 102.0, "mutant": "Q", "mutation": "K109Q", "reference_site": "109", "sequential_site": 118.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1504, "escape": 0.08636, "mature_H5_site": 102.0, "mutant": "R", "mutation": "K109R", "reference_site": "109", "sequential_site": 118.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.366, "escape": 0.01841, "mature_H5_site": 103.0, "mutant": "A", "mutation": "H110A", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.888, "escape": 0.8726, "mature_H5_site": 103.0, "mutant": "C", "mutation": "H110C", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.331, "escape": -0.7412, "mature_H5_site": 103.0, "mutant": "E", "mutation": "H110E", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.883, "escape": 0.1459, "mature_H5_site": 103.0, "mutant": "M", "mutation": "H110M", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7925, "escape": -0.2101, "mature_H5_site": 103.0, "mutant": "N", "mutation": "H110N", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.601, "escape": 0.2619, "mature_H5_site": 103.0, "mutant": "Q", "mutation": "H110Q", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5953, "escape": 0.55, "mature_H5_site": 103.0, "mutant": "S", "mutation": "H110S", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.135, "escape": 1.813, "mature_H5_site": 103.0, "mutant": "T", "mutation": "H110T", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.351, "escape": 0.1764, "mature_H5_site": 103.0, "mutant": "Y", "mutation": "H110Y", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.491, "escape": -0.2853, "mature_H5_site": 104.0, "mutant": "A", "mutation": "M111A", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8764, "escape": 0.02638, "mature_H5_site": 104.0, "mutant": "C", "mutation": "M111C", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.17, "escape": 0.311, "mature_H5_site": 104.0, "mutant": "D", "mutation": "M111D", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02311, "escape": -0.1405, "mature_H5_site": 104.0, "mutant": "G", "mutation": "M111G", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01186, "escape": -0.1154, "mature_H5_site": 104.0, "mutant": "H", "mutation": "M111H", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01526, "escape": -0.1313, "mature_H5_site": 104.0, "mutant": "I", "mutation": "M111I", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01373, "escape": -0.05562, "mature_H5_site": 104.0, "mutant": "L", "mutation": "M111L", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4343, "escape": -0.09963, "mature_H5_site": 104.0, "mutant": "S", "mutation": "M111S", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.037, "escape": -0.3408, "mature_H5_site": 104.0, "mutant": "T", "mutation": "M111T", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.444, "escape": 0.1326, "mature_H5_site": 104.0, "mutant": "W", "mutation": "M111W", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2695, "escape": 0.1264, "mature_H5_site": 104.0, "mutant": "Y", "mutation": "M111Y", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5001, "escape": 0.7496, "mature_H5_site": 105.0, "mutant": "C", "mutation": "L112C", "reference_site": "112", "sequential_site": 121.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4761, "escape": -0.02869, "mature_H5_site": 105.0, "mutant": "I", "mutation": "L112I", "reference_site": "112", "sequential_site": 121.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07681, "escape": -0.03742, "mature_H5_site": 105.0, "mutant": "M", "mutation": "L112M", "reference_site": "112", "sequential_site": 121.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.913, "escape": -0.2359, "mature_H5_site": 105.0, "mutant": "S", "mutation": "L112S", "reference_site": "112", "sequential_site": 121.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.093, "escape": 0.2275, "mature_H5_site": 105.0, "mutant": "V", "mutation": "L112V", "reference_site": "112", "sequential_site": 121.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04543, "escape": -0.1602, "mature_H5_site": 106.0, "mutant": "A", "mutation": "S113A", "reference_site": "113", "sequential_site": 122.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.981, "escape": -0.2079, "mature_H5_site": 106.0, "mutant": "G", "mutation": "S113G", "reference_site": "113", "sequential_site": 122.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04878, "escape": 0.5769, "mature_H5_site": 107.0, "mutant": "C", "mutation": "R114C", "reference_site": "114", "sequential_site": 123.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.285, "escape": 0.2075, "mature_H5_site": 107.0, "mutant": "K", "mutation": "R114K", "reference_site": "114", "sequential_site": 123.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.156, "escape": 1.072, "mature_H5_site": 107.0, "mutant": "Q", "mutation": "R114Q", "reference_site": "114", "sequential_site": 123.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4584, "escape": -0.09985, "mature_H5_site": 107.0, "mutant": "W", "mutation": "R114W", "reference_site": "114", "sequential_site": 123.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5778, "escape": -0.1128, "mature_H5_site": 107.0, "mutant": "Y", "mutation": "R114Y", "reference_site": "114", "sequential_site": 123.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9204, "escape": 0.6858, "mature_H5_site": 108.0, "mutant": "L", "mutation": "I115L", "reference_site": "115", "sequential_site": 124.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.07, "escape": 0.7697, "mature_H5_site": 109.0, "mutant": "H", "mutation": "N116H", "reference_site": "116", "sequential_site": 125.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00154, "escape": 0.1243, "mature_H5_site": 109.0, "mutant": "K", "mutation": "N116K", "reference_site": "116", "sequential_site": 125.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7297, "escape": 0.02335, "mature_H5_site": 109.0, "mutant": "M", "mutation": "N116M", "reference_site": "116", "sequential_site": 125.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.405, "escape": 1.855, "mature_H5_site": 109.0, "mutant": "P", "mutation": "N116P", "reference_site": "116", "sequential_site": 125.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0768, "escape": 0.08119, "mature_H5_site": 109.0, "mutant": "Q", "mutation": "N116Q", "reference_site": "116", "sequential_site": 125.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.368, "escape": 0.3367, "mature_H5_site": 109.0, "mutant": "S", "mutation": "N116S", "reference_site": "116", "sequential_site": 125.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.449, "escape": -0.1589, "mature_H5_site": 110.0, "mutant": "C", "mutation": "H117C", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2694, "escape": -0.1792, "mature_H5_site": 110.0, "mutant": "D", "mutation": "H117D", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03195, "escape": -0.1413, "mature_H5_site": 110.0, "mutant": "N", "mutation": "H117N", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3424, "escape": -0.04617, "mature_H5_site": 110.0, "mutant": "Q", "mutation": "H117Q", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3956, "escape": 0.05709, "mature_H5_site": 110.0, "mutant": "R", "mutation": "H117R", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03186, "escape": -0.05467, "mature_H5_site": 110.0, "mutant": "S", "mutation": "H117S", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5314, "escape": 0.3441, "mature_H5_site": 110.0, "mutant": "T", "mutation": "H117T", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03752, "escape": 0.01868, "mature_H5_site": 110.0, "mutant": "W", "mutation": "H117W", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5233, "escape": 0.8979, "mature_H5_site": 110.0, "mutant": "Y", "mutation": "H117Y", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9971, "escape": 0.3058, "mature_H5_site": 111.0, "mutant": "C", "mutation": "F118C", "reference_site": "118", "sequential_site": 127.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5722, "escape": 1.018, "mature_H5_site": 111.0, "mutant": "H", "mutation": "F118H", "reference_site": "118", "sequential_site": 127.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.001, "escape": 0.2572, "mature_H5_site": 111.0, "mutant": "T", "mutation": "F118T", "reference_site": "118", "sequential_site": 127.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8548, "escape": 1.797, "mature_H5_site": 111.0, "mutant": "Y", "mutation": "F118Y", "reference_site": "118", "sequential_site": 127.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3972, "escape": -0.06508, "mature_H5_site": 112.0, "mutant": "D", "mutation": "E119D", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.011, "escape": 0.04838, "mature_H5_site": 112.0, "mutant": "F", "mutation": "E119F", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.479, "escape": 0.02946, "mature_H5_site": 112.0, "mutant": "G", "mutation": "E119G", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07822, "escape": 0.1027, "mature_H5_site": 112.0, "mutant": "H", "mutation": "E119H", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.161, "escape": -0.05557, "mature_H5_site": 112.0, "mutant": "K", "mutation": "E119K", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0783, "escape": -0.1025, "mature_H5_site": 112.0, "mutant": "M", "mutation": "E119M", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4814, "escape": 0.01197, "mature_H5_site": 112.0, "mutant": "N", "mutation": "E119N", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06823, "escape": 0.1345, "mature_H5_site": 112.0, "mutant": "R", "mutation": "E119R", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5659, "escape": 0.02674, "mature_H5_site": 112.0, "mutant": "S", "mutation": "E119S", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3562, "escape": -0.0188, "mature_H5_site": 112.0, "mutant": "T", "mutation": "E119T", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4491, "escape": 0.03797, "mature_H5_site": 112.0, "mutant": "V", "mutation": "E119V", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.804, "escape": 1.006, "mature_H5_site": 112.0, "mutant": "W", "mutation": "E119W", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6957, "escape": 0.2087, "mature_H5_site": 112.0, "mutant": "Y", "mutation": "E119Y", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06322, "escape": 0.1296, "mature_H5_site": 2.0, "mutant": "C", "mutation": "Q12C", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4799, "escape": -0.1881, "mature_H5_site": 2.0, "mutant": "E", "mutation": "Q12E", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00978, "escape": 0.02351, "mature_H5_site": 2.0, "mutant": "F", "mutation": "Q12F", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2583, "escape": -0.2753, "mature_H5_site": 2.0, "mutant": "H", "mutation": "Q12H", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0239, "escape": 0.2966, "mature_H5_site": 2.0, "mutant": "I", "mutation": "Q12I", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03238, "escape": -0.1834, "mature_H5_site": 2.0, "mutant": "K", "mutation": "Q12K", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05822, "escape": 0.02254, "mature_H5_site": 2.0, "mutant": "N", "mutation": "Q12N", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1152, "escape": 0.145, "mature_H5_site": 2.0, "mutant": "R", "mutation": "Q12R", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.372, "escape": 0.09908, "mature_H5_site": 2.0, "mutant": "S", "mutation": "Q12S", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01009, "escape": -0.001379, "mature_H5_site": 2.0, "mutant": "V", "mutation": "Q12V", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9424, "escape": -0.2522, "mature_H5_site": 2.0, "mutant": "Y", "mutation": "Q12Y", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01951, "escape": -0.1708, "mature_H5_site": 113.0, "mutant": "A", "mutation": "K120A", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2547, "escape": 2.166, "mature_H5_site": 113.0, "mutant": "E", "mutation": "K120E", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8044, "escape": -0.3737, "mature_H5_site": 113.0, "mutant": "G", "mutation": "K120G", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5709, "escape": -0.2717, "mature_H5_site": 113.0, "mutant": "H", "mutation": "K120H", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3311, "escape": -0.1064, "mature_H5_site": 113.0, "mutant": "I", "mutation": "K120I", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03023, "escape": -0.211, "mature_H5_site": 113.0, "mutant": "M", "mutation": "K120M", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05283, "escape": -0.2781, "mature_H5_site": 113.0, "mutant": "P", "mutation": "K120P", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02981, "escape": -0.4338, "mature_H5_site": 113.0, "mutant": "Q", "mutation": "K120Q", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.692, "escape": 1.786, "mature_H5_site": 113.0, "mutant": "R", "mutation": "K120R", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0716, "escape": -0.1574, "mature_H5_site": 113.0, "mutant": "T", "mutation": "K120T", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.438, "escape": 0.07039, "mature_H5_site": 113.0, "mutant": "Y", "mutation": "K120Y", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03422, "escape": -0.1985, "mature_H5_site": 114.0, "mutant": "A", "mutation": "I121A", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.531, "escape": -0.06497, "mature_H5_site": 114.0, "mutant": "C", "mutation": "I121C", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3542, "escape": -0.2697, "mature_H5_site": 114.0, "mutant": "E", "mutation": "I121E", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1405, "escape": -0.03916, "mature_H5_site": 114.0, "mutant": "F", "mutation": "I121F", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0355, "escape": 0.7422, "mature_H5_site": 114.0, "mutant": "K", "mutation": "I121K", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03692, "escape": -0.2322, "mature_H5_site": 114.0, "mutant": "M", "mutation": "I121M", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06919, "escape": -0.1557, "mature_H5_site": 114.0, "mutant": "N", "mutation": "I121N", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2019, "escape": 0.4035, "mature_H5_site": 114.0, "mutant": "R", "mutation": "I121R", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03352, "escape": 0.02702, "mature_H5_site": 114.0, "mutant": "T", "mutation": "I121T", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6371, "escape": -0.006984, "mature_H5_site": 114.0, "mutant": "V", "mutation": "I121V", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2212, "escape": 1.502, "mature_H5_site": 114.0, "mutant": "W", "mutation": "I121W", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4973, "escape": 1.46, "mature_H5_site": 115.0, "mutant": "E", "mutation": "L122E", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3482, "escape": -0.2893, "mature_H5_site": 115.0, "mutant": "F", "mutation": "L122F", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02544, "escape": -0.3971, "mature_H5_site": 115.0, "mutant": "H", "mutation": "L122H", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3065, "escape": 0.2205, "mature_H5_site": 115.0, "mutant": "I", "mutation": "L122I", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.163, "escape": 2.597, "mature_H5_site": 115.0, "mutant": "K", "mutation": "L122K", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4126, "escape": -0.2023, "mature_H5_site": 115.0, "mutant": "M", "mutation": "L122M", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3185, "escape": -0.3813, "mature_H5_site": 115.0, "mutant": "N", "mutation": "L122N", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.001835, "escape": -0.4566, "mature_H5_site": 115.0, "mutant": "P", "mutation": "L122P", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07306, "escape": -0.2536, "mature_H5_site": 115.0, "mutant": "Q", "mutation": "L122Q", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01141, "escape": 3.042, "mature_H5_site": 115.0, "mutant": "R", "mutation": "L122R", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1468, "escape": 3.18, "mature_H5_site": 115.0, "mutant": "W", "mutation": "L122W", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1908, "escape": 0.1856, "mature_H5_site": 116.0, "mutant": "A", "mutation": "I123A", "reference_site": "123", "sequential_site": 132.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1483, "escape": 2.483, "mature_H5_site": 116.0, "mutant": "F", "mutation": "I123F", "reference_site": "123", "sequential_site": 132.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1876, "escape": 1.711, "mature_H5_site": 116.0, "mutant": "L", "mutation": "I123L", "reference_site": "123", "sequential_site": 132.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.001085, "escape": 1.456, "mature_H5_site": 116.0, "mutant": "M", "mutation": "I123M", "reference_site": "123", "sequential_site": 132.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.579, "escape": -0.05278, "mature_H5_site": 116.0, "mutant": "S", "mutation": "I123S", "reference_site": "123", "sequential_site": 132.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2315, "escape": 1.044, "mature_H5_site": 116.0, "mutant": "V", "mutation": "I123V", "reference_site": "123", "sequential_site": 132.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06524, "escape": 0.4879, "mature_H5_site": 116.0, "mutant": "W", "mutation": "I123W", "reference_site": "123", "sequential_site": 132.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06385, "escape": -0.4831, "mature_H5_site": 117.0, "mutant": "A", "mutation": "I124A", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5464, "escape": 0.7112, "mature_H5_site": 117.0, "mutant": "D", "mutation": "I124D", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1112, "escape": 0.3726, "mature_H5_site": 117.0, "mutant": "H", "mutation": "I124H", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4002, "escape": -0.3727, "mature_H5_site": 117.0, "mutant": "K", "mutation": "I124K", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1626, "escape": 0.429, "mature_H5_site": 117.0, "mutant": "L", "mutation": "I124L", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0379, "escape": 0.2968, "mature_H5_site": 117.0, "mutant": "N", "mutation": "I124N", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.078, "escape": -0.284, "mature_H5_site": 117.0, "mutant": "Q", "mutation": "I124Q", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2653, "escape": -0.2323, "mature_H5_site": 117.0, "mutant": "R", "mutation": "I124R", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6515, "escape": 0.1201, "mature_H5_site": 117.0, "mutant": "S", "mutation": "I124S", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07219, "escape": 0.3821, "mature_H5_site": 117.0, "mutant": "T", "mutation": "I124T", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01622, "escape": -0.1994, "mature_H5_site": 117.0, "mutant": "V", "mutation": "I124V", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0936, "escape": -0.03039, "mature_H5_site": 117.0, "mutant": "W", "mutation": "I124W", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3624, "escape": 0.333, "mature_H5_site": 117.0, "mutant": "Y", "mutation": "I124Y", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03685, "escape": 3.052, "mature_H5_site": 118.0, "mutant": "A", "mutation": "P125A", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0963, "escape": 3.146, "mature_H5_site": 118.0, "mutant": "D", "mutation": "P125D", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0373, "escape": 3.167, "mature_H5_site": 118.0, "mutant": "G", "mutation": "P125G", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6355, "escape": 3.003, "mature_H5_site": 118.0, "mutant": "H", "mutation": "P125H", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3328, "escape": 2.997, "mature_H5_site": 118.0, "mutant": "K", "mutation": "P125K", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06372, "escape": 3.011, "mature_H5_site": 118.0, "mutant": "N", "mutation": "P125N", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00216, "escape": 3.23, "mature_H5_site": 118.0, "mutant": "Q", "mutation": "P125Q", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1268, "escape": 3.013, "mature_H5_site": 118.0, "mutant": "R", "mutation": "P125R", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06537, "escape": 3.063, "mature_H5_site": 118.0, "mutant": "S", "mutation": "P125S", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00919, "escape": 2.889, "mature_H5_site": 118.0, "mutant": "T", "mutation": "P125T", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0403, "escape": 3.401, "mature_H5_site": 119.0, "mutant": "D", "mutation": "K125aD", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.483, "escape": 2.841, "mature_H5_site": 119.0, "mutant": "E", "mutation": "K125aE", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07407, "escape": 3.418, "mature_H5_site": 119.0, "mutant": "F", "mutation": "K125aF", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04975, "escape": 3.133, "mature_H5_site": 119.0, "mutant": "G", "mutation": "K125aG", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2167, "escape": 3.8, "mature_H5_site": 119.0, "mutant": "H", "mutation": "K125aH", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06885, "escape": 3.453, "mature_H5_site": 119.0, "mutant": "I", "mutation": "K125aI", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2719, "escape": 3.398, "mature_H5_site": 119.0, "mutant": "M", "mutation": "K125aM", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00878, "escape": 3.249, "mature_H5_site": 119.0, "mutant": "N", "mutation": "K125aN", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02823, "escape": 3.212, "mature_H5_site": 119.0, "mutant": "P", "mutation": "K125aP", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.195, "escape": 2.941, "mature_H5_site": 119.0, "mutant": "Q", "mutation": "K125aQ", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06646, "escape": 2.92, "mature_H5_site": 119.0, "mutant": "R", "mutation": "K125aR", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05916, "escape": 3.41, "mature_H5_site": 119.0, "mutant": "S", "mutation": "K125aS", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1732, "escape": 1.66, "mature_H5_site": 119.0, "mutant": "T", "mutation": "K125aT", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2305, "escape": 3.158, "mature_H5_site": 119.0, "mutant": "V", "mutation": "K125aV", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2351, "escape": 3.399, "mature_H5_site": 119.0, "mutant": "Y", "mutation": "K125aY", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4078, "escape": 3.249, "mature_H5_site": 120.0, "mutant": "F", "mutation": "S125bF", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07065, "escape": 1.461, "mature_H5_site": 120.0, "mutant": "G", "mutation": "S125bG", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06391, "escape": 3.017, "mature_H5_site": 120.0, "mutant": "I", "mutation": "S125bI", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.758, "escape": 3.001, "mature_H5_site": 120.0, "mutant": "K", "mutation": "S125bK", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3458, "escape": 2.677, "mature_H5_site": 120.0, "mutant": "N", "mutation": "S125bN", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04187, "escape": 0.2917, "mature_H5_site": 120.0, "mutant": "P", "mutation": "S125bP", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02757, "escape": 3.459, "mature_H5_site": 120.0, "mutant": "Q", "mutation": "S125bQ", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1137, "escape": 3.253, "mature_H5_site": 120.0, "mutant": "T", "mutation": "S125bT", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05417, "escape": 3.173, "mature_H5_site": 121.0, "mutant": "D", "mutation": "S126D", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07494, "escape": 3.103, "mature_H5_site": 121.0, "mutant": "E", "mutation": "S126E", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06291, "escape": 2.852, "mature_H5_site": 121.0, "mutant": "F", "mutation": "S126F", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06282, "escape": -0.1776, "mature_H5_site": 121.0, "mutant": "G", "mutation": "S126G", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05087, "escape": 2.741, "mature_H5_site": 121.0, "mutant": "H", "mutation": "S126H", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3866, "escape": 0.07918, "mature_H5_site": 121.0, "mutant": "I", "mutation": "S126I", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4674, "escape": 2.96, "mature_H5_site": 121.0, "mutant": "K", "mutation": "S126K", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02509, "escape": 2.884, "mature_H5_site": 121.0, "mutant": "N", "mutation": "S126N", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4739, "escape": -0.1871, "mature_H5_site": 121.0, "mutant": "V", "mutation": "S126V", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3799, "escape": 3.451, "mature_H5_site": 121.0, "mutant": "W", "mutation": "S126W", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2207, "escape": 2.82, "mature_H5_site": 121.0, "mutant": "Y", "mutation": "S126Y", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.167, "escape": 0.02, "mature_H5_site": 122.0, "mutant": "C", "mutation": "W127C", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03642, "escape": -0.1535, "mature_H5_site": 122.0, "mutant": "H", "mutation": "W127H", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1673, "escape": -0.4562, "mature_H5_site": 122.0, "mutant": "L", "mutation": "W127L", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1395, "escape": -0.191, "mature_H5_site": 122.0, "mutant": "M", "mutation": "W127M", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.015, "escape": -0.4534, "mature_H5_site": 122.0, "mutant": "N", "mutation": "W127N", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.579, "escape": -0.2225, "mature_H5_site": 122.0, "mutant": "Q", "mutation": "W127Q", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3057, "escape": 0.08394, "mature_H5_site": 122.0, "mutant": "T", "mutation": "W127T", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2977, "escape": 0.2108, "mature_H5_site": 122.0, "mutant": "V", "mutation": "W127V", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3755, "escape": 0.1191, "mature_H5_site": 122.0, "mutant": "Y", "mutation": "W127Y", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02553, "escape": 0.07569, "mature_H5_site": 123.0, "mutant": "A", "mutation": "P128A", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00625, "escape": -0.4193, "mature_H5_site": 123.0, "mutant": "F", "mutation": "P128F", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08099, "escape": 0.002157, "mature_H5_site": 123.0, "mutant": "G", "mutation": "P128G", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03691, "escape": -0.4016, "mature_H5_site": 123.0, "mutant": "H", "mutation": "P128H", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4396, "escape": -0.04468, "mature_H5_site": 123.0, "mutant": "K", "mutation": "P128K", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04475, "escape": -0.1503, "mature_H5_site": 123.0, "mutant": "L", "mutation": "P128L", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05714, "escape": -0.1969, "mature_H5_site": 123.0, "mutant": "N", "mutation": "P128N", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04128, "escape": -0.1082, "mature_H5_site": 123.0, "mutant": "Q", "mutation": "P128Q", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.006287, "escape": -0.2381, "mature_H5_site": 123.0, "mutant": "R", "mutation": "P128R", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07457, "escape": -0.4025, "mature_H5_site": 123.0, "mutant": "S", "mutation": "P128S", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.449, "escape": 0.01816, "mature_H5_site": 123.0, "mutant": "T", "mutation": "P128T", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05711, "escape": -0.1466, "mature_H5_site": 123.0, "mutant": "V", "mutation": "P128V", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06982, "escape": -0.06127, "mature_H5_site": 124.0, "mutant": "A", "mutation": "N129A", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1366, "escape": -0.2246, "mature_H5_site": 124.0, "mutant": "E", "mutation": "N129E", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07839, "escape": -0.02764, "mature_H5_site": 124.0, "mutant": "G", "mutation": "N129G", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07043, "escape": -0.008697, "mature_H5_site": 124.0, "mutant": "H", "mutation": "N129H", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4981, "escape": -0.1249, "mature_H5_site": 124.0, "mutant": "I", "mutation": "N129I", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3603, "escape": 0.2117, "mature_H5_site": 124.0, "mutant": "K", "mutation": "N129K", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0653, "escape": 0.1808, "mature_H5_site": 124.0, "mutant": "M", "mutation": "N129M", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2513, "escape": 0.2119, "mature_H5_site": 124.0, "mutant": "R", "mutation": "N129R", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1108, "escape": -0.1297, "mature_H5_site": 124.0, "mutant": "S", "mutation": "N129S", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05205, "escape": -0.1396, "mature_H5_site": 124.0, "mutant": "T", "mutation": "N129T", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3927, "escape": -0.3178, "mature_H5_site": 124.0, "mutant": "Y", "mutation": "N129Y", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8341, "escape": 0.1121, "mature_H5_site": 3.0, "mutant": "F", "mutation": "I13F", "reference_site": "13", "sequential_site": 19.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05027, "escape": 0.1239, "mature_H5_site": 3.0, "mutant": "L", "mutation": "I13L", "reference_site": "13", "sequential_site": 19.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3934, "escape": -0.04619, "mature_H5_site": 3.0, "mutant": "M", "mutation": "I13M", "reference_site": "13", "sequential_site": 19.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8262, "escape": -0.01413, "mature_H5_site": 3.0, "mutant": "V", "mutation": "I13V", "reference_site": "13", "sequential_site": 19.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1142, "escape": -0.2729, "mature_H5_site": 125.0, "mutant": "F", "mutation": "H130F", "reference_site": "130", "sequential_site": 141.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0569, "escape": 0.5673, "mature_H5_site": 125.0, "mutant": "L", "mutation": "H130L", "reference_site": "130", "sequential_site": 141.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07983, "escape": -0.09976, "mature_H5_site": 125.0, "mutant": "Q", "mutation": "H130Q", "reference_site": "130", "sequential_site": 141.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.488, "escape": 1.053, "mature_H5_site": 125.0, "mutant": "W", "mutation": "H130W", "reference_site": "130", "sequential_site": 141.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02402, "escape": 0.3376, "mature_H5_site": 126.0, "mutant": "A", "mutation": "E131A", "reference_site": "131", "sequential_site": 142.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1736, "escape": 0.2704, "mature_H5_site": 126.0, "mutant": "F", "mutation": "E131F", "reference_site": "131", "sequential_site": 142.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5302, "escape": -0.2095, "mature_H5_site": 126.0, "mutant": "K", "mutation": "E131K", "reference_site": "131", "sequential_site": 142.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0582, "escape": 0.257, "mature_H5_site": 126.0, "mutant": "N", "mutation": "E131N", "reference_site": "131", "sequential_site": 142.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4504, "escape": 0.2822, "mature_H5_site": 126.0, "mutant": "R", "mutation": "E131R", "reference_site": "131", "sequential_site": 142.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0516, "escape": -0.03735, "mature_H5_site": 126.0, "mutant": "S", "mutation": "E131S", "reference_site": "131", "sequential_site": 142.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02217, "escape": 0.4013, "mature_H5_site": 127.0, "mutant": "C", "mutation": "T132C", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1347, "escape": 2.849, "mature_H5_site": 127.0, "mutant": "E", "mutation": "T132E", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7645, "escape": 0.05045, "mature_H5_site": 127.0, "mutant": "F", "mutation": "T132F", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06669, "escape": -0.2899, "mature_H5_site": 127.0, "mutant": "G", "mutation": "T132G", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6061, "escape": 1.242, "mature_H5_site": 127.0, "mutant": "H", "mutation": "T132H", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5881, "escape": 0.08275, "mature_H5_site": 127.0, "mutant": "I", "mutation": "T132I", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1391, "escape": 2.412, "mature_H5_site": 127.0, "mutant": "K", "mutation": "T132K", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.523, "escape": -0.2476, "mature_H5_site": 127.0, "mutant": "L", "mutation": "T132L", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00575, "escape": -0.00613, "mature_H5_site": 127.0, "mutant": "M", "mutation": "T132M", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2738, "escape": 1.989, "mature_H5_site": 127.0, "mutant": "N", "mutation": "T132N", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3375, "escape": 0.2852, "mature_H5_site": 127.0, "mutant": "Q", "mutation": "T132Q", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08433, "escape": 2.339, "mature_H5_site": 127.0, "mutant": "R", "mutation": "T132R", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01629, "escape": -1.529, "mature_H5_site": 127.0, "mutant": "S", "mutation": "T132S", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1557, "escape": -0.288, "mature_H5_site": 127.0, "mutant": "V", "mutation": "T132V", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1217, "escape": 2.601, "mature_H5_site": 127.0, "mutant": "W", "mutation": "T132W", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06721, "escape": 2.439, "mature_H5_site": 128.0, "mutant": "E", "mutation": "S133E", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0365, "escape": -0.2508, "mature_H5_site": 128.0, "mutant": "H", "mutation": "S133H", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1876, "escape": 1.561, "mature_H5_site": 128.0, "mutant": "I", "mutation": "S133I", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01511, "escape": 0.3891, "mature_H5_site": 128.0, "mutant": "K", "mutation": "S133K", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4726, "escape": 1.565, "mature_H5_site": 128.0, "mutant": "N", "mutation": "S133N", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4765, "escape": 0.05845, "mature_H5_site": 128.0, "mutant": "R", "mutation": "S133R", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0368, "escape": 0.1272, "mature_H5_site": 128.0, "mutant": "T", "mutation": "S133T", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09649, "escape": 1.308, "mature_H5_site": 128.0, "mutant": "Y", "mutation": "S133Y", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1198, "escape": -0.2628, "mature_H5_site": 129.0, "mutant": "D", "mutation": "L133aD", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03465, "escape": -0.2023, "mature_H5_site": 129.0, "mutant": "E", "mutation": "L133aE", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.57, "escape": 0.1401, "mature_H5_site": 129.0, "mutant": "F", "mutation": "L133aF", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1576, "escape": 0.08441, "mature_H5_site": 129.0, "mutant": "G", "mutation": "L133aG", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03911, "escape": -0.005001, "mature_H5_site": 129.0, "mutant": "H", "mutation": "L133aH", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.42, "escape": 0.4757, "mature_H5_site": 129.0, "mutant": "K", "mutation": "L133aK", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09832, "escape": -0.5415, "mature_H5_site": 129.0, "mutant": "M", "mutation": "L133aM", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02306, "escape": -0.0539, "mature_H5_site": 129.0, "mutant": "N", "mutation": "L133aN", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02408, "escape": -0.2158, "mature_H5_site": 129.0, "mutant": "P", "mutation": "L133aP", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.234, "escape": 0.2031, "mature_H5_site": 129.0, "mutant": "Q", "mutation": "L133aQ", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5591, "escape": 0.1502, "mature_H5_site": 129.0, "mutant": "R", "mutation": "L133aR", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.795, "escape": -0.185, "mature_H5_site": 129.0, "mutant": "S", "mutation": "L133aS", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1648, "escape": 0.1362, "mature_H5_site": 129.0, "mutant": "V", "mutation": "L133aV", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2945, "escape": -0.04079, "mature_H5_site": 129.0, "mutant": "W", "mutation": "L133aW", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.06, "escape": -0.2993, "mature_H5_site": 130.0, "mutant": "A", "mutation": "G134A", "reference_site": "134", "sequential_site": 146.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0584, "escape": -0.1653, "mature_H5_site": 131.0, "mutant": "A", "mutation": "V135A", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1314, "escape": -0.204, "mature_H5_site": 131.0, "mutant": "D", "mutation": "V135D", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06537, "escape": -0.3434, "mature_H5_site": 131.0, "mutant": "E", "mutation": "V135E", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1621, "escape": -0.4158, "mature_H5_site": 131.0, "mutant": "F", "mutation": "V135F", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1416, "escape": -0.05025, "mature_H5_site": 131.0, "mutant": "H", "mutation": "V135H", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03009, "escape": -0.4169, "mature_H5_site": 131.0, "mutant": "I", "mutation": "V135I", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.19, "escape": -0.397, "mature_H5_site": 131.0, "mutant": "M", "mutation": "V135M", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1167, "escape": -0.4056, "mature_H5_site": 131.0, "mutant": "Q", "mutation": "V135Q", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06751, "escape": 0.6407, "mature_H5_site": 131.0, "mutant": "T", "mutation": "V135T", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7648, "escape": -0.5418, "mature_H5_site": 131.0, "mutant": "W", "mutation": "V135W", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4091, "escape": -0.2106, "mature_H5_site": 132.0, "mutant": "T", "mutation": "S136T", "reference_site": "136", "sequential_site": 148.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06001, "escape": -0.3072, "mature_H5_site": 133.0, "mutant": "C", "mutation": "A137C", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4466, "escape": -0.2966, "mature_H5_site": 133.0, "mutant": "D", "mutation": "A137D", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7334, "escape": -0.3961, "mature_H5_site": 133.0, "mutant": "E", "mutation": "A137E", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04292, "escape": -0.3528, "mature_H5_site": 133.0, "mutant": "F", "mutation": "A137F", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5479, "escape": -0.309, "mature_H5_site": 133.0, "mutant": "K", "mutation": "A137K", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05262, "escape": -0.4186, "mature_H5_site": 133.0, "mutant": "L", "mutation": "A137L", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04101, "escape": -0.2161, "mature_H5_site": 133.0, "mutant": "M", "mutation": "A137M", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.425, "escape": -0.2175, "mature_H5_site": 133.0, "mutant": "R", "mutation": "A137R", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02125, "escape": -0.5453, "mature_H5_site": 133.0, "mutant": "S", "mutation": "A137S", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1539, "escape": -0.7616, "mature_H5_site": 133.0, "mutant": "T", "mutation": "A137T", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4816, "escape": -0.3627, "mature_H5_site": 133.0, "mutant": "V", "mutation": "A137V", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06102, "escape": -0.4745, "mature_H5_site": 133.0, "mutant": "W", "mutation": "A137W", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.296, "escape": -0.2026, "mature_H5_site": 134.0, "mutant": "I", "mutation": "A138I", "reference_site": "138", "sequential_site": 150.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04583, "escape": -0.3034, "mature_H5_site": 134.0, "mutant": "S", "mutation": "A138S", "reference_site": "138", "sequential_site": 150.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1186, "escape": -0.6244, "mature_H5_site": 134.0, "mutant": "T", "mutation": "A138T", "reference_site": "138", "sequential_site": 150.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.014, "escape": -0.7718, "mature_H5_site": 134.0, "mutant": "V", "mutation": "A138V", "reference_site": "138", "sequential_site": 150.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.101, "escape": 1.638, "mature_H5_site": 135.0, "mutant": "G", "mutation": "C139G", "reference_site": "139", "sequential_site": 151.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03188, "escape": 0.1645, "mature_H5_site": 136.0, "mutant": "C", "mutation": "P140C", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.009375, "escape": -0.2321, "mature_H5_site": 136.0, "mutant": "D", "mutation": "P140D", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07475, "escape": 0.6646, "mature_H5_site": 136.0, "mutant": "F", "mutation": "P140F", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06391, "escape": -0.4702, "mature_H5_site": 136.0, "mutant": "H", "mutation": "P140H", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0757, "escape": 0.2739, "mature_H5_site": 136.0, "mutant": "K", "mutation": "P140K", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3775, "escape": 0.06179, "mature_H5_site": 136.0, "mutant": "L", "mutation": "P140L", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3911, "escape": 0.1027, "mature_H5_site": 136.0, "mutant": "M", "mutation": "P140M", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4926, "escape": 0.01294, "mature_H5_site": 136.0, "mutant": "N", "mutation": "P140N", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02771, "escape": 0.1996, "mature_H5_site": 136.0, "mutant": "R", "mutation": "P140R", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01783, "escape": -0.05645, "mature_H5_site": 136.0, "mutant": "S", "mutation": "P140S", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1215, "escape": 0.276, "mature_H5_site": 136.0, "mutant": "T", "mutation": "P140T", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.158, "escape": 0.03996, "mature_H5_site": 136.0, "mutant": "V", "mutation": "P140V", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05672, "escape": 2.512, "mature_H5_site": 137.0, "mutant": "A", "mutation": "Y141A", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.19, "escape": 2.025, "mature_H5_site": 137.0, "mutant": "C", "mutation": "Y141C", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05149, "escape": 2.837, "mature_H5_site": 137.0, "mutant": "D", "mutation": "Y141D", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2139, "escape": 3.097, "mature_H5_site": 137.0, "mutant": "E", "mutation": "Y141E", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1863, "escape": 0.07941, "mature_H5_site": 137.0, "mutant": "F", "mutation": "Y141F", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.003315, "escape": 2.734, "mature_H5_site": 137.0, "mutant": "I", "mutation": "Y141I", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1364, "escape": 2.742, "mature_H5_site": 137.0, "mutant": "K", "mutation": "Y141K", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02181, "escape": 2.025, "mature_H5_site": 137.0, "mutant": "N", "mutation": "Y141N", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04773, "escape": 0.05047, "mature_H5_site": 137.0, "mutant": "P", "mutation": "Y141P", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3758, "escape": 2.949, "mature_H5_site": 137.0, "mutant": "R", "mutation": "Y141R", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6931, "escape": 1.465, "mature_H5_site": 137.0, "mutant": "S", "mutation": "Y141S", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4748, "escape": 1.05, "mature_H5_site": 137.0, "mutant": "T", "mutation": "Y141T", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.003485, "escape": -0.5806, "mature_H5_site": 138.0, "mutant": "E", "mutation": "Q142E", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03895, "escape": 0.1558, "mature_H5_site": 138.0, "mutant": "G", "mutation": "Q142G", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07071, "escape": 0.3195, "mature_H5_site": 138.0, "mutant": "H", "mutation": "Q142H", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05583, "escape": -0.02341, "mature_H5_site": 138.0, "mutant": "I", "mutation": "Q142I", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06843, "escape": -0.06955, "mature_H5_site": 138.0, "mutant": "M", "mutation": "Q142M", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05586, "escape": 0.04341, "mature_H5_site": 138.0, "mutant": "N", "mutation": "Q142N", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9557, "escape": 0.015, "mature_H5_site": 138.0, "mutant": "P", "mutation": "Q142P", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07433, "escape": -0.284, "mature_H5_site": 138.0, "mutant": "S", "mutation": "Q142S", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03931, "escape": -0.2624, "mature_H5_site": 138.0, "mutant": "V", "mutation": "Q142V", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2743, "escape": -0.1882, "mature_H5_site": 138.0, "mutant": "W", "mutation": "Q142W", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02496, "escape": 0.02104, "mature_H5_site": 138.0, "mutant": "Y", "mutation": "Q142Y", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0359, "escape": -0.3209, "mature_H5_site": 139.0, "mutant": "E", "mutation": "G143E", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3977, "escape": -0.2634, "mature_H5_site": 139.0, "mutant": "F", "mutation": "G143F", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8786, "escape": -0.292, "mature_H5_site": 139.0, "mutant": "H", "mutation": "G143H", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2626, "escape": 0.4624, "mature_H5_site": 139.0, "mutant": "K", "mutation": "G143K", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06516, "escape": -0.004824, "mature_H5_site": 139.0, "mutant": "L", "mutation": "G143L", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1142, "escape": -0.01871, "mature_H5_site": 139.0, "mutant": "N", "mutation": "G143N", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.009535, "escape": 0.1753, "mature_H5_site": 139.0, "mutant": "R", "mutation": "G143R", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1981, "escape": -0.003142, "mature_H5_site": 139.0, "mutant": "S", "mutation": "G143S", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3401, "escape": 0.04412, "mature_H5_site": 139.0, "mutant": "V", "mutation": "G143V", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1149, "escape": 0.07651, "mature_H5_site": 139.0, "mutant": "W", "mutation": "G143W", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00378, "escape": 0.01326, "mature_H5_site": 139.0, "mutant": "Y", "mutation": "G143Y", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4667, "escape": 0.1597, "mature_H5_site": 140.0, "mutant": "D", "mutation": "A144D", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07616, "escape": 0.08225, "mature_H5_site": 140.0, "mutant": "E", "mutation": "A144E", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.403, "escape": -0.1619, "mature_H5_site": 140.0, "mutant": "F", "mutation": "A144F", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01749, "escape": 0.07977, "mature_H5_site": 140.0, "mutant": "G", "mutation": "A144G", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3443, "escape": -0.002209, "mature_H5_site": 140.0, "mutant": "H", "mutation": "A144H", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5277, "escape": 1.546, "mature_H5_site": 140.0, "mutant": "I", "mutation": "A144I", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.293, "escape": -0.05197, "mature_H5_site": 140.0, "mutant": "K", "mutation": "A144K", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.002535, "escape": 0.08968, "mature_H5_site": 140.0, "mutant": "M", "mutation": "A144M", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04423, "escape": -0.3044, "mature_H5_site": 140.0, "mutant": "N", "mutation": "A144N", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3302, "escape": 0.08403, "mature_H5_site": 140.0, "mutant": "P", "mutation": "A144P", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00594, "escape": -0.1928, "mature_H5_site": 140.0, "mutant": "Q", "mutation": "A144Q", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1412, "escape": 0.2822, "mature_H5_site": 140.0, "mutant": "R", "mutation": "A144R", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04508, "escape": -0.257, "mature_H5_site": 140.0, "mutant": "S", "mutation": "A144S", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2714, "escape": 0.7498, "mature_H5_site": 140.0, "mutant": "T", "mutation": "A144T", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00038, "escape": 0.3422, "mature_H5_site": 140.0, "mutant": "V", "mutation": "A144V", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2538, "escape": -0.3101, "mature_H5_site": 140.0, "mutant": "W", "mutation": "A144W", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3796, "escape": -0.3844, "mature_H5_site": 140.0, "mutant": "Y", "mutation": "A144Y", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03934, "escape": -0.07055, "mature_H5_site": 141.0, "mutant": "I", "mutation": "P145I", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.704, "escape": 0.6873, "mature_H5_site": 141.0, "mutant": "L", "mutation": "P145L", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.045, "escape": 1.081, "mature_H5_site": 141.0, "mutant": "M", "mutation": "P145M", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.513, "escape": 0.1997, "mature_H5_site": 141.0, "mutant": "N", "mutation": "P145N", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1068, "escape": 0.3174, "mature_H5_site": 141.0, "mutant": "Q", "mutation": "P145Q", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8528, "escape": 1.147, "mature_H5_site": 141.0, "mutant": "R", "mutation": "P145R", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07675, "escape": 0.3212, "mature_H5_site": 141.0, "mutant": "T", "mutation": "P145T", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2869, "escape": -0.08946, "mature_H5_site": 141.0, "mutant": "V", "mutation": "P145V", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0126, "escape": -0.001839, "mature_H5_site": 141.0, "mutant": "W", "mutation": "P145W", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01503, "escape": 3.027, "mature_H5_site": 142.0, "mutant": "F", "mutation": "S146F", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.134, "escape": 2.146, "mature_H5_site": 142.0, "mutant": "G", "mutation": "S146G", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04789, "escape": 2.841, "mature_H5_site": 142.0, "mutant": "H", "mutation": "S146H", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8817, "escape": -0.05139, "mature_H5_site": 142.0, "mutant": "I", "mutation": "S146I", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03554, "escape": 2.859, "mature_H5_site": 142.0, "mutant": "L", "mutation": "S146L", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3524, "escape": 2.792, "mature_H5_site": 142.0, "mutant": "N", "mutation": "S146N", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09551, "escape": 2.786, "mature_H5_site": 142.0, "mutant": "R", "mutation": "S146R", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3361, "escape": -0.3022, "mature_H5_site": 142.0, "mutant": "T", "mutation": "S146T", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.917, "escape": 0.1013, "mature_H5_site": 143.0, "mutant": "H", "mutation": "F147H", "reference_site": "147", "sequential_site": 159.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8665, "escape": 1.114, "mature_H5_site": 143.0, "mutant": "L", "mutation": "F147L", "reference_site": "147", "sequential_site": 159.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3293, "escape": 0.8014, "mature_H5_site": 143.0, "mutant": "M", "mutation": "F147M", "reference_site": "147", "sequential_site": 159.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.869, "escape": -0.1516, "mature_H5_site": 143.0, "mutant": "W", "mutation": "F147W", "reference_site": "147", "sequential_site": 159.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4523, "escape": -0.5212, "mature_H5_site": 144.0, "mutant": "M", "mutation": "F148M", "reference_site": "148", "sequential_site": 160.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9477, "escape": 0.08242, "mature_H5_site": 144.0, "mutant": "N", "mutation": "F148N", "reference_site": "148", "sequential_site": 160.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.119, "escape": -0.1023, "mature_H5_site": 144.0, "mutant": "Q", "mutation": "F148Q", "reference_site": "148", "sequential_site": 160.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.186, "escape": -0.2968, "mature_H5_site": 144.0, "mutant": "V", "mutation": "F148V", "reference_site": "148", "sequential_site": 160.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.278, "escape": -0.4586, "mature_H5_site": 144.0, "mutant": "W", "mutation": "F148W", "reference_site": "148", "sequential_site": 160.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03205, "escape": 3.635, "mature_H5_site": 145.0, "mutant": "A", "mutation": "R149A", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1535, "escape": 3.633, "mature_H5_site": 145.0, "mutant": "C", "mutation": "R149C", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2118, "escape": 3.081, "mature_H5_site": 145.0, "mutant": "F", "mutation": "R149F", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.007755, "escape": 3.379, "mature_H5_site": 145.0, "mutant": "G", "mutation": "R149G", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.162, "escape": 3.557, "mature_H5_site": 145.0, "mutant": "K", "mutation": "R149K", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07247, "escape": 2.962, "mature_H5_site": 145.0, "mutant": "M", "mutation": "R149M", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07749, "escape": 3.109, "mature_H5_site": 145.0, "mutant": "Q", "mutation": "R149Q", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07515, "escape": 3.156, "mature_H5_site": 145.0, "mutant": "T", "mutation": "R149T", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04122, "escape": 2.396, "mature_H5_site": 145.0, "mutant": "W", "mutation": "R149W", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07486, "escape": 2.892, "mature_H5_site": 145.0, "mutant": "Y", "mutation": "R149Y", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2574, "escape": -0.115, "mature_H5_site": 5.0, "mutant": "C", "mutation": "I15C", "reference_site": "15", "sequential_site": 21.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.427, "escape": -0.3055, "mature_H5_site": 5.0, "mutant": "L", "mutation": "I15L", "reference_site": "15", "sequential_site": 21.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3174, "escape": -0.103, "mature_H5_site": 5.0, "mutant": "T", "mutation": "I15T", "reference_site": "15", "sequential_site": 21.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.366, "escape": -0.1348, "mature_H5_site": 146.0, "mutant": "A", "mutation": "N150A", "reference_site": "150", "sequential_site": 162.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4099, "escape": -0.2803, "mature_H5_site": 146.0, "mutant": "I", "mutation": "N150I", "reference_site": "150", "sequential_site": 162.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04587, "escape": -0.01706, "mature_H5_site": 146.0, "mutant": "L", "mutation": "N150L", "reference_site": "150", "sequential_site": 162.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04971, "escape": 0.02664, "mature_H5_site": 146.0, "mutant": "S", "mutation": "N150S", "reference_site": "150", "sequential_site": 162.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06692, "escape": -0.3149, "mature_H5_site": 146.0, "mutant": "V", "mutation": "N150V", "reference_site": "150", "sequential_site": 162.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.254, "escape": 1.182, "mature_H5_site": 146.0, "mutant": "Y", "mutation": "N150Y", "reference_site": "150", "sequential_site": 162.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0663, "escape": 0.3009, "mature_H5_site": 147.0, "mutant": "C", "mutation": "V151C", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.163, "escape": 0.007245, "mature_H5_site": 147.0, "mutant": "E", "mutation": "V151E", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05281, "escape": -0.0131, "mature_H5_site": 147.0, "mutant": "G", "mutation": "V151G", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.332, "escape": 0.7508, "mature_H5_site": 147.0, "mutant": "H", "mutation": "V151H", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0214, "escape": 0.1915, "mature_H5_site": 147.0, "mutant": "I", "mutation": "V151I", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03836, "escape": 0.2419, "mature_H5_site": 147.0, "mutant": "L", "mutation": "V151L", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03176, "escape": 0.3002, "mature_H5_site": 147.0, "mutant": "M", "mutation": "V151M", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4025, "escape": 0.2795, "mature_H5_site": 147.0, "mutant": "Q", "mutation": "V151Q", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02103, "escape": 0.09144, "mature_H5_site": 147.0, "mutant": "S", "mutation": "V151S", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.954, "escape": 2.424, "mature_H5_site": 147.0, "mutant": "Y", "mutation": "V151Y", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5331, "escape": -0.3487, "mature_H5_site": 148.0, "mutant": "A", "mutation": "V152A", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02353, "escape": 1.751, "mature_H5_site": 148.0, "mutant": "D", "mutation": "V152D", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.536, "escape": 2.434, "mature_H5_site": 148.0, "mutant": "E", "mutation": "V152E", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2452, "escape": 0.9141, "mature_H5_site": 148.0, "mutant": "G", "mutation": "V152G", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00141, "escape": 2.122, "mature_H5_site": 148.0, "mutant": "L", "mutation": "V152L", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06008, "escape": 1.606, "mature_H5_site": 148.0, "mutant": "M", "mutation": "V152M", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07074, "escape": 1.487, "mature_H5_site": 148.0, "mutant": "N", "mutation": "V152N", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.305, "escape": -0.2263, "mature_H5_site": 148.0, "mutant": "Q", "mutation": "V152Q", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3185, "escape": 0.3235, "mature_H5_site": 150.0, "mutant": "A", "mutation": "L154A", "reference_site": "154", "sequential_site": 166.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01898, "escape": -0.01112, "mature_H5_site": 150.0, "mutant": "I", "mutation": "L154I", "reference_site": "154", "sequential_site": 166.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2172, "escape": -0.1374, "mature_H5_site": 150.0, "mutant": "M", "mutation": "L154M", "reference_site": "154", "sequential_site": 166.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08693, "escape": -0.2894, "mature_H5_site": 150.0, "mutant": "V", "mutation": "L154V", "reference_site": "154", "sequential_site": 166.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9856, "escape": -0.3034, "mature_H5_site": 151.0, "mutant": "A", "mutation": "I155A", "reference_site": "155", "sequential_site": 167.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06386, "escape": -0.5739, "mature_H5_site": 151.0, "mutant": "C", "mutation": "I155C", "reference_site": "155", "sequential_site": 167.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06906, "escape": -0.2904, "mature_H5_site": 151.0, "mutant": "L", "mutation": "I155L", "reference_site": "155", "sequential_site": 167.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.283, "escape": -0.2168, "mature_H5_site": 151.0, "mutant": "M", "mutation": "I155M", "reference_site": "155", "sequential_site": 167.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1159, "escape": -0.2387, "mature_H5_site": 151.0, "mutant": "N", "mutation": "I155N", "reference_site": "155", "sequential_site": 167.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.106, "escape": -0.4177, "mature_H5_site": 151.0, "mutant": "S", "mutation": "I155S", "reference_site": "155", "sequential_site": 167.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0539, "escape": 0.3626, "mature_H5_site": 151.0, "mutant": "V", "mutation": "I155V", "reference_site": "155", "sequential_site": 167.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06617, "escape": -0.3341, "mature_H5_site": 152.0, "mutant": "C", "mutation": "K156C", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.347, "escape": -0.3704, "mature_H5_site": 152.0, "mutant": "G", "mutation": "K156G", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7739, "escape": 0.152, "mature_H5_site": 152.0, "mutant": "I", "mutation": "K156I", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04545, "escape": -0.0168, "mature_H5_site": 152.0, "mutant": "M", "mutation": "K156M", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1758, "escape": -0.5739, "mature_H5_site": 152.0, "mutant": "N", "mutation": "K156N", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1166, "escape": -0.008837, "mature_H5_site": 152.0, "mutant": "Q", "mutation": "K156Q", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05433, "escape": 0.4424, "mature_H5_site": 152.0, "mutant": "R", "mutation": "K156R", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04606, "escape": -0.2449, "mature_H5_site": 152.0, "mutant": "S", "mutation": "K156S", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5045, "escape": -0.056, "mature_H5_site": 152.0, "mutant": "T", "mutation": "K156T", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4253, "escape": -0.1212, "mature_H5_site": 152.0, "mutant": "V", "mutation": "K156V", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00304, "escape": 0.4071, "mature_H5_site": 153.0, "mutant": "A", "mutation": "K157A", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04705, "escape": 0.7418, "mature_H5_site": 153.0, "mutant": "E", "mutation": "K157E", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05504, "escape": 0.4907, "mature_H5_site": 153.0, "mutant": "F", "mutation": "K157F", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01434, "escape": 0.1592, "mature_H5_site": 153.0, "mutant": "H", "mutation": "K157H", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7618, "escape": 0.1185, "mature_H5_site": 153.0, "mutant": "M", "mutation": "K157M", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3925, "escape": -0.2259, "mature_H5_site": 153.0, "mutant": "N", "mutation": "K157N", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1694, "escape": 0.3568, "mature_H5_site": 153.0, "mutant": "T", "mutation": "K157T", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6327, "escape": 0.4257, "mature_H5_site": 153.0, "mutant": "W", "mutation": "K157W", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03411, "escape": 0.3053, "mature_H5_site": 153.0, "mutant": "Y", "mutation": "K157Y", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2676, "escape": -0.192, "mature_H5_site": 154.0, "mutant": "A", "mutation": "N158A", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00687, "escape": -0.204, "mature_H5_site": 154.0, "mutant": "D", "mutation": "N158D", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02899, "escape": -0.0239, "mature_H5_site": 154.0, "mutant": "E", "mutation": "N158E", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0964, "escape": 0.008529, "mature_H5_site": 154.0, "mutant": "F", "mutation": "N158F", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0458, "escape": 0.01268, "mature_H5_site": 154.0, "mutant": "G", "mutation": "N158G", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1074, "escape": 0.0946, "mature_H5_site": 154.0, "mutant": "H", "mutation": "N158H", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2683, "escape": -0.1135, "mature_H5_site": 154.0, "mutant": "I", "mutation": "N158I", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.133, "escape": 0.05275, "mature_H5_site": 154.0, "mutant": "K", "mutation": "N158K", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08541, "escape": 0.1194, "mature_H5_site": 154.0, "mutant": "L", "mutation": "N158L", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2995, "escape": 0.1546, "mature_H5_site": 154.0, "mutant": "R", "mutation": "N158R", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00284, "escape": -0.06227, "mature_H5_site": 154.0, "mutant": "S", "mutation": "N158S", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01745, "escape": 0.2812, "mature_H5_site": 154.0, "mutant": "W", "mutation": "N158W", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7079, "escape": -0.2307, "mature_H5_site": 155.0, "mutant": "F", "mutation": "D159F", "reference_site": "159", "sequential_site": 171.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.346, "escape": -0.03179, "mature_H5_site": 155.0, "mutant": "L", "mutation": "D159L", "reference_site": "159", "sequential_site": 171.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5137, "escape": -0.2516, "mature_H5_site": 155.0, "mutant": "N", "mutation": "D159N", "reference_site": "159", "sequential_site": 171.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3926, "escape": 0.3888, "mature_H5_site": 155.0, "mutant": "Q", "mutation": "D159Q", "reference_site": "159", "sequential_site": 171.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.594, "escape": 0.2343, "mature_H5_site": 155.0, "mutant": "W", "mutation": "D159W", "reference_site": "159", "sequential_site": 171.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8296, "escape": -0.2102, "mature_H5_site": 155.0, "mutant": "Y", "mutation": "D159Y", "reference_site": "159", "sequential_site": 171.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.495, "escape": -0.1273, "mature_H5_site": 156.0, "mutant": "C", "mutation": "A160C", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4254, "escape": 0.05697, "mature_H5_site": 156.0, "mutant": "E", "mutation": "A160E", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1028, "escape": 0.1523, "mature_H5_site": 156.0, "mutant": "F", "mutation": "A160F", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01629, "escape": 0.009308, "mature_H5_site": 156.0, "mutant": "H", "mutation": "A160H", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5497, "escape": 0.03496, "mature_H5_site": 156.0, "mutant": "K", "mutation": "A160K", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07211, "escape": -0.05063, "mature_H5_site": 156.0, "mutant": "M", "mutation": "A160M", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3024, "escape": -0.01251, "mature_H5_site": 156.0, "mutant": "N", "mutation": "A160N", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1073, "escape": 0.1528, "mature_H5_site": 156.0, "mutant": "Q", "mutation": "A160Q", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0654, "escape": -0.2296, "mature_H5_site": 156.0, "mutant": "S", "mutation": "A160S", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03709, "escape": 0.05981, "mature_H5_site": 156.0, "mutant": "T", "mutation": "A160T", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2059, "escape": 0.1593, "mature_H5_site": 156.0, "mutant": "V", "mutation": "A160V", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03065, "escape": 0.2008, "mature_H5_site": 156.0, "mutant": "W", "mutation": "A160W", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.179, "escape": -0.2812, "mature_H5_site": 157.0, "mutant": "W", "mutation": "Y161W", "reference_site": "161", "sequential_site": 173.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.414, "escape": -0.2067, "mature_H5_site": 158.0, "mutant": "A", "mutation": "P162A", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5694, "escape": 0.05823, "mature_H5_site": 158.0, "mutant": "E", "mutation": "P162E", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2397, "escape": 0.00524, "mature_H5_site": 158.0, "mutant": "G", "mutation": "P162G", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5207, "escape": -0.2569, "mature_H5_site": 158.0, "mutant": "H", "mutation": "P162H", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02312, "escape": 0.1418, "mature_H5_site": 158.0, "mutant": "K", "mutation": "P162K", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4015, "escape": -0.2844, "mature_H5_site": 158.0, "mutant": "M", "mutation": "P162M", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02878, "escape": 0.1727, "mature_H5_site": 158.0, "mutant": "N", "mutation": "P162N", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3961, "escape": 0.1981, "mature_H5_site": 158.0, "mutant": "R", "mutation": "P162R", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1376, "escape": -0.01149, "mature_H5_site": 158.0, "mutant": "S", "mutation": "P162S", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6296, "escape": -0.01034, "mature_H5_site": 158.0, "mutant": "T", "mutation": "P162T", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5012, "escape": -0.2983, "mature_H5_site": 158.0, "mutant": "V", "mutation": "P162V", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3744, "escape": -0.1477, "mature_H5_site": 159.0, "mutant": "A", "mutation": "T163A", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06918, "escape": -0.2385, "mature_H5_site": 159.0, "mutant": "D", "mutation": "T163D", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.032, "escape": -0.2735, "mature_H5_site": 159.0, "mutant": "E", "mutation": "T163E", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4447, "escape": -0.1108, "mature_H5_site": 159.0, "mutant": "G", "mutation": "T163G", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1646, "escape": -0.1638, "mature_H5_site": 159.0, "mutant": "H", "mutation": "T163H", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01755, "escape": 0.08938, "mature_H5_site": 159.0, "mutant": "I", "mutation": "T163I", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06674, "escape": -0.207, "mature_H5_site": 159.0, "mutant": "K", "mutation": "T163K", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03057, "escape": 0.05088, "mature_H5_site": 159.0, "mutant": "M", "mutation": "T163M", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1049, "escape": -0.4705, "mature_H5_site": 159.0, "mutant": "N", "mutation": "T163N", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07433, "escape": -0.1046, "mature_H5_site": 159.0, "mutant": "P", "mutation": "T163P", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09958, "escape": -0.1752, "mature_H5_site": 159.0, "mutant": "Q", "mutation": "T163Q", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01879, "escape": -0.2128, "mature_H5_site": 159.0, "mutant": "V", "mutation": "T163V", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01324, "escape": -0.136, "mature_H5_site": 159.0, "mutant": "W", "mutation": "T163W", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06499, "escape": 1.642, "mature_H5_site": 160.0, "mutant": "A", "mutation": "I164A", "reference_site": "164", "sequential_site": 176.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1712, "escape": -0.1006, "mature_H5_site": 160.0, "mutant": "H", "mutation": "I164H", "reference_site": "164", "sequential_site": 176.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.936, "escape": -0.2082, "mature_H5_site": 160.0, "mutant": "K", "mutation": "I164K", "reference_site": "164", "sequential_site": 176.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6973, "escape": 0.07836, "mature_H5_site": 160.0, "mutant": "W", "mutation": "I164W", "reference_site": "164", "sequential_site": 176.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.667, "escape": -0.0603, "mature_H5_site": 161.0, "mutant": "A", "mutation": "K165A", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3008, "escape": -0.3058, "mature_H5_site": 161.0, "mutant": "C", "mutation": "K165C", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0386, "escape": -0.201, "mature_H5_site": 161.0, "mutant": "D", "mutation": "K165D", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1588, "escape": -0.2321, "mature_H5_site": 161.0, "mutant": "E", "mutation": "K165E", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01622, "escape": 0.06339, "mature_H5_site": 161.0, "mutant": "F", "mutation": "K165F", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01079, "escape": 0.1193, "mature_H5_site": 161.0, "mutant": "H", "mutation": "K165H", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04642, "escape": -0.03859, "mature_H5_site": 161.0, "mutant": "I", "mutation": "K165I", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7407, "escape": -0.01666, "mature_H5_site": 161.0, "mutant": "M", "mutation": "K165M", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05429, "escape": -0.09526, "mature_H5_site": 161.0, "mutant": "N", "mutation": "K165N", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07213, "escape": -0.1, "mature_H5_site": 161.0, "mutant": "Q", "mutation": "K165Q", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07884, "escape": 0.1014, "mature_H5_site": 161.0, "mutant": "R", "mutation": "K165R", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04617, "escape": 0.1271, "mature_H5_site": 161.0, "mutant": "V", "mutation": "K165V", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0739, "escape": -0.03619, "mature_H5_site": 161.0, "mutant": "Y", "mutation": "K165Y", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.235, "escape": -0.4028, "mature_H5_site": 162.0, "mutant": "A", "mutation": "I166A", "reference_site": "166", "sequential_site": 178.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03416, "escape": 0.0865, "mature_H5_site": 162.0, "mutant": "L", "mutation": "I166L", "reference_site": "166", "sequential_site": 178.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03975, "escape": -0.06184, "mature_H5_site": 162.0, "mutant": "S", "mutation": "I166S", "reference_site": "166", "sequential_site": 178.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06066, "escape": 1.733, "mature_H5_site": 162.0, "mutant": "W", "mutation": "I166W", "reference_site": "166", "sequential_site": 178.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01236, "escape": -0.04267, "mature_H5_site": 163.0, "mutant": "A", "mutation": "S167A", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6672, "escape": -0.03617, "mature_H5_site": 163.0, "mutant": "C", "mutation": "S167C", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01852, "escape": -0.1935, "mature_H5_site": 163.0, "mutant": "D", "mutation": "S167D", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00225, "escape": 0.02844, "mature_H5_site": 163.0, "mutant": "E", "mutation": "S167E", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.495, "escape": -0.3648, "mature_H5_site": 163.0, "mutant": "F", "mutation": "S167F", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1599, "escape": -0.2283, "mature_H5_site": 163.0, "mutant": "G", "mutation": "S167G", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6193, "escape": -0.2393, "mature_H5_site": 163.0, "mutant": "I", "mutation": "S167I", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1715, "escape": 0.004536, "mature_H5_site": 163.0, "mutant": "K", "mutation": "S167K", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1144, "escape": -0.6214, "mature_H5_site": 163.0, "mutant": "L", "mutation": "S167L", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05107, "escape": -0.0755, "mature_H5_site": 163.0, "mutant": "M", "mutation": "S167M", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1458, "escape": -0.5564, "mature_H5_site": 163.0, "mutant": "N", "mutation": "S167N", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01687, "escape": -0.6995, "mature_H5_site": 163.0, "mutant": "Q", "mutation": "S167Q", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3122, "escape": -0.3585, "mature_H5_site": 163.0, "mutant": "R", "mutation": "S167R", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1629, "escape": -0.5949, "mature_H5_site": 163.0, "mutant": "T", "mutation": "S167T", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00976, "escape": -0.1388, "mature_H5_site": 163.0, "mutant": "V", "mutation": "S167V", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1233, "escape": -0.08439, "mature_H5_site": 163.0, "mutant": "W", "mutation": "S167W", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03838, "escape": -0.1734, "mature_H5_site": 163.0, "mutant": "Y", "mutation": "S167Y", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1239, "escape": 0.4901, "mature_H5_site": 165.0, "mutant": "A", "mutation": "N169A", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8375, "escape": 0.2985, "mature_H5_site": 165.0, "mutant": "D", "mutation": "N169D", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.044, "escape": 0.4672, "mature_H5_site": 165.0, "mutant": "E", "mutation": "N169E", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8632, "escape": -0.1655, "mature_H5_site": 165.0, "mutant": "F", "mutation": "N169F", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6752, "escape": -0.08828, "mature_H5_site": 165.0, "mutant": "G", "mutation": "N169G", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3942, "escape": 0.4412, "mature_H5_site": 165.0, "mutant": "H", "mutation": "N169H", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5725, "escape": 0.0341, "mature_H5_site": 165.0, "mutant": "I", "mutation": "N169I", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5608, "escape": 0.427, "mature_H5_site": 165.0, "mutant": "K", "mutation": "N169K", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1149, "escape": 0.3557, "mature_H5_site": 165.0, "mutant": "L", "mutation": "N169L", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.62, "escape": 0.4631, "mature_H5_site": 165.0, "mutant": "M", "mutation": "N169M", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9624, "escape": -0.09284, "mature_H5_site": 165.0, "mutant": "P", "mutation": "N169P", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4913, "escape": 0.4797, "mature_H5_site": 165.0, "mutant": "Q", "mutation": "N169Q", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8052, "escape": 0.1466, "mature_H5_site": 165.0, "mutant": "R", "mutation": "N169R", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3594, "escape": 0.2676, "mature_H5_site": 165.0, "mutant": "S", "mutation": "N169S", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.203, "escape": -0.1354, "mature_H5_site": 165.0, "mutant": "T", "mutation": "N169T", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.061, "escape": 0.03409, "mature_H5_site": 165.0, "mutant": "V", "mutation": "N169V", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.636, "escape": 0.1605, "mature_H5_site": 165.0, "mutant": "W", "mutation": "N169W", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1939, "escape": 0.1832, "mature_H5_site": 165.0, "mutant": "Y", "mutation": "N169Y", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.573, "escape": 0.07453, "mature_H5_site": 7.0, "mutant": "C", "mutation": "Y17C", "reference_site": "17", "sequential_site": 23.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.0, "escape": -0.1608, "mature_H5_site": 7.0, "mutant": "F", "mutation": "Y17F", "reference_site": "17", "sequential_site": 23.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2625, "escape": -0.07638, "mature_H5_site": 7.0, "mutant": "M", "mutation": "Y17M", "reference_site": "17", "sequential_site": 23.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.791, "escape": 0.3127, "mature_H5_site": 7.0, "mutant": "Q", "mutation": "Y17Q", "reference_site": "17", "sequential_site": 23.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.212, "escape": -0.06781, "mature_H5_site": 7.0, "mutant": "T", "mutation": "Y17T", "reference_site": "17", "sequential_site": 23.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9518, "escape": 0.574, "mature_H5_site": 7.0, "mutant": "W", "mutation": "Y17W", "reference_site": "17", "sequential_site": 23.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2983, "escape": -0.02216, "mature_H5_site": 167.0, "mutant": "A", "mutation": "T171A", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.056, "escape": 0.6451, "mature_H5_site": 167.0, "mutant": "D", "mutation": "T171D", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4069, "escape": 0.3076, "mature_H5_site": 167.0, "mutant": "G", "mutation": "T171G", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4696, "escape": 0.1388, "mature_H5_site": 167.0, "mutant": "I", "mutation": "T171I", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.103, "escape": -0.03545, "mature_H5_site": 167.0, "mutant": "K", "mutation": "T171K", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.549, "escape": 0.2692, "mature_H5_site": 167.0, "mutant": "L", "mutation": "T171L", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5026, "escape": -0.387, "mature_H5_site": 167.0, "mutant": "N", "mutation": "T171N", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2303, "escape": 0.3765, "mature_H5_site": 167.0, "mutant": "Q", "mutation": "T171Q", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8508, "escape": 0.2916, "mature_H5_site": 167.0, "mutant": "R", "mutation": "T171R", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8176, "escape": 0.409, "mature_H5_site": 167.0, "mutant": "W", "mutation": "T171W", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3792, "escape": 0.05195, "mature_H5_site": 167.0, "mutant": "Y", "mutation": "T171Y", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01337, "escape": -0.224, "mature_H5_site": 168.0, "mutant": "A", "mutation": "N172A", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9611, "escape": -0.2131, "mature_H5_site": 168.0, "mutant": "C", "mutation": "N172C", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1689, "escape": -0.5241, "mature_H5_site": 168.0, "mutant": "E", "mutation": "N172E", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2781, "escape": -0.3703, "mature_H5_site": 168.0, "mutant": "F", "mutation": "N172F", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07389, "escape": -0.4112, "mature_H5_site": 168.0, "mutant": "I", "mutation": "N172I", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07534, "escape": 0.3291, "mature_H5_site": 168.0, "mutant": "K", "mutation": "N172K", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05631, "escape": -0.3091, "mature_H5_site": 168.0, "mutant": "L", "mutation": "N172L", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1514, "escape": -0.08232, "mature_H5_site": 168.0, "mutant": "M", "mutation": "N172M", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1487, "escape": 0.1864, "mature_H5_site": 168.0, "mutant": "R", "mutation": "N172R", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1809, "escape": -0.1216, "mature_H5_site": 168.0, "mutant": "V", "mutation": "N172V", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00201, "escape": -0.07823, "mature_H5_site": 168.0, "mutant": "W", "mutation": "N172W", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07883, "escape": 0.1684, "mature_H5_site": 168.0, "mutant": "Y", "mutation": "N172Y", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1192, "escape": 0.02509, "mature_H5_site": 169.0, "mutant": "A", "mutation": "R173A", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8701, "escape": -0.003679, "mature_H5_site": 169.0, "mutant": "D", "mutation": "R173D", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01784, "escape": -0.2435, "mature_H5_site": 169.0, "mutant": "E", "mutation": "R173E", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00217, "escape": 0.05618, "mature_H5_site": 169.0, "mutant": "F", "mutation": "R173F", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4831, "escape": 0.09366, "mature_H5_site": 169.0, "mutant": "G", "mutation": "R173G", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09069, "escape": 0.004711, "mature_H5_site": 169.0, "mutant": "I", "mutation": "R173I", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03937, "escape": 0.07645, "mature_H5_site": 169.0, "mutant": "K", "mutation": "R173K", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.214, "escape": 0.03365, "mature_H5_site": 169.0, "mutant": "M", "mutation": "R173M", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3454, "escape": 0.1241, "mature_H5_site": 169.0, "mutant": "N", "mutation": "R173N", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1161, "escape": -0.1345, "mature_H5_site": 169.0, "mutant": "P", "mutation": "R173P", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.196, "escape": -0.06179, "mature_H5_site": 169.0, "mutant": "Q", "mutation": "R173Q", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05164, "escape": 0.04666, "mature_H5_site": 169.0, "mutant": "S", "mutation": "R173S", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.499, "escape": -0.4488, "mature_H5_site": 169.0, "mutant": "T", "mutation": "R173T", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1727, "escape": 0.1835, "mature_H5_site": 169.0, "mutant": "V", "mutation": "R173V", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02192, "escape": -0.1387, "mature_H5_site": 169.0, "mutant": "W", "mutation": "R173W", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0249, "escape": -0.3465, "mature_H5_site": 169.0, "mutant": "Y", "mutation": "R173Y", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07123, "escape": -0.1524, "mature_H5_site": 170.0, "mutant": "D", "mutation": "E174D", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06942, "escape": 0.1618, "mature_H5_site": 170.0, "mutant": "F", "mutation": "E174F", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5007, "escape": -0.1583, "mature_H5_site": 170.0, "mutant": "G", "mutation": "E174G", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1451, "escape": 0.1423, "mature_H5_site": 170.0, "mutant": "H", "mutation": "E174H", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00608, "escape": -0.112, "mature_H5_site": 170.0, "mutant": "K", "mutation": "E174K", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02964, "escape": -0.03819, "mature_H5_site": 170.0, "mutant": "L", "mutation": "E174L", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4166, "escape": 0.4842, "mature_H5_site": 170.0, "mutant": "M", "mutation": "E174M", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2261, "escape": -0.04376, "mature_H5_site": 170.0, "mutant": "N", "mutation": "E174N", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02478, "escape": -0.3295, "mature_H5_site": 170.0, "mutant": "Q", "mutation": "E174Q", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2184, "escape": -0.3116, "mature_H5_site": 170.0, "mutant": "R", "mutation": "E174R", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07085, "escape": 0.2162, "mature_H5_site": 170.0, "mutant": "S", "mutation": "E174S", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.62, "escape": 1.675, "mature_H5_site": 170.0, "mutant": "T", "mutation": "E174T", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2008, "escape": 0.1098, "mature_H5_site": 170.0, "mutant": "V", "mutation": "E174V", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01863, "escape": -0.2327, "mature_H5_site": 171.0, "mutant": "A", "mutation": "D175A", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.501, "escape": -0.6777, "mature_H5_site": 171.0, "mutant": "E", "mutation": "D175E", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1506, "escape": 0.421, "mature_H5_site": 171.0, "mutant": "F", "mutation": "D175F", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4955, "escape": -0.2263, "mature_H5_site": 171.0, "mutant": "G", "mutation": "D175G", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07175, "escape": 0.1272, "mature_H5_site": 171.0, "mutant": "K", "mutation": "D175K", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02339, "escape": 0.2963, "mature_H5_site": 171.0, "mutant": "M", "mutation": "D175M", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05921, "escape": 0.02895, "mature_H5_site": 171.0, "mutant": "Q", "mutation": "D175Q", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.877, "escape": 0.1769, "mature_H5_site": 171.0, "mutant": "R", "mutation": "D175R", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05575, "escape": 0.02729, "mature_H5_site": 171.0, "mutant": "S", "mutation": "D175S", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3582, "escape": -0.06244, "mature_H5_site": 171.0, "mutant": "V", "mutation": "D175V", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1897, "escape": 0.2075, "mature_H5_site": 171.0, "mutant": "Y", "mutation": "D175Y", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.828, "escape": -0.3927, "mature_H5_site": 172.0, "mutant": "C", "mutation": "L176C", "reference_site": "176", "sequential_site": 188.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4143, "escape": 0.2014, "mature_H5_site": 172.0, "mutant": "I", "mutation": "L176I", "reference_site": "176", "sequential_site": 188.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09796, "escape": -0.004335, "mature_H5_site": 172.0, "mutant": "M", "mutation": "L176M", "reference_site": "176", "sequential_site": 188.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06912, "escape": 0.1672, "mature_H5_site": 172.0, "mutant": "V", "mutation": "L176V", "reference_site": "176", "sequential_site": 188.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.134, "escape": -0.4161, "mature_H5_site": 172.0, "mutant": "Y", "mutation": "L176Y", "reference_site": "176", "sequential_site": 188.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1164, "escape": -0.01731, "mature_H5_site": 173.0, "mutant": "I", "mutation": "L177I", "reference_site": "177", "sequential_site": 189.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06807, "escape": -0.03317, "mature_H5_site": 173.0, "mutant": "V", "mutation": "L177V", "reference_site": "177", "sequential_site": 189.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.24, "escape": 0.4024, "mature_H5_site": 174.0, "mutant": "F", "mutation": "I178F", "reference_site": "178", "sequential_site": 190.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.373, "escape": -0.2628, "mature_H5_site": 174.0, "mutant": "M", "mutation": "I178M", "reference_site": "178", "sequential_site": 190.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.728, "escape": -0.2727, "mature_H5_site": 174.0, "mutant": "W", "mutation": "I178W", "reference_site": "178", "sequential_site": 190.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03488, "escape": -0.1806, "mature_H5_site": 175.0, "mutant": "A", "mutation": "L179A", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.889, "escape": -0.2263, "mature_H5_site": 175.0, "mutant": "F", "mutation": "L179F", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.869, "escape": -0.03938, "mature_H5_site": 175.0, "mutant": "H", "mutation": "L179H", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4528, "escape": -0.1968, "mature_H5_site": 175.0, "mutant": "I", "mutation": "L179I", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02475, "escape": -0.2001, "mature_H5_site": 175.0, "mutant": "M", "mutation": "L179M", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.542, "escape": 0.04573, "mature_H5_site": 175.0, "mutant": "N", "mutation": "L179N", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.047, "escape": 0.05168, "mature_H5_site": 175.0, "mutant": "P", "mutation": "L179P", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7952, "escape": 0.0991, "mature_H5_site": 175.0, "mutant": "Q", "mutation": "L179Q", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06563, "escape": 0.02101, "mature_H5_site": 175.0, "mutant": "S", "mutation": "L179S", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3407, "escape": 0.2087, "mature_H5_site": 8.0, "mutant": "C", "mutation": "H18C", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2797, "escape": 0.03787, "mature_H5_site": 8.0, "mutant": "F", "mutation": "H18F", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.165, "escape": -0.1061, "mature_H5_site": 8.0, "mutant": "G", "mutation": "H18G", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.253, "escape": 0.2789, "mature_H5_site": 8.0, "mutant": "L", "mutation": "H18L", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.227, "escape": 0.2969, "mature_H5_site": 8.0, "mutant": "M", "mutation": "H18M", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2332, "escape": 0.03048, "mature_H5_site": 8.0, "mutant": "N", "mutation": "H18N", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3651, "escape": -0.454, "mature_H5_site": 8.0, "mutant": "R", "mutation": "H18R", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04067, "escape": -0.193, "mature_H5_site": 8.0, "mutant": "S", "mutation": "H18S", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0621, "escape": 0.07337, "mature_H5_site": 8.0, "mutant": "T", "mutation": "H18T", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.355, "escape": -0.399, "mature_H5_site": 8.0, "mutant": "Y", "mutation": "H18Y", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9538, "escape": 0.1434, "mature_H5_site": 176.0, "mutant": "Y", "mutation": "W180Y", "reference_site": "180", "sequential_site": 192.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04537, "escape": -0.01573, "mature_H5_site": 177.0, "mutant": "A", "mutation": "G181A", "reference_site": "181", "sequential_site": 193.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07884, "escape": -0.03736, "mature_H5_site": 178.0, "mutant": "C", "mutation": "I182C", "reference_site": "182", "sequential_site": 194.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.806, "escape": -0.3783, "mature_H5_site": 178.0, "mutant": "E", "mutation": "I182E", "reference_site": "182", "sequential_site": 194.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06189, "escape": 0.165, "mature_H5_site": 178.0, "mutant": "L", "mutation": "I182L", "reference_site": "182", "sequential_site": 194.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07634, "escape": -0.004034, "mature_H5_site": 178.0, "mutant": "M", "mutation": "I182M", "reference_site": "182", "sequential_site": 194.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2174, "escape": -0.1192, "mature_H5_site": 178.0, "mutant": "Q", "mutation": "I182Q", "reference_site": "182", "sequential_site": 194.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5711, "escape": -0.1888, "mature_H5_site": 178.0, "mutant": "T", "mutation": "I182T", "reference_site": "182", "sequential_site": 194.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.411, "escape": -0.37, "mature_H5_site": 179.0, "mutant": "Q", "mutation": "H183Q", "reference_site": "183", "sequential_site": 195.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.86, "escape": -0.1626, "mature_H5_site": 181.0, "mutant": "G", "mutation": "S185G", "reference_site": "185", "sequential_site": 197.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7509, "escape": -0.2052, "mature_H5_site": 181.0, "mutant": "I", "mutation": "S185I", "reference_site": "185", "sequential_site": 197.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6169, "escape": -0.2711, "mature_H5_site": 181.0, "mutant": "N", "mutation": "S185N", "reference_site": "185", "sequential_site": 197.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4204, "escape": -0.291, "mature_H5_site": 181.0, "mutant": "V", "mutation": "S185V", "reference_site": "185", "sequential_site": 197.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8998, "escape": -0.1432, "mature_H5_site": 182.0, "mutant": "A", "mutation": "N186A", "reference_site": "186", "sequential_site": 198.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.398, "escape": -0.4509, "mature_H5_site": 182.0, "mutant": "D", "mutation": "N186D", "reference_site": "186", "sequential_site": 198.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.444, "escape": -0.1863, "mature_H5_site": 182.0, "mutant": "Q", "mutation": "N186Q", "reference_site": "186", "sequential_site": 198.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01905, "escape": -0.0733, "mature_H5_site": 182.0, "mutant": "S", "mutation": "N186S", "reference_site": "186", "sequential_site": 198.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.564, "escape": 0.147, "mature_H5_site": 182.0, "mutant": "Y", "mutation": "N186Y", "reference_site": "186", "sequential_site": 198.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.205, "escape": -0.06113, "mature_H5_site": 183.0, "mutant": "A", "mutation": "N187A", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1002, "escape": 0.0005838, "mature_H5_site": 183.0, "mutant": "C", "mutation": "N187C", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2446, "escape": -0.6428, "mature_H5_site": 183.0, "mutant": "D", "mutation": "N187D", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07847, "escape": -0.3515, "mature_H5_site": 183.0, "mutant": "E", "mutation": "N187E", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06036, "escape": -0.4119, "mature_H5_site": 183.0, "mutant": "G", "mutation": "N187G", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08441, "escape": -0.1933, "mature_H5_site": 183.0, "mutant": "H", "mutation": "N187H", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4657, "escape": -0.1268, "mature_H5_site": 183.0, "mutant": "K", "mutation": "N187K", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.098, "escape": 0.4952, "mature_H5_site": 183.0, "mutant": "R", "mutation": "N187R", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07217, "escape": -0.1117, "mature_H5_site": 183.0, "mutant": "T", "mutation": "N187T", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4867, "escape": -0.3537, "mature_H5_site": 183.0, "mutant": "V", "mutation": "N187V", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3038, "escape": -0.2529, "mature_H5_site": 183.0, "mutant": "W", "mutation": "N187W", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01341, "escape": 0.3608, "mature_H5_site": 183.0, "mutant": "Y", "mutation": "N187Y", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.009199, "escape": 0.03698, "mature_H5_site": 184.0, "mutant": "C", "mutation": "A188C", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03025, "escape": -0.04814, "mature_H5_site": 184.0, "mutant": "D", "mutation": "A188D", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06724, "escape": 0.05778, "mature_H5_site": 184.0, "mutant": "E", "mutation": "A188E", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1551, "escape": -0.0844, "mature_H5_site": 184.0, "mutant": "F", "mutation": "A188F", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06618, "escape": 0.08443, "mature_H5_site": 184.0, "mutant": "G", "mutation": "A188G", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01178, "escape": 0.02839, "mature_H5_site": 184.0, "mutant": "H", "mutation": "A188H", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.002775, "escape": -0.002236, "mature_H5_site": 184.0, "mutant": "I", "mutation": "A188I", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5312, "escape": 0.1473, "mature_H5_site": 184.0, "mutant": "K", "mutation": "A188K", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1761, "escape": 0.09693, "mature_H5_site": 184.0, "mutant": "M", "mutation": "A188M", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04956, "escape": -0.06099, "mature_H5_site": 184.0, "mutant": "N", "mutation": "A188N", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09303, "escape": 0.06817, "mature_H5_site": 184.0, "mutant": "P", "mutation": "A188P", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06341, "escape": -0.0274, "mature_H5_site": 184.0, "mutant": "Q", "mutation": "A188Q", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05409, "escape": 0.1304, "mature_H5_site": 184.0, "mutant": "R", "mutation": "A188R", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01764, "escape": -0.1221, "mature_H5_site": 184.0, "mutant": "V", "mutation": "A188V", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1052, "escape": 0.03695, "mature_H5_site": 185.0, "mutant": "D", "mutation": "E189D", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7629, "escape": 0.3212, "mature_H5_site": 185.0, "mutant": "G", "mutation": "E189G", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5244, "escape": 0.4519, "mature_H5_site": 185.0, "mutant": "H", "mutation": "E189H", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.341, "escape": 0.4646, "mature_H5_site": 185.0, "mutant": "K", "mutation": "E189K", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.232, "escape": -0.2238, "mature_H5_site": 185.0, "mutant": "L", "mutation": "E189L", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0163, "escape": 0.02761, "mature_H5_site": 185.0, "mutant": "M", "mutation": "E189M", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7946, "escape": 0.6186, "mature_H5_site": 185.0, "mutant": "N", "mutation": "E189N", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7278, "escape": 0.1789, "mature_H5_site": 185.0, "mutant": "P", "mutation": "E189P", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1914, "escape": -0.189, "mature_H5_site": 185.0, "mutant": "V", "mutation": "E189V", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8216, "escape": 0.4235, "mature_H5_site": 9.0, "mutant": "N", "mutation": "A19N", "reference_site": "19", "sequential_site": 25.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07206, "escape": 0.08862, "mature_H5_site": 9.0, "mutant": "Q", "mutation": "A19Q", "reference_site": "19", "sequential_site": 25.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7174, "escape": -0.06962, "mature_H5_site": 9.0, "mutant": "T", "mutation": "A19T", "reference_site": "19", "sequential_site": 25.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.204, "escape": -0.08989, "mature_H5_site": 9.0, "mutant": "W", "mutation": "A19W", "reference_site": "19", "sequential_site": 25.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.004065, "escape": -0.1951, "mature_H5_site": 187.0, "mutant": "N", "mutation": "Q191N", "reference_site": "191", "sequential_site": 203.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01022, "escape": 0.002161, "mature_H5_site": 188.0, "mutant": "A", "mutation": "T192A", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.289, "escape": -0.6611, "mature_H5_site": 188.0, "mutant": "C", "mutation": "T192C", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07811, "escape": -0.1814, "mature_H5_site": 188.0, "mutant": "D", "mutation": "T192D", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03511, "escape": -0.08978, "mature_H5_site": 188.0, "mutant": "H", "mutation": "T192H", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03367, "escape": -0.1479, "mature_H5_site": 188.0, "mutant": "I", "mutation": "T192I", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7805, "escape": -0.08739, "mature_H5_site": 188.0, "mutant": "K", "mutation": "T192K", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05107, "escape": -0.2931, "mature_H5_site": 188.0, "mutant": "M", "mutation": "T192M", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03194, "escape": -0.01393, "mature_H5_site": 188.0, "mutant": "N", "mutation": "T192N", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03218, "escape": -0.08627, "mature_H5_site": 188.0, "mutant": "Q", "mutation": "T192Q", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.154, "escape": 0.05905, "mature_H5_site": 188.0, "mutant": "R", "mutation": "T192R", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0295, "escape": -0.3739, "mature_H5_site": 188.0, "mutant": "S", "mutation": "T192S", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3159, "escape": 0.1226, "mature_H5_site": 188.0, "mutant": "V", "mutation": "T192V", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2659, "escape": -0.2813, "mature_H5_site": 188.0, "mutant": "W", "mutation": "T192W", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.002195, "escape": -0.0494, "mature_H5_site": 188.0, "mutant": "Y", "mutation": "T192Y", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03588, "escape": -0.2565, "mature_H5_site": 189.0, "mutant": "A", "mutation": "N193A", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3979, "escape": -0.248, "mature_H5_site": 189.0, "mutant": "F", "mutation": "N193F", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2481, "escape": 0.1876, "mature_H5_site": 189.0, "mutant": "K", "mutation": "N193K", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1422, "escape": 0.003028, "mature_H5_site": 189.0, "mutant": "M", "mutation": "N193M", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01775, "escape": 0.3312, "mature_H5_site": 189.0, "mutant": "Q", "mutation": "N193Q", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.397, "escape": 0.371, "mature_H5_site": 189.0, "mutant": "R", "mutation": "N193R", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07625, "escape": -0.1193, "mature_H5_site": 189.0, "mutant": "S", "mutation": "N193S", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2069, "escape": -0.09963, "mature_H5_site": 189.0, "mutant": "W", "mutation": "N193W", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4655, "escape": 0.0004073, "mature_H5_site": 189.0, "mutant": "Y", "mutation": "N193Y", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1717, "escape": -0.2451, "mature_H5_site": 190.0, "mutant": "M", "mutation": "L194M", "reference_site": "194", "sequential_site": 206.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.869, "escape": -0.03773, "mature_H5_site": 190.0, "mutant": "N", "mutation": "L194N", "reference_site": "194", "sequential_site": 206.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2559, "escape": -0.2344, "mature_H5_site": 192.0, "mutant": "D", "mutation": "K196D", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07444, "escape": 0.09297, "mature_H5_site": 192.0, "mutant": "H", "mutation": "K196H", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07812, "escape": -0.2728, "mature_H5_site": 192.0, "mutant": "L", "mutation": "K196L", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02107, "escape": 0.02128, "mature_H5_site": 192.0, "mutant": "M", "mutation": "K196M", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01249, "escape": -0.3053, "mature_H5_site": 192.0, "mutant": "N", "mutation": "K196N", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07326, "escape": -0.008077, "mature_H5_site": 192.0, "mutant": "Q", "mutation": "K196Q", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09238, "escape": 0.09212, "mature_H5_site": 192.0, "mutant": "R", "mutation": "K196R", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06693, "escape": 0.02741, "mature_H5_site": 192.0, "mutant": "S", "mutation": "K196S", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07787, "escape": 0.04889, "mature_H5_site": 192.0, "mutant": "V", "mutation": "K196V", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05117, "escape": -0.01791, "mature_H5_site": 192.0, "mutant": "W", "mutation": "K196W", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04911, "escape": -0.04955, "mature_H5_site": 193.0, "mutant": "E", "mutation": "N197E", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8245, "escape": -0.2378, "mature_H5_site": 193.0, "mutant": "G", "mutation": "N197G", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7363, "escape": -0.1187, "mature_H5_site": 193.0, "mutant": "K", "mutation": "N197K", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1396, "escape": -0.3234, "mature_H5_site": 193.0, "mutant": "M", "mutation": "N197M", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03522, "escape": 0.4992, "mature_H5_site": 193.0, "mutant": "Q", "mutation": "N197Q", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02481, "escape": -0.1963, "mature_H5_site": 193.0, "mutant": "R", "mutation": "N197R", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01479, "escape": -0.1517, "mature_H5_site": 193.0, "mutant": "S", "mutation": "N197S", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.219, "escape": 0.1607, "mature_H5_site": 193.0, "mutant": "T", "mutation": "N197T", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.439, "escape": -0.06339, "mature_H5_site": 193.0, "mutant": "V", "mutation": "N197V", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09866, "escape": -0.1696, "mature_H5_site": 193.0, "mutant": "Y", "mutation": "N197Y", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.076, "escape": -0.2696, "mature_H5_site": 194.0, "mutant": "E", "mutation": "P198E", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2687, "escape": -0.08324, "mature_H5_site": 194.0, "mutant": "G", "mutation": "P198G", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3047, "escape": -0.4165, "mature_H5_site": 194.0, "mutant": "H", "mutation": "P198H", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3696, "escape": -0.2756, "mature_H5_site": 194.0, "mutant": "I", "mutation": "P198I", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.459, "escape": -0.05886, "mature_H5_site": 194.0, "mutant": "L", "mutation": "P198L", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02524, "escape": -0.3257, "mature_H5_site": 194.0, "mutant": "M", "mutation": "P198M", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0473, "escape": -0.3067, "mature_H5_site": 194.0, "mutant": "Q", "mutation": "P198Q", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05373, "escape": -0.1763, "mature_H5_site": 194.0, "mutant": "S", "mutation": "P198S", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09659, "escape": -0.114, "mature_H5_site": 194.0, "mutant": "V", "mutation": "P198V", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03991, "escape": -0.1713, "mature_H5_site": 194.0, "mutant": "Y", "mutation": "P198Y", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.566, "escape": 0.06575, "mature_H5_site": 195.0, "mutant": "C", "mutation": "T199C", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05215, "escape": -0.09247, "mature_H5_site": 195.0, "mutant": "D", "mutation": "T199D", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2546, "escape": -0.1693, "mature_H5_site": 195.0, "mutant": "F", "mutation": "T199F", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1286, "escape": -0.01323, "mature_H5_site": 195.0, "mutant": "G", "mutation": "T199G", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03299, "escape": -0.09094, "mature_H5_site": 195.0, "mutant": "H", "mutation": "T199H", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1948, "escape": -0.06926, "mature_H5_site": 195.0, "mutant": "I", "mutation": "T199I", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03725, "escape": 0.2871, "mature_H5_site": 195.0, "mutant": "K", "mutation": "T199K", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00957, "escape": -0.004227, "mature_H5_site": 195.0, "mutant": "L", "mutation": "T199L", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2989, "escape": 0.02166, "mature_H5_site": 195.0, "mutant": "Q", "mutation": "T199Q", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03191, "escape": -0.1701, "mature_H5_site": 195.0, "mutant": "S", "mutation": "T199S", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07707, "escape": 0.1872, "mature_H5_site": 195.0, "mutant": "V", "mutation": "T199V", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0692, "escape": -0.1379, "mature_H5_site": 195.0, "mutant": "Y", "mutation": "T199Y", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5433, "escape": -0.004259, "mature_H5_site": -9.0, "mutant": "F", "mutation": "L2F", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4676, "escape": 0.1022, "mature_H5_site": -9.0, "mutant": "G", "mutation": "L2G", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.057, "escape": -0.124, "mature_H5_site": -9.0, "mutant": "H", "mutation": "L2H", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5281, "escape": 0.05759, "mature_H5_site": -9.0, "mutant": "I", "mutation": "L2I", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06773, "escape": -0.02673, "mature_H5_site": -9.0, "mutant": "M", "mutation": "L2M", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.256, "escape": -0.2675, "mature_H5_site": -9.0, "mutant": "Q", "mutation": "L2Q", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01022, "escape": -0.1821, "mature_H5_site": -9.0, "mutant": "S", "mutation": "L2S", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.608, "escape": -0.2709, "mature_H5_site": -9.0, "mutant": "V", "mutation": "L2V", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2817, "escape": 0.04213, "mature_H5_site": -9.0, "mutant": "W", "mutation": "L2W", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3166, "escape": 0.1947, "mature_H5_site": -9.0, "mutant": "Y", "mutation": "L2Y", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.053, "escape": -0.1874, "mature_H5_site": 10.0, "mutant": "T", "mutation": "N20T", "reference_site": "20", "sequential_site": 26.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1878, "escape": 0.02132, "mature_H5_site": 196.0, "mutant": "A", "mutation": "T200A", "reference_site": "200", "sequential_site": 212.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5365, "escape": -0.02245, "mature_H5_site": 196.0, "mutant": "C", "mutation": "T200C", "reference_site": "200", "sequential_site": 212.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03888, "escape": -0.06065, "mature_H5_site": 196.0, "mutant": "G", "mutation": "T200G", "reference_site": "200", "sequential_site": 212.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07342, "escape": -0.03757, "mature_H5_site": 196.0, "mutant": "P", "mutation": "T200P", "reference_site": "200", "sequential_site": 212.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01604, "escape": -0.158, "mature_H5_site": 196.0, "mutant": "V", "mutation": "T200V", "reference_site": "200", "sequential_site": 212.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04903, "escape": -0.2639, "mature_H5_site": 197.0, "mutant": "A", "mutation": "Y201A", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.773, "escape": -0.03198, "mature_H5_site": 197.0, "mutant": "C", "mutation": "Y201C", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4882, "escape": -0.1738, "mature_H5_site": 197.0, "mutant": "D", "mutation": "Y201D", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04513, "escape": -0.4342, "mature_H5_site": 197.0, "mutant": "E", "mutation": "Y201E", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1835, "escape": -0.173, "mature_H5_site": 197.0, "mutant": "F", "mutation": "Y201F", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4292, "escape": -0.2934, "mature_H5_site": 197.0, "mutant": "G", "mutation": "Y201G", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01717, "escape": 0.2168, "mature_H5_site": 197.0, "mutant": "M", "mutation": "Y201M", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0749, "escape": -0.03107, "mature_H5_site": 197.0, "mutant": "R", "mutation": "Y201R", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07129, "escape": -0.3276, "mature_H5_site": 197.0, "mutant": "S", "mutation": "Y201S", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.041, "escape": 0.6935, "mature_H5_site": 197.0, "mutant": "V", "mutation": "Y201V", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.004945, "escape": -0.05598, "mature_H5_site": 197.0, "mutant": "W", "mutation": "Y201W", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.325, "escape": 0.0472, "mature_H5_site": 198.0, "mutant": "C", "mutation": "I202C", "reference_site": "202", "sequential_site": 214.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4756, "escape": -0.3243, "mature_H5_site": 198.0, "mutant": "L", "mutation": "I202L", "reference_site": "202", "sequential_site": 214.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03982, "escape": 0.1326, "mature_H5_site": 198.0, "mutant": "M", "mutation": "I202M", "reference_site": "202", "sequential_site": 214.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.184, "escape": 0.07641, "mature_H5_site": 198.0, "mutant": "S", "mutation": "I202S", "reference_site": "202", "sequential_site": 214.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.007615, "escape": -0.3012, "mature_H5_site": 198.0, "mutant": "T", "mutation": "I202T", "reference_site": "202", "sequential_site": 214.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.215, "escape": 0.09616, "mature_H5_site": 198.0, "mutant": "V", "mutation": "I202V", "reference_site": "202", "sequential_site": 214.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02631, "escape": -0.5365, "mature_H5_site": 199.0, "mutant": "F", "mutation": "S203F", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5688, "escape": -0.1332, "mature_H5_site": 199.0, "mutant": "G", "mutation": "S203G", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3072, "escape": -0.0916, "mature_H5_site": 199.0, "mutant": "H", "mutation": "S203H", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.499, "escape": -0.5819, "mature_H5_site": 199.0, "mutant": "I", "mutation": "S203I", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05166, "escape": 0.2034, "mature_H5_site": 199.0, "mutant": "L", "mutation": "S203L", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4317, "escape": -0.1957, "mature_H5_site": 199.0, "mutant": "N", "mutation": "S203N", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09187, "escape": -0.2082, "mature_H5_site": 199.0, "mutant": "Q", "mutation": "S203Q", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6649, "escape": -0.2604, "mature_H5_site": 199.0, "mutant": "V", "mutation": "S203V", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02779, "escape": -0.07602, "mature_H5_site": 200.0, "mutant": "A", "mutation": "V204A", "reference_site": "204", "sequential_site": 216.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9364, "escape": 0.1337, "mature_H5_site": 200.0, "mutant": "C", "mutation": "V204C", "reference_site": "204", "sequential_site": 216.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.667, "escape": -0.1846, "mature_H5_site": 200.0, "mutant": "F", "mutation": "V204F", "reference_site": "204", "sequential_site": 216.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.056, "escape": -0.02624, "mature_H5_site": 200.0, "mutant": "G", "mutation": "V204G", "reference_site": "204", "sequential_site": 216.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3403, "escape": -0.3178, "mature_H5_site": 200.0, "mutant": "S", "mutation": "V204S", "reference_site": "204", "sequential_site": 216.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06503, "escape": -0.03911, "mature_H5_site": 200.0, "mutant": "T", "mutation": "V204T", "reference_site": "204", "sequential_site": 216.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.938, "escape": -0.4082, "mature_H5_site": 200.0, "mutant": "W", "mutation": "V204W", "reference_site": "204", "sequential_site": 216.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.012, "escape": -0.4071, "mature_H5_site": 201.0, "mutant": "C", "mutation": "G205C", "reference_site": "205", "sequential_site": 217.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.443, "escape": -0.08732, "mature_H5_site": 201.0, "mutant": "S", "mutation": "G205S", "reference_site": "205", "sequential_site": 217.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5742, "escape": -0.2025, "mature_H5_site": 201.0, "mutant": "T", "mutation": "G205T", "reference_site": "205", "sequential_site": 217.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.1, "escape": -0.3163, "mature_H5_site": 202.0, "mutant": "C", "mutation": "T206C", "reference_site": "206", "sequential_site": 218.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2482, "escape": -0.1044, "mature_H5_site": 202.0, "mutant": "H", "mutation": "T206H", "reference_site": "206", "sequential_site": 218.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7795, "escape": -0.2584, "mature_H5_site": 203.0, "mutant": "A", "mutation": "S207A", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.002705, "escape": -0.09056, "mature_H5_site": 203.0, "mutant": "C", "mutation": "S207C", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1294, "escape": -0.1127, "mature_H5_site": 203.0, "mutant": "D", "mutation": "S207D", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06497, "escape": 0.001849, "mature_H5_site": 203.0, "mutant": "E", "mutation": "S207E", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3525, "escape": -0.5003, "mature_H5_site": 203.0, "mutant": "G", "mutation": "S207G", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02117, "escape": -1.249, "mature_H5_site": 203.0, "mutant": "I", "mutation": "S207I", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06246, "escape": -0.02048, "mature_H5_site": 203.0, "mutant": "K", "mutation": "S207K", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02478, "escape": -0.06315, "mature_H5_site": 203.0, "mutant": "N", "mutation": "S207N", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2801, "escape": -0.05741, "mature_H5_site": 203.0, "mutant": "Q", "mutation": "S207Q", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1829, "escape": -0.1599, "mature_H5_site": 203.0, "mutant": "T", "mutation": "S207T", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9663, "escape": -0.07773, "mature_H5_site": 203.0, "mutant": "W", "mutation": "S207W", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4845, "escape": 0.0858, "mature_H5_site": 204.0, "mutant": "C", "mutation": "T208C", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04, "escape": -0.006182, "mature_H5_site": 204.0, "mutant": "D", "mutation": "T208D", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07075, "escape": -0.1696, "mature_H5_site": 204.0, "mutant": "E", "mutation": "T208E", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03211, "escape": -0.08504, "mature_H5_site": 204.0, "mutant": "G", "mutation": "T208G", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05084, "escape": 0.05301, "mature_H5_site": 204.0, "mutant": "I", "mutation": "T208I", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00554, "escape": 0.09699, "mature_H5_site": 204.0, "mutant": "K", "mutation": "T208K", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0802, "escape": 0.4997, "mature_H5_site": 204.0, "mutant": "L", "mutation": "T208L", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3923, "escape": 0.1116, "mature_H5_site": 204.0, "mutant": "M", "mutation": "T208M", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2482, "escape": -0.096, "mature_H5_site": 204.0, "mutant": "R", "mutation": "T208R", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2978, "escape": 0.03934, "mature_H5_site": 204.0, "mutant": "S", "mutation": "T208S", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0459, "escape": 0.1234, "mature_H5_site": 204.0, "mutant": "W", "mutation": "T208W", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4254, "escape": 0.1608, "mature_H5_site": 204.0, "mutant": "Y", "mutation": "T208Y", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2622, "escape": 0.06802, "mature_H5_site": 205.0, "mutant": "E", "mutation": "L209E", "reference_site": "209", "sequential_site": 221.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1419, "escape": -0.0247, "mature_H5_site": 205.0, "mutant": "M", "mutation": "L209M", "reference_site": "209", "sequential_site": 221.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2147, "escape": -0.01916, "mature_H5_site": 205.0, "mutant": "T", "mutation": "L209T", "reference_site": "209", "sequential_site": 221.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.382, "escape": 0.04222, "mature_H5_site": 205.0, "mutant": "V", "mutation": "L209V", "reference_site": "209", "sequential_site": 221.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": null, "escape": -0.2265, "mature_H5_site": 205.0, "mutant": "Y", "mutation": "L209Y", "reference_site": "209", "sequential_site": 221.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6686, "escape": 0.0824, "mature_H5_site": 11.0, "mutant": "G", "mutation": "N21G", "reference_site": "21", "sequential_site": 27.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.355, "escape": -0.06831, "mature_H5_site": 11.0, "mutant": "K", "mutation": "N21K", "reference_site": "21", "sequential_site": 27.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05349, "escape": -0.214, "mature_H5_site": 11.0, "mutant": "L", "mutation": "N21L", "reference_site": "21", "sequential_site": 27.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.708, "escape": -0.3526, "mature_H5_site": 206.0, "mutant": "L", "mutation": "N210L", "reference_site": "210", "sequential_site": 222.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.603, "escape": -0.1148, "mature_H5_site": 206.0, "mutant": "T", "mutation": "N210T", "reference_site": "210", "sequential_site": 222.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1783, "escape": 0.1698, "mature_H5_site": 207.0, "mutant": "C", "mutation": "Q211C", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1263, "escape": 0.2431, "mature_H5_site": 207.0, "mutant": "D", "mutation": "Q211D", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06217, "escape": 0.1493, "mature_H5_site": 207.0, "mutant": "E", "mutation": "Q211E", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.061, "escape": -0.1525, "mature_H5_site": 207.0, "mutant": "F", "mutation": "Q211F", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.219, "escape": 0.1546, "mature_H5_site": 207.0, "mutant": "G", "mutation": "Q211G", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06265, "escape": 0.1298, "mature_H5_site": 207.0, "mutant": "H", "mutation": "Q211H", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7477, "escape": -0.07083, "mature_H5_site": 207.0, "mutant": "K", "mutation": "Q211K", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1064, "escape": -0.01978, "mature_H5_site": 207.0, "mutant": "L", "mutation": "Q211L", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06665, "escape": -0.005234, "mature_H5_site": 207.0, "mutant": "N", "mutation": "Q211N", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1399, "escape": -0.3492, "mature_H5_site": 207.0, "mutant": "R", "mutation": "Q211R", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04676, "escape": -0.04164, "mature_H5_site": 207.0, "mutant": "S", "mutation": "Q211S", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.475, "escape": -0.08243, "mature_H5_site": 207.0, "mutant": "T", "mutation": "Q211T", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4775, "escape": -0.06344, "mature_H5_site": 207.0, "mutant": "V", "mutation": "Q211V", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04648, "escape": -0.1913, "mature_H5_site": 207.0, "mutant": "W", "mutation": "Q211W", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1633, "escape": 0.157, "mature_H5_site": 207.0, "mutant": "Y", "mutation": "Q211Y", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05157, "escape": -0.06, "mature_H5_site": 208.0, "mutant": "A", "mutation": "R212A", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1094, "escape": -0.5093, "mature_H5_site": 208.0, "mutant": "C", "mutation": "R212C", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.009905, "escape": -0.2257, "mature_H5_site": 208.0, "mutant": "F", "mutation": "R212F", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0764, "escape": 0.001655, "mature_H5_site": 208.0, "mutant": "I", "mutation": "R212I", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.351, "escape": -0.03455, "mature_H5_site": 208.0, "mutant": "K", "mutation": "R212K", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.001365, "escape": -0.06434, "mature_H5_site": 208.0, "mutant": "N", "mutation": "R212N", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3394, "escape": -0.2397, "mature_H5_site": 208.0, "mutant": "Q", "mutation": "R212Q", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.86, "escape": -0.2804, "mature_H5_site": 208.0, "mutant": "S", "mutation": "R212S", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06514, "escape": -0.2171, "mature_H5_site": 208.0, "mutant": "Y", "mutation": "R212Y", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03875, "escape": -0.03917, "mature_H5_site": 209.0, "mutant": "C", "mutation": "L213C", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2292, "escape": -0.1746, "mature_H5_site": 209.0, "mutant": "E", "mutation": "L213E", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.855, "escape": -0.1997, "mature_H5_site": 209.0, "mutant": "G", "mutation": "L213G", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.006395, "escape": 0.1369, "mature_H5_site": 209.0, "mutant": "H", "mutation": "L213H", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6634, "escape": 0.1068, "mature_H5_site": 209.0, "mutant": "I", "mutation": "L213I", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9553, "escape": -0.1995, "mature_H5_site": 209.0, "mutant": "K", "mutation": "L213K", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1603, "escape": -0.3552, "mature_H5_site": 209.0, "mutant": "Q", "mutation": "L213Q", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.638, "escape": -0.2029, "mature_H5_site": 209.0, "mutant": "R", "mutation": "L213R", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1492, "escape": -0.1398, "mature_H5_site": 209.0, "mutant": "S", "mutation": "L213S", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.061, "escape": 0.00533, "mature_H5_site": 209.0, "mutant": "T", "mutation": "L213T", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.03, "escape": -0.2493, "mature_H5_site": 209.0, "mutant": "V", "mutation": "L213V", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.302, "escape": -0.1594, "mature_H5_site": 209.0, "mutant": "W", "mutation": "L213W", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.002795, "escape": -0.0009427, "mature_H5_site": 209.0, "mutant": "Y", "mutation": "L213Y", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07426, "escape": 0.05464, "mature_H5_site": 210.0, "mutant": "C", "mutation": "A214C", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02426, "escape": -0.09687, "mature_H5_site": 210.0, "mutant": "D", "mutation": "A214D", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01068, "escape": 0.04728, "mature_H5_site": 210.0, "mutant": "E", "mutation": "A214E", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05656, "escape": 0.1248, "mature_H5_site": 210.0, "mutant": "K", "mutation": "A214K", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06172, "escape": 0.05562, "mature_H5_site": 210.0, "mutant": "L", "mutation": "A214L", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02643, "escape": 0.1783, "mature_H5_site": 210.0, "mutant": "M", "mutation": "A214M", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01319, "escape": 0.004035, "mature_H5_site": 210.0, "mutant": "N", "mutation": "A214N", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1523, "escape": -0.04505, "mature_H5_site": 210.0, "mutant": "Q", "mutation": "A214Q", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6893, "escape": 0.6081, "mature_H5_site": 210.0, "mutant": "R", "mutation": "A214R", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3456, "escape": 0.03531, "mature_H5_site": 210.0, "mutant": "S", "mutation": "A214S", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0005658, "escape": 0.3728, "mature_H5_site": 210.0, "mutant": "T", "mutation": "A214T", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1736, "escape": 0.00465, "mature_H5_site": 210.0, "mutant": "V", "mutation": "A214V", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.634, "escape": -0.3946, "mature_H5_site": 211.0, "mutant": "C", "mutation": "P215C", "reference_site": "215", "sequential_site": 227.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.431, "escape": -0.2348, "mature_H5_site": 211.0, "mutant": "V", "mutation": "P215V", "reference_site": "215", "sequential_site": 227.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0329, "escape": -0.2777, "mature_H5_site": 212.0, "mutant": "C", "mutation": "K216C", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08566, "escape": -0.3122, "mature_H5_site": 212.0, "mutant": "F", "mutation": "K216F", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03417, "escape": -0.4104, "mature_H5_site": 212.0, "mutant": "H", "mutation": "K216H", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3852, "escape": -0.03494, "mature_H5_site": 212.0, "mutant": "I", "mutation": "K216I", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07761, "escape": 0.02211, "mature_H5_site": 212.0, "mutant": "L", "mutation": "K216L", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02587, "escape": -0.2232, "mature_H5_site": 212.0, "mutant": "M", "mutation": "K216M", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.257, "escape": -0.3506, "mature_H5_site": 212.0, "mutant": "N", "mutation": "K216N", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04816, "escape": 0.05008, "mature_H5_site": 212.0, "mutant": "R", "mutation": "K216R", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05051, "escape": -0.1455, "mature_H5_site": 212.0, "mutant": "S", "mutation": "K216S", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3187, "escape": -0.2277, "mature_H5_site": 213.0, "mutant": "A", "mutation": "I217A", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4126, "escape": 0.1307, "mature_H5_site": 213.0, "mutant": "C", "mutation": "I217C", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2592, "escape": -0.02221, "mature_H5_site": 213.0, "mutant": "E", "mutation": "I217E", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06098, "escape": -0.033, "mature_H5_site": 213.0, "mutant": "F", "mutation": "I217F", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1569, "escape": -0.2626, "mature_H5_site": 213.0, "mutant": "H", "mutation": "I217H", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3126, "escape": 0.1012, "mature_H5_site": 213.0, "mutant": "K", "mutation": "I217K", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6056, "escape": -0.2087, "mature_H5_site": 213.0, "mutant": "R", "mutation": "I217R", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.04, "escape": -0.1031, "mature_H5_site": 213.0, "mutant": "S", "mutation": "I217S", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4957, "escape": -0.3644, "mature_H5_site": 213.0, "mutant": "T", "mutation": "I217T", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.216, "escape": -0.1449, "mature_H5_site": 213.0, "mutant": "V", "mutation": "I217V", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0001195, "escape": -0.0486, "mature_H5_site": 213.0, "mutant": "W", "mutation": "I217W", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2463, "escape": 0.0644, "mature_H5_site": 214.0, "mutant": "C", "mutation": "A218C", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0487, "escape": -0.4198, "mature_H5_site": 214.0, "mutant": "F", "mutation": "A218F", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2427, "escape": -0.04008, "mature_H5_site": 214.0, "mutant": "G", "mutation": "A218G", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.29, "escape": -0.2468, "mature_H5_site": 214.0, "mutant": "H", "mutation": "A218H", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8935, "escape": 0.9598, "mature_H5_site": 214.0, "mutant": "L", "mutation": "A218L", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8063, "escape": 0.07837, "mature_H5_site": 214.0, "mutant": "M", "mutation": "A218M", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03717, "escape": -0.06703, "mature_H5_site": 214.0, "mutant": "N", "mutation": "A218N", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1621, "escape": 0.1391, "mature_H5_site": 214.0, "mutant": "S", "mutation": "A218S", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3872, "escape": -0.1551, "mature_H5_site": 214.0, "mutant": "T", "mutation": "A218T", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6792, "escape": 0.3093, "mature_H5_site": 214.0, "mutant": "V", "mutation": "A218V", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01311, "escape": -0.4034, "mature_H5_site": 215.0, "mutant": "A", "mutation": "T219A", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02908, "escape": -0.1795, "mature_H5_site": 215.0, "mutant": "C", "mutation": "T219C", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07375, "escape": -0.5912, "mature_H5_site": 215.0, "mutant": "D", "mutation": "T219D", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06439, "escape": -0.6651, "mature_H5_site": 215.0, "mutant": "E", "mutation": "T219E", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0208, "escape": -0.2733, "mature_H5_site": 215.0, "mutant": "F", "mutation": "T219F", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6563, "escape": 0.2327, "mature_H5_site": 215.0, "mutant": "K", "mutation": "T219K", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01552, "escape": -0.004871, "mature_H5_site": 215.0, "mutant": "L", "mutation": "T219L", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3844, "escape": -0.3238, "mature_H5_site": 215.0, "mutant": "M", "mutation": "T219M", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01061, "escape": -0.1336, "mature_H5_site": 215.0, "mutant": "P", "mutation": "T219P", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1603, "escape": 0.1185, "mature_H5_site": 215.0, "mutant": "R", "mutation": "T219R", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0449, "escape": 0.1095, "mature_H5_site": 215.0, "mutant": "W", "mutation": "T219W", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02245, "escape": -0.01236, "mature_H5_site": 215.0, "mutant": "Y", "mutation": "T219Y", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.261, "escape": -0.1257, "mature_H5_site": 12.0, "mutant": "E", "mutation": "S22E", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01645, "escape": -0.07764, "mature_H5_site": 12.0, "mutant": "G", "mutation": "S22G", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0678, "escape": -0.1535, "mature_H5_site": 12.0, "mutant": "H", "mutation": "S22H", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.093, "escape": -0.4784, "mature_H5_site": 12.0, "mutant": "K", "mutation": "S22K", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3824, "escape": 0.04684, "mature_H5_site": 12.0, "mutant": "N", "mutation": "S22N", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2029, "escape": -0.3134, "mature_H5_site": 12.0, "mutant": "Q", "mutation": "S22Q", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6728, "escape": -0.2525, "mature_H5_site": 12.0, "mutant": "T", "mutation": "S22T", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1991, "escape": -0.1335, "mature_H5_site": 12.0, "mutant": "V", "mutation": "S22V", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3714, "escape": -0.1197, "mature_H5_site": 217.0, "mutant": "N", "mutation": "S221N", "reference_site": "221", "sequential_site": 233.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.726, "escape": -0.4254, "mature_H5_site": 217.0, "mutant": "Q", "mutation": "S221Q", "reference_site": "221", "sequential_site": 233.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06572, "escape": -0.02151, "mature_H5_site": 217.0, "mutant": "T", "mutation": "S221T", "reference_site": "221", "sequential_site": 233.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2128, "escape": 0.3001, "mature_H5_site": 218.0, "mutant": "A", "mutation": "Q222A", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0449, "escape": -0.3825, "mature_H5_site": 218.0, "mutant": "C", "mutation": "Q222C", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2266, "escape": -0.4598, "mature_H5_site": 218.0, "mutant": "D", "mutation": "Q222D", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.052, "escape": -0.08905, "mature_H5_site": 218.0, "mutant": "E", "mutation": "Q222E", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4377, "escape": 0.1148, "mature_H5_site": 218.0, "mutant": "G", "mutation": "Q222G", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1208, "escape": -0.3784, "mature_H5_site": 218.0, "mutant": "I", "mutation": "Q222I", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.164, "escape": 0.07595, "mature_H5_site": 218.0, "mutant": "K", "mutation": "Q222K", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3618, "escape": -0.2867, "mature_H5_site": 218.0, "mutant": "L", "mutation": "Q222L", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00794, "escape": 0.01044, "mature_H5_site": 218.0, "mutant": "M", "mutation": "Q222M", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7274, "escape": -0.1046, "mature_H5_site": 218.0, "mutant": "N", "mutation": "Q222N", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2373, "escape": 0.3201, "mature_H5_site": 218.0, "mutant": "P", "mutation": "Q222P", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6401, "escape": -0.1273, "mature_H5_site": 218.0, "mutant": "R", "mutation": "Q222R", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05038, "escape": 0.2159, "mature_H5_site": 218.0, "mutant": "S", "mutation": "Q222S", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3952, "escape": -0.07952, "mature_H5_site": 218.0, "mutant": "T", "mutation": "Q222T", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04258, "escape": -0.2605, "mature_H5_site": 218.0, "mutant": "V", "mutation": "Q222V", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07365, "escape": -0.4353, "mature_H5_site": 218.0, "mutant": "W", "mutation": "Q222W", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7141, "escape": -0.3384, "mature_H5_site": 218.0, "mutant": "Y", "mutation": "Q222Y", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4831, "escape": -0.1204, "mature_H5_site": 219.0, "mutant": "C", "mutation": "V223C", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7263, "escape": -0.05024, "mature_H5_site": 219.0, "mutant": "F", "mutation": "V223F", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.585, "escape": 0.002036, "mature_H5_site": 219.0, "mutant": "H", "mutation": "V223H", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6187, "escape": -0.03639, "mature_H5_site": 219.0, "mutant": "M", "mutation": "V223M", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.577, "escape": -0.1583, "mature_H5_site": 219.0, "mutant": "N", "mutation": "V223N", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5101, "escape": -0.1419, "mature_H5_site": 219.0, "mutant": "Q", "mutation": "V223Q", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2131, "escape": -0.02995, "mature_H5_site": 219.0, "mutant": "R", "mutation": "V223R", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.241, "escape": -0.2202, "mature_H5_site": 219.0, "mutant": "S", "mutation": "V223S", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6693, "escape": -0.094, "mature_H5_site": 219.0, "mutant": "W", "mutation": "V223W", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02828, "escape": -0.3245, "mature_H5_site": 220.0, "mutant": "A", "mutation": "N224A", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6787, "escape": -0.1694, "mature_H5_site": 220.0, "mutant": "C", "mutation": "N224C", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.381, "escape": -0.07404, "mature_H5_site": 220.0, "mutant": "E", "mutation": "N224E", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6112, "escape": -0.05322, "mature_H5_site": 220.0, "mutant": "F", "mutation": "N224F", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1535, "escape": -0.2386, "mature_H5_site": 220.0, "mutant": "G", "mutation": "N224G", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.008507, "escape": 0.1322, "mature_H5_site": 220.0, "mutant": "K", "mutation": "N224K", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0627, "escape": -0.2598, "mature_H5_site": 220.0, "mutant": "M", "mutation": "N224M", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9023, "escape": 0.2965, "mature_H5_site": 220.0, "mutant": "R", "mutation": "N224R", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1981, "escape": -0.00801, "mature_H5_site": 220.0, "mutant": "S", "mutation": "N224S", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3341, "escape": -0.01176, "mature_H5_site": 220.0, "mutant": "Y", "mutation": "N224Y", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5885, "escape": -0.2541, "mature_H5_site": 221.0, "mutant": "A", "mutation": "G225A", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.563, "escape": -0.2926, "mature_H5_site": 221.0, "mutant": "E", "mutation": "G225E", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4221, "escape": -0.1991, "mature_H5_site": 221.0, "mutant": "F", "mutation": "G225F", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01002, "escape": -0.2823, "mature_H5_site": 221.0, "mutant": "H", "mutation": "G225H", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3914, "escape": -0.3282, "mature_H5_site": 221.0, "mutant": "N", "mutation": "G225N", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9766, "escape": -0.367, "mature_H5_site": 221.0, "mutant": "Q", "mutation": "G225Q", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2233, "escape": -0.175, "mature_H5_site": 221.0, "mutant": "R", "mutation": "G225R", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2021, "escape": -0.09643, "mature_H5_site": 221.0, "mutant": "S", "mutation": "G225S", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.234, "escape": -0.4179, "mature_H5_site": 221.0, "mutant": "W", "mutation": "G225W", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.221, "escape": -0.4736, "mature_H5_site": 221.0, "mutant": "Y", "mutation": "G225Y", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.005089, "escape": -0.1383, "mature_H5_site": 223.0, "mutant": "A", "mutation": "R227A", "reference_site": "227", "sequential_site": 239.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.062, "escape": -0.4187, "mature_H5_site": 223.0, "mutant": "G", "mutation": "R227G", "reference_site": "227", "sequential_site": 239.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08733, "escape": -0.009869, "mature_H5_site": 223.0, "mutant": "K", "mutation": "R227K", "reference_site": "227", "sequential_site": 239.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.373, "escape": -0.8189, "mature_H5_site": 223.0, "mutant": "L", "mutation": "R227L", "reference_site": "227", "sequential_site": 239.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03078, "escape": -0.3459, "mature_H5_site": 223.0, "mutant": "M", "mutation": "R227M", "reference_site": "227", "sequential_site": 239.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07086, "escape": -0.2369, "mature_H5_site": 223.0, "mutant": "Q", "mutation": "R227Q", "reference_site": "227", "sequential_site": 239.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3811, "escape": -0.251, "mature_H5_site": 223.0, "mutant": "S", "mutation": "R227S", "reference_site": "227", "sequential_site": 239.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03982, "escape": -0.3393, "mature_H5_site": 223.0, "mutant": "T", "mutation": "R227T", "reference_site": "227", "sequential_site": 239.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.308, "escape": -0.1733, "mature_H5_site": 223.0, "mutant": "W", "mutation": "R227W", "reference_site": "227", "sequential_site": 239.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7881, "escape": -0.1518, "mature_H5_site": 224.0, "mutant": "A", "mutation": "G228A", "reference_site": "228", "sequential_site": 240.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.221, "escape": -0.3193, "mature_H5_site": 13.0, "mutant": "D", "mutation": "T23D", "reference_site": "23", "sequential_site": 29.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.112, "escape": -0.1033, "mature_H5_site": 13.0, "mutant": "E", "mutation": "T23E", "reference_site": "23", "sequential_site": 29.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.042, "escape": 0.05594, "mature_H5_site": 13.0, "mutant": "K", "mutation": "T23K", "reference_site": "23", "sequential_site": 29.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.851, "escape": -0.119, "mature_H5_site": 13.0, "mutant": "N", "mutation": "T23N", "reference_site": "23", "sequential_site": 29.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.788, "escape": -0.07704, "mature_H5_site": 13.0, "mutant": "R", "mutation": "T23R", "reference_site": "23", "sequential_site": 29.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02638, "escape": -0.5903, "mature_H5_site": 13.0, "mutant": "S", "mutation": "T23S", "reference_site": "23", "sequential_site": 29.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3338, "escape": -0.3908, "mature_H5_site": 226.0, "mutant": "H", "mutation": "M230H", "reference_site": "230", "sequential_site": 242.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6565, "escape": 1.359, "mature_H5_site": 226.0, "mutant": "I", "mutation": "M230I", "reference_site": "230", "sequential_site": 242.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05557, "escape": 2.056, "mature_H5_site": 226.0, "mutant": "V", "mutation": "M230V", "reference_site": "230", "sequential_site": 242.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.441, "escape": -0.4141, "mature_H5_site": 227.0, "mutant": "A", "mutation": "D231A", "reference_site": "231", "sequential_site": 243.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9362, "escape": -0.2495, "mature_H5_site": 227.0, "mutant": "C", "mutation": "D231C", "reference_site": "231", "sequential_site": 243.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05072, "escape": 0.3479, "mature_H5_site": 227.0, "mutant": "E", "mutation": "D231E", "reference_site": "231", "sequential_site": 243.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4206, "escape": 0.02639, "mature_H5_site": 227.0, "mutant": "K", "mutation": "D231K", "reference_site": "231", "sequential_site": 243.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.682, "escape": 0.03431, "mature_H5_site": 227.0, "mutant": "M", "mutation": "D231M", "reference_site": "231", "sequential_site": 243.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03781, "escape": -0.2834, "mature_H5_site": 227.0, "mutant": "N", "mutation": "D231N", "reference_site": "231", "sequential_site": 243.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06307, "escape": -0.06724, "mature_H5_site": 227.0, "mutant": "S", "mutation": "D231S", "reference_site": "231", "sequential_site": 243.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3806, "escape": 0.3759, "mature_H5_site": 227.0, "mutant": "T", "mutation": "D231T", "reference_site": "231", "sequential_site": 243.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6277, "escape": -0.345, "mature_H5_site": 227.0, "mutant": "W", "mutation": "D231W", "reference_site": "231", "sequential_site": 243.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2985, "escape": -0.07793, "mature_H5_site": 227.0, "mutant": "Y", "mutation": "D231Y", "reference_site": "231", "sequential_site": 243.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.305, "escape": -0.1672, "mature_H5_site": 228.0, "mutant": "H", "mutation": "F232H", "reference_site": "232", "sequential_site": 244.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1306, "escape": 0.6761, "mature_H5_site": 228.0, "mutant": "L", "mutation": "F232L", "reference_site": "232", "sequential_site": 244.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01892, "escape": -0.1253, "mature_H5_site": 228.0, "mutant": "W", "mutation": "F232W", "reference_site": "232", "sequential_site": 244.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03671, "escape": -0.2028, "mature_H5_site": 228.0, "mutant": "Y", "mutation": "F232Y", "reference_site": "232", "sequential_site": 244.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3993, "escape": -0.4018, "mature_H5_site": 229.0, "mutant": "A", "mutation": "F233A", "reference_site": "233", "sequential_site": 245.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.809, "escape": 0.0933, "mature_H5_site": 229.0, "mutant": "C", "mutation": "F233C", "reference_site": "233", "sequential_site": 245.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.486, "escape": -0.4298, "mature_H5_site": 229.0, "mutant": "D", "mutation": "F233D", "reference_site": "233", "sequential_site": 245.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9423, "escape": -0.3161, "mature_H5_site": 229.0, "mutant": "E", "mutation": "F233E", "reference_site": "233", "sequential_site": 245.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1909, "escape": 0.05664, "mature_H5_site": 229.0, "mutant": "H", "mutation": "F233H", "reference_site": "233", "sequential_site": 245.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2687, "escape": -0.03716, "mature_H5_site": 229.0, "mutant": "L", "mutation": "F233L", "reference_site": "233", "sequential_site": 245.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5644, "escape": 0.3474, "mature_H5_site": 229.0, "mutant": "Q", "mutation": "F233Q", "reference_site": "233", "sequential_site": 245.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2455, "escape": -0.08315, "mature_H5_site": 229.0, "mutant": "R", "mutation": "F233R", "reference_site": "233", "sequential_site": 245.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9978, "escape": -0.1193, "mature_H5_site": 229.0, "mutant": "S", "mutation": "F233S", "reference_site": "233", "sequential_site": 245.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01381, "escape": 0.04304, "mature_H5_site": 229.0, "mutant": "Y", "mutation": "F233Y", "reference_site": "233", "sequential_site": 245.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4576, "escape": -0.05919, "mature_H5_site": 230.0, "mutant": "F", "mutation": "W234F", "reference_site": "234", "sequential_site": 246.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6301, "escape": -0.1924, "mature_H5_site": 232.0, "mutant": "A", "mutation": "I236A", "reference_site": "236", "sequential_site": 248.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.054, "escape": -0.3181, "mature_H5_site": 232.0, "mutant": "S", "mutation": "I236S", "reference_site": "236", "sequential_site": 248.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0821, "escape": -0.03648, "mature_H5_site": 232.0, "mutant": "T", "mutation": "I236T", "reference_site": "236", "sequential_site": 248.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4451, "escape": -0.02354, "mature_H5_site": 232.0, "mutant": "V", "mutation": "I236V", "reference_site": "236", "sequential_site": 248.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06227, "escape": 0.01228, "mature_H5_site": 235.0, "mutant": "A", "mutation": "P239A", "reference_site": "239", "sequential_site": 251.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00035, "escape": -0.09309, "mature_H5_site": 235.0, "mutant": "C", "mutation": "P239C", "reference_site": "239", "sequential_site": 251.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2724, "escape": -0.1416, "mature_H5_site": 235.0, "mutant": "F", "mutation": "P239F", "reference_site": "239", "sequential_site": 251.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03368, "escape": -0.04589, "mature_H5_site": 235.0, "mutant": "H", "mutation": "P239H", "reference_site": "239", "sequential_site": 251.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1499, "escape": -0.04626, "mature_H5_site": 235.0, "mutant": "I", "mutation": "P239I", "reference_site": "239", "sequential_site": 251.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07137, "escape": 0.073, "mature_H5_site": 235.0, "mutant": "K", "mutation": "P239K", "reference_site": "239", "sequential_site": 251.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03603, "escape": -0.288, "mature_H5_site": 235.0, "mutant": "N", "mutation": "P239N", "reference_site": "239", "sequential_site": 251.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1848, "escape": -0.5516, "mature_H5_site": 235.0, "mutant": "R", "mutation": "P239R", "reference_site": "239", "sequential_site": 251.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03696, "escape": -0.1008, "mature_H5_site": 235.0, "mutant": "T", "mutation": "P239T", "reference_site": "239", "sequential_site": 251.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02009, "escape": -0.005262, "mature_H5_site": 235.0, "mutant": "V", "mutation": "P239V", "reference_site": "239", "sequential_site": 251.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3104, "escape": -0.05136, "mature_H5_site": 14.0, "mutant": "A", "mutation": "E24A", "reference_site": "24", "sequential_site": 30.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01662, "escape": -0.1554, "mature_H5_site": 14.0, "mutant": "C", "mutation": "E24C", "reference_site": "24", "sequential_site": 30.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02677, "escape": -0.1403, "mature_H5_site": 14.0, "mutant": "D", "mutation": "E24D", "reference_site": "24", "sequential_site": 30.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00755, "escape": -0.03972, "mature_H5_site": 14.0, "mutant": "I", "mutation": "E24I", "reference_site": "24", "sequential_site": 30.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07343, "escape": -0.04969, "mature_H5_site": 14.0, "mutant": "K", "mutation": "E24K", "reference_site": "24", "sequential_site": 30.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1671, "escape": -0.08319, "mature_H5_site": 14.0, "mutant": "N", "mutation": "E24N", "reference_site": "24", "sequential_site": 30.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06496, "escape": 0.2355, "mature_H5_site": 14.0, "mutant": "T", "mutation": "E24T", "reference_site": "24", "sequential_site": 30.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09474, "escape": 0.1062, "mature_H5_site": 14.0, "mutant": "V", "mutation": "E24V", "reference_site": "24", "sequential_site": 30.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02058, "escape": 0.1091, "mature_H5_site": 14.0, "mutant": "W", "mutation": "E24W", "reference_site": "24", "sequential_site": 30.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07234, "escape": 0.04931, "mature_H5_site": 14.0, "mutant": "Y", "mutation": "E24Y", "reference_site": "24", "sequential_site": 30.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05736, "escape": 0.06702, "mature_H5_site": 236.0, "mutant": "A", "mutation": "D240A", "reference_site": "240", "sequential_site": 252.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06234, "escape": 0.05281, "mature_H5_site": 236.0, "mutant": "C", "mutation": "D240C", "reference_site": "240", "sequential_site": 252.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00056, "escape": -0.1122, "mature_H5_site": 236.0, "mutant": "E", "mutation": "D240E", "reference_site": "240", "sequential_site": 252.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4038, "escape": 0.1001, "mature_H5_site": 236.0, "mutant": "H", "mutation": "D240H", "reference_site": "240", "sequential_site": 252.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01827, "escape": 0.1972, "mature_H5_site": 236.0, "mutant": "I", "mutation": "D240I", "reference_site": "240", "sequential_site": 252.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1773, "escape": 0.1906, "mature_H5_site": 236.0, "mutant": "K", "mutation": "D240K", "reference_site": "240", "sequential_site": 252.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.162, "escape": 0.1958, "mature_H5_site": 236.0, "mutant": "L", "mutation": "D240L", "reference_site": "240", "sequential_site": 252.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06425, "escape": 0.0594, "mature_H5_site": 236.0, "mutant": "N", "mutation": "D240N", "reference_site": "240", "sequential_site": 252.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2, "escape": 0.3583, "mature_H5_site": 236.0, "mutant": "Q", "mutation": "D240Q", "reference_site": "240", "sequential_site": 252.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.375, "escape": 0.312, "mature_H5_site": 236.0, "mutant": "S", "mutation": "D240S", "reference_site": "240", "sequential_site": 252.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03591, "escape": -0.0242, "mature_H5_site": 236.0, "mutant": "T", "mutation": "D240T", "reference_site": "240", "sequential_site": 252.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2345, "escape": 0.1094, "mature_H5_site": 236.0, "mutant": "V", "mutation": "D240V", "reference_site": "240", "sequential_site": 252.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2791, "escape": 0.1886, "mature_H5_site": 236.0, "mutant": "W", "mutation": "D240W", "reference_site": "240", "sequential_site": 252.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": null, "escape": -0.08335, "mature_H5_site": 236.0, "mutant": "Y", "mutation": "D240Y", "reference_site": "240", "sequential_site": 252.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.638, "escape": -0.3016, "mature_H5_site": 237.0, "mutant": "A", "mutation": "D241A", "reference_site": "241", "sequential_site": 253.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06689, "escape": -0.03766, "mature_H5_site": 237.0, "mutant": "E", "mutation": "D241E", "reference_site": "241", "sequential_site": 253.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9867, "escape": -0.332, "mature_H5_site": 237.0, "mutant": "G", "mutation": "D241G", "reference_site": "241", "sequential_site": 253.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.127, "escape": -0.0269, "mature_H5_site": 238.0, "mutant": "C", "mutation": "A242C", "reference_site": "242", "sequential_site": 254.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00228, "escape": -0.3579, "mature_H5_site": 238.0, "mutant": "D", "mutation": "A242D", "reference_site": "242", "sequential_site": 254.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3154, "escape": -0.3918, "mature_H5_site": 238.0, "mutant": "F", "mutation": "A242F", "reference_site": "242", "sequential_site": 254.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05014, "escape": -0.3156, "mature_H5_site": 238.0, "mutant": "G", "mutation": "A242G", "reference_site": "242", "sequential_site": 254.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7801, "escape": -0.07894, "mature_H5_site": 238.0, "mutant": "H", "mutation": "A242H", "reference_site": "242", "sequential_site": 254.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.898, "escape": -0.2125, "mature_H5_site": 238.0, "mutant": "N", "mutation": "A242N", "reference_site": "242", "sequential_site": 254.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5513, "escape": -0.4264, "mature_H5_site": 238.0, "mutant": "P", "mutation": "A242P", "reference_site": "242", "sequential_site": 254.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02188, "escape": -0.3422, "mature_H5_site": 238.0, "mutant": "S", "mutation": "A242S", "reference_site": "242", "sequential_site": 254.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03773, "escape": 0.006155, "mature_H5_site": 238.0, "mutant": "T", "mutation": "A242T", "reference_site": "242", "sequential_site": 254.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01979, "escape": -0.02396, "mature_H5_site": 238.0, "mutant": "V", "mutation": "A242V", "reference_site": "242", "sequential_site": 254.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04473, "escape": -0.1076, "mature_H5_site": 239.0, "mutant": "L", "mutation": "I243L", "reference_site": "243", "sequential_site": 255.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06378, "escape": -0.2252, "mature_H5_site": 239.0, "mutant": "M", "mutation": "I243M", "reference_site": "243", "sequential_site": 255.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1009, "escape": -0.2416, "mature_H5_site": 239.0, "mutant": "V", "mutation": "I243V", "reference_site": "243", "sequential_site": 255.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.352, "escape": -0.08113, "mature_H5_site": 240.0, "mutant": "E", "mutation": "H244E", "reference_site": "244", "sequential_site": 256.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.005, "escape": 0.07127, "mature_H5_site": 240.0, "mutant": "F", "mutation": "H244F", "reference_site": "244", "sequential_site": 256.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03123, "escape": 0.000747, "mature_H5_site": 240.0, "mutant": "I", "mutation": "H244I", "reference_site": "244", "sequential_site": 256.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1735, "escape": -0.2477, "mature_H5_site": 240.0, "mutant": "L", "mutation": "H244L", "reference_site": "244", "sequential_site": 256.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5471, "escape": -0.4958, "mature_H5_site": 240.0, "mutant": "Q", "mutation": "H244Q", "reference_site": "244", "sequential_site": 256.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8379, "escape": 0.004699, "mature_H5_site": 240.0, "mutant": "S", "mutation": "H244S", "reference_site": "244", "sequential_site": 256.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4743, "escape": 0.1866, "mature_H5_site": 240.0, "mutant": "T", "mutation": "H244T", "reference_site": "244", "sequential_site": 256.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02739, "escape": -0.05427, "mature_H5_site": 240.0, "mutant": "Y", "mutation": "H244Y", "reference_site": "244", "sequential_site": 256.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1846, "escape": 0.04724, "mature_H5_site": 241.0, "mutant": "L", "mutation": "F245L", "reference_site": "245", "sequential_site": 257.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06792, "escape": -0.1247, "mature_H5_site": 241.0, "mutant": "V", "mutation": "F245V", "reference_site": "245", "sequential_site": 257.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2588, "escape": 0.06928, "mature_H5_site": 241.0, "mutant": "W", "mutation": "F245W", "reference_site": "245", "sequential_site": 257.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05965, "escape": 0.003786, "mature_H5_site": 241.0, "mutant": "Y", "mutation": "F245Y", "reference_site": "245", "sequential_site": 257.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4036, "escape": 0.09363, "mature_H5_site": 242.0, "mutant": "A", "mutation": "E246A", "reference_site": "246", "sequential_site": 258.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8272, "escape": -0.1804, "mature_H5_site": 242.0, "mutant": "D", "mutation": "E246D", "reference_site": "246", "sequential_site": 258.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07021, "escape": -0.09178, "mature_H5_site": 242.0, "mutant": "H", "mutation": "E246H", "reference_site": "246", "sequential_site": 258.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1924, "escape": 0.1927, "mature_H5_site": 242.0, "mutant": "I", "mutation": "E246I", "reference_site": "246", "sequential_site": 258.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.639, "escape": 0.339, "mature_H5_site": 242.0, "mutant": "K", "mutation": "E246K", "reference_site": "246", "sequential_site": 258.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5186, "escape": 0.5471, "mature_H5_site": 242.0, "mutant": "L", "mutation": "E246L", "reference_site": "246", "sequential_site": 258.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03527, "escape": -0.1783, "mature_H5_site": 242.0, "mutant": "M", "mutation": "E246M", "reference_site": "246", "sequential_site": 258.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1961, "escape": -0.1448, "mature_H5_site": 242.0, "mutant": "N", "mutation": "E246N", "reference_site": "246", "sequential_site": 258.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.953, "escape": 0.0956, "mature_H5_site": 242.0, "mutant": "R", "mutation": "E246R", "reference_site": "246", "sequential_site": 258.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02232, "escape": -0.09514, "mature_H5_site": 242.0, "mutant": "S", "mutation": "E246S", "reference_site": "246", "sequential_site": 258.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4647, "escape": -0.1743, "mature_H5_site": 242.0, "mutant": "V", "mutation": "E246V", "reference_site": "246", "sequential_site": 258.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1823, "escape": -0.03776, "mature_H5_site": 242.0, "mutant": "W", "mutation": "E246W", "reference_site": "246", "sequential_site": 258.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04611, "escape": -0.05038, "mature_H5_site": 243.0, "mutant": "A", "mutation": "S247A", "reference_site": "247", "sequential_site": 259.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9194, "escape": -0.03282, "mature_H5_site": 243.0, "mutant": "F", "mutation": "S247F", "reference_site": "247", "sequential_site": 259.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5357, "escape": -0.01562, "mature_H5_site": 243.0, "mutant": "T", "mutation": "S247T", "reference_site": "247", "sequential_site": 259.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07866, "escape": -0.1306, "mature_H5_site": 244.0, "mutant": "A", "mutation": "N248A", "reference_site": "248", "sequential_site": 260.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02962, "escape": -0.04534, "mature_H5_site": 244.0, "mutant": "D", "mutation": "N248D", "reference_site": "248", "sequential_site": 260.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4819, "escape": -0.1677, "mature_H5_site": 244.0, "mutant": "E", "mutation": "N248E", "reference_site": "248", "sequential_site": 260.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.067, "escape": -0.07439, "mature_H5_site": 244.0, "mutant": "I", "mutation": "N248I", "reference_site": "248", "sequential_site": 260.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.151, "escape": -0.3569, "mature_H5_site": 244.0, "mutant": "L", "mutation": "N248L", "reference_site": "248", "sequential_site": 260.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9711, "escape": -0.07523, "mature_H5_site": 244.0, "mutant": "M", "mutation": "N248M", "reference_site": "248", "sequential_site": 260.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0659, "escape": -0.2022, "mature_H5_site": 244.0, "mutant": "Q", "mutation": "N248Q", "reference_site": "248", "sequential_site": 260.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1791, "escape": 0.0296, "mature_H5_site": 15.0, "mutant": "C", "mutation": "Q25C", "reference_site": "25", "sequential_site": 31.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2037, "escape": 0.02275, "mature_H5_site": 15.0, "mutant": "E", "mutation": "Q25E", "reference_site": "25", "sequential_site": 31.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9915, "escape": 0.03138, "mature_H5_site": 15.0, "mutant": "I", "mutation": "Q25I", "reference_site": "25", "sequential_site": 31.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05322, "escape": -0.07474, "mature_H5_site": 15.0, "mutant": "K", "mutation": "Q25K", "reference_site": "25", "sequential_site": 31.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4802, "escape": 0.3284, "mature_H5_site": 15.0, "mutant": "L", "mutation": "Q25L", "reference_site": "25", "sequential_site": 31.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0263, "escape": 0.03917, "mature_H5_site": 15.0, "mutant": "N", "mutation": "Q25N", "reference_site": "25", "sequential_site": 31.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2161, "escape": -0.0148, "mature_H5_site": 15.0, "mutant": "R", "mutation": "Q25R", "reference_site": "25", "sequential_site": 31.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05477, "escape": -0.1085, "mature_H5_site": 15.0, "mutant": "W", "mutation": "Q25W", "reference_site": "25", "sequential_site": 31.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5637, "escape": -0.1666, "mature_H5_site": 15.0, "mutant": "Y", "mutation": "Q25Y", "reference_site": "25", "sequential_site": 31.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2077, "escape": -0.4081, "mature_H5_site": 246.0, "mutant": "S", "mutation": "N250S", "reference_site": "250", "sequential_site": 262.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04736, "escape": -0.02703, "mature_H5_site": 247.0, "mutant": "I", "mutation": "F251I", "reference_site": "251", "sequential_site": 263.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3646, "escape": -0.1086, "mature_H5_site": 247.0, "mutant": "L", "mutation": "F251L", "reference_site": "251", "sequential_site": 263.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06907, "escape": -0.2598, "mature_H5_site": 247.0, "mutant": "M", "mutation": "F251M", "reference_site": "251", "sequential_site": 263.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2702, "escape": -0.1423, "mature_H5_site": 247.0, "mutant": "W", "mutation": "F251W", "reference_site": "251", "sequential_site": 263.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1505, "escape": 0.3793, "mature_H5_site": 248.0, "mutant": "L", "mutation": "I252L", "reference_site": "252", "sequential_site": 264.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2476, "escape": 0.001609, "mature_H5_site": 248.0, "mutant": "M", "mutation": "I252M", "reference_site": "252", "sequential_site": 264.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1272, "escape": 0.001794, "mature_H5_site": 248.0, "mutant": "V", "mutation": "I252V", "reference_site": "252", "sequential_site": 264.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02496, "escape": -0.1992, "mature_H5_site": 249.0, "mutant": "C", "mutation": "A253C", "reference_site": "253", "sequential_site": 265.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9725, "escape": 0.1429, "mature_H5_site": 249.0, "mutant": "I", "mutation": "A253I", "reference_site": "253", "sequential_site": 265.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7596, "escape": -0.1382, "mature_H5_site": 249.0, "mutant": "L", "mutation": "A253L", "reference_site": "253", "sequential_site": 265.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0624, "escape": -0.1447, "mature_H5_site": 249.0, "mutant": "P", "mutation": "A253P", "reference_site": "253", "sequential_site": 265.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3065, "escape": -0.1882, "mature_H5_site": 249.0, "mutant": "T", "mutation": "A253T", "reference_site": "253", "sequential_site": 265.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08648, "escape": -0.1344, "mature_H5_site": 249.0, "mutant": "V", "mutation": "A253V", "reference_site": "253", "sequential_site": 265.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.442, "escape": 0.7928, "mature_H5_site": 250.0, "mutant": "A", "mutation": "P254A", "reference_site": "254", "sequential_site": 266.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.545, "escape": 0.187, "mature_H5_site": 250.0, "mutant": "S", "mutation": "P254S", "reference_site": "254", "sequential_site": 266.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08652, "escape": 3.126, "mature_H5_site": 251.0, "mutant": "A", "mutation": "E255A", "reference_site": "255", "sequential_site": 267.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.707, "escape": 2.941, "mature_H5_site": 251.0, "mutant": "D", "mutation": "E255D", "reference_site": "255", "sequential_site": 267.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05388, "escape": 3.184, "mature_H5_site": 251.0, "mutant": "F", "mutation": "E255F", "reference_site": "255", "sequential_site": 267.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.114, "escape": 3.319, "mature_H5_site": 251.0, "mutant": "H", "mutation": "E255H", "reference_site": "255", "sequential_site": 267.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.057, "escape": 3.327, "mature_H5_site": 251.0, "mutant": "I", "mutation": "E255I", "reference_site": "255", "sequential_site": 267.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4098, "escape": 3.32, "mature_H5_site": 251.0, "mutant": "K", "mutation": "E255K", "reference_site": "255", "sequential_site": 267.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01654, "escape": 3.23, "mature_H5_site": 251.0, "mutant": "M", "mutation": "E255M", "reference_site": "255", "sequential_site": 267.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0449, "escape": 3.018, "mature_H5_site": 251.0, "mutant": "Q", "mutation": "E255Q", "reference_site": "255", "sequential_site": 267.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04152, "escape": 3.125, "mature_H5_site": 251.0, "mutant": "R", "mutation": "E255R", "reference_site": "255", "sequential_site": 267.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07055, "escape": 2.971, "mature_H5_site": 251.0, "mutant": "S", "mutation": "E255S", "reference_site": "255", "sequential_site": 267.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2516, "escape": 3.732, "mature_H5_site": 251.0, "mutant": "T", "mutation": "E255T", "reference_site": "255", "sequential_site": 267.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05987, "escape": 3.118, "mature_H5_site": 251.0, "mutant": "V", "mutation": "E255V", "reference_site": "255", "sequential_site": 267.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03663, "escape": 3.479, "mature_H5_site": 251.0, "mutant": "W", "mutation": "E255W", "reference_site": "255", "sequential_site": 267.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02599, "escape": 3.19, "mature_H5_site": 251.0, "mutant": "Y", "mutation": "E255Y", "reference_site": "255", "sequential_site": 267.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1794, "escape": 2.801, "mature_H5_site": 252.0, "mutant": "A", "mutation": "Y256A", "reference_site": "256", "sequential_site": 268.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7673, "escape": 2.224, "mature_H5_site": 252.0, "mutant": "C", "mutation": "Y256C", "reference_site": "256", "sequential_site": 268.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.645, "escape": 2.891, "mature_H5_site": 252.0, "mutant": "E", "mutation": "Y256E", "reference_site": "256", "sequential_site": 268.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3248, "escape": 2.596, "mature_H5_site": 252.0, "mutant": "F", "mutation": "Y256F", "reference_site": "256", "sequential_site": 268.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1096, "escape": -0.1253, "mature_H5_site": 252.0, "mutant": "H", "mutation": "Y256H", "reference_site": "256", "sequential_site": 268.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2811, "escape": 2.17, "mature_H5_site": 252.0, "mutant": "I", "mutation": "Y256I", "reference_site": "256", "sequential_site": 268.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5509, "escape": 3.298, "mature_H5_site": 252.0, "mutant": "K", "mutation": "Y256K", "reference_site": "256", "sequential_site": 268.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1837, "escape": 1.708, "mature_H5_site": 252.0, "mutant": "L", "mutation": "Y256L", "reference_site": "256", "sequential_site": 268.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8669, "escape": 2.49, "mature_H5_site": 252.0, "mutant": "N", "mutation": "Y256N", "reference_site": "256", "sequential_site": 268.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07612, "escape": 0.1525, "mature_H5_site": 252.0, "mutant": "Q", "mutation": "Y256Q", "reference_site": "256", "sequential_site": 268.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04036, "escape": 1.941, "mature_H5_site": 252.0, "mutant": "S", "mutation": "Y256S", "reference_site": "256", "sequential_site": 268.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7166, "escape": 0.5342, "mature_H5_site": 252.0, "mutant": "T", "mutation": "Y256T", "reference_site": "256", "sequential_site": 268.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03938, "escape": 2.364, "mature_H5_site": 252.0, "mutant": "V", "mutation": "Y256V", "reference_site": "256", "sequential_site": 268.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0641, "escape": -0.2495, "mature_H5_site": 252.0, "mutant": "W", "mutation": "Y256W", "reference_site": "256", "sequential_site": 268.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8768, "escape": 0.5673, "mature_H5_site": 253.0, "mutant": "C", "mutation": "A257C", "reference_site": "257", "sequential_site": 269.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.378, "escape": 2.005, "mature_H5_site": 253.0, "mutant": "M", "mutation": "A257M", "reference_site": "257", "sequential_site": 269.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4608, "escape": 0.7846, "mature_H5_site": 253.0, "mutant": "S", "mutation": "A257S", "reference_site": "257", "sequential_site": 269.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7475, "escape": 0.3804, "mature_H5_site": 253.0, "mutant": "V", "mutation": "A257V", "reference_site": "257", "sequential_site": 269.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.191, "escape": 1.556, "mature_H5_site": 254.0, "mutant": "F", "mutation": "Y258F", "reference_site": "258", "sequential_site": 270.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.466, "escape": 0.03375, "mature_H5_site": 254.0, "mutant": "H", "mutation": "Y258H", "reference_site": "258", "sequential_site": 270.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2232, "escape": 0.5119, "mature_H5_site": 254.0, "mutant": "I", "mutation": "Y258I", "reference_site": "258", "sequential_site": 270.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03454, "escape": 0.07415, "mature_H5_site": 254.0, "mutant": "M", "mutation": "Y258M", "reference_site": "258", "sequential_site": 270.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.331, "escape": 0.1523, "mature_H5_site": 254.0, "mutant": "V", "mutation": "Y258V", "reference_site": "258", "sequential_site": 270.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.625, "escape": 0.4128, "mature_H5_site": 254.0, "mutant": "W", "mutation": "Y258W", "reference_site": "258", "sequential_site": 270.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07852, "escape": -0.3565, "mature_H5_site": 255.0, "mutant": "A", "mutation": "K259A", "reference_site": "259", "sequential_site": 271.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.027, "escape": -0.2575, "mature_H5_site": 255.0, "mutant": "E", "mutation": "K259E", "reference_site": "259", "sequential_site": 271.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.286, "escape": -0.1445, "mature_H5_site": 255.0, "mutant": "F", "mutation": "K259F", "reference_site": "259", "sequential_site": 271.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.102, "escape": -0.09893, "mature_H5_site": 255.0, "mutant": "G", "mutation": "K259G", "reference_site": "259", "sequential_site": 271.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6033, "escape": 0.2721, "mature_H5_site": 255.0, "mutant": "H", "mutation": "K259H", "reference_site": "259", "sequential_site": 271.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3481, "escape": -0.04213, "mature_H5_site": 255.0, "mutant": "L", "mutation": "K259L", "reference_site": "259", "sequential_site": 271.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2186, "escape": -0.01192, "mature_H5_site": 255.0, "mutant": "M", "mutation": "K259M", "reference_site": "259", "sequential_site": 271.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.182, "escape": -0.4183, "mature_H5_site": 255.0, "mutant": "Q", "mutation": "K259Q", "reference_site": "259", "sequential_site": 271.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3963, "escape": -0.2106, "mature_H5_site": 255.0, "mutant": "R", "mutation": "K259R", "reference_site": "259", "sequential_site": 271.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03081, "escape": -0.04404, "mature_H5_site": 255.0, "mutant": "S", "mutation": "K259S", "reference_site": "259", "sequential_site": 271.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2181, "escape": 0.02327, "mature_H5_site": 255.0, "mutant": "V", "mutation": "K259V", "reference_site": "259", "sequential_site": 271.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5995, "escape": 0.06171, "mature_H5_site": 16.0, "mutant": "I", "mutation": "V26I", "reference_site": "26", "sequential_site": 32.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07074, "escape": -0.1104, "mature_H5_site": 256.0, "mutant": "A", "mutation": "I260A", "reference_site": "260", "sequential_site": 272.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.726, "escape": -0.1945, "mature_H5_site": 256.0, "mutant": "S", "mutation": "I260S", "reference_site": "260", "sequential_site": 272.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1632, "escape": 0.053, "mature_H5_site": 256.0, "mutant": "V", "mutation": "I260V", "reference_site": "260", "sequential_site": 272.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.751, "escape": -0.2692, "mature_H5_site": 256.0, "mutant": "W", "mutation": "I260W", "reference_site": "260", "sequential_site": 272.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8537, "escape": 0.03938, "mature_H5_site": 257.0, "mutant": "A", "mutation": "V261A", "reference_site": "261", "sequential_site": 273.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04576, "escape": 0.01894, "mature_H5_site": 257.0, "mutant": "C", "mutation": "V261C", "reference_site": "261", "sequential_site": 273.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8042, "escape": 0.2734, "mature_H5_site": 257.0, "mutant": "E", "mutation": "V261E", "reference_site": "261", "sequential_site": 273.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7212, "escape": 0.1575, "mature_H5_site": 257.0, "mutant": "F", "mutation": "V261F", "reference_site": "261", "sequential_site": 273.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4881, "escape": 0.1704, "mature_H5_site": 257.0, "mutant": "K", "mutation": "V261K", "reference_site": "261", "sequential_site": 273.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01508, "escape": -0.1029, "mature_H5_site": 257.0, "mutant": "M", "mutation": "V261M", "reference_site": "261", "sequential_site": 273.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05874, "escape": 0.6357, "mature_H5_site": 257.0, "mutant": "N", "mutation": "V261N", "reference_site": "261", "sequential_site": 273.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3833, "escape": 0.2515, "mature_H5_site": 257.0, "mutant": "S", "mutation": "V261S", "reference_site": "261", "sequential_site": 273.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06115, "escape": 0.01546, "mature_H5_site": 257.0, "mutant": "T", "mutation": "V261T", "reference_site": "261", "sequential_site": 273.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.533, "escape": 1.696, "mature_H5_site": 257.0, "mutant": "W", "mutation": "V261W", "reference_site": "261", "sequential_site": 273.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.901, "escape": 0.6975, "mature_H5_site": 258.0, "mutant": "A", "mutation": "K262A", "reference_site": "262", "sequential_site": 274.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.525, "escape": 0.4963, "mature_H5_site": 258.0, "mutant": "E", "mutation": "K262E", "reference_site": "262", "sequential_site": 274.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.688, "escape": 1.957, "mature_H5_site": 258.0, "mutant": "I", "mutation": "K262I", "reference_site": "262", "sequential_site": 274.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.933, "escape": 0.205, "mature_H5_site": 258.0, "mutant": "L", "mutation": "K262L", "reference_site": "262", "sequential_site": 274.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.799, "escape": 0.5379, "mature_H5_site": 258.0, "mutant": "M", "mutation": "K262M", "reference_site": "262", "sequential_site": 274.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.393, "escape": 1.148, "mature_H5_site": 258.0, "mutant": "N", "mutation": "K262N", "reference_site": "262", "sequential_site": 274.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9813, "escape": 0.1466, "mature_H5_site": 258.0, "mutant": "R", "mutation": "K262R", "reference_site": "262", "sequential_site": 274.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.583, "escape": 1.511, "mature_H5_site": 258.0, "mutant": "T", "mutation": "K262T", "reference_site": "262", "sequential_site": 274.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9504, "escape": 0.04735, "mature_H5_site": 259.0, "mutant": "A", "mutation": "K262aA", "reference_site": "262a", "sequential_site": 275.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5241, "escape": -0.219, "mature_H5_site": 259.0, "mutant": "C", "mutation": "K262aC", "reference_site": "262a", "sequential_site": 275.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08961, "escape": -0.0212, "mature_H5_site": 259.0, "mutant": "E", "mutation": "K262aE", "reference_site": "262a", "sequential_site": 275.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7404, "escape": 0.03558, "mature_H5_site": 259.0, "mutant": "F", "mutation": "K262aF", "reference_site": "262a", "sequential_site": 275.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.779, "escape": -0.00739, "mature_H5_site": 259.0, "mutant": "I", "mutation": "K262aI", "reference_site": "262a", "sequential_site": 275.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.601, "escape": -0.05717, "mature_H5_site": 259.0, "mutant": "L", "mutation": "K262aL", "reference_site": "262a", "sequential_site": 275.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1283, "escape": 0.03092, "mature_H5_site": 259.0, "mutant": "M", "mutation": "K262aM", "reference_site": "262a", "sequential_site": 275.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5621, "escape": 0.6265, "mature_H5_site": 259.0, "mutant": "N", "mutation": "K262aN", "reference_site": "262a", "sequential_site": 275.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08908, "escape": 0.03916, "mature_H5_site": 259.0, "mutant": "P", "mutation": "K262aP", "reference_site": "262a", "sequential_site": 275.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1121, "escape": 0.02385, "mature_H5_site": 259.0, "mutant": "Q", "mutation": "K262aQ", "reference_site": "262a", "sequential_site": 275.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06869, "escape": -0.1759, "mature_H5_site": 259.0, "mutant": "R", "mutation": "K262aR", "reference_site": "262a", "sequential_site": 275.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05537, "escape": -0.06309, "mature_H5_site": 259.0, "mutant": "V", "mutation": "K262aV", "reference_site": "262a", "sequential_site": 275.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4806, "escape": 0.6893, "mature_H5_site": 260.0, "mutant": "N", "mutation": "G263N", "reference_site": "263", "sequential_site": 276.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.199, "escape": 1.558, "mature_H5_site": 260.0, "mutant": "V", "mutation": "G263V", "reference_site": "263", "sequential_site": 276.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04274, "escape": -0.1849, "mature_H5_site": 261.0, "mutant": "E", "mutation": "D264E", "reference_site": "264", "sequential_site": 277.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4896, "escape": -0.1329, "mature_H5_site": 261.0, "mutant": "S", "mutation": "D264S", "reference_site": "264", "sequential_site": 277.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04174, "escape": -0.2379, "mature_H5_site": 261.0, "mutant": "W", "mutation": "D264W", "reference_site": "264", "sequential_site": 277.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07162, "escape": 0.09298, "mature_H5_site": 261.0, "mutant": "Y", "mutation": "D264Y", "reference_site": "264", "sequential_site": 277.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.004765, "escape": 0.09442, "mature_H5_site": 262.0, "mutant": "T", "mutation": "S265T", "reference_site": "265", "sequential_site": 278.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1485, "escape": 0.03634, "mature_H5_site": 263.0, "mutant": "A", "mutation": "T266A", "reference_site": "266", "sequential_site": 279.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.704, "escape": 0.2735, "mature_H5_site": 263.0, "mutant": "D", "mutation": "T266D", "reference_site": "266", "sequential_site": 279.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08722, "escape": -0.1551, "mature_H5_site": 263.0, "mutant": "E", "mutation": "T266E", "reference_site": "266", "sequential_site": 279.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.817, "escape": 1.176, "mature_H5_site": 263.0, "mutant": "G", "mutation": "T266G", "reference_site": "266", "sequential_site": 279.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09486, "escape": 0.03756, "mature_H5_site": 263.0, "mutant": "N", "mutation": "T266N", "reference_site": "266", "sequential_site": 279.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.989, "escape": 0.4391, "mature_H5_site": 263.0, "mutant": "S", "mutation": "T266S", "reference_site": "266", "sequential_site": 279.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2074, "escape": 0.2345, "mature_H5_site": 263.0, "mutant": "V", "mutation": "T266V", "reference_site": "266", "sequential_site": 279.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7231, "escape": 0.02226, "mature_H5_site": 264.0, "mutant": "M", "mutation": "I267M", "reference_site": "267", "sequential_site": 280.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3549, "escape": -0.05063, "mature_H5_site": 264.0, "mutant": "V", "mutation": "I267V", "reference_site": "267", "sequential_site": 280.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0026, "escape": -0.0199, "mature_H5_site": 264.0, "mutant": "Y", "mutation": "I267Y", "reference_site": "267", "sequential_site": 280.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04886, "escape": 0.4472, "mature_H5_site": 265.0, "mutant": "I", "mutation": "M268I", "reference_site": "268", "sequential_site": 281.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6561, "escape": 0.3903, "mature_H5_site": 265.0, "mutant": "L", "mutation": "M268L", "reference_site": "268", "sequential_site": 281.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.97, "escape": -0.1806, "mature_H5_site": 265.0, "mutant": "Y", "mutation": "M268Y", "reference_site": "268", "sequential_site": 281.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06521, "escape": 0.2317, "mature_H5_site": 266.0, "mutant": "A", "mutation": "K269A", "reference_site": "269", "sequential_site": 282.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05252, "escape": 0.03259, "mature_H5_site": 266.0, "mutant": "E", "mutation": "K269E", "reference_site": "269", "sequential_site": 282.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1037, "escape": 0.05929, "mature_H5_site": 266.0, "mutant": "F", "mutation": "K269F", "reference_site": "269", "sequential_site": 282.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1979, "escape": -0.04408, "mature_H5_site": 266.0, "mutant": "G", "mutation": "K269G", "reference_site": "269", "sequential_site": 282.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2601, "escape": -0.0419, "mature_H5_site": 266.0, "mutant": "I", "mutation": "K269I", "reference_site": "269", "sequential_site": 282.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05869, "escape": -0.08159, "mature_H5_site": 266.0, "mutant": "N", "mutation": "K269N", "reference_site": "269", "sequential_site": 282.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3809, "escape": 0.2594, "mature_H5_site": 266.0, "mutant": "P", "mutation": "K269P", "reference_site": "269", "sequential_site": 282.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2058, "escape": 0.1444, "mature_H5_site": 266.0, "mutant": "R", "mutation": "K269R", "reference_site": "269", "sequential_site": 282.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.548, "escape": -0.0195, "mature_H5_site": 266.0, "mutant": "S", "mutation": "K269S", "reference_site": "269", "sequential_site": 282.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2104, "escape": 0.1485, "mature_H5_site": 266.0, "mutant": "W", "mutation": "K269W", "reference_site": "269", "sequential_site": 282.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03421, "escape": 0.03324, "mature_H5_site": 266.0, "mutant": "Y", "mutation": "K269Y", "reference_site": "269", "sequential_site": 282.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3213, "escape": 0.118, "mature_H5_site": 17.0, "mutant": "E", "mutation": "D27E", "reference_site": "27", "sequential_site": 33.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7211, "escape": -0.05772, "mature_H5_site": 17.0, "mutant": "H", "mutation": "D27H", "reference_site": "27", "sequential_site": 33.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.124, "escape": 0.1157, "mature_H5_site": 17.0, "mutant": "N", "mutation": "D27N", "reference_site": "27", "sequential_site": 33.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.137, "escape": -0.3548, "mature_H5_site": 17.0, "mutant": "S", "mutation": "D27S", "reference_site": "27", "sequential_site": 33.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01864, "escape": 0.06901, "mature_H5_site": 267.0, "mutant": "A", "mutation": "S270A", "reference_site": "270", "sequential_site": 283.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8488, "escape": 0.3099, "mature_H5_site": 267.0, "mutant": "G", "mutation": "S270G", "reference_site": "270", "sequential_site": 283.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.244, "escape": -0.03571, "mature_H5_site": 267.0, "mutant": "P", "mutation": "S270P", "reference_site": "270", "sequential_site": 283.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.09, "escape": 0.1177, "mature_H5_site": 267.0, "mutant": "Y", "mutation": "S270Y", "reference_site": "270", "sequential_site": 283.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1557, "escape": -0.07627, "mature_H5_site": 268.0, "mutant": "C", "mutation": "G271C", "reference_site": "271", "sequential_site": 284.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1137, "escape": -0.01943, "mature_H5_site": 268.0, "mutant": "D", "mutation": "G271D", "reference_site": "271", "sequential_site": 284.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01537, "escape": 0.1166, "mature_H5_site": 268.0, "mutant": "E", "mutation": "G271E", "reference_site": "271", "sequential_site": 284.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1898, "escape": -0.00126, "mature_H5_site": 268.0, "mutant": "I", "mutation": "G271I", "reference_site": "271", "sequential_site": 284.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07054, "escape": 0.04142, "mature_H5_site": 268.0, "mutant": "L", "mutation": "G271L", "reference_site": "271", "sequential_site": 284.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.009605, "escape": 0.01691, "mature_H5_site": 268.0, "mutant": "M", "mutation": "G271M", "reference_site": "271", "sequential_site": 284.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2581, "escape": -0.0393, "mature_H5_site": 268.0, "mutant": "N", "mutation": "G271N", "reference_site": "271", "sequential_site": 284.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03999, "escape": -0.0191, "mature_H5_site": 268.0, "mutant": "Q", "mutation": "G271Q", "reference_site": "271", "sequential_site": 284.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1469, "escape": -0.1494, "mature_H5_site": 268.0, "mutant": "R", "mutation": "G271R", "reference_site": "271", "sequential_site": 284.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02725, "escape": -0.1647, "mature_H5_site": 268.0, "mutant": "S", "mutation": "G271S", "reference_site": "271", "sequential_site": 284.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0728, "escape": -0.1069, "mature_H5_site": 268.0, "mutant": "T", "mutation": "G271T", "reference_site": "271", "sequential_site": 284.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8843, "escape": 0.03602, "mature_H5_site": 268.0, "mutant": "Y", "mutation": "G271Y", "reference_site": "271", "sequential_site": 284.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2633, "escape": 0.07199, "mature_H5_site": 269.0, "mutant": "A", "mutation": "V272A", "reference_site": "272", "sequential_site": 285.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08906, "escape": 0.2991, "mature_H5_site": 269.0, "mutant": "C", "mutation": "V272C", "reference_site": "272", "sequential_site": 285.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3006, "escape": -0.1803, "mature_H5_site": 269.0, "mutant": "E", "mutation": "V272E", "reference_site": "272", "sequential_site": 285.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05965, "escape": 0.05267, "mature_H5_site": 269.0, "mutant": "L", "mutation": "V272L", "reference_site": "272", "sequential_site": 285.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8292, "escape": 0.1163, "mature_H5_site": 269.0, "mutant": "M", "mutation": "V272M", "reference_site": "272", "sequential_site": 285.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8411, "escape": -0.1677, "mature_H5_site": 269.0, "mutant": "N", "mutation": "V272N", "reference_site": "272", "sequential_site": 285.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01186, "escape": 0.6109, "mature_H5_site": 269.0, "mutant": "S", "mutation": "V272S", "reference_site": "272", "sequential_site": 285.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2572, "escape": -0.00918, "mature_H5_site": 269.0, "mutant": "T", "mutation": "V272T", "reference_site": "272", "sequential_site": 285.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.205, "escape": -0.1206, "mature_H5_site": 269.0, "mutant": "Y", "mutation": "V272Y", "reference_site": "272", "sequential_site": 285.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04307, "escape": 0.04664, "mature_H5_site": 270.0, "mutant": "D", "mutation": "E273D", "reference_site": "273", "sequential_site": 286.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.008185, "escape": -0.6036, "mature_H5_site": 270.0, "mutant": "F", "mutation": "E273F", "reference_site": "273", "sequential_site": 286.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7489, "escape": -0.1296, "mature_H5_site": 270.0, "mutant": "G", "mutation": "E273G", "reference_site": "273", "sequential_site": 286.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.89, "escape": 0.06686, "mature_H5_site": 270.0, "mutant": "H", "mutation": "E273H", "reference_site": "273", "sequential_site": 286.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05892, "escape": -0.01494, "mature_H5_site": 270.0, "mutant": "K", "mutation": "E273K", "reference_site": "273", "sequential_site": 286.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07617, "escape": -1.197, "mature_H5_site": 270.0, "mutant": "L", "mutation": "E273L", "reference_site": "273", "sequential_site": 286.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5956, "escape": 0.1143, "mature_H5_site": 270.0, "mutant": "N", "mutation": "E273N", "reference_site": "273", "sequential_site": 286.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05613, "escape": -0.1471, "mature_H5_site": 270.0, "mutant": "P", "mutation": "E273P", "reference_site": "273", "sequential_site": 286.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4189, "escape": -0.008385, "mature_H5_site": 270.0, "mutant": "R", "mutation": "E273R", "reference_site": "273", "sequential_site": 286.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.264, "escape": 0.06243, "mature_H5_site": 270.0, "mutant": "S", "mutation": "E273S", "reference_site": "273", "sequential_site": 286.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07145, "escape": -0.05482, "mature_H5_site": 270.0, "mutant": "V", "mutation": "E273V", "reference_site": "273", "sequential_site": 286.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.213, "escape": -0.04024, "mature_H5_site": 270.0, "mutant": "W", "mutation": "E273W", "reference_site": "273", "sequential_site": 286.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1791, "escape": -0.1167, "mature_H5_site": 270.0, "mutant": "Y", "mutation": "E273Y", "reference_site": "273", "sequential_site": 286.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1473, "escape": 0.09561, "mature_H5_site": 271.0, "mutant": "F", "mutation": "Y274F", "reference_site": "274", "sequential_site": 287.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9315, "escape": 0.1384, "mature_H5_site": 271.0, "mutant": "H", "mutation": "Y274H", "reference_site": "274", "sequential_site": 287.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7471, "escape": -0.01539, "mature_H5_site": 271.0, "mutant": "K", "mutation": "Y274K", "reference_site": "274", "sequential_site": 287.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5867, "escape": -0.169, "mature_H5_site": 271.0, "mutant": "L", "mutation": "Y274L", "reference_site": "274", "sequential_site": 287.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3086, "escape": 0.06517, "mature_H5_site": 271.0, "mutant": "M", "mutation": "Y274M", "reference_site": "274", "sequential_site": 287.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5091, "escape": -0.1784, "mature_H5_site": 271.0, "mutant": "Q", "mutation": "Y274Q", "reference_site": "274", "sequential_site": 287.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.342, "escape": -0.2601, "mature_H5_site": 271.0, "mutant": "V", "mutation": "Y274V", "reference_site": "274", "sequential_site": 287.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.374, "escape": 0.09422, "mature_H5_site": 271.0, "mutant": "W", "mutation": "Y274W", "reference_site": "274", "sequential_site": 287.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3067, "escape": 0.04818, "mature_H5_site": 272.0, "mutant": "A", "mutation": "G275A", "reference_site": "275", "sequential_site": 288.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2103, "escape": 0.05373, "mature_H5_site": 272.0, "mutant": "C", "mutation": "G275C", "reference_site": "275", "sequential_site": 288.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1904, "escape": -0.05947, "mature_H5_site": 272.0, "mutant": "D", "mutation": "G275D", "reference_site": "275", "sequential_site": 288.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00481, "escape": 0.3833, "mature_H5_site": 272.0, "mutant": "E", "mutation": "G275E", "reference_site": "275", "sequential_site": 288.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07922, "escape": 0.04893, "mature_H5_site": 272.0, "mutant": "F", "mutation": "G275F", "reference_site": "275", "sequential_site": 288.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05633, "escape": -0.105, "mature_H5_site": 272.0, "mutant": "I", "mutation": "G275I", "reference_site": "275", "sequential_site": 288.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5344, "escape": -0.00448, "mature_H5_site": 272.0, "mutant": "L", "mutation": "G275L", "reference_site": "275", "sequential_site": 288.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": null, "escape": -0.1593, "mature_H5_site": 272.0, "mutant": "M", "mutation": "G275M", "reference_site": "275", "sequential_site": 288.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1075, "escape": 0.05045, "mature_H5_site": 272.0, "mutant": "N", "mutation": "G275N", "reference_site": "275", "sequential_site": 288.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3611, "escape": -0.1017, "mature_H5_site": 272.0, "mutant": "Q", "mutation": "G275Q", "reference_site": "275", "sequential_site": 288.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04569, "escape": 0.3491, "mature_H5_site": 272.0, "mutant": "S", "mutation": "G275S", "reference_site": "275", "sequential_site": 288.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.356, "escape": -0.1783, "mature_H5_site": 272.0, "mutant": "T", "mutation": "G275T", "reference_site": "275", "sequential_site": 288.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7538, "escape": -0.2104, "mature_H5_site": 272.0, "mutant": "V", "mutation": "G275V", "reference_site": "275", "sequential_site": 288.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06164, "escape": 0.1089, "mature_H5_site": 272.0, "mutant": "Y", "mutation": "G275Y", "reference_site": "275", "sequential_site": 288.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04673, "escape": 0.4913, "mature_H5_site": 273.0, "mutant": "A", "mutation": "H276A", "reference_site": "276", "sequential_site": 289.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.639, "escape": 0.7076, "mature_H5_site": 273.0, "mutant": "C", "mutation": "H276C", "reference_site": "276", "sequential_site": 289.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03909, "escape": 0.1201, "mature_H5_site": 273.0, "mutant": "D", "mutation": "H276D", "reference_site": "276", "sequential_site": 289.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0575, "escape": 0.04669, "mature_H5_site": 273.0, "mutant": "E", "mutation": "H276E", "reference_site": "276", "sequential_site": 289.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2528, "escape": -0.118, "mature_H5_site": 273.0, "mutant": "F", "mutation": "H276F", "reference_site": "276", "sequential_site": 289.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1161, "escape": 0.2191, "mature_H5_site": 273.0, "mutant": "I", "mutation": "H276I", "reference_site": "276", "sequential_site": 289.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03018, "escape": 0.1047, "mature_H5_site": 273.0, "mutant": "L", "mutation": "H276L", "reference_site": "276", "sequential_site": 289.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4396, "escape": -1.501, "mature_H5_site": 273.0, "mutant": "M", "mutation": "H276M", "reference_site": "276", "sequential_site": 289.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06345, "escape": 0.03879, "mature_H5_site": 273.0, "mutant": "N", "mutation": "H276N", "reference_site": "276", "sequential_site": 289.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09073, "escape": 0.04115, "mature_H5_site": 273.0, "mutant": "P", "mutation": "H276P", "reference_site": "276", "sequential_site": 289.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05824, "escape": 0.1024, "mature_H5_site": 273.0, "mutant": "Q", "mutation": "H276Q", "reference_site": "276", "sequential_site": 289.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2119, "escape": 0.1065, "mature_H5_site": 273.0, "mutant": "R", "mutation": "H276R", "reference_site": "276", "sequential_site": 289.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07586, "escape": 0.1984, "mature_H5_site": 273.0, "mutant": "S", "mutation": "H276S", "reference_site": "276", "sequential_site": 289.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01836, "escape": 0.15, "mature_H5_site": 273.0, "mutant": "V", "mutation": "H276V", "reference_site": "276", "sequential_site": 289.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6703, "escape": -0.01978, "mature_H5_site": 275.0, "mutant": "A", "mutation": "N278A", "reference_site": "278", "sequential_site": 291.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06275, "escape": -0.005319, "mature_H5_site": 275.0, "mutant": "D", "mutation": "N278D", "reference_site": "278", "sequential_site": 291.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06308, "escape": 0.2006, "mature_H5_site": 275.0, "mutant": "E", "mutation": "N278E", "reference_site": "278", "sequential_site": 291.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03093, "escape": 0.03655, "mature_H5_site": 275.0, "mutant": "G", "mutation": "N278G", "reference_site": "278", "sequential_site": 291.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08326, "escape": 0.133, "mature_H5_site": 275.0, "mutant": "I", "mutation": "N278I", "reference_site": "278", "sequential_site": 291.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04685, "escape": 0.01764, "mature_H5_site": 275.0, "mutant": "Q", "mutation": "N278Q", "reference_site": "278", "sequential_site": 291.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06859, "escape": 0.002574, "mature_H5_site": 275.0, "mutant": "V", "mutation": "N278V", "reference_site": "278", "sequential_site": 291.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1673, "escape": 0.2883, "mature_H5_site": 275.0, "mutant": "W", "mutation": "N278W", "reference_site": "278", "sequential_site": 291.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04979, "escape": -0.107, "mature_H5_site": 276.0, "mutant": "A", "mutation": "T279A", "reference_site": "279", "sequential_site": 292.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6106, "escape": -0.1514, "mature_H5_site": 276.0, "mutant": "E", "mutation": "T279E", "reference_site": "279", "sequential_site": 292.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.607, "escape": -0.09196, "mature_H5_site": 276.0, "mutant": "G", "mutation": "T279G", "reference_site": "279", "sequential_site": 292.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.076, "escape": 0.5816, "mature_H5_site": 276.0, "mutant": "I", "mutation": "T279I", "reference_site": "279", "sequential_site": 292.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.208, "escape": -0.3779, "mature_H5_site": 276.0, "mutant": "L", "mutation": "T279L", "reference_site": "279", "sequential_site": 292.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.149, "escape": -0.2774, "mature_H5_site": 276.0, "mutant": "Q", "mutation": "T279Q", "reference_site": "279", "sequential_site": 292.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.256, "escape": 0.1555, "mature_H5_site": 276.0, "mutant": "R", "mutation": "T279R", "reference_site": "279", "sequential_site": 292.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1961, "escape": 0.03962, "mature_H5_site": 276.0, "mutant": "S", "mutation": "T279S", "reference_site": "279", "sequential_site": 292.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.494, "escape": 0.06834, "mature_H5_site": 276.0, "mutant": "V", "mutation": "T279V", "reference_site": "279", "sequential_site": 292.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2367, "escape": 0.003323, "mature_H5_site": 276.0, "mutant": "Y", "mutation": "T279Y", "reference_site": "279", "sequential_site": 292.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2911, "escape": 0.1925, "mature_H5_site": 277.0, "mutant": "A", "mutation": "K280A", "reference_site": "280", "sequential_site": 293.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4976, "escape": 0.04683, "mature_H5_site": 277.0, "mutant": "D", "mutation": "K280D", "reference_site": "280", "sequential_site": 293.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1043, "escape": -0.5057, "mature_H5_site": 277.0, "mutant": "E", "mutation": "K280E", "reference_site": "280", "sequential_site": 293.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1471, "escape": 0.127, "mature_H5_site": 277.0, "mutant": "F", "mutation": "K280F", "reference_site": "280", "sequential_site": 293.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2482, "escape": 0.1769, "mature_H5_site": 277.0, "mutant": "H", "mutation": "K280H", "reference_site": "280", "sequential_site": 293.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04782, "escape": 0.05046, "mature_H5_site": 277.0, "mutant": "I", "mutation": "K280I", "reference_site": "280", "sequential_site": 293.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1948, "escape": -0.02884, "mature_H5_site": 277.0, "mutant": "M", "mutation": "K280M", "reference_site": "280", "sequential_site": 293.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03372, "escape": -0.03175, "mature_H5_site": 277.0, "mutant": "N", "mutation": "K280N", "reference_site": "280", "sequential_site": 293.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3246, "escape": 0.01967, "mature_H5_site": 277.0, "mutant": "R", "mutation": "K280R", "reference_site": "280", "sequential_site": 293.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.239, "escape": -1.087, "mature_H5_site": 277.0, "mutant": "T", "mutation": "K280T", "reference_site": "280", "sequential_site": 293.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07706, "escape": -0.001231, "mature_H5_site": 277.0, "mutant": "V", "mutation": "K280V", "reference_site": "280", "sequential_site": 293.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1321, "escape": -0.01546, "mature_H5_site": 277.0, "mutant": "W", "mutation": "K280W", "reference_site": "280", "sequential_site": 293.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7026, "escape": -0.04771, "mature_H5_site": 280.0, "mutant": "A", "mutation": "T283A", "reference_site": "283", "sequential_site": 296.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.281, "escape": 0.02255, "mature_H5_site": 280.0, "mutant": "C", "mutation": "T283C", "reference_site": "283", "sequential_site": 296.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00089, "escape": 0.1834, "mature_H5_site": 280.0, "mutant": "S", "mutation": "T283S", "reference_site": "283", "sequential_site": 296.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.361, "escape": -0.04907, "mature_H5_site": 281.0, "mutant": "C", "mutation": "P284C", "reference_site": "284", "sequential_site": 297.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.187, "escape": -0.03394, "mature_H5_site": 281.0, "mutant": "E", "mutation": "P284E", "reference_site": "284", "sequential_site": 297.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.278, "escape": -0.0362, "mature_H5_site": 281.0, "mutant": "I", "mutation": "P284I", "reference_site": "284", "sequential_site": 297.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.218, "escape": 0.2464, "mature_H5_site": 281.0, "mutant": "K", "mutation": "P284K", "reference_site": "284", "sequential_site": 297.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.144, "escape": -0.1057, "mature_H5_site": 281.0, "mutant": "L", "mutation": "P284L", "reference_site": "284", "sequential_site": 297.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.138, "escape": -0.08481, "mature_H5_site": 281.0, "mutant": "N", "mutation": "P284N", "reference_site": "284", "sequential_site": 297.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3004, "escape": -0.1358, "mature_H5_site": 281.0, "mutant": "Q", "mutation": "P284Q", "reference_site": "284", "sequential_site": 297.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8283, "escape": -0.09192, "mature_H5_site": 281.0, "mutant": "S", "mutation": "P284S", "reference_site": "284", "sequential_site": 297.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.185, "escape": 0.03583, "mature_H5_site": 281.0, "mutant": "W", "mutation": "P284W", "reference_site": "284", "sequential_site": 297.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6299, "escape": 0.2545, "mature_H5_site": 282.0, "mutant": "C", "mutation": "V285C", "reference_site": "285", "sequential_site": 298.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04041, "escape": -0.0299, "mature_H5_site": 282.0, "mutant": "D", "mutation": "V285D", "reference_site": "285", "sequential_site": 298.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.134, "escape": -0.176, "mature_H5_site": 282.0, "mutant": "E", "mutation": "V285E", "reference_site": "285", "sequential_site": 298.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04734, "escape": 0.09359, "mature_H5_site": 282.0, "mutant": "F", "mutation": "V285F", "reference_site": "285", "sequential_site": 298.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4318, "escape": -0.2018, "mature_H5_site": 282.0, "mutant": "H", "mutation": "V285H", "reference_site": "285", "sequential_site": 298.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5692, "escape": -0.0002749, "mature_H5_site": 282.0, "mutant": "K", "mutation": "V285K", "reference_site": "285", "sequential_site": 298.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05529, "escape": -0.1611, "mature_H5_site": 282.0, "mutant": "L", "mutation": "V285L", "reference_site": "285", "sequential_site": 298.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02511, "escape": -0.2199, "mature_H5_site": 282.0, "mutant": "M", "mutation": "V285M", "reference_site": "285", "sequential_site": 298.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03936, "escape": -0.1286, "mature_H5_site": 282.0, "mutant": "R", "mutation": "V285R", "reference_site": "285", "sequential_site": 298.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.141, "escape": 0.5087, "mature_H5_site": 282.0, "mutant": "T", "mutation": "V285T", "reference_site": "285", "sequential_site": 298.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1219, "escape": -0.002267, "mature_H5_site": 282.0, "mutant": "Y", "mutation": "V285Y", "reference_site": "285", "sequential_site": 298.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.212, "escape": -0.1622, "mature_H5_site": 284.0, "mutant": "C", "mutation": "A287C", "reference_site": "287", "sequential_site": 300.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03492, "escape": -0.1773, "mature_H5_site": 284.0, "mutant": "G", "mutation": "A287G", "reference_site": "287", "sequential_site": 300.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3706, "escape": -0.2602, "mature_H5_site": 284.0, "mutant": "S", "mutation": "A287S", "reference_site": "287", "sequential_site": 300.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.235, "escape": 0.0668, "mature_H5_site": 284.0, "mutant": "T", "mutation": "A287T", "reference_site": "287", "sequential_site": 300.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6565, "escape": 0.03409, "mature_H5_site": 285.0, "mutant": "L", "mutation": "I288L", "reference_site": "288", "sequential_site": 301.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3081, "escape": -0.07684, "mature_H5_site": 285.0, "mutant": "T", "mutation": "I288T", "reference_site": "288", "sequential_site": 301.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07299, "escape": 0.2384, "mature_H5_site": 285.0, "mutant": "V", "mutation": "I288V", "reference_site": "288", "sequential_site": 301.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2427, "escape": 0.04257, "mature_H5_site": 286.0, "mutant": "C", "mutation": "N289C", "reference_site": "289", "sequential_site": 302.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02386, "escape": 0.02426, "mature_H5_site": 286.0, "mutant": "D", "mutation": "N289D", "reference_site": "289", "sequential_site": 302.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6729, "escape": -0.1265, "mature_H5_site": 286.0, "mutant": "E", "mutation": "N289E", "reference_site": "289", "sequential_site": 302.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5121, "escape": -0.06328, "mature_H5_site": 286.0, "mutant": "F", "mutation": "N289F", "reference_site": "289", "sequential_site": 302.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.476, "escape": 0.3273, "mature_H5_site": 286.0, "mutant": "H", "mutation": "N289H", "reference_site": "289", "sequential_site": 302.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8409, "escape": 0.2134, "mature_H5_site": 286.0, "mutant": "K", "mutation": "N289K", "reference_site": "289", "sequential_site": 302.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2793, "escape": 0.258, "mature_H5_site": 286.0, "mutant": "L", "mutation": "N289L", "reference_site": "289", "sequential_site": 302.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3157, "escape": 0.1481, "mature_H5_site": 286.0, "mutant": "M", "mutation": "N289M", "reference_site": "289", "sequential_site": 302.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7309, "escape": 0.1648, "mature_H5_site": 286.0, "mutant": "P", "mutation": "N289P", "reference_site": "289", "sequential_site": 302.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05491, "escape": 0.06495, "mature_H5_site": 286.0, "mutant": "Q", "mutation": "N289Q", "reference_site": "289", "sequential_site": 302.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5173, "escape": -0.3161, "mature_H5_site": 286.0, "mutant": "R", "mutation": "N289R", "reference_site": "289", "sequential_site": 302.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2118, "escape": 0.172, "mature_H5_site": 286.0, "mutant": "S", "mutation": "N289S", "reference_site": "289", "sequential_site": 302.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7815, "escape": 0.2078, "mature_H5_site": 286.0, "mutant": "T", "mutation": "N289T", "reference_site": "289", "sequential_site": 302.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.64, "escape": 0.1778, "mature_H5_site": 286.0, "mutant": "V", "mutation": "N289V", "reference_site": "289", "sequential_site": 302.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.375, "escape": -0.1896, "mature_H5_site": 286.0, "mutant": "Y", "mutation": "N289Y", "reference_site": "289", "sequential_site": 302.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.212, "escape": 0.1309, "mature_H5_site": 19.0, "mutant": "F", "mutation": "I29F", "reference_site": "29", "sequential_site": 35.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.404, "escape": -0.1265, "mature_H5_site": 19.0, "mutant": "N", "mutation": "I29N", "reference_site": "29", "sequential_site": 35.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.142, "escape": 0.03662, "mature_H5_site": 19.0, "mutant": "Q", "mutation": "I29Q", "reference_site": "29", "sequential_site": 35.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.179, "escape": 0.4818, "mature_H5_site": 19.0, "mutant": "S", "mutation": "I29S", "reference_site": "29", "sequential_site": 35.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3447, "escape": -0.03608, "mature_H5_site": 19.0, "mutant": "V", "mutation": "I29V", "reference_site": "29", "sequential_site": 35.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.062, "escape": 0.4707, "mature_H5_site": 19.0, "mutant": "W", "mutation": "I29W", "reference_site": "29", "sequential_site": 35.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4521, "escape": 0.3005, "mature_H5_site": 287.0, "mutant": "A", "mutation": "S290A", "reference_site": "290", "sequential_site": 303.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.79, "escape": 0.00938, "mature_H5_site": 287.0, "mutant": "D", "mutation": "S290D", "reference_site": "290", "sequential_site": 303.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4681, "escape": -0.1667, "mature_H5_site": 287.0, "mutant": "F", "mutation": "S290F", "reference_site": "290", "sequential_site": 303.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4433, "escape": 0.05783, "mature_H5_site": 287.0, "mutant": "H", "mutation": "S290H", "reference_site": "290", "sequential_site": 303.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8901, "escape": -0.02908, "mature_H5_site": 287.0, "mutant": "I", "mutation": "S290I", "reference_site": "290", "sequential_site": 303.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.141, "escape": -0.0779, "mature_H5_site": 287.0, "mutant": "L", "mutation": "S290L", "reference_site": "290", "sequential_site": 303.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.687, "escape": 0.03605, "mature_H5_site": 287.0, "mutant": "M", "mutation": "S290M", "reference_site": "290", "sequential_site": 303.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02721, "escape": 0.2192, "mature_H5_site": 287.0, "mutant": "N", "mutation": "S290N", "reference_site": "290", "sequential_site": 303.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": null, "escape": -0.1196, "mature_H5_site": null, "mutant": "R", "mutation": "S290R", "reference_site": "290", "sequential_site": null, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1778, "escape": 0.189, "mature_H5_site": 287.0, "mutant": "T", "mutation": "S290T", "reference_site": "290", "sequential_site": 303.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4178, "escape": 0.1528, "mature_H5_site": 287.0, "mutant": "V", "mutation": "S290V", "reference_site": "290", "sequential_site": 303.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.708, "escape": 1.208, "mature_H5_site": 287.0, "mutant": "W", "mutation": "S290W", "reference_site": "290", "sequential_site": 303.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.034, "escape": 0.01686, "mature_H5_site": 287.0, "mutant": "Y", "mutation": "S290Y", "reference_site": "290", "sequential_site": 303.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.512, "escape": 0.008697, "mature_H5_site": 288.0, "mutant": "D", "mutation": "S291D", "reference_site": "291", "sequential_site": 304.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01435, "escape": 0.08652, "mature_H5_site": 288.0, "mutant": "E", "mutation": "S291E", "reference_site": "291", "sequential_site": 304.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3417, "escape": 0.6023, "mature_H5_site": 288.0, "mutant": "F", "mutation": "S291F", "reference_site": "291", "sequential_site": 304.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1044, "escape": 0.1239, "mature_H5_site": 288.0, "mutant": "G", "mutation": "S291G", "reference_site": "291", "sequential_site": 304.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4173, "escape": 0.5732, "mature_H5_site": 288.0, "mutant": "H", "mutation": "S291H", "reference_site": "291", "sequential_site": 304.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3105, "escape": 0.4457, "mature_H5_site": 288.0, "mutant": "I", "mutation": "S291I", "reference_site": "291", "sequential_site": 304.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9585, "escape": 0.5022, "mature_H5_site": 288.0, "mutant": "K", "mutation": "S291K", "reference_site": "291", "sequential_site": 304.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.112, "escape": 0.8865, "mature_H5_site": 288.0, "mutant": "L", "mutation": "S291L", "reference_site": "291", "sequential_site": 304.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1897, "escape": 0.02779, "mature_H5_site": 288.0, "mutant": "N", "mutation": "S291N", "reference_site": "291", "sequential_site": 304.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4923, "escape": -0.03973, "mature_H5_site": 288.0, "mutant": "P", "mutation": "S291P", "reference_site": "291", "sequential_site": 304.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2441, "escape": 0.1474, "mature_H5_site": 288.0, "mutant": "Q", "mutation": "S291Q", "reference_site": "291", "sequential_site": 304.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04824, "escape": -0.05479, "mature_H5_site": 288.0, "mutant": "T", "mutation": "S291T", "reference_site": "291", "sequential_site": 304.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.921, "escape": 0.337, "mature_H5_site": 288.0, "mutant": "Y", "mutation": "S291Y", "reference_site": "291", "sequential_site": 304.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07493, "escape": 0.1631, "mature_H5_site": 289.0, "mutant": "A", "mutation": "M292A", "reference_site": "292", "sequential_site": 305.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.104, "escape": 0.1067, "mature_H5_site": 289.0, "mutant": "C", "mutation": "M292C", "reference_site": "292", "sequential_site": 305.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4671, "escape": -0.3098, "mature_H5_site": 289.0, "mutant": "E", "mutation": "M292E", "reference_site": "292", "sequential_site": 305.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3826, "escape": 1.049, "mature_H5_site": 289.0, "mutant": "F", "mutation": "M292F", "reference_site": "292", "sequential_site": 305.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.628, "escape": -0.08928, "mature_H5_site": 289.0, "mutant": "G", "mutation": "M292G", "reference_site": "292", "sequential_site": 305.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9509, "escape": -0.05645, "mature_H5_site": 289.0, "mutant": "H", "mutation": "M292H", "reference_site": "292", "sequential_site": 305.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5777, "escape": 0.111, "mature_H5_site": 289.0, "mutant": "I", "mutation": "M292I", "reference_site": "292", "sequential_site": 305.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5759, "escape": -0.001539, "mature_H5_site": 289.0, "mutant": "K", "mutation": "M292K", "reference_site": "292", "sequential_site": 305.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1714, "escape": -0.04587, "mature_H5_site": 289.0, "mutant": "L", "mutation": "M292L", "reference_site": "292", "sequential_site": 305.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2639, "escape": 0.09799, "mature_H5_site": 289.0, "mutant": "N", "mutation": "M292N", "reference_site": "292", "sequential_site": 305.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4293, "escape": -0.02658, "mature_H5_site": 289.0, "mutant": "Q", "mutation": "M292Q", "reference_site": "292", "sequential_site": 305.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.195, "escape": 0.07516, "mature_H5_site": 289.0, "mutant": "R", "mutation": "M292R", "reference_site": "292", "sequential_site": 305.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03645, "escape": 0.0538, "mature_H5_site": 289.0, "mutant": "V", "mutation": "M292V", "reference_site": "292", "sequential_site": 305.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9639, "escape": -0.1531, "mature_H5_site": 290.0, "mutant": "A", "mutation": "P293A", "reference_site": "293", "sequential_site": 306.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.288, "escape": 0.1159, "mature_H5_site": 290.0, "mutant": "I", "mutation": "P293I", "reference_site": "293", "sequential_site": 306.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.104, "escape": 0.1579, "mature_H5_site": 290.0, "mutant": "S", "mutation": "P293S", "reference_site": "293", "sequential_site": 306.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.006, "escape": -0.122, "mature_H5_site": 291.0, "mutant": "W", "mutation": "F294W", "reference_site": "294", "sequential_site": 307.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.033, "escape": 0.1342, "mature_H5_site": 292.0, "mutant": "E", "mutation": "H295E", "reference_site": "295", "sequential_site": 308.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1798, "escape": 0.1199, "mature_H5_site": 292.0, "mutant": "M", "mutation": "H295M", "reference_site": "295", "sequential_site": 308.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.243, "escape": 0.3084, "mature_H5_site": 292.0, "mutant": "N", "mutation": "H295N", "reference_site": "295", "sequential_site": 308.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5552, "escape": 0.05817, "mature_H5_site": 292.0, "mutant": "Q", "mutation": "H295Q", "reference_site": "295", "sequential_site": 308.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2204, "escape": 0.0707, "mature_H5_site": 293.0, "mutant": "C", "mutation": "N296C", "reference_site": "296", "sequential_site": 309.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.482, "escape": 0.2873, "mature_H5_site": 293.0, "mutant": "G", "mutation": "N296G", "reference_site": "296", "sequential_site": 309.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.011, "escape": 0.4794, "mature_H5_site": 293.0, "mutant": "H", "mutation": "N296H", "reference_site": "296", "sequential_site": 309.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9063, "escape": -0.007098, "mature_H5_site": 293.0, "mutant": "K", "mutation": "N296K", "reference_site": "296", "sequential_site": 309.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.267, "escape": -0.2047, "mature_H5_site": 293.0, "mutant": "M", "mutation": "N296M", "reference_site": "296", "sequential_site": 309.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.692, "escape": -0.338, "mature_H5_site": 294.0, "mutant": "A", "mutation": "I297A", "reference_site": "297", "sequential_site": 310.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.356, "escape": -0.1556, "mature_H5_site": 294.0, "mutant": "C", "mutation": "I297C", "reference_site": "297", "sequential_site": 310.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4859, "escape": 0.0125, "mature_H5_site": 295.0, "mutant": "A", "mutation": "H298A", "reference_site": "298", "sequential_site": 311.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1668, "escape": 0.2826, "mature_H5_site": 295.0, "mutant": "C", "mutation": "H298C", "reference_site": "298", "sequential_site": 311.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.268, "escape": 0.1671, "mature_H5_site": 295.0, "mutant": "E", "mutation": "H298E", "reference_site": "298", "sequential_site": 311.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.212, "escape": 0.04681, "mature_H5_site": 295.0, "mutant": "F", "mutation": "H298F", "reference_site": "298", "sequential_site": 311.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.829, "escape": 0.8958, "mature_H5_site": 295.0, "mutant": "G", "mutation": "H298G", "reference_site": "298", "sequential_site": 311.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3204, "escape": 0.000618, "mature_H5_site": 295.0, "mutant": "I", "mutation": "H298I", "reference_site": "298", "sequential_site": 311.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4391, "escape": -0.2701, "mature_H5_site": 295.0, "mutant": "M", "mutation": "H298M", "reference_site": "298", "sequential_site": 311.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04058, "escape": 0.141, "mature_H5_site": 295.0, "mutant": "N", "mutation": "H298N", "reference_site": "298", "sequential_site": 311.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01038, "escape": 0.04178, "mature_H5_site": 295.0, "mutant": "S", "mutation": "H298S", "reference_site": "298", "sequential_site": 311.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5103, "escape": -0.298, "mature_H5_site": 295.0, "mutant": "V", "mutation": "H298V", "reference_site": "298", "sequential_site": 311.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.174, "escape": 0.1174, "mature_H5_site": 295.0, "mutant": "W", "mutation": "H298W", "reference_site": "298", "sequential_site": 311.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.371, "escape": -1.081, "mature_H5_site": 295.0, "mutant": "Y", "mutation": "H298Y", "reference_site": "298", "sequential_site": 311.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3082, "escape": -0.2207, "mature_H5_site": 296.0, "mutant": "A", "mutation": "P299A", "reference_site": "299", "sequential_site": 312.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.869, "escape": -0.05164, "mature_H5_site": 296.0, "mutant": "D", "mutation": "P299D", "reference_site": "299", "sequential_site": 312.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05282, "escape": -0.02014, "mature_H5_site": 296.0, "mutant": "E", "mutation": "P299E", "reference_site": "299", "sequential_site": 312.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5805, "escape": 0.05537, "mature_H5_site": 296.0, "mutant": "F", "mutation": "P299F", "reference_site": "299", "sequential_site": 312.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.298, "escape": 0.1465, "mature_H5_site": 296.0, "mutant": "H", "mutation": "P299H", "reference_site": "299", "sequential_site": 312.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6738, "escape": 0.242, "mature_H5_site": 296.0, "mutant": "K", "mutation": "P299K", "reference_site": "299", "sequential_site": 312.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.341, "escape": 0.8721, "mature_H5_site": 296.0, "mutant": "L", "mutation": "P299L", "reference_site": "299", "sequential_site": 312.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1411, "escape": -0.05898, "mature_H5_site": 296.0, "mutant": "M", "mutation": "P299M", "reference_site": "299", "sequential_site": 312.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.006735, "escape": 0.1042, "mature_H5_site": 296.0, "mutant": "Q", "mutation": "P299Q", "reference_site": "299", "sequential_site": 312.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02747, "escape": 0.003139, "mature_H5_site": 296.0, "mutant": "R", "mutation": "P299R", "reference_site": "299", "sequential_site": 312.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3645, "escape": 0.2847, "mature_H5_site": 296.0, "mutant": "S", "mutation": "P299S", "reference_site": "299", "sequential_site": 312.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3982, "escape": 0.1284, "mature_H5_site": 296.0, "mutant": "V", "mutation": "P299V", "reference_site": "299", "sequential_site": 312.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.009955, "escape": -0.03678, "mature_H5_site": 296.0, "mutant": "W", "mutation": "P299W", "reference_site": "299", "sequential_site": 312.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.274, "escape": -0.08361, "mature_H5_site": 296.0, "mutant": "Y", "mutation": "P299Y", "reference_site": "299", "sequential_site": 312.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09102, "escape": -0.4294, "mature_H5_site": -8.0, "mutant": "C", "mutation": "A3C", "reference_site": "3", "sequential_site": 9.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04236, "escape": -0.001673, "mature_H5_site": -8.0, "mutant": "F", "mutation": "A3F", "reference_site": "3", "sequential_site": 9.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.115, "escape": -0.03357, "mature_H5_site": -8.0, "mutant": "G", "mutation": "A3G", "reference_site": "3", "sequential_site": 9.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1002, "escape": 0.1151, "mature_H5_site": -8.0, "mutant": "I", "mutation": "A3I", "reference_site": "3", "sequential_site": 9.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01363, "escape": -0.03805, "mature_H5_site": -8.0, "mutant": "M", "mutation": "A3M", "reference_site": "3", "sequential_site": 9.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.024, "escape": -0.2068, "mature_H5_site": -8.0, "mutant": "P", "mutation": "A3P", "reference_site": "3", "sequential_site": 9.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.291, "escape": -0.01417, "mature_H5_site": -8.0, "mutant": "S", "mutation": "A3S", "reference_site": "3", "sequential_site": 9.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1812, "escape": -0.1589, "mature_H5_site": -8.0, "mutant": "T", "mutation": "A3T", "reference_site": "3", "sequential_site": 9.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1149, "escape": 0.02894, "mature_H5_site": -8.0, "mutant": "W", "mutation": "A3W", "reference_site": "3", "sequential_site": 9.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0315, "escape": -0.004542, "mature_H5_site": -8.0, "mutant": "Y", "mutation": "A3Y", "reference_site": "3", "sequential_site": 9.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3339, "escape": 0.08438, "mature_H5_site": 20.0, "mutant": "I", "mutation": "M30I", "reference_site": "30", "sequential_site": 36.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05798, "escape": 0.2975, "mature_H5_site": 20.0, "mutant": "L", "mutation": "M30L", "reference_site": "30", "sequential_site": 36.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.603, "escape": -0.03278, "mature_H5_site": 20.0, "mutant": "Q", "mutation": "M30Q", "reference_site": "30", "sequential_site": 36.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01377, "escape": -0.03566, "mature_H5_site": 20.0, "mutant": "R", "mutation": "M30R", "reference_site": "30", "sequential_site": 36.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.258, "escape": 0.1893, "mature_H5_site": 20.0, "mutant": "T", "mutation": "M30T", "reference_site": "30", "sequential_site": 36.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.516, "escape": -0.1021, "mature_H5_site": 20.0, "mutant": "V", "mutation": "M30V", "reference_site": "30", "sequential_site": 36.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.746, "escape": 0.1443, "mature_H5_site": 20.0, "mutant": "W", "mutation": "M30W", "reference_site": "30", "sequential_site": 36.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02554, "escape": -0.06126, "mature_H5_site": 20.0, "mutant": "Y", "mutation": "M30Y", "reference_site": "30", "sequential_site": 36.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2448, "escape": -0.08752, "mature_H5_site": 297.0, "mutant": "C", "mutation": "L300C", "reference_site": "300", "sequential_site": 313.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5598, "escape": 0.199, "mature_H5_site": 297.0, "mutant": "H", "mutation": "L300H", "reference_site": "300", "sequential_site": 313.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.324, "escape": 0.1142, "mature_H5_site": 297.0, "mutant": "I", "mutation": "L300I", "reference_site": "300", "sequential_site": 313.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3473, "escape": 0.2038, "mature_H5_site": 297.0, "mutant": "M", "mutation": "L300M", "reference_site": "300", "sequential_site": 313.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06018, "escape": 0.2664, "mature_H5_site": 297.0, "mutant": "N", "mutation": "L300N", "reference_site": "300", "sequential_site": 313.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2622, "escape": 0.02107, "mature_H5_site": 297.0, "mutant": "S", "mutation": "L300S", "reference_site": "300", "sequential_site": 313.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6339, "escape": -0.1377, "mature_H5_site": 297.0, "mutant": "T", "mutation": "L300T", "reference_site": "300", "sequential_site": 313.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8056, "escape": 0.2608, "mature_H5_site": 297.0, "mutant": "Y", "mutation": "L300Y", "reference_site": "300", "sequential_site": 313.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.639, "escape": -0.03079, "mature_H5_site": 298.0, "mutant": "A", "mutation": "T301A", "reference_site": "301", "sequential_site": 314.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.795, "escape": 0.00571, "mature_H5_site": 298.0, "mutant": "I", "mutation": "T301I", "reference_site": "301", "sequential_site": 314.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0938, "escape": 0.06181, "mature_H5_site": 298.0, "mutant": "L", "mutation": "T301L", "reference_site": "301", "sequential_site": 314.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5401, "escape": -0.1401, "mature_H5_site": 298.0, "mutant": "M", "mutation": "T301M", "reference_site": "301", "sequential_site": 314.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2265, "escape": 0.109, "mature_H5_site": 298.0, "mutant": "N", "mutation": "T301N", "reference_site": "301", "sequential_site": 314.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01294, "escape": 0.2102, "mature_H5_site": 298.0, "mutant": "Q", "mutation": "T301Q", "reference_site": "301", "sequential_site": 314.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3608, "escape": 0.05882, "mature_H5_site": 298.0, "mutant": "V", "mutation": "T301V", "reference_site": "301", "sequential_site": 314.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1224, "escape": 0.4613, "mature_H5_site": 298.0, "mutant": "Y", "mutation": "T301Y", "reference_site": "301", "sequential_site": 314.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.574, "escape": -0.01192, "mature_H5_site": 299.0, "mutant": "A", "mutation": "I302A", "reference_site": "302", "sequential_site": 315.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05906, "escape": 0.2275, "mature_H5_site": 299.0, "mutant": "L", "mutation": "I302L", "reference_site": "302", "sequential_site": 315.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7368, "escape": 0.0008577, "mature_H5_site": 299.0, "mutant": "M", "mutation": "I302M", "reference_site": "302", "sequential_site": 315.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.171, "escape": 0.1071, "mature_H5_site": 299.0, "mutant": "T", "mutation": "I302T", "reference_site": "302", "sequential_site": 315.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06557, "escape": 0.2954, "mature_H5_site": 299.0, "mutant": "V", "mutation": "I302V", "reference_site": "302", "sequential_site": 315.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4521, "escape": 0.2992, "mature_H5_site": 301.0, "mutant": "A", "mutation": "E304A", "reference_site": "304", "sequential_site": 317.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.556, "escape": -0.1354, "mature_H5_site": 301.0, "mutant": "D", "mutation": "E304D", "reference_site": "304", "sequential_site": 317.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.296, "escape": 0.5005, "mature_H5_site": 301.0, "mutant": "F", "mutation": "E304F", "reference_site": "304", "sequential_site": 317.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7993, "escape": 0.0914, "mature_H5_site": 301.0, "mutant": "G", "mutation": "E304G", "reference_site": "304", "sequential_site": 317.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7413, "escape": 0.08975, "mature_H5_site": 301.0, "mutant": "H", "mutation": "E304H", "reference_site": "304", "sequential_site": 317.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.001, "escape": 0.3356, "mature_H5_site": 301.0, "mutant": "I", "mutation": "E304I", "reference_site": "304", "sequential_site": 317.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.052, "escape": -0.09664, "mature_H5_site": 301.0, "mutant": "K", "mutation": "E304K", "reference_site": "304", "sequential_site": 317.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2023, "escape": 0.08349, "mature_H5_site": 301.0, "mutant": "M", "mutation": "E304M", "reference_site": "304", "sequential_site": 317.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.965, "escape": 0.1921, "mature_H5_site": 301.0, "mutant": "R", "mutation": "E304R", "reference_site": "304", "sequential_site": 317.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08097, "escape": 0.02439, "mature_H5_site": 301.0, "mutant": "S", "mutation": "E304S", "reference_site": "304", "sequential_site": 317.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06391, "escape": 0.113, "mature_H5_site": 301.0, "mutant": "V", "mutation": "E304V", "reference_site": "304", "sequential_site": 317.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.136, "escape": 0.2232, "mature_H5_site": 303.0, "mutant": "G", "mutation": "P306G", "reference_site": "306", "sequential_site": 319.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.445, "escape": -0.3103, "mature_H5_site": 304.0, "mutant": "E", "mutation": "K307E", "reference_site": "307", "sequential_site": 320.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.498, "escape": 0.005968, "mature_H5_site": 304.0, "mutant": "H", "mutation": "K307H", "reference_site": "307", "sequential_site": 320.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.319, "escape": 0.757, "mature_H5_site": 304.0, "mutant": "R", "mutation": "K307R", "reference_site": "307", "sequential_site": 320.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.49, "escape": -0.4236, "mature_H5_site": 304.0, "mutant": "V", "mutation": "K307V", "reference_site": "307", "sequential_site": 320.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.817, "escape": -0.02406, "mature_H5_site": 306.0, "mutant": "C", "mutation": "V309C", "reference_site": "309", "sequential_site": 322.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.686, "escape": -0.3853, "mature_H5_site": 306.0, "mutant": "L", "mutation": "V309L", "reference_site": "309", "sequential_site": 322.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.359, "escape": -0.09407, "mature_H5_site": 306.0, "mutant": "T", "mutation": "V309T", "reference_site": "309", "sequential_site": 322.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2336, "escape": -0.0339, "mature_H5_site": 21.0, "mutant": "A", "mutation": "E31A", "reference_site": "31", "sequential_site": 37.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7526, "escape": -0.3872, "mature_H5_site": 21.0, "mutant": "C", "mutation": "E31C", "reference_site": "31", "sequential_site": 37.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.013, "escape": -0.3363, "mature_H5_site": 21.0, "mutant": "D", "mutation": "E31D", "reference_site": "31", "sequential_site": 37.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.533, "escape": -0.2526, "mature_H5_site": 21.0, "mutant": "G", "mutation": "E31G", "reference_site": "31", "sequential_site": 37.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2315, "escape": 0.129, "mature_H5_site": 21.0, "mutant": "K", "mutation": "E31K", "reference_site": "31", "sequential_site": 37.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.094, "escape": -0.3046, "mature_H5_site": 21.0, "mutant": "L", "mutation": "E31L", "reference_site": "31", "sequential_site": 37.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3974, "escape": 0.1148, "mature_H5_site": 21.0, "mutant": "N", "mutation": "E31N", "reference_site": "31", "sequential_site": 37.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07231, "escape": -0.01291, "mature_H5_site": 21.0, "mutant": "Q", "mutation": "E31Q", "reference_site": "31", "sequential_site": 37.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6499, "escape": -0.04284, "mature_H5_site": 21.0, "mutant": "R", "mutation": "E31R", "reference_site": "31", "sequential_site": 37.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2634, "escape": -0.07708, "mature_H5_site": 21.0, "mutant": "S", "mutation": "E31S", "reference_site": "31", "sequential_site": 37.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5679, "escape": -0.2122, "mature_H5_site": 21.0, "mutant": "V", "mutation": "E31V", "reference_site": "31", "sequential_site": 37.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.377, "escape": 0.09271, "mature_H5_site": 21.0, "mutant": "W", "mutation": "E31W", "reference_site": "31", "sequential_site": 37.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.498, "escape": -0.08631, "mature_H5_site": 21.0, "mutant": "Y", "mutation": "E31Y", "reference_site": "31", "sequential_site": 37.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.508, "escape": 0.3346, "mature_H5_site": 307.0, "mutant": "C", "mutation": "K310C", "reference_site": "310", "sequential_site": 323.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.008, "escape": -0.2912, "mature_H5_site": 307.0, "mutant": "D", "mutation": "K310D", "reference_site": "310", "sequential_site": 323.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.009, "escape": -0.2213, "mature_H5_site": 307.0, "mutant": "F", "mutation": "K310F", "reference_site": "310", "sequential_site": 323.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.408, "escape": -0.1853, "mature_H5_site": 307.0, "mutant": "G", "mutation": "K310G", "reference_site": "310", "sequential_site": 323.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3301, "escape": 0.01026, "mature_H5_site": 307.0, "mutant": "H", "mutation": "K310H", "reference_site": "310", "sequential_site": 323.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7102, "escape": -0.03662, "mature_H5_site": 307.0, "mutant": "N", "mutation": "K310N", "reference_site": "310", "sequential_site": 323.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7229, "escape": -0.1037, "mature_H5_site": 307.0, "mutant": "Q", "mutation": "K310Q", "reference_site": "310", "sequential_site": 323.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2898, "escape": -0.172, "mature_H5_site": 307.0, "mutant": "R", "mutation": "K310R", "reference_site": "310", "sequential_site": 323.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03533, "escape": 0.1045, "mature_H5_site": 308.0, "mutant": "A", "mutation": "S311A", "reference_site": "311", "sequential_site": 324.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.629, "escape": 0.1283, "mature_H5_site": 308.0, "mutant": "G", "mutation": "S311G", "reference_site": "311", "sequential_site": 324.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3355, "escape": 0.3164, "mature_H5_site": 308.0, "mutant": "I", "mutation": "S311I", "reference_site": "311", "sequential_site": 324.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.167, "escape": -0.2394, "mature_H5_site": 308.0, "mutant": "N", "mutation": "S311N", "reference_site": "311", "sequential_site": 324.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1297, "escape": -0.06343, "mature_H5_site": 308.0, "mutant": "T", "mutation": "S311T", "reference_site": "311", "sequential_site": 324.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4553, "escape": 0.00229, "mature_H5_site": 309.0, "mutant": "A", "mutation": "N312A", "reference_site": "312", "sequential_site": 325.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07363, "escape": 0.03397, "mature_H5_site": 309.0, "mutant": "C", "mutation": "N312C", "reference_site": "312", "sequential_site": 325.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03951, "escape": -0.01744, "mature_H5_site": 309.0, "mutant": "D", "mutation": "N312D", "reference_site": "312", "sequential_site": 325.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09834, "escape": 0.03447, "mature_H5_site": 309.0, "mutant": "E", "mutation": "N312E", "reference_site": "312", "sequential_site": 325.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.004592, "escape": 0.03821, "mature_H5_site": 309.0, "mutant": "F", "mutation": "N312F", "reference_site": "312", "sequential_site": 325.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01632, "escape": 0.1448, "mature_H5_site": 309.0, "mutant": "H", "mutation": "N312H", "reference_site": "312", "sequential_site": 325.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1411, "escape": -0.01692, "mature_H5_site": 309.0, "mutant": "I", "mutation": "N312I", "reference_site": "312", "sequential_site": 325.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3112, "escape": 0.07499, "mature_H5_site": 309.0, "mutant": "L", "mutation": "N312L", "reference_site": "312", "sequential_site": 325.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2403, "escape": -0.09296, "mature_H5_site": 309.0, "mutant": "M", "mutation": "N312M", "reference_site": "312", "sequential_site": 325.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3483, "escape": 0.04234, "mature_H5_site": 309.0, "mutant": "P", "mutation": "N312P", "reference_site": "312", "sequential_site": 325.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03838, "escape": 0.1654, "mature_H5_site": 309.0, "mutant": "R", "mutation": "N312R", "reference_site": "312", "sequential_site": 325.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06465, "escape": -0.1193, "mature_H5_site": 309.0, "mutant": "S", "mutation": "N312S", "reference_site": "312", "sequential_site": 325.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00225, "escape": 0.1461, "mature_H5_site": 309.0, "mutant": "T", "mutation": "N312T", "reference_site": "312", "sequential_site": 325.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05144, "escape": 0.02698, "mature_H5_site": 309.0, "mutant": "V", "mutation": "N312V", "reference_site": "312", "sequential_site": 325.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04393, "escape": 0.06898, "mature_H5_site": 310.0, "mutant": "A", "mutation": "K313A", "reference_site": "313", "sequential_site": 326.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5039, "escape": -0.3381, "mature_H5_site": 310.0, "mutant": "C", "mutation": "K313C", "reference_site": "313", "sequential_site": 326.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2309, "escape": 0.1373, "mature_H5_site": 310.0, "mutant": "F", "mutation": "K313F", "reference_site": "313", "sequential_site": 326.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8627, "escape": 0.009569, "mature_H5_site": 310.0, "mutant": "G", "mutation": "K313G", "reference_site": "313", "sequential_site": 326.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5647, "escape": -0.2477, "mature_H5_site": 310.0, "mutant": "M", "mutation": "K313M", "reference_site": "313", "sequential_site": 326.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3387, "escape": 0.0007118, "mature_H5_site": 310.0, "mutant": "N", "mutation": "K313N", "reference_site": "313", "sequential_site": 326.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6448, "escape": 0.04586, "mature_H5_site": 310.0, "mutant": "Q", "mutation": "K313Q", "reference_site": "313", "sequential_site": 326.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2134, "escape": 0.09424, "mature_H5_site": 310.0, "mutant": "R", "mutation": "K313R", "reference_site": "313", "sequential_site": 326.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.069, "escape": -0.08939, "mature_H5_site": 310.0, "mutant": "V", "mutation": "K313V", "reference_site": "313", "sequential_site": 326.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.006, "escape": -0.201, "mature_H5_site": 310.0, "mutant": "W", "mutation": "K313W", "reference_site": "313", "sequential_site": 326.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8353, "escape": 0.0125, "mature_H5_site": 310.0, "mutant": "Y", "mutation": "K313Y", "reference_site": "313", "sequential_site": 326.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.427, "escape": -0.08489, "mature_H5_site": 311.0, "mutant": "I", "mutation": "L314I", "reference_site": "314", "sequential_site": 327.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06373, "escape": -0.3318, "mature_H5_site": 312.0, "mutant": "A", "mutation": "V315A", "reference_site": "315", "sequential_site": 328.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2216, "escape": -0.08811, "mature_H5_site": 312.0, "mutant": "C", "mutation": "V315C", "reference_site": "315", "sequential_site": 328.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.312, "escape": 0.06284, "mature_H5_site": 312.0, "mutant": "F", "mutation": "V315F", "reference_site": "315", "sequential_site": 328.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.008165, "escape": 0.1714, "mature_H5_site": 312.0, "mutant": "I", "mutation": "V315I", "reference_site": "315", "sequential_site": 328.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5023, "escape": -0.1793, "mature_H5_site": 312.0, "mutant": "K", "mutation": "V315K", "reference_site": "315", "sequential_site": 328.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3479, "escape": -0.0704, "mature_H5_site": 312.0, "mutant": "L", "mutation": "V315L", "reference_site": "315", "sequential_site": 328.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.003785, "escape": -0.005658, "mature_H5_site": 312.0, "mutant": "M", "mutation": "V315M", "reference_site": "315", "sequential_site": 328.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5965, "escape": 0.3312, "mature_H5_site": 312.0, "mutant": "N", "mutation": "V315N", "reference_site": "315", "sequential_site": 328.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4559, "escape": -0.08263, "mature_H5_site": 312.0, "mutant": "Q", "mutation": "V315Q", "reference_site": "315", "sequential_site": 328.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05245, "escape": 0.3072, "mature_H5_site": 312.0, "mutant": "R", "mutation": "V315R", "reference_site": "315", "sequential_site": 328.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.159, "escape": -0.1034, "mature_H5_site": 312.0, "mutant": "Y", "mutation": "V315Y", "reference_site": "315", "sequential_site": 328.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.05, "escape": -0.1365, "mature_H5_site": 313.0, "mutant": "M", "mutation": "L316M", "reference_site": "316", "sequential_site": 329.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8901, "escape": 0.2241, "mature_H5_site": 313.0, "mutant": "V", "mutation": "L316V", "reference_site": "316", "sequential_site": 329.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5958, "escape": 0.05762, "mature_H5_site": 314.0, "mutant": "G", "mutation": "A317G", "reference_site": "317", "sequential_site": 330.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.553, "escape": 0.3774, "mature_H5_site": 314.0, "mutant": "T", "mutation": "A317T", "reference_site": "317", "sequential_site": 330.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4158, "escape": -0.03959, "mature_H5_site": 314.0, "mutant": "V", "mutation": "A317V", "reference_site": "317", "sequential_site": 330.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.136, "escape": -0.2219, "mature_H5_site": 315.0, "mutant": "E", "mutation": "T318E", "reference_site": "318", "sequential_site": 331.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.169, "escape": -0.09829, "mature_H5_site": 315.0, "mutant": "H", "mutation": "T318H", "reference_site": "318", "sequential_site": 331.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.735, "escape": 0.1342, "mature_H5_site": 315.0, "mutant": "I", "mutation": "T318I", "reference_site": "318", "sequential_site": 331.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3248, "escape": -0.002727, "mature_H5_site": 315.0, "mutant": "M", "mutation": "T318M", "reference_site": "318", "sequential_site": 331.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3703, "escape": 0.05232, "mature_H5_site": 315.0, "mutant": "Q", "mutation": "T318Q", "reference_site": "318", "sequential_site": 331.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5656, "escape": -0.009344, "mature_H5_site": 315.0, "mutant": "R", "mutation": "T318R", "reference_site": "318", "sequential_site": 331.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.23, "escape": 0.02781, "mature_H5_site": 315.0, "mutant": "V", "mutation": "T318V", "reference_site": "318", "sequential_site": 331.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.446, "escape": -0.1868, "mature_H5_site": 315.0, "mutant": "W", "mutation": "T318W", "reference_site": "318", "sequential_site": 331.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.926, "escape": -0.2343, "mature_H5_site": 22.0, "mutant": "A", "mutation": "K32A", "reference_site": "32", "sequential_site": 38.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9328, "escape": -0.3428, "mature_H5_site": 22.0, "mutant": "C", "mutation": "K32C", "reference_site": "32", "sequential_site": 38.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3666, "escape": -0.2906, "mature_H5_site": 22.0, "mutant": "H", "mutation": "K32H", "reference_site": "32", "sequential_site": 38.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2186, "escape": -0.2142, "mature_H5_site": 22.0, "mutant": "I", "mutation": "K32I", "reference_site": "32", "sequential_site": 38.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4696, "escape": -0.175, "mature_H5_site": 22.0, "mutant": "M", "mutation": "K32M", "reference_site": "32", "sequential_site": 38.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4788, "escape": -0.04463, "mature_H5_site": 22.0, "mutant": "N", "mutation": "K32N", "reference_site": "32", "sequential_site": 38.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03636, "escape": -0.0675, "mature_H5_site": 22.0, "mutant": "P", "mutation": "K32P", "reference_site": "32", "sequential_site": 38.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03646, "escape": -0.1031, "mature_H5_site": 22.0, "mutant": "Q", "mutation": "K32Q", "reference_site": "32", "sequential_site": 38.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7013, "escape": 0.08203, "mature_H5_site": 22.0, "mutant": "R", "mutation": "K32R", "reference_site": "32", "sequential_site": 38.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03918, "escape": -0.2871, "mature_H5_site": 22.0, "mutant": "S", "mutation": "K32S", "reference_site": "32", "sequential_site": 38.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.857, "escape": 0.1501, "mature_H5_site": 22.0, "mutant": "V", "mutation": "K32V", "reference_site": "32", "sequential_site": 38.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.007195, "escape": -0.3209, "mature_H5_site": 22.0, "mutant": "Y", "mutation": "K32Y", "reference_site": "32", "sequential_site": 38.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.906, "escape": 0.02204, "mature_H5_site": 317.0, "mutant": "C", "mutation": "L320C", "reference_site": "320", "sequential_site": 333.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4321, "escape": -0.113, "mature_H5_site": 317.0, "mutant": "I", "mutation": "L320I", "reference_site": "320", "sequential_site": 333.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06974, "escape": -0.03277, "mature_H5_site": 317.0, "mutant": "M", "mutation": "L320M", "reference_site": "320", "sequential_site": 333.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.267, "escape": 0.1038, "mature_H5_site": 318.0, "mutant": "K", "mutation": "R321K", "reference_site": "321", "sequential_site": 334.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.947, "escape": 0.243, "mature_H5_site": 318.0, "mutant": "P", "mutation": "R321P", "reference_site": "321", "sequential_site": 334.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.754, "escape": -0.05591, "mature_H5_site": 318.0, "mutant": "T", "mutation": "R321T", "reference_site": "321", "sequential_site": 334.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.62, "escape": -0.2454, "mature_H5_site": 319.0, "mutant": "C", "mutation": "N322C", "reference_site": "322", "sequential_site": 335.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5156, "escape": 0.7024, "mature_H5_site": 319.0, "mutant": "G", "mutation": "N322G", "reference_site": "322", "sequential_site": 335.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.63, "escape": -0.3147, "mature_H5_site": 319.0, "mutant": "S", "mutation": "N322S", "reference_site": "322", "sequential_site": 335.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04155, "escape": 0.01495, "mature_H5_site": 320.0, "mutant": "A", "mutation": "S323A", "reference_site": "323", "sequential_site": 336.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.29, "escape": 0.3805, "mature_H5_site": 320.0, "mutant": "C", "mutation": "S323C", "reference_site": "323", "sequential_site": 336.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.003295, "escape": -0.1841, "mature_H5_site": 320.0, "mutant": "G", "mutation": "S323G", "reference_site": "323", "sequential_site": 336.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07157, "escape": 0.1078, "mature_H5_site": 320.0, "mutant": "H", "mutation": "S323H", "reference_site": "323", "sequential_site": 336.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.707, "escape": 0.5153, "mature_H5_site": 320.0, "mutant": "I", "mutation": "S323I", "reference_site": "323", "sequential_site": 336.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06501, "escape": 0.2701, "mature_H5_site": 320.0, "mutant": "K", "mutation": "S323K", "reference_site": "323", "sequential_site": 336.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.485, "escape": 0.008377, "mature_H5_site": 320.0, "mutant": "L", "mutation": "S323L", "reference_site": "323", "sequential_site": 336.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5236, "escape": -0.04285, "mature_H5_site": 320.0, "mutant": "N", "mutation": "S323N", "reference_site": "323", "sequential_site": 336.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1952, "escape": -0.2116, "mature_H5_site": 320.0, "mutant": "P", "mutation": "S323P", "reference_site": "323", "sequential_site": 336.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05623, "escape": 0.7802, "mature_H5_site": 320.0, "mutant": "Q", "mutation": "S323Q", "reference_site": "323", "sequential_site": 336.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.102, "escape": 0.2439, "mature_H5_site": 320.0, "mutant": "V", "mutation": "S323V", "reference_site": "323", "sequential_site": 336.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01485, "escape": 0.2475, "mature_H5_site": 320.0, "mutant": "W", "mutation": "S323W", "reference_site": "323", "sequential_site": 336.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07295, "escape": -0.3415, "mature_H5_site": 320.0, "mutant": "Y", "mutation": "S323Y", "reference_site": "323", "sequential_site": 336.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6343, "escape": -0.007656, "mature_H5_site": 321.0, "mutant": "A", "mutation": "P324A", "reference_site": "324", "sequential_site": 337.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2232, "escape": -0.2873, "mature_H5_site": 321.0, "mutant": "C", "mutation": "P324C", "reference_site": "324", "sequential_site": 337.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1866, "escape": -0.09876, "mature_H5_site": 321.0, "mutant": "E", "mutation": "P324E", "reference_site": "324", "sequential_site": 337.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09831, "escape": 0.05126, "mature_H5_site": 321.0, "mutant": "H", "mutation": "P324H", "reference_site": "324", "sequential_site": 337.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1055, "escape": 0.1398, "mature_H5_site": 321.0, "mutant": "I", "mutation": "P324I", "reference_site": "324", "sequential_site": 337.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1588, "escape": -0.1758, "mature_H5_site": 321.0, "mutant": "N", "mutation": "P324N", "reference_site": "324", "sequential_site": 337.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07755, "escape": 0.1959, "mature_H5_site": 321.0, "mutant": "Q", "mutation": "P324Q", "reference_site": "324", "sequential_site": 337.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04963, "escape": 0.0285, "mature_H5_site": 321.0, "mutant": "R", "mutation": "P324R", "reference_site": "324", "sequential_site": 337.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07107, "escape": -0.05246, "mature_H5_site": 321.0, "mutant": "S", "mutation": "P324S", "reference_site": "324", "sequential_site": 337.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7241, "escape": -0.08257, "mature_H5_site": 321.0, "mutant": "T", "mutation": "P324T", "reference_site": "324", "sequential_site": 337.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1532, "escape": -0.1378, "mature_H5_site": 321.0, "mutant": "V", "mutation": "P324V", "reference_site": "324", "sequential_site": 337.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4194, "escape": 0.005378, "mature_H5_site": 321.0, "mutant": "W", "mutation": "P324W", "reference_site": "324", "sequential_site": 337.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01924, "escape": 0.1087, "mature_H5_site": 322.0, "mutant": "A", "mutation": "L325A", "reference_site": "325", "sequential_site": 338.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1827, "escape": -0.1898, "mature_H5_site": 322.0, "mutant": "C", "mutation": "L325C", "reference_site": "325", "sequential_site": 338.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03556, "escape": -0.04993, "mature_H5_site": 322.0, "mutant": "D", "mutation": "L325D", "reference_site": "325", "sequential_site": 338.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2797, "escape": -0.0878, "mature_H5_site": 322.0, "mutant": "E", "mutation": "L325E", "reference_site": "325", "sequential_site": 338.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1614, "escape": 0.1878, "mature_H5_site": 322.0, "mutant": "G", "mutation": "L325G", "reference_site": "325", "sequential_site": 338.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6185, "escape": -0.008387, "mature_H5_site": 322.0, "mutant": "H", "mutation": "L325H", "reference_site": "325", "sequential_site": 338.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07276, "escape": 0.3933, "mature_H5_site": 322.0, "mutant": "I", "mutation": "L325I", "reference_site": "325", "sequential_site": 338.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1546, "escape": -0.0418, "mature_H5_site": 322.0, "mutant": "K", "mutation": "L325K", "reference_site": "325", "sequential_site": 338.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3378, "escape": -0.1151, "mature_H5_site": 322.0, "mutant": "M", "mutation": "L325M", "reference_site": "325", "sequential_site": 338.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07551, "escape": 0.2019, "mature_H5_site": 322.0, "mutant": "N", "mutation": "L325N", "reference_site": "325", "sequential_site": 338.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06666, "escape": -0.03944, "mature_H5_site": 322.0, "mutant": "Q", "mutation": "L325Q", "reference_site": "325", "sequential_site": 338.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07336, "escape": -0.09619, "mature_H5_site": 322.0, "mutant": "R", "mutation": "L325R", "reference_site": "325", "sequential_site": 338.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00195, "escape": -0.1703, "mature_H5_site": 322.0, "mutant": "V", "mutation": "L325V", "reference_site": "325", "sequential_site": 338.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02877, "escape": -0.07816, "mature_H5_site": 322.0, "mutant": "W", "mutation": "L325W", "reference_site": "325", "sequential_site": 338.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04685, "escape": -0.06209, "mature_H5_site": 323.0, "mutant": "A", "mutation": "R326A", "reference_site": "326", "sequential_site": 339.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08008, "escape": -0.05844, "mature_H5_site": 323.0, "mutant": "C", "mutation": "R326C", "reference_site": "326", "sequential_site": 339.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1051, "escape": 0.3251, "mature_H5_site": 323.0, "mutant": "F", "mutation": "R326F", "reference_site": "326", "sequential_site": 339.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.003475, "escape": 0.05825, "mature_H5_site": 323.0, "mutant": "H", "mutation": "R326H", "reference_site": "326", "sequential_site": 339.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4284, "escape": 0.2923, "mature_H5_site": 323.0, "mutant": "K", "mutation": "R326K", "reference_site": "326", "sequential_site": 339.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2477, "escape": 0.03776, "mature_H5_site": 323.0, "mutant": "L", "mutation": "R326L", "reference_site": "326", "sequential_site": 339.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02796, "escape": 0.02285, "mature_H5_site": 323.0, "mutant": "M", "mutation": "R326M", "reference_site": "326", "sequential_site": 339.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04852, "escape": 0.1866, "mature_H5_site": 323.0, "mutant": "Q", "mutation": "R326Q", "reference_site": "326", "sequential_site": 339.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2349, "escape": -0.1319, "mature_H5_site": 323.0, "mutant": "S", "mutation": "R326S", "reference_site": "326", "sequential_site": 339.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1277, "escape": -0.06982, "mature_H5_site": 323.0, "mutant": "V", "mutation": "R326V", "reference_site": "326", "sequential_site": 339.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3319, "escape": 0.1415, "mature_H5_site": 323.0, "mutant": "W", "mutation": "R326W", "reference_site": "326", "sequential_site": 339.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03368, "escape": 0.1448, "mature_H5_site": 323.0, "mutant": "Y", "mutation": "R326Y", "reference_site": "326", "sequential_site": 339.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3196, "escape": -0.1202, "mature_H5_site": 324.0, "mutant": "A", "mutation": "E327A", "reference_site": "327", "sequential_site": 340.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2663, "escape": -0.3346, "mature_H5_site": 324.0, "mutant": "C", "mutation": "E327C", "reference_site": "327", "sequential_site": 340.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1089, "escape": -0.2481, "mature_H5_site": 324.0, "mutant": "D", "mutation": "E327D", "reference_site": "327", "sequential_site": 340.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.002401, "escape": 0.2152, "mature_H5_site": 324.0, "mutant": "F", "mutation": "E327F", "reference_site": "327", "sequential_site": 340.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06116, "escape": -0.1444, "mature_H5_site": 324.0, "mutant": "G", "mutation": "E327G", "reference_site": "327", "sequential_site": 340.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1623, "escape": -0.0003018, "mature_H5_site": 324.0, "mutant": "H", "mutation": "E327H", "reference_site": "327", "sequential_site": 340.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1583, "escape": 0.00189, "mature_H5_site": 324.0, "mutant": "I", "mutation": "E327I", "reference_site": "327", "sequential_site": 340.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.744, "escape": -0.997, "mature_H5_site": 324.0, "mutant": "K", "mutation": "E327K", "reference_site": "327", "sequential_site": 340.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06317, "escape": -0.2018, "mature_H5_site": 324.0, "mutant": "L", "mutation": "E327L", "reference_site": "327", "sequential_site": 340.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07594, "escape": 0.4073, "mature_H5_site": 324.0, "mutant": "Q", "mutation": "E327Q", "reference_site": "327", "sequential_site": 340.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2668, "escape": 0.3037, "mature_H5_site": 324.0, "mutant": "R", "mutation": "E327R", "reference_site": "327", "sequential_site": 340.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4871, "escape": -0.2175, "mature_H5_site": 324.0, "mutant": "S", "mutation": "E327S", "reference_site": "327", "sequential_site": 340.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2793, "escape": -0.06143, "mature_H5_site": 324.0, "mutant": "V", "mutation": "E327V", "reference_site": "327", "sequential_site": 340.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04419, "escape": -0.01175, "mature_H5_site": 324.0, "mutant": "W", "mutation": "E327W", "reference_site": "327", "sequential_site": 340.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03971, "escape": -0.03465, "mature_H5_site": 324.0, "mutant": "Y", "mutation": "E327Y", "reference_site": "327", "sequential_site": 340.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04226, "escape": 0.2719, "mature_H5_site": 325.0, "mutant": "A", "mutation": "K328A", "reference_site": "328", "sequential_site": 341.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7532, "escape": -0.07901, "mature_H5_site": 325.0, "mutant": "C", "mutation": "K328C", "reference_site": "328", "sequential_site": 341.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.877, "escape": -0.3628, "mature_H5_site": 325.0, "mutant": "E", "mutation": "K328E", "reference_site": "328", "sequential_site": 341.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1584, "escape": -0.02581, "mature_H5_site": 325.0, "mutant": "F", "mutation": "K328F", "reference_site": "328", "sequential_site": 341.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03592, "escape": 0.1404, "mature_H5_site": 325.0, "mutant": "G", "mutation": "K328G", "reference_site": "328", "sequential_site": 341.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00832, "escape": -0.1318, "mature_H5_site": 325.0, "mutant": "H", "mutation": "K328H", "reference_site": "328", "sequential_site": 341.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03372, "escape": -0.09304, "mature_H5_site": 325.0, "mutant": "I", "mutation": "K328I", "reference_site": "328", "sequential_site": 341.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.213, "escape": -0.01936, "mature_H5_site": 325.0, "mutant": "N", "mutation": "K328N", "reference_site": "328", "sequential_site": 341.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07345, "escape": 0.02552, "mature_H5_site": 325.0, "mutant": "R", "mutation": "K328R", "reference_site": "328", "sequential_site": 341.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3032, "escape": -0.05536, "mature_H5_site": 325.0, "mutant": "S", "mutation": "K328S", "reference_site": "328", "sequential_site": 341.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05675, "escape": 0.1127, "mature_H5_site": 325.0, "mutant": "V", "mutation": "K328V", "reference_site": "328", "sequential_site": 341.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8701, "escape": 0.1053, "mature_H5_site": 325.0, "mutant": "W", "mutation": "K328W", "reference_site": "328", "sequential_site": 341.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06475, "escape": 0.07817, "mature_H5_site": 327.0, "mutant": "A", "mutation": "R328bA", "reference_site": "328b", "sequential_site": 343.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08059, "escape": -0.2221, "mature_H5_site": 327.0, "mutant": "C", "mutation": "R328bC", "reference_site": "328b", "sequential_site": 343.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.25, "escape": 0.02293, "mature_H5_site": 327.0, "mutant": "G", "mutation": "R328bG", "reference_site": "328b", "sequential_site": 343.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1409, "escape": -0.1383, "mature_H5_site": 327.0, "mutant": "I", "mutation": "R328bI", "reference_site": "328b", "sequential_site": 343.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0356, "escape": -0.1843, "mature_H5_site": 327.0, "mutant": "K", "mutation": "R328bK", "reference_site": "328b", "sequential_site": 343.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.003765, "escape": 0.2668, "mature_H5_site": 327.0, "mutant": "L", "mutation": "R328bL", "reference_site": "328b", "sequential_site": 343.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02313, "escape": -0.1274, "mature_H5_site": 327.0, "mutant": "M", "mutation": "R328bM", "reference_site": "328b", "sequential_site": 343.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09431, "escape": -0.05989, "mature_H5_site": 327.0, "mutant": "P", "mutation": "R328bP", "reference_site": "328b", "sequential_site": 343.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.943, "escape": 0.1658, "mature_H5_site": 327.0, "mutant": "S", "mutation": "R328bS", "reference_site": "328b", "sequential_site": 343.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3589, "escape": 0.2712, "mature_H5_site": 327.0, "mutant": "T", "mutation": "R328bT", "reference_site": "328b", "sequential_site": 343.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1196, "escape": 0.2385, "mature_H5_site": 327.0, "mutant": "Y", "mutation": "R328bY", "reference_site": "328b", "sequential_site": 343.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09191, "escape": -0.07049, "mature_H5_site": 328.0, "mutant": "R", "mutation": "K328cR", "reference_site": "328c", "sequential_site": 344.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.001, "escape": 0.2734, "mature_H5_site": 328.0, "mutant": "V", "mutation": "K328cV", "reference_site": "328c", "sequential_site": 344.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7969, "escape": -0.05019, "mature_H5_site": 23.0, "mutant": "A", "mutation": "N33A", "reference_site": "33", "sequential_site": 39.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7246, "escape": -0.1412, "mature_H5_site": 23.0, "mutant": "E", "mutation": "N33E", "reference_site": "33", "sequential_site": 39.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.034, "escape": -0.02533, "mature_H5_site": 23.0, "mutant": "F", "mutation": "N33F", "reference_site": "33", "sequential_site": 39.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1855, "escape": -0.2541, "mature_H5_site": 23.0, "mutant": "H", "mutation": "N33H", "reference_site": "33", "sequential_site": 39.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.683, "escape": -0.1191, "mature_H5_site": 23.0, "mutant": "K", "mutation": "N33K", "reference_site": "33", "sequential_site": 39.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.027, "escape": -0.2112, "mature_H5_site": 23.0, "mutant": "M", "mutation": "N33M", "reference_site": "33", "sequential_site": 39.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6412, "escape": -0.1297, "mature_H5_site": 23.0, "mutant": "Q", "mutation": "N33Q", "reference_site": "33", "sequential_site": 39.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2287, "escape": -0.2022, "mature_H5_site": 23.0, "mutant": "R", "mutation": "N33R", "reference_site": "33", "sequential_site": 39.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.217, "escape": -0.02931, "mature_H5_site": 23.0, "mutant": "S", "mutation": "N33S", "reference_site": "33", "sequential_site": 39.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.403, "escape": 0.008726, "mature_H5_site": 330.0, "mutant": "F", "mutation": "G330F", "reference_site": "330", "sequential_site": 346.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.855, "escape": -0.05427, "mature_H5_site": 330.0, "mutant": "N", "mutation": "G330N", "reference_site": "330", "sequential_site": 346.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1889, "escape": 0.0009098, "mature_H5_site": 330.0, "mutant": "W", "mutation": "G330W", "reference_site": "330", "sequential_site": 346.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.83, "escape": -0.2457, "mature_H5_site": 331.0, "mutant": "M", "mutation": "L331M", "reference_site": "331", "sequential_site": 347.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.362, "escape": 1.182, "mature_H5_site": 331.0, "mutant": "V", "mutation": "L331V", "reference_site": "331", "sequential_site": 347.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.856, "escape": 0.005096, "mature_H5_site": 332.0, "mutant": "A", "mutation": "F332A", "reference_site": "332", "sequential_site": 348.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.181, "escape": 0.3405, "mature_H5_site": 332.0, "mutant": "L", "mutation": "F332L", "reference_site": "332", "sequential_site": 348.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.221, "escape": -0.03772, "mature_H5_site": 332.0, "mutant": "M", "mutation": "F332M", "reference_site": "332", "sequential_site": 348.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.939, "escape": 0.06297, "mature_H5_site": 332.0, "mutant": "V", "mutation": "F332V", "reference_site": "332", "sequential_site": 348.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.035, "escape": -0.3008, "mature_H5_site": 333.0, "mutant": "A", "mutation": "G333A", "reference_site": "333", "sequential_site": 349.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.189, "escape": -0.0729, "mature_H5_site": 333.0, "mutant": "F", "mutation": "G333F", "reference_site": "333", "sequential_site": 349.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.604, "escape": 0.1846, "mature_H5_site": 333.0, "mutant": "H", "mutation": "G333H", "reference_site": "333", "sequential_site": 349.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.65, "escape": 0.7615, "mature_H5_site": 333.0, "mutant": "K", "mutation": "G333K", "reference_site": "333", "sequential_site": 349.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6009, "escape": 0.319, "mature_H5_site": 333.0, "mutant": "L", "mutation": "G333L", "reference_site": "333", "sequential_site": 349.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2621, "escape": -0.226, "mature_H5_site": 333.0, "mutant": "M", "mutation": "G333M", "reference_site": "333", "sequential_site": 349.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.191, "escape": 0.6282, "mature_H5_site": 333.0, "mutant": "Q", "mutation": "G333Q", "reference_site": "333", "sequential_site": 349.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.603, "escape": 0.5894, "mature_H5_site": 333.0, "mutant": "R", "mutation": "G333R", "reference_site": "333", "sequential_site": 349.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7004, "escape": 0.3073, "mature_H5_site": 333.0, "mutant": "S", "mutation": "G333S", "reference_site": "333", "sequential_site": 349.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.585, "escape": -0.2488, "mature_H5_site": 333.0, "mutant": "V", "mutation": "G333V", "reference_site": "333", "sequential_site": 349.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.516, "escape": 0.106, "mature_H5_site": 333.0, "mutant": "W", "mutation": "G333W", "reference_site": "333", "sequential_site": 349.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.925, "escape": 0.07261, "mature_H5_site": 333.0, "mutant": "Y", "mutation": "G333Y", "reference_site": "333", "sequential_site": 349.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.603, "escape": -0.3979, "mature_H5_site": 334.0, "mutant": "C", "mutation": "A334C", "reference_site": "334", "sequential_site": 350.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.491, "escape": -0.1001, "mature_H5_site": 334.0, "mutant": "I", "mutation": "A334I", "reference_site": "334", "sequential_site": 350.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.422, "escape": -0.2423, "mature_H5_site": 334.0, "mutant": "L", "mutation": "A334L", "reference_site": "334", "sequential_site": 350.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.235, "escape": 0.1943, "mature_H5_site": 334.0, "mutant": "M", "mutation": "A334M", "reference_site": "334", "sequential_site": 350.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.266, "escape": -0.5851, "mature_H5_site": 334.0, "mutant": "S", "mutation": "A334S", "reference_site": "334", "sequential_site": 350.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.7, "escape": 0.1587, "mature_H5_site": 334.0, "mutant": "T", "mutation": "A334T", "reference_site": "334", "sequential_site": 350.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3644, "escape": 0.2043, "mature_H5_site": 335.0, "mutant": "L", "mutation": "I335L", "reference_site": "335", "sequential_site": 351.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7006, "escape": 0.3777, "mature_H5_site": 335.0, "mutant": "M", "mutation": "I335M", "reference_site": "335", "sequential_site": 351.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05497, "escape": 0.182, "mature_H5_site": 335.0, "mutant": "V", "mutation": "I335V", "reference_site": "335", "sequential_site": 351.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.301, "escape": 0.2295, "mature_H5_site": 336.0, "mutant": "G", "mutation": "A336G", "reference_site": "336", "sequential_site": 352.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.581, "escape": -0.3083, "mature_H5_site": 336.0, "mutant": "M", "mutation": "A336M", "reference_site": "336", "sequential_site": 352.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.913, "escape": -0.3845, "mature_H5_site": 336.0, "mutant": "S", "mutation": "A336S", "reference_site": "336", "sequential_site": 352.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.642, "escape": -0.1685, "mature_H5_site": 336.0, "mutant": "T", "mutation": "A336T", "reference_site": "336", "sequential_site": 352.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.758, "escape": -0.2029, "mature_H5_site": 336.0, "mutant": "V", "mutation": "A336V", "reference_site": "336", "sequential_site": 352.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.99, "escape": -0.3044, "mature_H5_site": 336.0, "mutant": "W", "mutation": "A336W", "reference_site": "336", "sequential_site": 352.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.553, "escape": -1.209, "mature_H5_site": 338.0, "mutant": "I", "mutation": "F338I", "reference_site": "338", "sequential_site": 354.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.463, "escape": -0.2326, "mature_H5_site": 338.0, "mutant": "W", "mutation": "F338W", "reference_site": "338", "sequential_site": 354.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.254, "escape": -0.1869, "mature_H5_site": 338.0, "mutant": "Y", "mutation": "F338Y", "reference_site": "338", "sequential_site": 354.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.061, "escape": -0.04104, "mature_H5_site": 340.0, "mutant": "F", "mutation": "E340F", "reference_site": "340", "sequential_site": 356.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.924, "escape": 0.1143, "mature_H5_site": 340.0, "mutant": "G", "mutation": "E340G", "reference_site": "340", "sequential_site": 356.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.38, "escape": 0.0727, "mature_H5_site": 340.0, "mutant": "I", "mutation": "E340I", "reference_site": "340", "sequential_site": 356.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.12, "escape": 0.104, "mature_H5_site": 340.0, "mutant": "M", "mutation": "E340M", "reference_site": "340", "sequential_site": 356.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.501, "escape": -0.08286, "mature_H5_site": 340.0, "mutant": "Q", "mutation": "E340Q", "reference_site": "340", "sequential_site": 356.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.847, "escape": 0.1191, "mature_H5_site": 340.0, "mutant": "W", "mutation": "E340W", "reference_site": "340", "sequential_site": 356.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.554, "escape": -0.4006, "mature_H5_site": 341.0, "mutant": "D", "mutation": "G341D", "reference_site": "341", "sequential_site": 357.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.848, "escape": -0.06832, "mature_H5_site": 341.0, "mutant": "K", "mutation": "G341K", "reference_site": "341", "sequential_site": 357.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.082, "escape": 0.1788, "mature_H5_site": 341.0, "mutant": "M", "mutation": "G341M", "reference_site": "341", "sequential_site": 357.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.494, "escape": -0.1715, "mature_H5_site": 341.0, "mutant": "Q", "mutation": "G341Q", "reference_site": "341", "sequential_site": 357.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.26, "escape": 0.006079, "mature_H5_site": 341.0, "mutant": "R", "mutation": "G341R", "reference_site": "341", "sequential_site": 357.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.226, "escape": -0.3898, "mature_H5_site": 341.0, "mutant": "S", "mutation": "G341S", "reference_site": "341", "sequential_site": 357.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.311, "escape": -0.006029, "mature_H5_site": 341.0, "mutant": "T", "mutation": "G341T", "reference_site": "341", "sequential_site": 357.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.096, "escape": 0.1023, "mature_H5_site": 341.0, "mutant": "V", "mutation": "G341V", "reference_site": "341", "sequential_site": 357.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.008405, "escape": 0.2838, "mature_H5_site": 344.0, "mutant": "D", "mutation": "Q344D", "reference_site": "344", "sequential_site": 360.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05667, "escape": 0.04377, "mature_H5_site": 344.0, "mutant": "E", "mutation": "Q344E", "reference_site": "344", "sequential_site": 360.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07407, "escape": 0.174, "mature_H5_site": 344.0, "mutant": "H", "mutation": "Q344H", "reference_site": "344", "sequential_site": 360.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.02, "escape": -0.1061, "mature_H5_site": 344.0, "mutant": "I", "mutation": "Q344I", "reference_site": "344", "sequential_site": 360.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7721, "escape": 0.3993, "mature_H5_site": 344.0, "mutant": "K", "mutation": "Q344K", "reference_site": "344", "sequential_site": 360.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.051, "escape": -0.04899, "mature_H5_site": 344.0, "mutant": "L", "mutation": "Q344L", "reference_site": "344", "sequential_site": 360.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.316, "escape": 0.07985, "mature_H5_site": 344.0, "mutant": "M", "mutation": "Q344M", "reference_site": "344", "sequential_site": 360.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0657, "escape": 0.02728, "mature_H5_site": 344.0, "mutant": "N", "mutation": "Q344N", "reference_site": "344", "sequential_site": 360.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06274, "escape": -0.07752, "mature_H5_site": 344.0, "mutant": "P", "mutation": "Q344P", "reference_site": "344", "sequential_site": 360.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.141, "escape": 0.3357, "mature_H5_site": 344.0, "mutant": "R", "mutation": "Q344R", "reference_site": "344", "sequential_site": 360.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3437, "escape": 0.1412, "mature_H5_site": 344.0, "mutant": "S", "mutation": "Q344S", "reference_site": "344", "sequential_site": 360.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5702, "escape": -0.02791, "mature_H5_site": 344.0, "mutant": "T", "mutation": "Q344T", "reference_site": "344", "sequential_site": 360.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9498, "escape": 0.5225, "mature_H5_site": 344.0, "mutant": "V", "mutation": "Q344V", "reference_site": "344", "sequential_site": 360.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1852, "escape": -0.01474, "mature_H5_site": 344.0, "mutant": "W", "mutation": "Q344W", "reference_site": "344", "sequential_site": 360.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.884, "escape": 0.1382, "mature_H5_site": 345.0, "mutant": "A", "mutation": "G345A", "reference_site": "345", "sequential_site": 361.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.799, "escape": -1.034, "mature_H5_site": 345.0, "mutant": "C", "mutation": "G345C", "reference_site": "345", "sequential_site": 361.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.53, "escape": -0.3757, "mature_H5_site": 345.0, "mutant": "F", "mutation": "G345F", "reference_site": "345", "sequential_site": 361.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.366, "escape": -0.03916, "mature_H5_site": 345.0, "mutant": "H", "mutation": "G345H", "reference_site": "345", "sequential_site": 361.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.68, "escape": -0.04809, "mature_H5_site": 345.0, "mutant": "L", "mutation": "G345L", "reference_site": "345", "sequential_site": 361.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.797, "escape": 0.1293, "mature_H5_site": 345.0, "mutant": "M", "mutation": "G345M", "reference_site": "345", "sequential_site": 361.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.389, "escape": -0.2652, "mature_H5_site": 345.0, "mutant": "P", "mutation": "G345P", "reference_site": "345", "sequential_site": 361.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.069, "escape": 0.1584, "mature_H5_site": 345.0, "mutant": "R", "mutation": "G345R", "reference_site": "345", "sequential_site": 361.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.144, "escape": 0.04988, "mature_H5_site": 345.0, "mutant": "S", "mutation": "G345S", "reference_site": "345", "sequential_site": 361.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.675, "escape": 0.3914, "mature_H5_site": 345.0, "mutant": "T", "mutation": "G345T", "reference_site": "345", "sequential_site": 361.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.405, "escape": -0.08019, "mature_H5_site": 345.0, "mutant": "Y", "mutation": "G345Y", "reference_site": "345", "sequential_site": 361.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05502, "escape": 0.2029, "mature_H5_site": 346.0, "mutant": "F", "mutation": "M346F", "reference_site": "346", "sequential_site": 362.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.894, "escape": 0.1079, "mature_H5_site": 346.0, "mutant": "I", "mutation": "M346I", "reference_site": "346", "sequential_site": 362.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5736, "escape": -0.1805, "mature_H5_site": 346.0, "mutant": "L", "mutation": "M346L", "reference_site": "346", "sequential_site": 362.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7103, "escape": -0.1488, "mature_H5_site": 347.0, "mutant": "A", "mutation": "V347A", "reference_site": "347", "sequential_site": 363.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5873, "escape": -0.2944, "mature_H5_site": 347.0, "mutant": "C", "mutation": "V347C", "reference_site": "347", "sequential_site": 363.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.319, "escape": -0.3191, "mature_H5_site": 347.0, "mutant": "E", "mutation": "V347E", "reference_site": "347", "sequential_site": 363.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.121, "escape": 0.08342, "mature_H5_site": 347.0, "mutant": "F", "mutation": "V347F", "reference_site": "347", "sequential_site": 363.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.654, "escape": -0.008278, "mature_H5_site": 347.0, "mutant": "G", "mutation": "V347G", "reference_site": "347", "sequential_site": 363.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2599, "escape": 0.5225, "mature_H5_site": 347.0, "mutant": "I", "mutation": "V347I", "reference_site": "347", "sequential_site": 363.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03992, "escape": -0.02534, "mature_H5_site": 347.0, "mutant": "L", "mutation": "V347L", "reference_site": "347", "sequential_site": 363.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05824, "escape": -0.04718, "mature_H5_site": 347.0, "mutant": "M", "mutation": "V347M", "reference_site": "347", "sequential_site": 363.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.001, "escape": -0.08876, "mature_H5_site": 347.0, "mutant": "Q", "mutation": "V347Q", "reference_site": "347", "sequential_site": 363.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7611, "escape": -0.03494, "mature_H5_site": 347.0, "mutant": "R", "mutation": "V347R", "reference_site": "347", "sequential_site": 363.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.125, "escape": -0.1302, "mature_H5_site": 347.0, "mutant": "S", "mutation": "V347S", "reference_site": "347", "sequential_site": 363.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07594, "escape": -0.06455, "mature_H5_site": 347.0, "mutant": "Y", "mutation": "V347Y", "reference_site": "347", "sequential_site": 363.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.844, "escape": -0.108, "mature_H5_site": 348.0, "mutant": "C", "mutation": "D348C", "reference_site": "348", "sequential_site": 364.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2697, "escape": 0.05897, "mature_H5_site": 348.0, "mutant": "E", "mutation": "D348E", "reference_site": "348", "sequential_site": 364.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.615, "escape": -0.1531, "mature_H5_site": 348.0, "mutant": "F", "mutation": "D348F", "reference_site": "348", "sequential_site": 364.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5736, "escape": -0.03747, "mature_H5_site": 348.0, "mutant": "H", "mutation": "D348H", "reference_site": "348", "sequential_site": 364.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2994, "escape": -0.05591, "mature_H5_site": 348.0, "mutant": "N", "mutation": "D348N", "reference_site": "348", "sequential_site": 364.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7125, "escape": -0.2811, "mature_H5_site": 348.0, "mutant": "Q", "mutation": "D348Q", "reference_site": "348", "sequential_site": 364.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1254, "escape": 0.000197, "mature_H5_site": 348.0, "mutant": "S", "mutation": "D348S", "reference_site": "348", "sequential_site": 364.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9481, "escape": -0.2542, "mature_H5_site": 348.0, "mutant": "T", "mutation": "D348T", "reference_site": "348", "sequential_site": 364.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5348, "escape": -0.684, "mature_H5_site": 348.0, "mutant": "V", "mutation": "D348V", "reference_site": "348", "sequential_site": 364.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.868, "escape": -0.01634, "mature_H5_site": 348.0, "mutant": "W", "mutation": "D348W", "reference_site": "348", "sequential_site": 364.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4447, "escape": -0.2124, "mature_H5_site": 348.0, "mutant": "Y", "mutation": "D348Y", "reference_site": "348", "sequential_site": 364.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.931, "escape": -0.2141, "mature_H5_site": 349.0, "mutant": "S", "mutation": "G349S", "reference_site": "349", "sequential_site": 365.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05959, "escape": -0.1302, "mature_H5_site": 25.0, "mutant": "A", "mutation": "T35A", "reference_site": "35", "sequential_site": 41.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6734, "escape": -0.2174, "mature_H5_site": 25.0, "mutant": "D", "mutation": "T35D", "reference_site": "35", "sequential_site": 41.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06106, "escape": -0.3182, "mature_H5_site": 25.0, "mutant": "F", "mutation": "T35F", "reference_site": "35", "sequential_site": 41.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05531, "escape": -0.07215, "mature_H5_site": 25.0, "mutant": "K", "mutation": "T35K", "reference_site": "35", "sequential_site": 41.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06399, "escape": -0.2218, "mature_H5_site": 25.0, "mutant": "L", "mutation": "T35L", "reference_site": "35", "sequential_site": 41.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.303, "escape": 0.08276, "mature_H5_site": 25.0, "mutant": "M", "mutation": "T35M", "reference_site": "35", "sequential_site": 41.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04879, "escape": 0.16, "mature_H5_site": 25.0, "mutant": "N", "mutation": "T35N", "reference_site": "35", "sequential_site": 41.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03163, "escape": 0.03729, "mature_H5_site": 25.0, "mutant": "P", "mutation": "T35P", "reference_site": "35", "sequential_site": 41.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3758, "escape": -0.2703, "mature_H5_site": 25.0, "mutant": "S", "mutation": "T35S", "reference_site": "35", "sequential_site": 41.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07353, "escape": -0.01062, "mature_H5_site": 25.0, "mutant": "Y", "mutation": "T35Y", "reference_site": "35", "sequential_site": 41.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.746, "escape": -0.207, "mature_H5_site": 350.0, "mutant": "F", "mutation": "W350F", "reference_site": "350", "sequential_site": 366.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.03, "escape": -0.05295, "mature_H5_site": 350.0, "mutant": "I", "mutation": "W350I", "reference_site": "350", "sequential_site": 366.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.606, "escape": -0.1648, "mature_H5_site": 350.0, "mutant": "Y", "mutation": "W350Y", "reference_site": "350", "sequential_site": 366.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3944, "escape": -0.08162, "mature_H5_site": 353.0, "mutant": "F", "mutation": "Y353F", "reference_site": "353", "sequential_site": 369.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5176, "escape": -0.07071, "mature_H5_site": 353.0, "mutant": "W", "mutation": "Y353W", "reference_site": "353", "sequential_site": 369.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.611, "escape": -0.07842, "mature_H5_site": 354.0, "mutant": "F", "mutation": "H354F", "reference_site": "354", "sequential_site": 370.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2202, "escape": 0.08546, "mature_H5_site": 354.0, "mutant": "K", "mutation": "H354K", "reference_site": "354", "sequential_site": 370.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.059, "escape": 0.1253, "mature_H5_site": 354.0, "mutant": "L", "mutation": "H354L", "reference_site": "354", "sequential_site": 370.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1193, "escape": -0.06762, "mature_H5_site": 354.0, "mutant": "M", "mutation": "H354M", "reference_site": "354", "sequential_site": 370.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1964, "escape": 0.07998, "mature_H5_site": 354.0, "mutant": "R", "mutation": "H354R", "reference_site": "354", "sequential_site": 370.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.544, "escape": 0.03963, "mature_H5_site": 354.0, "mutant": "W", "mutation": "H354W", "reference_site": "354", "sequential_site": 370.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.301, "escape": 0.121, "mature_H5_site": 354.0, "mutant": "Y", "mutation": "H354Y", "reference_site": "354", "sequential_site": 370.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3039, "escape": 0.1044, "mature_H5_site": 355.0, "mutant": "A", "mutation": "H355A", "reference_site": "355", "sequential_site": 371.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.263, "escape": -0.009844, "mature_H5_site": 355.0, "mutant": "F", "mutation": "H355F", "reference_site": "355", "sequential_site": 371.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1826, "escape": -0.0517, "mature_H5_site": 355.0, "mutant": "L", "mutation": "H355L", "reference_site": "355", "sequential_site": 371.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6519, "escape": -0.05033, "mature_H5_site": 355.0, "mutant": "M", "mutation": "H355M", "reference_site": "355", "sequential_site": 371.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2482, "escape": 0.07681, "mature_H5_site": 355.0, "mutant": "S", "mutation": "H355S", "reference_site": "355", "sequential_site": 371.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3129, "escape": 0.004634, "mature_H5_site": 355.0, "mutant": "V", "mutation": "H355V", "reference_site": "355", "sequential_site": 371.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.204, "escape": -0.1701, "mature_H5_site": 355.0, "mutant": "Y", "mutation": "H355Y", "reference_site": "355", "sequential_site": 371.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06263, "escape": -0.02404, "mature_H5_site": 356.0, "mutant": "C", "mutation": "S356C", "reference_site": "356", "sequential_site": 372.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1314, "escape": 0.0332, "mature_H5_site": 356.0, "mutant": "D", "mutation": "S356D", "reference_site": "356", "sequential_site": 372.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1531, "escape": -0.04035, "mature_H5_site": 356.0, "mutant": "E", "mutation": "S356E", "reference_site": "356", "sequential_site": 372.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07867, "escape": -0.08293, "mature_H5_site": 356.0, "mutant": "F", "mutation": "S356F", "reference_site": "356", "sequential_site": 372.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6692, "escape": -0.3738, "mature_H5_site": 356.0, "mutant": "H", "mutation": "S356H", "reference_site": "356", "sequential_site": 372.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1908, "escape": 0.2172, "mature_H5_site": 356.0, "mutant": "I", "mutation": "S356I", "reference_site": "356", "sequential_site": 372.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2403, "escape": 0.1167, "mature_H5_site": 356.0, "mutant": "K", "mutation": "S356K", "reference_site": "356", "sequential_site": 372.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07318, "escape": -0.128, "mature_H5_site": 356.0, "mutant": "L", "mutation": "S356L", "reference_site": "356", "sequential_site": 372.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1524, "escape": -0.1149, "mature_H5_site": 356.0, "mutant": "M", "mutation": "S356M", "reference_site": "356", "sequential_site": 372.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3316, "escape": -0.04254, "mature_H5_site": 356.0, "mutant": "N", "mutation": "S356N", "reference_site": "356", "sequential_site": 372.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1829, "escape": 0.01036, "mature_H5_site": 356.0, "mutant": "R", "mutation": "S356R", "reference_site": "356", "sequential_site": 372.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04664, "escape": -0.09106, "mature_H5_site": 356.0, "mutant": "T", "mutation": "S356T", "reference_site": "356", "sequential_site": 372.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04194, "escape": -0.2374, "mature_H5_site": 356.0, "mutant": "V", "mutation": "S356V", "reference_site": "356", "sequential_site": 372.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5616, "escape": 0.003983, "mature_H5_site": 356.0, "mutant": "W", "mutation": "S356W", "reference_site": "356", "sequential_site": 372.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1878, "escape": -0.1636, "mature_H5_site": 358.0, "mutant": "C", "mutation": "E358C", "reference_site": "358", "sequential_site": 374.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01101, "escape": -0.1045, "mature_H5_site": 358.0, "mutant": "D", "mutation": "E358D", "reference_site": "358", "sequential_site": 374.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3746, "escape": 0.000383, "mature_H5_site": 358.0, "mutant": "G", "mutation": "E358G", "reference_site": "358", "sequential_site": 374.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3734, "escape": -0.05477, "mature_H5_site": 358.0, "mutant": "I", "mutation": "E358I", "reference_site": "358", "sequential_site": 374.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2666, "escape": -0.08344, "mature_H5_site": 358.0, "mutant": "L", "mutation": "E358L", "reference_site": "358", "sequential_site": 374.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07484, "escape": 0.0922, "mature_H5_site": 358.0, "mutant": "N", "mutation": "E358N", "reference_site": "358", "sequential_site": 374.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2098, "escape": -0.01949, "mature_H5_site": 358.0, "mutant": "Q", "mutation": "E358Q", "reference_site": "358", "sequential_site": 374.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7569, "escape": -0.1038, "mature_H5_site": 358.0, "mutant": "S", "mutation": "E358S", "reference_site": "358", "sequential_site": 374.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07576, "escape": -0.0226, "mature_H5_site": 358.0, "mutant": "T", "mutation": "E358T", "reference_site": "358", "sequential_site": 374.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07242, "escape": -0.02109, "mature_H5_site": 358.0, "mutant": "V", "mutation": "E358V", "reference_site": "358", "sequential_site": 374.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.351, "escape": -0.2733, "mature_H5_site": 358.0, "mutant": "W", "mutation": "E358W", "reference_site": "358", "sequential_site": 374.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.569, "escape": 0.05663, "mature_H5_site": 359.0, "mutant": "A", "mutation": "Q359A", "reference_site": "359", "sequential_site": 375.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4672, "escape": 0.09789, "mature_H5_site": 359.0, "mutant": "D", "mutation": "Q359D", "reference_site": "359", "sequential_site": 375.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04854, "escape": 0.09289, "mature_H5_site": 359.0, "mutant": "E", "mutation": "Q359E", "reference_site": "359", "sequential_site": 375.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1041, "escape": 0.04914, "mature_H5_site": 359.0, "mutant": "H", "mutation": "Q359H", "reference_site": "359", "sequential_site": 375.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04396, "escape": -0.2798, "mature_H5_site": 359.0, "mutant": "I", "mutation": "Q359I", "reference_site": "359", "sequential_site": 375.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.583, "escape": 0.02772, "mature_H5_site": 359.0, "mutant": "K", "mutation": "Q359K", "reference_site": "359", "sequential_site": 375.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03834, "escape": 0.06209, "mature_H5_site": 359.0, "mutant": "L", "mutation": "Q359L", "reference_site": "359", "sequential_site": 375.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5241, "escape": 0.05682, "mature_H5_site": 359.0, "mutant": "M", "mutation": "Q359M", "reference_site": "359", "sequential_site": 375.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.733, "escape": -0.1868, "mature_H5_site": 359.0, "mutant": "N", "mutation": "Q359N", "reference_site": "359", "sequential_site": 375.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8552, "escape": 0.05289, "mature_H5_site": 359.0, "mutant": "R", "mutation": "Q359R", "reference_site": "359", "sequential_site": 375.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4509, "escape": -0.07598, "mature_H5_site": 359.0, "mutant": "V", "mutation": "Q359V", "reference_site": "359", "sequential_site": 375.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05101, "escape": 0.08763, "mature_H5_site": 359.0, "mutant": "W", "mutation": "Q359W", "reference_site": "359", "sequential_site": 375.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2526, "escape": -0.1037, "mature_H5_site": 26.0, "mutant": "I", "mutation": "V36I", "reference_site": "36", "sequential_site": 42.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.399, "escape": -0.02733, "mature_H5_site": 360.0, "mutant": "S", "mutation": "G360S", "reference_site": "360", "sequential_site": 376.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.355, "escape": 0.2216, "mature_H5_site": 360.0, "mutant": "W", "mutation": "G360W", "reference_site": "360", "sequential_site": 376.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4424, "escape": -0.05232, "mature_H5_site": 361.0, "mutant": "D", "mutation": "S361D", "reference_site": "361", "sequential_site": 377.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3236, "escape": -0.06171, "mature_H5_site": 361.0, "mutant": "F", "mutation": "S361F", "reference_site": "361", "sequential_site": 377.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06629, "escape": 0.08882, "mature_H5_site": 361.0, "mutant": "H", "mutation": "S361H", "reference_site": "361", "sequential_site": 377.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.081, "escape": -0.5801, "mature_H5_site": 361.0, "mutant": "K", "mutation": "S361K", "reference_site": "361", "sequential_site": 377.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.347, "escape": -0.01376, "mature_H5_site": 361.0, "mutant": "L", "mutation": "S361L", "reference_site": "361", "sequential_site": 377.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05795, "escape": 0.03815, "mature_H5_site": 361.0, "mutant": "M", "mutation": "S361M", "reference_site": "361", "sequential_site": 377.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2279, "escape": -0.04098, "mature_H5_site": 361.0, "mutant": "Q", "mutation": "S361Q", "reference_site": "361", "sequential_site": 377.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1748, "escape": 0.1076, "mature_H5_site": 361.0, "mutant": "R", "mutation": "S361R", "reference_site": "361", "sequential_site": 377.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0247, "escape": -0.03381, "mature_H5_site": 361.0, "mutant": "T", "mutation": "S361T", "reference_site": "361", "sequential_site": 377.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06492, "escape": -0.1016, "mature_H5_site": 361.0, "mutant": "V", "mutation": "S361V", "reference_site": "361", "sequential_site": 377.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05194, "escape": -0.04055, "mature_H5_site": 361.0, "mutant": "W", "mutation": "S361W", "reference_site": "361", "sequential_site": 377.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1629, "escape": 0.03853, "mature_H5_site": 361.0, "mutant": "Y", "mutation": "S361Y", "reference_site": "361", "sequential_site": 377.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9292, "escape": -0.01311, "mature_H5_site": 362.0, "mutant": "C", "mutation": "G362C", "reference_site": "362", "sequential_site": 378.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7029, "escape": -0.1107, "mature_H5_site": 362.0, "mutant": "D", "mutation": "G362D", "reference_site": "362", "sequential_site": 378.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.182, "escape": 0.2291, "mature_H5_site": 362.0, "mutant": "E", "mutation": "G362E", "reference_site": "362", "sequential_site": 378.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.253, "escape": -0.3833, "mature_H5_site": 362.0, "mutant": "F", "mutation": "G362F", "reference_site": "362", "sequential_site": 378.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5714, "escape": 0.06813, "mature_H5_site": 362.0, "mutant": "H", "mutation": "G362H", "reference_site": "362", "sequential_site": 378.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.314, "escape": -0.2304, "mature_H5_site": 362.0, "mutant": "I", "mutation": "G362I", "reference_site": "362", "sequential_site": 378.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.322, "escape": -0.1621, "mature_H5_site": 362.0, "mutant": "K", "mutation": "G362K", "reference_site": "362", "sequential_site": 378.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3178, "escape": -0.7315, "mature_H5_site": 362.0, "mutant": "M", "mutation": "G362M", "reference_site": "362", "sequential_site": 378.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.336, "escape": -0.1451, "mature_H5_site": 362.0, "mutant": "N", "mutation": "G362N", "reference_site": "362", "sequential_site": 378.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7936, "escape": -0.07796, "mature_H5_site": 362.0, "mutant": "Q", "mutation": "G362Q", "reference_site": "362", "sequential_site": 378.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7424, "escape": 0.6001, "mature_H5_site": 362.0, "mutant": "R", "mutation": "G362R", "reference_site": "362", "sequential_site": 378.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03737, "escape": 0.03908, "mature_H5_site": 362.0, "mutant": "S", "mutation": "G362S", "reference_site": "362", "sequential_site": 378.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.421, "escape": -0.08028, "mature_H5_site": 362.0, "mutant": "V", "mutation": "G362V", "reference_site": "362", "sequential_site": 378.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.339, "escape": -0.1238, "mature_H5_site": 362.0, "mutant": "W", "mutation": "G362W", "reference_site": "362", "sequential_site": 378.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.616, "escape": 0.05044, "mature_H5_site": 363.0, "mutant": "I", "mutation": "Y363I", "reference_site": "363", "sequential_site": 379.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.219, "escape": -0.1572, "mature_H5_site": 363.0, "mutant": "M", "mutation": "Y363M", "reference_site": "363", "sequential_site": 379.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6294, "escape": -0.1064, "mature_H5_site": 363.0, "mutant": "W", "mutation": "Y363W", "reference_site": "363", "sequential_site": 379.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.161, "escape": -0.3361, "mature_H5_site": 364.0, "mutant": "C", "mutation": "A364C", "reference_site": "364", "sequential_site": 380.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.33, "escape": 0.1354, "mature_H5_site": 364.0, "mutant": "G", "mutation": "A364G", "reference_site": "364", "sequential_site": 380.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.359, "escape": 0.1028, "mature_H5_site": 364.0, "mutant": "I", "mutation": "A364I", "reference_site": "364", "sequential_site": 380.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9535, "escape": 0.1904, "mature_H5_site": 364.0, "mutant": "M", "mutation": "A364M", "reference_site": "364", "sequential_site": 380.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1324, "escape": -0.1575, "mature_H5_site": 364.0, "mutant": "S", "mutation": "A364S", "reference_site": "364", "sequential_site": 380.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.18, "escape": 0.08217, "mature_H5_site": 364.0, "mutant": "T", "mutation": "A364T", "reference_site": "364", "sequential_site": 380.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.008, "escape": 0.1668, "mature_H5_site": 364.0, "mutant": "V", "mutation": "A364V", "reference_site": "364", "sequential_site": 380.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1733, "escape": 0.09965, "mature_H5_site": 365.0, "mutant": "S", "mutation": "A365S", "reference_site": "365", "sequential_site": 381.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.175, "escape": 0.01531, "mature_H5_site": 365.0, "mutant": "T", "mutation": "A365T", "reference_site": "365", "sequential_site": 381.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2832, "escape": -0.2459, "mature_H5_site": 367.0, "mutant": "N", "mutation": "K367N", "reference_site": "367", "sequential_site": 383.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03098, "escape": 0.03992, "mature_H5_site": 367.0, "mutant": "Q", "mutation": "K367Q", "reference_site": "367", "sequential_site": 383.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2061, "escape": -0.2819, "mature_H5_site": 368.0, "mutant": "G", "mutation": "E368G", "reference_site": "368", "sequential_site": 384.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00354, "escape": -0.04848, "mature_H5_site": 368.0, "mutant": "K", "mutation": "E368K", "reference_site": "368", "sequential_site": 384.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1512, "escape": -0.2059, "mature_H5_site": 369.0, "mutant": "C", "mutation": "S369C", "reference_site": "369", "sequential_site": 385.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06606, "escape": -0.006034, "mature_H5_site": 369.0, "mutant": "G", "mutation": "S369G", "reference_site": "369", "sequential_site": 385.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01304, "escape": -0.6634, "mature_H5_site": 370.0, "mutant": "S", "mutation": "T370S", "reference_site": "370", "sequential_site": 386.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.667, "escape": -0.04271, "mature_H5_site": 370.0, "mutant": "V", "mutation": "T370V", "reference_site": "370", "sequential_site": 386.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07425, "escape": 0.0006227, "mature_H5_site": 371.0, "mutant": "A", "mutation": "Q371A", "reference_site": "371", "sequential_site": 387.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.769, "escape": 0.1232, "mature_H5_site": 371.0, "mutant": "D", "mutation": "Q371D", "reference_site": "371", "sequential_site": 387.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2286, "escape": -0.001035, "mature_H5_site": 371.0, "mutant": "E", "mutation": "Q371E", "reference_site": "371", "sequential_site": 387.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5295, "escape": -0.1705, "mature_H5_site": 371.0, "mutant": "G", "mutation": "Q371G", "reference_site": "371", "sequential_site": 387.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.143, "escape": 0.02499, "mature_H5_site": 371.0, "mutant": "I", "mutation": "Q371I", "reference_site": "371", "sequential_site": 387.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.69, "escape": 0.5324, "mature_H5_site": 371.0, "mutant": "K", "mutation": "Q371K", "reference_site": "371", "sequential_site": 387.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7269, "escape": 0.09149, "mature_H5_site": 371.0, "mutant": "M", "mutation": "Q371M", "reference_site": "371", "sequential_site": 387.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01187, "escape": 0.06273, "mature_H5_site": 371.0, "mutant": "N", "mutation": "Q371N", "reference_site": "371", "sequential_site": 387.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2476, "escape": -0.3414, "mature_H5_site": 371.0, "mutant": "S", "mutation": "Q371S", "reference_site": "371", "sequential_site": 387.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9552, "escape": -0.09899, "mature_H5_site": 371.0, "mutant": "T", "mutation": "Q371T", "reference_site": "371", "sequential_site": 387.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.256, "escape": 0.4686, "mature_H5_site": 371.0, "mutant": "V", "mutation": "Q371V", "reference_site": "371", "sequential_site": 387.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05935, "escape": -0.1482, "mature_H5_site": 372.0, "mutant": "A", "mutation": "K372A", "reference_site": "372", "sequential_site": 388.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06388, "escape": 0.07503, "mature_H5_site": 372.0, "mutant": "C", "mutation": "K372C", "reference_site": "372", "sequential_site": 388.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.725, "escape": -0.1768, "mature_H5_site": 372.0, "mutant": "D", "mutation": "K372D", "reference_site": "372", "sequential_site": 388.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5297, "escape": -0.05345, "mature_H5_site": 372.0, "mutant": "F", "mutation": "K372F", "reference_site": "372", "sequential_site": 388.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4995, "escape": -0.3108, "mature_H5_site": 372.0, "mutant": "G", "mutation": "K372G", "reference_site": "372", "sequential_site": 388.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3715, "escape": -0.1195, "mature_H5_site": 372.0, "mutant": "H", "mutation": "K372H", "reference_site": "372", "sequential_site": 388.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03692, "escape": -0.2237, "mature_H5_site": 372.0, "mutant": "L", "mutation": "K372L", "reference_site": "372", "sequential_site": 388.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5105, "escape": 0.08828, "mature_H5_site": 372.0, "mutant": "M", "mutation": "K372M", "reference_site": "372", "sequential_site": 388.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04168, "escape": -0.04293, "mature_H5_site": 372.0, "mutant": "N", "mutation": "K372N", "reference_site": "372", "sequential_site": 388.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.002069, "escape": 0.006871, "mature_H5_site": 372.0, "mutant": "Q", "mutation": "K372Q", "reference_site": "372", "sequential_site": 388.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02441, "escape": -0.1722, "mature_H5_site": 372.0, "mutant": "R", "mutation": "K372R", "reference_site": "372", "sequential_site": 388.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1544, "escape": 0.001452, "mature_H5_site": 372.0, "mutant": "T", "mutation": "K372T", "reference_site": "372", "sequential_site": 388.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5793, "escape": -0.1266, "mature_H5_site": 372.0, "mutant": "V", "mutation": "K372V", "reference_site": "372", "sequential_site": 388.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2627, "escape": 0.1208, "mature_H5_site": 372.0, "mutant": "W", "mutation": "K372W", "reference_site": "372", "sequential_site": 388.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1247, "escape": 0.138, "mature_H5_site": 372.0, "mutant": "Y", "mutation": "K372Y", "reference_site": "372", "sequential_site": 388.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01648, "escape": -0.03447, "mature_H5_site": 373.0, "mutant": "G", "mutation": "A373G", "reference_site": "373", "sequential_site": 389.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": null, "escape": -0.3641, "mature_H5_site": null, "mutant": "A", "mutation": "I374A", "reference_site": "374", "sequential_site": null, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2379, "escape": -0.05181, "mature_H5_site": 374.0, "mutant": "F", "mutation": "I374F", "reference_site": "374", "sequential_site": 390.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.44, "escape": -0.1362, "mature_H5_site": 374.0, "mutant": "H", "mutation": "I374H", "reference_site": "374", "sequential_site": 390.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05206, "escape": -0.02778, "mature_H5_site": 374.0, "mutant": "L", "mutation": "I374L", "reference_site": "374", "sequential_site": 390.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.213, "escape": 0.0586, "mature_H5_site": 374.0, "mutant": "N", "mutation": "I374N", "reference_site": "374", "sequential_site": 390.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1133, "escape": 0.1721, "mature_H5_site": 374.0, "mutant": "Q", "mutation": "I374Q", "reference_site": "374", "sequential_site": 390.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03036, "escape": -0.1987, "mature_H5_site": 374.0, "mutant": "V", "mutation": "I374V", "reference_site": "374", "sequential_site": 390.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.064, "escape": 0.1509, "mature_H5_site": 375.0, "mutant": "C", "mutation": "D375C", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7386, "escape": -0.02429, "mature_H5_site": 375.0, "mutant": "E", "mutation": "D375E", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7592, "escape": 0.01741, "mature_H5_site": 375.0, "mutant": "F", "mutation": "D375F", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01165, "escape": -0.2542, "mature_H5_site": 375.0, "mutant": "G", "mutation": "D375G", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3345, "escape": -0.159, "mature_H5_site": 375.0, "mutant": "H", "mutation": "D375H", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9873, "escape": -0.02676, "mature_H5_site": 375.0, "mutant": "I", "mutation": "D375I", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.27, "escape": 0.1231, "mature_H5_site": 375.0, "mutant": "K", "mutation": "D375K", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2831, "escape": 0.09382, "mature_H5_site": 375.0, "mutant": "L", "mutation": "D375L", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8669, "escape": 0.08502, "mature_H5_site": 375.0, "mutant": "M", "mutation": "D375M", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01528, "escape": 0.2822, "mature_H5_site": 375.0, "mutant": "N", "mutation": "D375N", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.195, "escape": 0.2582, "mature_H5_site": 375.0, "mutant": "Q", "mutation": "D375Q", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.206, "escape": -0.09108, "mature_H5_site": 375.0, "mutant": "R", "mutation": "D375R", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1904, "escape": -0.05029, "mature_H5_site": 375.0, "mutant": "S", "mutation": "D375S", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.289, "escape": -0.09333, "mature_H5_site": 375.0, "mutant": "T", "mutation": "D375T", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.016, "escape": -0.02912, "mature_H5_site": 375.0, "mutant": "V", "mutation": "D375V", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6915, "escape": -1.256, "mature_H5_site": 375.0, "mutant": "W", "mutation": "D375W", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3159, "escape": -0.1955, "mature_H5_site": 375.0, "mutant": "Y", "mutation": "D375Y", "reference_site": "375", "sequential_site": 391.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.79, "escape": 0.3369, "mature_H5_site": 376.0, "mutant": "A", "mutation": "G376A", "reference_site": "376", "sequential_site": 392.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3486, "escape": -0.1718, "mature_H5_site": 376.0, "mutant": "C", "mutation": "G376C", "reference_site": "376", "sequential_site": 392.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.518, "escape": -0.4387, "mature_H5_site": 376.0, "mutant": "E", "mutation": "G376E", "reference_site": "376", "sequential_site": 392.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.242, "escape": 0.4214, "mature_H5_site": 376.0, "mutant": "F", "mutation": "G376F", "reference_site": "376", "sequential_site": 392.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7905, "escape": -0.03184, "mature_H5_site": 376.0, "mutant": "K", "mutation": "G376K", "reference_site": "376", "sequential_site": 392.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.567, "escape": -0.2242, "mature_H5_site": 376.0, "mutant": "M", "mutation": "G376M", "reference_site": "376", "sequential_site": 392.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.103, "escape": -0.129, "mature_H5_site": 376.0, "mutant": "R", "mutation": "G376R", "reference_site": "376", "sequential_site": 392.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1824, "escape": 0.2197, "mature_H5_site": 376.0, "mutant": "S", "mutation": "G376S", "reference_site": "376", "sequential_site": 392.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.891, "escape": -0.05662, "mature_H5_site": 376.0, "mutant": "W", "mutation": "G376W", "reference_site": "376", "sequential_site": 392.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.938, "escape": -0.1591, "mature_H5_site": 377.0, "mutant": "C", "mutation": "V377C", "reference_site": "377", "sequential_site": 393.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.735, "escape": 0.1738, "mature_H5_site": 377.0, "mutant": "I", "mutation": "V377I", "reference_site": "377", "sequential_site": 393.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3085, "escape": 0.3067, "mature_H5_site": 377.0, "mutant": "L", "mutation": "V377L", "reference_site": "377", "sequential_site": 393.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06978, "escape": -0.07578, "mature_H5_site": 377.0, "mutant": "M", "mutation": "V377M", "reference_site": "377", "sequential_site": 393.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1386, "escape": -0.1573, "mature_H5_site": 377.0, "mutant": "T", "mutation": "V377T", "reference_site": "377", "sequential_site": 393.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1649, "escape": 0.0219, "mature_H5_site": 378.0, "mutant": "A", "mutation": "T378A", "reference_site": "378", "sequential_site": 394.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7997, "escape": -0.05411, "mature_H5_site": 378.0, "mutant": "C", "mutation": "T378C", "reference_site": "378", "sequential_site": 394.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4491, "escape": -0.1532, "mature_H5_site": 378.0, "mutant": "D", "mutation": "T378D", "reference_site": "378", "sequential_site": 394.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3271, "escape": -0.4752, "mature_H5_site": 378.0, "mutant": "E", "mutation": "T378E", "reference_site": "378", "sequential_site": 394.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.282, "escape": 0.05616, "mature_H5_site": 378.0, "mutant": "F", "mutation": "T378F", "reference_site": "378", "sequential_site": 394.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3682, "escape": -0.03558, "mature_H5_site": 378.0, "mutant": "I", "mutation": "T378I", "reference_site": "378", "sequential_site": 394.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.496, "escape": 0.4807, "mature_H5_site": 378.0, "mutant": "M", "mutation": "T378M", "reference_site": "378", "sequential_site": 394.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00125, "escape": -0.09814, "mature_H5_site": 378.0, "mutant": "N", "mutation": "T378N", "reference_site": "378", "sequential_site": 394.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03988, "escape": -0.03293, "mature_H5_site": 378.0, "mutant": "Q", "mutation": "T378Q", "reference_site": "378", "sequential_site": 394.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02766, "escape": -0.08444, "mature_H5_site": 378.0, "mutant": "R", "mutation": "T378R", "reference_site": "378", "sequential_site": 394.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.113, "escape": -0.111, "mature_H5_site": 378.0, "mutant": "S", "mutation": "T378S", "reference_site": "378", "sequential_site": 394.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.275, "escape": -0.2697, "mature_H5_site": 378.0, "mutant": "V", "mutation": "T378V", "reference_site": "378", "sequential_site": 394.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04362, "escape": -0.4961, "mature_H5_site": 378.0, "mutant": "Y", "mutation": "T378Y", "reference_site": "378", "sequential_site": 394.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.128, "escape": 0.09082, "mature_H5_site": 379.0, "mutant": "A", "mutation": "N379A", "reference_site": "379", "sequential_site": 395.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06038, "escape": -0.04233, "mature_H5_site": 379.0, "mutant": "C", "mutation": "N379C", "reference_site": "379", "sequential_site": 395.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.167, "escape": -0.4481, "mature_H5_site": 379.0, "mutant": "E", "mutation": "N379E", "reference_site": "379", "sequential_site": 395.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.461, "escape": -0.1411, "mature_H5_site": 379.0, "mutant": "F", "mutation": "N379F", "reference_site": "379", "sequential_site": 395.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4054, "escape": -0.05817, "mature_H5_site": 379.0, "mutant": "H", "mutation": "N379H", "reference_site": "379", "sequential_site": 395.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.567, "escape": 0.1518, "mature_H5_site": 379.0, "mutant": "K", "mutation": "N379K", "reference_site": "379", "sequential_site": 395.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2277, "escape": 0.1084, "mature_H5_site": 379.0, "mutant": "M", "mutation": "N379M", "reference_site": "379", "sequential_site": 395.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1106, "escape": 0.2821, "mature_H5_site": 379.0, "mutant": "Q", "mutation": "N379Q", "reference_site": "379", "sequential_site": 395.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8377, "escape": -0.04186, "mature_H5_site": 379.0, "mutant": "S", "mutation": "N379S", "reference_site": "379", "sequential_site": 395.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4985, "escape": -0.06034, "mature_H5_site": 379.0, "mutant": "T", "mutation": "N379T", "reference_site": "379", "sequential_site": 395.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1851, "escape": -0.09477, "mature_H5_site": 379.0, "mutant": "V", "mutation": "N379V", "reference_site": "379", "sequential_site": 395.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4376, "escape": -0.0136, "mature_H5_site": 28.0, "mutant": "D", "mutation": "H38D", "reference_site": "38", "sequential_site": 44.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7857, "escape": -0.2399, "mature_H5_site": 28.0, "mutant": "E", "mutation": "H38E", "reference_site": "38", "sequential_site": 44.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4315, "escape": 0.2042, "mature_H5_site": 28.0, "mutant": "G", "mutation": "H38G", "reference_site": "38", "sequential_site": 44.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05457, "escape": -0.03364, "mature_H5_site": 28.0, "mutant": "K", "mutation": "H38K", "reference_site": "38", "sequential_site": 44.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8934, "escape": -0.249, "mature_H5_site": 28.0, "mutant": "L", "mutation": "H38L", "reference_site": "38", "sequential_site": 44.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1058, "escape": -0.0801, "mature_H5_site": 28.0, "mutant": "M", "mutation": "H38M", "reference_site": "38", "sequential_site": 44.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1779, "escape": -0.04834, "mature_H5_site": 28.0, "mutant": "N", "mutation": "H38N", "reference_site": "38", "sequential_site": 44.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1169, "escape": 0.2705, "mature_H5_site": 28.0, "mutant": "Q", "mutation": "H38Q", "reference_site": "38", "sequential_site": 44.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5789, "escape": -0.08627, "mature_H5_site": 28.0, "mutant": "R", "mutation": "H38R", "reference_site": "38", "sequential_site": 44.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.009455, "escape": 0.07342, "mature_H5_site": 28.0, "mutant": "S", "mutation": "H38S", "reference_site": "38", "sequential_site": 44.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.123, "escape": -0.4003, "mature_H5_site": 28.0, "mutant": "V", "mutation": "H38V", "reference_site": "38", "sequential_site": 44.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.464, "escape": -0.1097, "mature_H5_site": 28.0, "mutant": "W", "mutation": "H38W", "reference_site": "38", "sequential_site": 44.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5849, "escape": -0.01248, "mature_H5_site": 28.0, "mutant": "Y", "mutation": "H38Y", "reference_site": "38", "sequential_site": 44.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.931, "escape": -0.0129, "mature_H5_site": 380.0, "mutant": "I", "mutation": "K380I", "reference_site": "380", "sequential_site": 396.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.23, "escape": 0.8584, "mature_H5_site": 380.0, "mutant": "M", "mutation": "K380M", "reference_site": "380", "sequential_site": 396.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.494, "escape": 0.3957, "mature_H5_site": 380.0, "mutant": "R", "mutation": "K380R", "reference_site": "380", "sequential_site": 396.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5301, "escape": -0.3649, "mature_H5_site": 381.0, "mutant": "A", "mutation": "V381A", "reference_site": "381", "sequential_site": 397.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06348, "escape": -0.03332, "mature_H5_site": 381.0, "mutant": "C", "mutation": "V381C", "reference_site": "381", "sequential_site": 397.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6062, "escape": -0.06454, "mature_H5_site": 381.0, "mutant": "L", "mutation": "V381L", "reference_site": "381", "sequential_site": 397.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7463, "escape": -0.03376, "mature_H5_site": 381.0, "mutant": "M", "mutation": "V381M", "reference_site": "381", "sequential_site": 397.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.674, "escape": -0.1113, "mature_H5_site": 381.0, "mutant": "Q", "mutation": "V381Q", "reference_site": "381", "sequential_site": 397.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02307, "escape": 0.1236, "mature_H5_site": 382.0, "mutant": "D", "mutation": "N382D", "reference_site": "382", "sequential_site": 398.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.459, "escape": -0.1613, "mature_H5_site": 382.0, "mutant": "E", "mutation": "N382E", "reference_site": "382", "sequential_site": 398.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.942, "escape": -0.1953, "mature_H5_site": 382.0, "mutant": "F", "mutation": "N382F", "reference_site": "382", "sequential_site": 398.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.393, "escape": -0.1179, "mature_H5_site": 382.0, "mutant": "H", "mutation": "N382H", "reference_site": "382", "sequential_site": 398.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7948, "escape": 0.2865, "mature_H5_site": 382.0, "mutant": "I", "mutation": "N382I", "reference_site": "382", "sequential_site": 398.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.231, "escape": 0.08295, "mature_H5_site": 382.0, "mutant": "K", "mutation": "N382K", "reference_site": "382", "sequential_site": 398.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7235, "escape": 0.09776, "mature_H5_site": 382.0, "mutant": "L", "mutation": "N382L", "reference_site": "382", "sequential_site": 398.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5337, "escape": -0.07274, "mature_H5_site": 382.0, "mutant": "R", "mutation": "N382R", "reference_site": "382", "sequential_site": 398.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00319, "escape": 0.2021, "mature_H5_site": 382.0, "mutant": "S", "mutation": "N382S", "reference_site": "382", "sequential_site": 398.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1704, "escape": 0.2448, "mature_H5_site": 382.0, "mutant": "T", "mutation": "N382T", "reference_site": "382", "sequential_site": 398.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1851, "escape": -0.06446, "mature_H5_site": 382.0, "mutant": "V", "mutation": "N382V", "reference_site": "382", "sequential_site": 398.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.075, "escape": -0.2891, "mature_H5_site": 382.0, "mutant": "W", "mutation": "N382W", "reference_site": "382", "sequential_site": 398.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01306, "escape": -0.08805, "mature_H5_site": 383.0, "mutant": "A", "mutation": "S383A", "reference_site": "383", "sequential_site": 399.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4896, "escape": 0.001631, "mature_H5_site": 383.0, "mutant": "C", "mutation": "S383C", "reference_site": "383", "sequential_site": 399.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.058, "escape": 0.0709, "mature_H5_site": 383.0, "mutant": "F", "mutation": "S383F", "reference_site": "383", "sequential_site": 399.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02006, "escape": -0.003721, "mature_H5_site": 383.0, "mutant": "H", "mutation": "S383H", "reference_site": "383", "sequential_site": 399.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.77, "escape": 0.06516, "mature_H5_site": 383.0, "mutant": "M", "mutation": "S383M", "reference_site": "383", "sequential_site": 399.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1286, "escape": 0.1515, "mature_H5_site": 383.0, "mutant": "Q", "mutation": "S383Q", "reference_site": "383", "sequential_site": 399.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.756, "escape": -0.3103, "mature_H5_site": 383.0, "mutant": "R", "mutation": "S383R", "reference_site": "383", "sequential_site": 399.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.592, "escape": 0.2281, "mature_H5_site": 383.0, "mutant": "T", "mutation": "S383T", "reference_site": "383", "sequential_site": 399.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6387, "escape": -0.01161, "mature_H5_site": 383.0, "mutant": "Y", "mutation": "S383Y", "reference_site": "383", "sequential_site": 399.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.41, "escape": -0.2775, "mature_H5_site": 384.0, "mutant": "C", "mutation": "I384C", "reference_site": "384", "sequential_site": 400.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08789, "escape": 0.07201, "mature_H5_site": 384.0, "mutant": "L", "mutation": "I384L", "reference_site": "384", "sequential_site": 400.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05531, "escape": -0.1451, "mature_H5_site": 384.0, "mutant": "M", "mutation": "I384M", "reference_site": "384", "sequential_site": 400.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07887, "escape": -0.09638, "mature_H5_site": 384.0, "mutant": "V", "mutation": "I384V", "reference_site": "384", "sequential_site": 400.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.643, "escape": 0.03992, "mature_H5_site": 384.0, "mutant": "W", "mutation": "I384W", "reference_site": "384", "sequential_site": 400.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7933, "escape": 0.1236, "mature_H5_site": 384.0, "mutant": "Y", "mutation": "I384Y", "reference_site": "384", "sequential_site": 400.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.094, "escape": 0.3118, "mature_H5_site": 385.0, "mutant": "C", "mutation": "I385C", "reference_site": "385", "sequential_site": 401.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2661, "escape": -0.1037, "mature_H5_site": 385.0, "mutant": "L", "mutation": "I385L", "reference_site": "385", "sequential_site": 401.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.565, "escape": 0.3162, "mature_H5_site": 385.0, "mutant": "M", "mutation": "I385M", "reference_site": "385", "sequential_site": 401.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.891, "escape": 0.4095, "mature_H5_site": 385.0, "mutant": "R", "mutation": "I385R", "reference_site": "385", "sequential_site": 401.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.327, "escape": 0.14, "mature_H5_site": 385.0, "mutant": "S", "mutation": "I385S", "reference_site": "385", "sequential_site": 401.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5425, "escape": -0.07469, "mature_H5_site": 385.0, "mutant": "T", "mutation": "I385T", "reference_site": "385", "sequential_site": 401.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06388, "escape": -1.187, "mature_H5_site": 385.0, "mutant": "V", "mutation": "I385V", "reference_site": "385", "sequential_site": 401.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2489, "escape": 0.05104, "mature_H5_site": 386.0, "mutant": "A", "mutation": "D386A", "reference_site": "386", "sequential_site": 402.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4324, "escape": 0.3289, "mature_H5_site": 386.0, "mutant": "C", "mutation": "D386C", "reference_site": "386", "sequential_site": 402.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3902, "escape": 0.00504, "mature_H5_site": 386.0, "mutant": "E", "mutation": "D386E", "reference_site": "386", "sequential_site": 402.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05201, "escape": 0.2977, "mature_H5_site": 386.0, "mutant": "F", "mutation": "D386F", "reference_site": "386", "sequential_site": 402.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6954, "escape": 0.5172, "mature_H5_site": 386.0, "mutant": "G", "mutation": "D386G", "reference_site": "386", "sequential_site": 402.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4652, "escape": 0.2302, "mature_H5_site": 386.0, "mutant": "H", "mutation": "D386H", "reference_site": "386", "sequential_site": 402.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07297, "escape": -0.09292, "mature_H5_site": 386.0, "mutant": "I", "mutation": "D386I", "reference_site": "386", "sequential_site": 402.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6246, "escape": -0.3797, "mature_H5_site": 386.0, "mutant": "K", "mutation": "D386K", "reference_site": "386", "sequential_site": 402.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3314, "escape": 0.4718, "mature_H5_site": 386.0, "mutant": "M", "mutation": "D386M", "reference_site": "386", "sequential_site": 402.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2731, "escape": 0.2235, "mature_H5_site": 386.0, "mutant": "N", "mutation": "D386N", "reference_site": "386", "sequential_site": 402.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01364, "escape": 0.1824, "mature_H5_site": 386.0, "mutant": "Q", "mutation": "D386Q", "reference_site": "386", "sequential_site": 402.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04728, "escape": -0.2232, "mature_H5_site": 386.0, "mutant": "T", "mutation": "D386T", "reference_site": "386", "sequential_site": 402.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05536, "escape": 0.09861, "mature_H5_site": 386.0, "mutant": "V", "mutation": "D386V", "reference_site": "386", "sequential_site": 402.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3205, "escape": -0.06875, "mature_H5_site": 386.0, "mutant": "Y", "mutation": "D386Y", "reference_site": "386", "sequential_site": 402.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4461, "escape": -0.04278, "mature_H5_site": 387.0, "mutant": "A", "mutation": "K387A", "reference_site": "387", "sequential_site": 403.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0548, "escape": 0.3279, "mature_H5_site": 387.0, "mutant": "C", "mutation": "K387C", "reference_site": "387", "sequential_site": 403.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2553, "escape": -0.02059, "mature_H5_site": 387.0, "mutant": "N", "mutation": "K387N", "reference_site": "387", "sequential_site": 403.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.029, "escape": -0.1096, "mature_H5_site": 387.0, "mutant": "Q", "mutation": "K387Q", "reference_site": "387", "sequential_site": 403.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4854, "escape": 0.1678, "mature_H5_site": 387.0, "mutant": "R", "mutation": "K387R", "reference_site": "387", "sequential_site": 403.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03702, "escape": 0.1171, "mature_H5_site": 387.0, "mutant": "T", "mutation": "K387T", "reference_site": "387", "sequential_site": 403.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.353, "escape": 0.3005, "mature_H5_site": 387.0, "mutant": "V", "mutation": "K387V", "reference_site": "387", "sequential_site": 403.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.811, "escape": -0.003391, "mature_H5_site": 388.0, "mutant": "C", "mutation": "M388C", "reference_site": "388", "sequential_site": 404.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.483, "escape": 0.2578, "mature_H5_site": 388.0, "mutant": "I", "mutation": "M388I", "reference_site": "388", "sequential_site": 404.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.896, "escape": 0.2233, "mature_H5_site": 388.0, "mutant": "T", "mutation": "M388T", "reference_site": "388", "sequential_site": 404.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.352, "escape": 0.03795, "mature_H5_site": 389.0, "mutant": "C", "mutation": "N389C", "reference_site": "389", "sequential_site": 405.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9133, "escape": -0.04773, "mature_H5_site": 389.0, "mutant": "D", "mutation": "N389D", "reference_site": "389", "sequential_site": 405.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06765, "escape": 0.1329, "mature_H5_site": 389.0, "mutant": "E", "mutation": "N389E", "reference_site": "389", "sequential_site": 405.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5404, "escape": 0.1826, "mature_H5_site": 389.0, "mutant": "G", "mutation": "N389G", "reference_site": "389", "sequential_site": 405.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3852, "escape": 0.06684, "mature_H5_site": 389.0, "mutant": "H", "mutation": "N389H", "reference_site": "389", "sequential_site": 405.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7934, "escape": -0.3059, "mature_H5_site": 389.0, "mutant": "I", "mutation": "N389I", "reference_site": "389", "sequential_site": 405.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.876, "escape": 0.07269, "mature_H5_site": 389.0, "mutant": "K", "mutation": "N389K", "reference_site": "389", "sequential_site": 405.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4306, "escape": 0.1198, "mature_H5_site": 389.0, "mutant": "Q", "mutation": "N389Q", "reference_site": "389", "sequential_site": 405.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.322, "escape": 0.5137, "mature_H5_site": 389.0, "mutant": "R", "mutation": "N389R", "reference_site": "389", "sequential_site": 405.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4582, "escape": 0.1823, "mature_H5_site": 389.0, "mutant": "S", "mutation": "N389S", "reference_site": "389", "sequential_site": 405.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1446, "escape": 0.1856, "mature_H5_site": 389.0, "mutant": "T", "mutation": "N389T", "reference_site": "389", "sequential_site": 405.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2366, "escape": 0.401, "mature_H5_site": 389.0, "mutant": "V", "mutation": "N389V", "reference_site": "389", "sequential_site": 405.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04963, "escape": 0.08161, "mature_H5_site": 389.0, "mutant": "Y", "mutation": "N389Y", "reference_site": "389", "sequential_site": 405.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.027, "escape": 0.003715, "mature_H5_site": 29.0, "mutant": "F", "mutation": "A39F", "reference_site": "39", "sequential_site": 45.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7388, "escape": 0.08357, "mature_H5_site": 29.0, "mutant": "G", "mutation": "A39G", "reference_site": "39", "sequential_site": 45.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06004, "escape": -0.03114, "mature_H5_site": 29.0, "mutant": "I", "mutation": "A39I", "reference_site": "39", "sequential_site": 45.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.784, "escape": -0.321, "mature_H5_site": 29.0, "mutant": "L", "mutation": "A39L", "reference_site": "39", "sequential_site": 45.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.246, "escape": 0.01441, "mature_H5_site": 29.0, "mutant": "R", "mutation": "A39R", "reference_site": "39", "sequential_site": 45.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3065, "escape": -0.1887, "mature_H5_site": 29.0, "mutant": "T", "mutation": "A39T", "reference_site": "39", "sequential_site": 45.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09754, "escape": -0.2352, "mature_H5_site": 29.0, "mutant": "V", "mutation": "A39V", "reference_site": "39", "sequential_site": 45.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07439, "escape": 0.01351, "mature_H5_site": 29.0, "mutant": "W", "mutation": "A39W", "reference_site": "39", "sequential_site": 45.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2895, "escape": 0.4703, "mature_H5_site": 29.0, "mutant": "Y", "mutation": "A39Y", "reference_site": "39", "sequential_site": 45.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.324, "escape": 0.001054, "mature_H5_site": 390.0, "mutant": "A", "mutation": "T390A", "reference_site": "390", "sequential_site": 406.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.099, "escape": 0.07989, "mature_H5_site": 390.0, "mutant": "C", "mutation": "T390C", "reference_site": "390", "sequential_site": 406.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.853, "escape": 0.181, "mature_H5_site": 390.0, "mutant": "G", "mutation": "T390G", "reference_site": "390", "sequential_site": 406.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.057, "escape": -0.08328, "mature_H5_site": 390.0, "mutant": "I", "mutation": "T390I", "reference_site": "390", "sequential_site": 406.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.005, "escape": -0.307, "mature_H5_site": 390.0, "mutant": "L", "mutation": "T390L", "reference_site": "390", "sequential_site": 406.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6905, "escape": 0.09688, "mature_H5_site": 390.0, "mutant": "M", "mutation": "T390M", "reference_site": "390", "sequential_site": 406.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9618, "escape": 0.2369, "mature_H5_site": 390.0, "mutant": "Q", "mutation": "T390Q", "reference_site": "390", "sequential_site": 406.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0215, "escape": -0.341, "mature_H5_site": 390.0, "mutant": "V", "mutation": "T390V", "reference_site": "390", "sequential_site": 406.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01487, "escape": -0.01269, "mature_H5_site": 391.0, "mutant": "E", "mutation": "Q391E", "reference_site": "391", "sequential_site": 407.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.048, "escape": -0.1289, "mature_H5_site": 391.0, "mutant": "G", "mutation": "Q391G", "reference_site": "391", "sequential_site": 407.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2074, "escape": 0.01945, "mature_H5_site": 391.0, "mutant": "H", "mutation": "Q391H", "reference_site": "391", "sequential_site": 407.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.854, "escape": 0.4592, "mature_H5_site": 391.0, "mutant": "K", "mutation": "Q391K", "reference_site": "391", "sequential_site": 407.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05083, "escape": -0.08657, "mature_H5_site": 391.0, "mutant": "N", "mutation": "Q391N", "reference_site": "391", "sequential_site": 407.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.053, "escape": -0.1927, "mature_H5_site": 391.0, "mutant": "P", "mutation": "Q391P", "reference_site": "391", "sequential_site": 407.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7793, "escape": 0.02571, "mature_H5_site": 391.0, "mutant": "R", "mutation": "Q391R", "reference_site": "391", "sequential_site": 407.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.47, "escape": 0.6295, "mature_H5_site": 391.0, "mutant": "S", "mutation": "Q391S", "reference_site": "391", "sequential_site": 407.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.687, "escape": 0.5158, "mature_H5_site": 392.0, "mutant": "D", "mutation": "F392D", "reference_site": "392", "sequential_site": 408.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.15, "escape": -0.04539, "mature_H5_site": 392.0, "mutant": "E", "mutation": "F392E", "reference_site": "392", "sequential_site": 408.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.545, "escape": 0.2753, "mature_H5_site": 392.0, "mutant": "N", "mutation": "F392N", "reference_site": "392", "sequential_site": 408.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.559, "escape": -0.3187, "mature_H5_site": 392.0, "mutant": "Q", "mutation": "F392Q", "reference_site": "392", "sequential_site": 408.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06695, "escape": -0.02866, "mature_H5_site": 392.0, "mutant": "W", "mutation": "F392W", "reference_site": "392", "sequential_site": 408.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06471, "escape": 0.2264, "mature_H5_site": 392.0, "mutant": "Y", "mutation": "F392Y", "reference_site": "392", "sequential_site": 408.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6151, "escape": 0.1438, "mature_H5_site": 393.0, "mutant": "C", "mutation": "E393C", "reference_site": "393", "sequential_site": 409.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.115, "escape": -0.2272, "mature_H5_site": 393.0, "mutant": "G", "mutation": "E393G", "reference_site": "393", "sequential_site": 409.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.063, "escape": 0.1734, "mature_H5_site": 393.0, "mutant": "H", "mutation": "E393H", "reference_site": "393", "sequential_site": 409.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.632, "escape": 0.3591, "mature_H5_site": 393.0, "mutant": "L", "mutation": "E393L", "reference_site": "393", "sequential_site": 409.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7436, "escape": -0.3715, "mature_H5_site": 393.0, "mutant": "M", "mutation": "E393M", "reference_site": "393", "sequential_site": 409.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.673, "escape": -0.2434, "mature_H5_site": 393.0, "mutant": "N", "mutation": "E393N", "reference_site": "393", "sequential_site": 409.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9021, "escape": 0.4666, "mature_H5_site": 393.0, "mutant": "Q", "mutation": "E393Q", "reference_site": "393", "sequential_site": 409.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5766, "escape": 0.009522, "mature_H5_site": 393.0, "mutant": "S", "mutation": "E393S", "reference_site": "393", "sequential_site": 409.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9938, "escape": 0.003305, "mature_H5_site": 393.0, "mutant": "T", "mutation": "E393T", "reference_site": "393", "sequential_site": 409.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3754, "escape": -0.04059, "mature_H5_site": 394.0, "mutant": "S", "mutation": "A394S", "reference_site": "394", "sequential_site": 410.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1565, "escape": -0.1842, "mature_H5_site": 395.0, "mutant": "A", "mutation": "V395A", "reference_site": "395", "sequential_site": 411.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1455, "escape": 0.1682, "mature_H5_site": 395.0, "mutant": "C", "mutation": "V395C", "reference_site": "395", "sequential_site": 411.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.303, "escape": 0.01617, "mature_H5_site": 395.0, "mutant": "D", "mutation": "V395D", "reference_site": "395", "sequential_site": 411.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2526, "escape": 0.3741, "mature_H5_site": 395.0, "mutant": "F", "mutation": "V395F", "reference_site": "395", "sequential_site": 411.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6314, "escape": 0.01323, "mature_H5_site": 395.0, "mutant": "G", "mutation": "V395G", "reference_site": "395", "sequential_site": 411.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9791, "escape": -0.03061, "mature_H5_site": 395.0, "mutant": "L", "mutation": "V395L", "reference_site": "395", "sequential_site": 411.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0625, "escape": 0.005479, "mature_H5_site": 395.0, "mutant": "M", "mutation": "V395M", "reference_site": "395", "sequential_site": 411.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1606, "escape": -0.3381, "mature_H5_site": 395.0, "mutant": "Q", "mutation": "V395Q", "reference_site": "395", "sequential_site": 411.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5861, "escape": 0.5815, "mature_H5_site": 395.0, "mutant": "R", "mutation": "V395R", "reference_site": "395", "sequential_site": 411.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01376, "escape": 0.06751, "mature_H5_site": 395.0, "mutant": "S", "mutation": "V395S", "reference_site": "395", "sequential_site": 411.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05529, "escape": 0.1157, "mature_H5_site": 395.0, "mutant": "T", "mutation": "V395T", "reference_site": "395", "sequential_site": 411.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.521, "escape": -0.1566, "mature_H5_site": 396.0, "mutant": "A", "mutation": "G396A", "reference_site": "396", "sequential_site": 412.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01034, "escape": 0.3686, "mature_H5_site": 396.0, "mutant": "C", "mutation": "G396C", "reference_site": "396", "sequential_site": 412.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9118, "escape": 0.04752, "mature_H5_site": 396.0, "mutant": "D", "mutation": "G396D", "reference_site": "396", "sequential_site": 412.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.826, "escape": -0.3308, "mature_H5_site": 396.0, "mutant": "N", "mutation": "G396N", "reference_site": "396", "sequential_site": 412.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.354, "escape": -0.008409, "mature_H5_site": 396.0, "mutant": "P", "mutation": "G396P", "reference_site": "396", "sequential_site": 412.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.341, "escape": 0.3601, "mature_H5_site": 396.0, "mutant": "Q", "mutation": "G396Q", "reference_site": "396", "sequential_site": 412.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.317, "escape": -0.04985, "mature_H5_site": 396.0, "mutant": "S", "mutation": "G396S", "reference_site": "396", "sequential_site": 412.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.925, "escape": -0.01965, "mature_H5_site": 396.0, "mutant": "V", "mutation": "G396V", "reference_site": "396", "sequential_site": 412.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7532, "escape": 0.1518, "mature_H5_site": 397.0, "mutant": "A", "mutation": "R397A", "reference_site": "397", "sequential_site": 413.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.439, "escape": 0.1083, "mature_H5_site": 397.0, "mutant": "C", "mutation": "R397C", "reference_site": "397", "sequential_site": 413.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2741, "escape": 0.05683, "mature_H5_site": 397.0, "mutant": "E", "mutation": "R397E", "reference_site": "397", "sequential_site": 413.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.7, "escape": 1.847, "mature_H5_site": 397.0, "mutant": "F", "mutation": "R397F", "reference_site": "397", "sequential_site": 413.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09892, "escape": -0.04303, "mature_H5_site": 397.0, "mutant": "G", "mutation": "R397G", "reference_site": "397", "sequential_site": 413.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1115, "escape": -0.3233, "mature_H5_site": 397.0, "mutant": "K", "mutation": "R397K", "reference_site": "397", "sequential_site": 413.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.856, "escape": -0.01382, "mature_H5_site": 397.0, "mutant": "M", "mutation": "R397M", "reference_site": "397", "sequential_site": 413.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04207, "escape": 0.09376, "mature_H5_site": 397.0, "mutant": "N", "mutation": "R397N", "reference_site": "397", "sequential_site": 413.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.417, "escape": 0.5323, "mature_H5_site": 397.0, "mutant": "P", "mutation": "R397P", "reference_site": "397", "sequential_site": 413.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01926, "escape": 0.395, "mature_H5_site": 397.0, "mutant": "Q", "mutation": "R397Q", "reference_site": "397", "sequential_site": 413.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7415, "escape": 0.5638, "mature_H5_site": 397.0, "mutant": "S", "mutation": "R397S", "reference_site": "397", "sequential_site": 413.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7234, "escape": 0.5487, "mature_H5_site": 397.0, "mutant": "Y", "mutation": "R397Y", "reference_site": "397", "sequential_site": 413.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2475, "escape": -0.001879, "mature_H5_site": 398.0, "mutant": "C", "mutation": "E398C", "reference_site": "398", "sequential_site": 414.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05463, "escape": 0.1586, "mature_H5_site": 398.0, "mutant": "D", "mutation": "E398D", "reference_site": "398", "sequential_site": 414.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.789, "escape": 1.888, "mature_H5_site": 398.0, "mutant": "N", "mutation": "E398N", "reference_site": "398", "sequential_site": 414.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.617, "escape": -0.05622, "mature_H5_site": 398.0, "mutant": "Q", "mutation": "E398Q", "reference_site": "398", "sequential_site": 414.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.783, "escape": 1.795, "mature_H5_site": 398.0, "mutant": "V", "mutation": "E398V", "reference_site": "398", "sequential_site": 414.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8844, "escape": 0.4589, "mature_H5_site": 399.0, "mutant": "W", "mutation": "F399W", "reference_site": "399", "sequential_site": 415.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05993, "escape": 0.07789, "mature_H5_site": -7.0, "mutant": "C", "mutation": "I4C", "reference_site": "4", "sequential_site": 10.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.454, "escape": -0.1398, "mature_H5_site": -7.0, "mutant": "H", "mutation": "I4H", "reference_site": "4", "sequential_site": 10.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03197, "escape": -0.02692, "mature_H5_site": -7.0, "mutant": "M", "mutation": "I4M", "reference_site": "4", "sequential_site": 10.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7617, "escape": -0.09159, "mature_H5_site": -7.0, "mutant": "W", "mutation": "I4W", "reference_site": "4", "sequential_site": 10.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2044, "escape": -0.1024, "mature_H5_site": 30.0, "mutant": "C", "mutation": "Q40C", "reference_site": "40", "sequential_site": 46.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2469, "escape": 0.229, "mature_H5_site": 30.0, "mutant": "E", "mutation": "Q40E", "reference_site": "40", "sequential_site": 46.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1545, "escape": -0.1756, "mature_H5_site": 30.0, "mutant": "H", "mutation": "Q40H", "reference_site": "40", "sequential_site": 46.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2197, "escape": 0.1401, "mature_H5_site": 30.0, "mutant": "K", "mutation": "Q40K", "reference_site": "40", "sequential_site": 46.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.426, "escape": -0.1014, "mature_H5_site": 30.0, "mutant": "R", "mutation": "Q40R", "reference_site": "40", "sequential_site": 46.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2906, "escape": -0.0469, "mature_H5_site": 30.0, "mutant": "S", "mutation": "Q40S", "reference_site": "40", "sequential_site": 46.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01736, "escape": 0.4971, "mature_H5_site": 30.0, "mutant": "V", "mutation": "Q40V", "reference_site": "40", "sequential_site": 46.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1165, "escape": 0.03423, "mature_H5_site": 30.0, "mutant": "W", "mutation": "Q40W", "reference_site": "40", "sequential_site": 46.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01834, "escape": -0.2179, "mature_H5_site": 400.0, "mutant": "C", "mutation": "N400C", "reference_site": "400", "sequential_site": 416.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.981, "escape": -0.2504, "mature_H5_site": 400.0, "mutant": "D", "mutation": "N400D", "reference_site": "400", "sequential_site": 416.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5786, "escape": 0.1139, "mature_H5_site": 400.0, "mutant": "G", "mutation": "N400G", "reference_site": "400", "sequential_site": 416.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3016, "escape": -0.6211, "mature_H5_site": 400.0, "mutant": "H", "mutation": "N400H", "reference_site": "400", "sequential_site": 416.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.741, "escape": -0.263, "mature_H5_site": 400.0, "mutant": "K", "mutation": "N400K", "reference_site": "400", "sequential_site": 416.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06839, "escape": -0.3059, "mature_H5_site": 400.0, "mutant": "S", "mutation": "N400S", "reference_site": "400", "sequential_site": 416.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1383, "escape": -0.198, "mature_H5_site": 401.0, "mutant": "C", "mutation": "N401C", "reference_site": "401", "sequential_site": 417.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.106, "escape": 0.06256, "mature_H5_site": 401.0, "mutant": "D", "mutation": "N401D", "reference_site": "401", "sequential_site": 417.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07135, "escape": -0.05616, "mature_H5_site": 401.0, "mutant": "F", "mutation": "N401F", "reference_site": "401", "sequential_site": 417.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04331, "escape": -0.3299, "mature_H5_site": 401.0, "mutant": "G", "mutation": "N401G", "reference_site": "401", "sequential_site": 417.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04602, "escape": -0.06421, "mature_H5_site": 401.0, "mutant": "K", "mutation": "N401K", "reference_site": "401", "sequential_site": 417.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": null, "escape": -0.07234, "mature_H5_site": null, "mutant": "M", "mutation": "N401M", "reference_site": "401", "sequential_site": null, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7028, "escape": -0.0815, "mature_H5_site": 401.0, "mutant": "P", "mutation": "N401P", "reference_site": "401", "sequential_site": 417.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07158, "escape": 0.1818, "mature_H5_site": 401.0, "mutant": "Q", "mutation": "N401Q", "reference_site": "401", "sequential_site": 417.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05539, "escape": -0.06439, "mature_H5_site": 401.0, "mutant": "R", "mutation": "N401R", "reference_site": "401", "sequential_site": 417.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06799, "escape": -0.1784, "mature_H5_site": 401.0, "mutant": "T", "mutation": "N401T", "reference_site": "401", "sequential_site": 417.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04712, "escape": -0.03031, "mature_H5_site": 401.0, "mutant": "V", "mutation": "N401V", "reference_site": "401", "sequential_site": 417.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06691, "escape": 0.02309, "mature_H5_site": 401.0, "mutant": "W", "mutation": "N401W", "reference_site": "401", "sequential_site": 417.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04162, "escape": 0.05117, "mature_H5_site": 401.0, "mutant": "Y", "mutation": "N401Y", "reference_site": "401", "sequential_site": 417.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.101, "escape": 0.2249, "mature_H5_site": 402.0, "mutant": "C", "mutation": "L402C", "reference_site": "402", "sequential_site": 418.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.153, "escape": -0.317, "mature_H5_site": 402.0, "mutant": "D", "mutation": "L402D", "reference_site": "402", "sequential_site": 418.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.873, "escape": 0.07385, "mature_H5_site": 402.0, "mutant": "E", "mutation": "L402E", "reference_site": "402", "sequential_site": 418.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2883, "escape": -0.1895, "mature_H5_site": 402.0, "mutant": "F", "mutation": "L402F", "reference_site": "402", "sequential_site": 418.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7639, "escape": 0.091, "mature_H5_site": 402.0, "mutant": "M", "mutation": "L402M", "reference_site": "402", "sequential_site": 418.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.304, "escape": -0.1518, "mature_H5_site": 402.0, "mutant": "N", "mutation": "L402N", "reference_site": "402", "sequential_site": 418.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7077, "escape": 0.3624, "mature_H5_site": 402.0, "mutant": "Q", "mutation": "L402Q", "reference_site": "402", "sequential_site": 418.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.002795, "escape": -0.003446, "mature_H5_site": 402.0, "mutant": "V", "mutation": "L402V", "reference_site": "402", "sequential_site": 418.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4193, "escape": 0.01583, "mature_H5_site": 402.0, "mutant": "Y", "mutation": "L402Y", "reference_site": "402", "sequential_site": 418.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.271, "escape": 0.1809, "mature_H5_site": 404.0, "mutant": "C", "mutation": "R404C", "reference_site": "404", "sequential_site": 420.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5145, "escape": -0.3176, "mature_H5_site": 404.0, "mutant": "H", "mutation": "R404H", "reference_site": "404", "sequential_site": 420.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.553, "escape": -0.3903, "mature_H5_site": 404.0, "mutant": "I", "mutation": "R404I", "reference_site": "404", "sequential_site": 420.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05765, "escape": 0.5533, "mature_H5_site": 404.0, "mutant": "K", "mutation": "R404K", "reference_site": "404", "sequential_site": 420.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.418, "escape": -0.1465, "mature_H5_site": 404.0, "mutant": "L", "mutation": "R404L", "reference_site": "404", "sequential_site": 420.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1928, "escape": -0.1138, "mature_H5_site": 404.0, "mutant": "M", "mutation": "R404M", "reference_site": "404", "sequential_site": 420.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09634, "escape": -0.2506, "mature_H5_site": 404.0, "mutant": "Q", "mutation": "R404Q", "reference_site": "404", "sequential_site": 420.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.17, "escape": -0.2108, "mature_H5_site": 406.0, "mutant": "F", "mutation": "I406F", "reference_site": "406", "sequential_site": 422.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6878, "escape": 0.07923, "mature_H5_site": 406.0, "mutant": "L", "mutation": "I406L", "reference_site": "406", "sequential_site": 422.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4836, "escape": -0.05026, "mature_H5_site": 406.0, "mutant": "V", "mutation": "I406V", "reference_site": "406", "sequential_site": 422.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.41, "escape": 0.1495, "mature_H5_site": 406.0, "mutant": "W", "mutation": "I406W", "reference_site": "406", "sequential_site": 422.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.752, "escape": 0.08519, "mature_H5_site": 407.0, "mutant": "A", "mutation": "E407A", "reference_site": "407", "sequential_site": 423.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.755, "escape": -0.6233, "mature_H5_site": 407.0, "mutant": "C", "mutation": "E407C", "reference_site": "407", "sequential_site": 423.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.647, "escape": -0.1551, "mature_H5_site": 407.0, "mutant": "D", "mutation": "E407D", "reference_site": "407", "sequential_site": 423.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2576, "escape": -0.03149, "mature_H5_site": 407.0, "mutant": "F", "mutation": "E407F", "reference_site": "407", "sequential_site": 423.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.514, "escape": -0.08133, "mature_H5_site": 407.0, "mutant": "G", "mutation": "E407G", "reference_site": "407", "sequential_site": 423.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0126, "escape": 0.1961, "mature_H5_site": 407.0, "mutant": "H", "mutation": "E407H", "reference_site": "407", "sequential_site": 423.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.201, "escape": 0.2345, "mature_H5_site": 407.0, "mutant": "K", "mutation": "E407K", "reference_site": "407", "sequential_site": 423.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.286, "escape": 0.00917, "mature_H5_site": 407.0, "mutant": "N", "mutation": "E407N", "reference_site": "407", "sequential_site": 423.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.301, "escape": -0.05494, "mature_H5_site": 407.0, "mutant": "T", "mutation": "E407T", "reference_site": "407", "sequential_site": 423.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3366, "escape": 0.0931, "mature_H5_site": 407.0, "mutant": "Y", "mutation": "E407Y", "reference_site": "407", "sequential_site": 423.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0657, "escape": 0.1627, "mature_H5_site": 408.0, "mutant": "A", "mutation": "N408A", "reference_site": "408", "sequential_site": 424.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.862, "escape": 0.06574, "mature_H5_site": 408.0, "mutant": "D", "mutation": "N408D", "reference_site": "408", "sequential_site": 424.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6343, "escape": -0.03282, "mature_H5_site": 408.0, "mutant": "E", "mutation": "N408E", "reference_site": "408", "sequential_site": 424.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9346, "escape": -0.07716, "mature_H5_site": 408.0, "mutant": "F", "mutation": "N408F", "reference_site": "408", "sequential_site": 424.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1895, "escape": 0.006761, "mature_H5_site": 408.0, "mutant": "G", "mutation": "N408G", "reference_site": "408", "sequential_site": 424.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.672, "escape": 1.673, "mature_H5_site": 408.0, "mutant": "K", "mutation": "N408K", "reference_site": "408", "sequential_site": 424.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04266, "escape": 0.1387, "mature_H5_site": 408.0, "mutant": "L", "mutation": "N408L", "reference_site": "408", "sequential_site": 424.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7057, "escape": 0.1815, "mature_H5_site": 408.0, "mutant": "M", "mutation": "N408M", "reference_site": "408", "sequential_site": 424.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04367, "escape": 0.2109, "mature_H5_site": 408.0, "mutant": "Q", "mutation": "N408Q", "reference_site": "408", "sequential_site": 424.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6967, "escape": -0.03307, "mature_H5_site": 408.0, "mutant": "S", "mutation": "N408S", "reference_site": "408", "sequential_site": 424.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4969, "escape": 0.1335, "mature_H5_site": 408.0, "mutant": "T", "mutation": "N408T", "reference_site": "408", "sequential_site": 424.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.117, "escape": 1.605, "mature_H5_site": 408.0, "mutant": "V", "mutation": "N408V", "reference_site": "408", "sequential_site": 424.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9513, "escape": -0.2024, "mature_H5_site": 408.0, "mutant": "W", "mutation": "N408W", "reference_site": "408", "sequential_site": 424.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.169, "escape": -0.07289, "mature_H5_site": 408.0, "mutant": "Y", "mutation": "N408Y", "reference_site": "408", "sequential_site": 424.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.154, "escape": -0.03091, "mature_H5_site": 409.0, "mutant": "V", "mutation": "L409V", "reference_site": "409", "sequential_site": 425.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2946, "escape": -0.09383, "mature_H5_site": 31.0, "mutant": "E", "mutation": "D41E", "reference_site": "41", "sequential_site": 47.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3858, "escape": 0.01226, "mature_H5_site": 31.0, "mutant": "G", "mutation": "D41G", "reference_site": "41", "sequential_site": 47.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3564, "escape": 0.009323, "mature_H5_site": 31.0, "mutant": "K", "mutation": "D41K", "reference_site": "41", "sequential_site": 47.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5279, "escape": -0.1661, "mature_H5_site": 31.0, "mutant": "L", "mutation": "D41L", "reference_site": "41", "sequential_site": 47.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05694, "escape": -0.1751, "mature_H5_site": 31.0, "mutant": "M", "mutation": "D41M", "reference_site": "41", "sequential_site": 47.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03961, "escape": -0.0532, "mature_H5_site": 31.0, "mutant": "N", "mutation": "D41N", "reference_site": "41", "sequential_site": 47.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4959, "escape": -0.2359, "mature_H5_site": 31.0, "mutant": "P", "mutation": "D41P", "reference_site": "41", "sequential_site": 47.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06001, "escape": -0.01481, "mature_H5_site": 31.0, "mutant": "Q", "mutation": "D41Q", "reference_site": "41", "sequential_site": 47.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7866, "escape": 0.1625, "mature_H5_site": 31.0, "mutant": "R", "mutation": "D41R", "reference_site": "41", "sequential_site": 47.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9921, "escape": 0.1059, "mature_H5_site": 31.0, "mutant": "T", "mutation": "D41T", "reference_site": "41", "sequential_site": 47.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3471, "escape": -0.007914, "mature_H5_site": 31.0, "mutant": "W", "mutation": "D41W", "reference_site": "41", "sequential_site": 47.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2681, "escape": -0.1671, "mature_H5_site": 31.0, "mutant": "Y", "mutation": "D41Y", "reference_site": "41", "sequential_site": 47.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3307, "escape": 0.3212, "mature_H5_site": 410.0, "mutant": "A", "mutation": "N410A", "reference_site": "410", "sequential_site": 426.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9637, "escape": 0.2087, "mature_H5_site": 410.0, "mutant": "D", "mutation": "N410D", "reference_site": "410", "sequential_site": 426.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.21, "escape": 0.06824, "mature_H5_site": 410.0, "mutant": "E", "mutation": "N410E", "reference_site": "410", "sequential_site": 426.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3021, "escape": 0.6049, "mature_H5_site": 410.0, "mutant": "G", "mutation": "N410G", "reference_site": "410", "sequential_site": 426.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.005135, "escape": 0.3688, "mature_H5_site": 410.0, "mutant": "H", "mutation": "N410H", "reference_site": "410", "sequential_site": 426.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.587, "escape": 0.2086, "mature_H5_site": 410.0, "mutant": "S", "mutation": "N410S", "reference_site": "410", "sequential_site": 426.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.803, "escape": -0.1222, "mature_H5_site": 411.0, "mutant": "C", "mutation": "K411C", "reference_site": "411", "sequential_site": 427.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.829, "escape": 0.07917, "mature_H5_site": 411.0, "mutant": "E", "mutation": "K411E", "reference_site": "411", "sequential_site": 427.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.723, "escape": 0.3016, "mature_H5_site": 411.0, "mutant": "L", "mutation": "K411L", "reference_site": "411", "sequential_site": 427.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.522, "escape": -0.06394, "mature_H5_site": 411.0, "mutant": "N", "mutation": "K411N", "reference_site": "411", "sequential_site": 427.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07197, "escape": -0.04921, "mature_H5_site": 411.0, "mutant": "R", "mutation": "K411R", "reference_site": "411", "sequential_site": 427.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.332, "escape": -0.3422, "mature_H5_site": 411.0, "mutant": "V", "mutation": "K411V", "reference_site": "411", "sequential_site": 427.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.093, "escape": -0.2785, "mature_H5_site": 412.0, "mutant": "H", "mutation": "K412H", "reference_site": "412", "sequential_site": 428.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.598, "escape": 0.1538, "mature_H5_site": 412.0, "mutant": "I", "mutation": "K412I", "reference_site": "412", "sequential_site": 428.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.572, "escape": -0.1845, "mature_H5_site": 412.0, "mutant": "N", "mutation": "K412N", "reference_site": "412", "sequential_site": 428.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.692, "escape": -0.1044, "mature_H5_site": 412.0, "mutant": "Q", "mutation": "K412Q", "reference_site": "412", "sequential_site": 428.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.35, "escape": 0.3095, "mature_H5_site": 412.0, "mutant": "V", "mutation": "K412V", "reference_site": "412", "sequential_site": 428.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.118, "escape": -0.06355, "mature_H5_site": 412.0, "mutant": "Y", "mutation": "K412Y", "reference_site": "412", "sequential_site": 428.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2718, "escape": 0.146, "mature_H5_site": 413.0, "mutant": "I", "mutation": "M413I", "reference_site": "413", "sequential_site": 429.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00092, "escape": -0.08622, "mature_H5_site": 413.0, "mutant": "L", "mutation": "M413L", "reference_site": "413", "sequential_site": 429.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1254, "escape": 0.1778, "mature_H5_site": 413.0, "mutant": "V", "mutation": "M413V", "reference_site": "413", "sequential_site": 429.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.028, "escape": 0.2144, "mature_H5_site": 414.0, "mutant": "A", "mutation": "E414A", "reference_site": "414", "sequential_site": 430.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2649, "escape": 0.05906, "mature_H5_site": 414.0, "mutant": "H", "mutation": "E414H", "reference_site": "414", "sequential_site": 430.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2315, "escape": 0.07272, "mature_H5_site": 414.0, "mutant": "I", "mutation": "E414I", "reference_site": "414", "sequential_site": 430.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4277, "escape": 0.2236, "mature_H5_site": 414.0, "mutant": "M", "mutation": "E414M", "reference_site": "414", "sequential_site": 430.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.718, "escape": 0.1908, "mature_H5_site": 414.0, "mutant": "N", "mutation": "E414N", "reference_site": "414", "sequential_site": 430.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3755, "escape": -0.05171, "mature_H5_site": 414.0, "mutant": "Q", "mutation": "E414Q", "reference_site": "414", "sequential_site": 430.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.983, "escape": 0.4483, "mature_H5_site": 414.0, "mutant": "R", "mutation": "E414R", "reference_site": "414", "sequential_site": 430.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06156, "escape": -0.02918, "mature_H5_site": 414.0, "mutant": "V", "mutation": "E414V", "reference_site": "414", "sequential_site": 430.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.343, "escape": -0.1784, "mature_H5_site": 415.0, "mutant": "A", "mutation": "D415A", "reference_site": "415", "sequential_site": 431.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.162, "escape": -0.1001, "mature_H5_site": 415.0, "mutant": "E", "mutation": "D415E", "reference_site": "415", "sequential_site": 431.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7733, "escape": -0.003263, "mature_H5_site": 415.0, "mutant": "N", "mutation": "D415N", "reference_site": "415", "sequential_site": 431.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.832, "escape": -0.05814, "mature_H5_site": 415.0, "mutant": "Q", "mutation": "D415Q", "reference_site": "415", "sequential_site": 431.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7084, "escape": 0.412, "mature_H5_site": 416.0, "mutant": "A", "mutation": "G416A", "reference_site": "416", "sequential_site": 432.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.516, "escape": 0.4304, "mature_H5_site": 416.0, "mutant": "N", "mutation": "G416N", "reference_site": "416", "sequential_site": 432.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.183, "escape": 0.1378, "mature_H5_site": 416.0, "mutant": "Q", "mutation": "G416Q", "reference_site": "416", "sequential_site": 432.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.225, "escape": -0.1047, "mature_H5_site": 416.0, "mutant": "S", "mutation": "G416S", "reference_site": "416", "sequential_site": 432.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.716, "escape": 0.3827, "mature_H5_site": 416.0, "mutant": "Y", "mutation": "G416Y", "reference_site": "416", "sequential_site": 432.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.915, "escape": -0.05305, "mature_H5_site": 417.0, "mutant": "L", "mutation": "F417L", "reference_site": "417", "sequential_site": 433.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9041, "escape": 0.465, "mature_H5_site": 418.0, "mutant": "D", "mutation": "L418D", "reference_site": "418", "sequential_site": 434.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.364, "escape": -0.07574, "mature_H5_site": 418.0, "mutant": "E", "mutation": "L418E", "reference_site": "418", "sequential_site": 434.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.561, "escape": 0.3844, "mature_H5_site": 418.0, "mutant": "F", "mutation": "L418F", "reference_site": "418", "sequential_site": 434.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.891, "escape": 0.437, "mature_H5_site": 418.0, "mutant": "H", "mutation": "L418H", "reference_site": "418", "sequential_site": 434.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.664, "escape": 0.7268, "mature_H5_site": 418.0, "mutant": "N", "mutation": "L418N", "reference_site": "418", "sequential_site": 434.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06695, "escape": 0.1254, "mature_H5_site": 418.0, "mutant": "Q", "mutation": "L418Q", "reference_site": "418", "sequential_site": 434.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.031, "escape": 0.7302, "mature_H5_site": 419.0, "mutant": "E", "mutation": "D419E", "reference_site": "419", "sequential_site": 435.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8767, "escape": -0.1868, "mature_H5_site": 419.0, "mutant": "G", "mutation": "D419G", "reference_site": "419", "sequential_site": 435.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3654, "escape": 0.1801, "mature_H5_site": 419.0, "mutant": "M", "mutation": "D419M", "reference_site": "419", "sequential_site": 435.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8315, "escape": -0.06725, "mature_H5_site": 419.0, "mutant": "N", "mutation": "D419N", "reference_site": "419", "sequential_site": 435.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.552, "escape": 0.8675, "mature_H5_site": 419.0, "mutant": "Q", "mutation": "D419Q", "reference_site": "419", "sequential_site": 435.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2809, "escape": 0.04851, "mature_H5_site": 419.0, "mutant": "S", "mutation": "D419S", "reference_site": "419", "sequential_site": 435.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.383, "escape": -0.1051, "mature_H5_site": 419.0, "mutant": "V", "mutation": "D419V", "reference_site": "419", "sequential_site": 435.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.487, "escape": -0.1865, "mature_H5_site": 419.0, "mutant": "Y", "mutation": "D419Y", "reference_site": "419", "sequential_site": 435.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03869, "escape": 0.08377, "mature_H5_site": 420.0, "mutant": "L", "mutation": "V420L", "reference_site": "420", "sequential_site": 436.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.333, "escape": -0.1663, "mature_H5_site": 420.0, "mutant": "M", "mutation": "V420M", "reference_site": "420", "sequential_site": 436.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.581, "escape": -0.1128, "mature_H5_site": 420.0, "mutant": "T", "mutation": "V420T", "reference_site": "420", "sequential_site": 436.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.24, "escape": -0.03183, "mature_H5_site": 422.0, "mutant": "Q", "mutation": "T422Q", "reference_site": "422", "sequential_site": 438.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.786, "escape": 0.07761, "mature_H5_site": 422.0, "mutant": "S", "mutation": "T422S", "reference_site": "422", "sequential_site": 438.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3063, "escape": -0.005459, "mature_H5_site": 424.0, "mutant": "E", "mutation": "N424E", "reference_site": "424", "sequential_site": 440.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.472, "escape": -0.1908, "mature_H5_site": 425.0, "mutant": "G", "mutation": "A425G", "reference_site": "425", "sequential_site": 441.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8683, "escape": 0.3005, "mature_H5_site": 425.0, "mutant": "I", "mutation": "A425I", "reference_site": "425", "sequential_site": 441.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5487, "escape": -0.1303, "mature_H5_site": 425.0, "mutant": "S", "mutation": "A425S", "reference_site": "425", "sequential_site": 441.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9384, "escape": -0.3545, "mature_H5_site": 425.0, "mutant": "T", "mutation": "A425T", "reference_site": "425", "sequential_site": 441.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.986, "escape": -0.1199, "mature_H5_site": 425.0, "mutant": "V", "mutation": "A425V", "reference_site": "425", "sequential_site": 441.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.55, "escape": -0.1409, "mature_H5_site": 426.0, "mutant": "D", "mutation": "E426D", "reference_site": "426", "sequential_site": 442.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.967, "escape": -0.2302, "mature_H5_site": 426.0, "mutant": "G", "mutation": "E426G", "reference_site": "426", "sequential_site": 442.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.457, "escape": 0.4266, "mature_H5_site": 426.0, "mutant": "K", "mutation": "E426K", "reference_site": "426", "sequential_site": 442.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.756, "escape": -0.1402, "mature_H5_site": 426.0, "mutant": "Q", "mutation": "E426Q", "reference_site": "426", "sequential_site": 442.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.746, "escape": -0.1438, "mature_H5_site": 426.0, "mutant": "V", "mutation": "E426V", "reference_site": "426", "sequential_site": 442.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.266, "escape": -0.258, "mature_H5_site": 427.0, "mutant": "I", "mutation": "L427I", "reference_site": "427", "sequential_site": 443.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.566, "escape": 0.5518, "mature_H5_site": 427.0, "mutant": "M", "mutation": "L427M", "reference_site": "427", "sequential_site": 443.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.942, "escape": 0.1142, "mature_H5_site": 427.0, "mutant": "V", "mutation": "L427V", "reference_site": "427", "sequential_site": 443.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.503, "escape": 0.1756, "mature_H5_site": 427.0, "mutant": "Y", "mutation": "L427Y", "reference_site": "427", "sequential_site": 443.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6339, "escape": -0.2258, "mature_H5_site": 428.0, "mutant": "F", "mutation": "L428F", "reference_site": "428", "sequential_site": 444.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.555, "escape": 0.2733, "mature_H5_site": 428.0, "mutant": "I", "mutation": "L428I", "reference_site": "428", "sequential_site": 444.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1434, "escape": 0.04949, "mature_H5_site": 428.0, "mutant": "M", "mutation": "L428M", "reference_site": "428", "sequential_site": 444.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1104, "escape": 0.1629, "mature_H5_site": 429.0, "mutant": "I", "mutation": "V429I", "reference_site": "429", "sequential_site": 445.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.595, "escape": 0.1012, "mature_H5_site": 429.0, "mutant": "L", "mutation": "V429L", "reference_site": "429", "sequential_site": 445.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8071, "escape": 0.1483, "mature_H5_site": 429.0, "mutant": "T", "mutation": "V429T", "reference_site": "429", "sequential_site": 445.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.112, "escape": -0.371, "mature_H5_site": 33.0, "mutant": "M", "mutation": "L43M", "reference_site": "43", "sequential_site": 49.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.697, "escape": 0.1177, "mature_H5_site": 430.0, "mutant": "I", "mutation": "L430I", "reference_site": "430", "sequential_site": 446.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.355, "escape": 0.08069, "mature_H5_site": 430.0, "mutant": "M", "mutation": "L430M", "reference_site": "430", "sequential_site": 446.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.613, "escape": -0.168, "mature_H5_site": 430.0, "mutant": "V", "mutation": "L430V", "reference_site": "430", "sequential_site": 446.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.519, "escape": 1.127, "mature_H5_site": 431.0, "mutant": "I", "mutation": "M431I", "reference_site": "431", "sequential_site": 447.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.249, "escape": -0.3162, "mature_H5_site": 431.0, "mutant": "K", "mutation": "M431K", "reference_site": "431", "sequential_site": 447.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.466, "escape": -0.6503, "mature_H5_site": 431.0, "mutant": "L", "mutation": "M431L", "reference_site": "431", "sequential_site": 447.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3077, "escape": -0.004708, "mature_H5_site": 431.0, "mutant": "W", "mutation": "M431W", "reference_site": "431", "sequential_site": 447.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.131, "escape": -0.2048, "mature_H5_site": 431.0, "mutant": "Y", "mutation": "M431Y", "reference_site": "431", "sequential_site": 447.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07977, "escape": -0.01196, "mature_H5_site": 432.0, "mutant": "A", "mutation": "E432A", "reference_site": "432", "sequential_site": 448.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -6.04, "escape": -0.4261, "mature_H5_site": 432.0, "mutant": "K", "mutation": "E432K", "reference_site": "432", "sequential_site": 448.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.557, "escape": -0.9686, "mature_H5_site": 432.0, "mutant": "Q", "mutation": "E432Q", "reference_site": "432", "sequential_site": 448.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5347, "escape": 0.01384, "mature_H5_site": 432.0, "mutant": "S", "mutation": "E432S", "reference_site": "432", "sequential_site": 448.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.329, "escape": 0.02214, "mature_H5_site": 432.0, "mutant": "T", "mutation": "E432T", "reference_site": "432", "sequential_site": 448.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.063, "escape": -0.1715, "mature_H5_site": 434.0, "mutant": "D", "mutation": "E434D", "reference_site": "434", "sequential_site": 450.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0387, "escape": 0.1469, "mature_H5_site": 434.0, "mutant": "G", "mutation": "E434G", "reference_site": "434", "sequential_site": 450.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.256, "escape": -0.00536, "mature_H5_site": 434.0, "mutant": "R", "mutation": "E434R", "reference_site": "434", "sequential_site": 450.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7249, "escape": 0.6155, "mature_H5_site": 434.0, "mutant": "T", "mutation": "E434T", "reference_site": "434", "sequential_site": 450.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.672, "escape": 0.5727, "mature_H5_site": 435.0, "mutant": "D", "mutation": "R435D", "reference_site": "435", "sequential_site": 451.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.909, "escape": -0.05276, "mature_H5_site": 435.0, "mutant": "E", "mutation": "R435E", "reference_site": "435", "sequential_site": 451.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.13, "escape": 0.0165, "mature_H5_site": 435.0, "mutant": "K", "mutation": "R435K", "reference_site": "435", "sequential_site": 451.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.046, "escape": -0.1818, "mature_H5_site": 435.0, "mutant": "N", "mutation": "R435N", "reference_site": "435", "sequential_site": 451.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.022, "escape": 0.06399, "mature_H5_site": 435.0, "mutant": "Q", "mutation": "R435Q", "reference_site": "435", "sequential_site": 451.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5108, "escape": 0.1605, "mature_H5_site": 437.0, "mutant": "M", "mutation": "L437M", "reference_site": "437", "sequential_site": 453.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03785, "escape": -0.01682, "mature_H5_site": 438.0, "mutant": "A", "mutation": "D438A", "reference_site": "438", "sequential_site": 454.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.3, "escape": -0.4231, "mature_H5_site": 438.0, "mutant": "C", "mutation": "D438C", "reference_site": "438", "sequential_site": 454.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.005413, "escape": -0.003102, "mature_H5_site": 438.0, "mutant": "E", "mutation": "D438E", "reference_site": "438", "sequential_site": 454.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6214, "escape": -0.08699, "mature_H5_site": 438.0, "mutant": "F", "mutation": "D438F", "reference_site": "438", "sequential_site": 454.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09642, "escape": 0.2838, "mature_H5_site": 438.0, "mutant": "G", "mutation": "D438G", "reference_site": "438", "sequential_site": 454.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.258, "escape": 0.04259, "mature_H5_site": 438.0, "mutant": "H", "mutation": "D438H", "reference_site": "438", "sequential_site": 454.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.496, "escape": 0.3724, "mature_H5_site": 438.0, "mutant": "L", "mutation": "D438L", "reference_site": "438", "sequential_site": 454.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2758, "escape": -0.2063, "mature_H5_site": 438.0, "mutant": "M", "mutation": "D438M", "reference_site": "438", "sequential_site": 454.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.181, "escape": -0.1669, "mature_H5_site": 438.0, "mutant": "N", "mutation": "D438N", "reference_site": "438", "sequential_site": 454.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04463, "escape": -0.1121, "mature_H5_site": 438.0, "mutant": "Q", "mutation": "D438Q", "reference_site": "438", "sequential_site": 454.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.494, "escape": 0.441, "mature_H5_site": 438.0, "mutant": "R", "mutation": "D438R", "reference_site": "438", "sequential_site": 454.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.927, "escape": 0.1944, "mature_H5_site": 438.0, "mutant": "S", "mutation": "D438S", "reference_site": "438", "sequential_site": 454.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.139, "escape": -0.1372, "mature_H5_site": 438.0, "mutant": "W", "mutation": "D438W", "reference_site": "438", "sequential_site": 454.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.841, "escape": -0.1231, "mature_H5_site": 438.0, "mutant": "Y", "mutation": "D438Y", "reference_site": "438", "sequential_site": 454.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.66, "escape": 0.09293, "mature_H5_site": 439.0, "mutant": "L", "mutation": "F439L", "reference_site": "439", "sequential_site": 455.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04575, "escape": -0.2089, "mature_H5_site": 439.0, "mutant": "W", "mutation": "F439W", "reference_site": "439", "sequential_site": 455.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3818, "escape": 0.168, "mature_H5_site": 439.0, "mutant": "Y", "mutation": "F439Y", "reference_site": "439", "sequential_site": 455.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02215, "escape": 0.1264, "mature_H5_site": 34.0, "mutant": "C", "mutation": "E44C", "reference_site": "44", "sequential_site": 50.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7662, "escape": -0.5496, "mature_H5_site": 34.0, "mutant": "D", "mutation": "E44D", "reference_site": "44", "sequential_site": 50.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.505, "escape": 0.02042, "mature_H5_site": 34.0, "mutant": "H", "mutation": "E44H", "reference_site": "44", "sequential_site": 50.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1896, "escape": 0.02123, "mature_H5_site": 34.0, "mutant": "L", "mutation": "E44L", "reference_site": "44", "sequential_site": 50.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2553, "escape": 0.02804, "mature_H5_site": 34.0, "mutant": "M", "mutation": "E44M", "reference_site": "44", "sequential_site": 50.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05356, "escape": 0.1484, "mature_H5_site": 34.0, "mutant": "Q", "mutation": "E44Q", "reference_site": "44", "sequential_site": 50.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.068, "escape": -0.06773, "mature_H5_site": 34.0, "mutant": "S", "mutation": "E44S", "reference_site": "44", "sequential_site": 50.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4047, "escape": 0.3071, "mature_H5_site": 34.0, "mutant": "T", "mutation": "E44T", "reference_site": "44", "sequential_site": 50.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1029, "escape": 0.01946, "mature_H5_site": 34.0, "mutant": "Y", "mutation": "E44Y", "reference_site": "44", "sequential_site": 50.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.59, "escape": -0.2067, "mature_H5_site": 441.0, "mutant": "C", "mutation": "D441C", "reference_site": "441", "sequential_site": 457.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01512, "escape": 0.002782, "mature_H5_site": 441.0, "mutant": "F", "mutation": "D441F", "reference_site": "441", "sequential_site": 457.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3171, "escape": 0.331, "mature_H5_site": 441.0, "mutant": "G", "mutation": "D441G", "reference_site": "441", "sequential_site": 457.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6087, "escape": 0.01364, "mature_H5_site": 441.0, "mutant": "H", "mutation": "D441H", "reference_site": "441", "sequential_site": 457.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06995, "escape": 0.05708, "mature_H5_site": 441.0, "mutant": "I", "mutation": "D441I", "reference_site": "441", "sequential_site": 457.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7025, "escape": -0.1097, "mature_H5_site": 441.0, "mutant": "L", "mutation": "D441L", "reference_site": "441", "sequential_site": 457.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0691, "escape": -0.1511, "mature_H5_site": 441.0, "mutant": "M", "mutation": "D441M", "reference_site": "441", "sequential_site": 457.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1571, "escape": 0.4002, "mature_H5_site": 441.0, "mutant": "N", "mutation": "D441N", "reference_site": "441", "sequential_site": 457.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5308, "escape": 1.097, "mature_H5_site": 441.0, "mutant": "Q", "mutation": "D441Q", "reference_site": "441", "sequential_site": 457.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5698, "escape": 0.2363, "mature_H5_site": 441.0, "mutant": "R", "mutation": "D441R", "reference_site": "441", "sequential_site": 457.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6056, "escape": 0.04118, "mature_H5_site": 441.0, "mutant": "S", "mutation": "D441S", "reference_site": "441", "sequential_site": 457.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4856, "escape": 0.3476, "mature_H5_site": 441.0, "mutant": "T", "mutation": "D441T", "reference_site": "441", "sequential_site": 457.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.18, "escape": 0.01029, "mature_H5_site": 441.0, "mutant": "V", "mutation": "D441V", "reference_site": "441", "sequential_site": 457.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1939, "escape": 0.2401, "mature_H5_site": 441.0, "mutant": "W", "mutation": "D441W", "reference_site": "441", "sequential_site": 457.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1355, "escape": 0.2572, "mature_H5_site": 441.0, "mutant": "Y", "mutation": "D441Y", "reference_site": "441", "sequential_site": 457.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6136, "escape": 0.2032, "mature_H5_site": 442.0, "mutant": "A", "mutation": "S442A", "reference_site": "442", "sequential_site": 458.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4608, "escape": -0.1018, "mature_H5_site": 442.0, "mutant": "C", "mutation": "S442C", "reference_site": "442", "sequential_site": 458.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4101, "escape": 0.2822, "mature_H5_site": 442.0, "mutant": "D", "mutation": "S442D", "reference_site": "442", "sequential_site": 458.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5783, "escape": 0.356, "mature_H5_site": 442.0, "mutant": "G", "mutation": "S442G", "reference_site": "442", "sequential_site": 458.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.848, "escape": 2.128, "mature_H5_site": 442.0, "mutant": "H", "mutation": "S442H", "reference_site": "442", "sequential_site": 458.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3888, "escape": -0.03805, "mature_H5_site": 442.0, "mutant": "I", "mutation": "S442I", "reference_site": "442", "sequential_site": 458.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4139, "escape": 0.2118, "mature_H5_site": 442.0, "mutant": "M", "mutation": "S442M", "reference_site": "442", "sequential_site": 458.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.097, "escape": 0.8131, "mature_H5_site": 442.0, "mutant": "N", "mutation": "S442N", "reference_site": "442", "sequential_site": 458.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4683, "escape": 0.3038, "mature_H5_site": 442.0, "mutant": "Q", "mutation": "S442Q", "reference_site": "442", "sequential_site": 458.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8914, "escape": 1.515, "mature_H5_site": 442.0, "mutant": "T", "mutation": "S442T", "reference_site": "442", "sequential_site": 458.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5617, "escape": 0.01154, "mature_H5_site": 442.0, "mutant": "V", "mutation": "S442V", "reference_site": "442", "sequential_site": 458.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3473, "escape": 0.02902, "mature_H5_site": 442.0, "mutant": "Y", "mutation": "S442Y", "reference_site": "442", "sequential_site": 458.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.646, "escape": 0.2124, "mature_H5_site": 443.0, "mutant": "A", "mutation": "N443A", "reference_site": "443", "sequential_site": 459.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.353, "escape": 0.03665, "mature_H5_site": 443.0, "mutant": "C", "mutation": "N443C", "reference_site": "443", "sequential_site": 459.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1554, "escape": 0.1174, "mature_H5_site": 443.0, "mutant": "M", "mutation": "N443M", "reference_site": "443", "sequential_site": 459.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4758, "escape": 0.08033, "mature_H5_site": 443.0, "mutant": "S", "mutation": "N443S", "reference_site": "443", "sequential_site": 459.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3497, "escape": -0.1136, "mature_H5_site": 443.0, "mutant": "T", "mutation": "N443T", "reference_site": "443", "sequential_site": 459.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5405, "escape": 0.03667, "mature_H5_site": 443.0, "mutant": "V", "mutation": "N443V", "reference_site": "443", "sequential_site": 459.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.765, "escape": -0.1998, "mature_H5_site": 444.0, "mutant": "I", "mutation": "V444I", "reference_site": "444", "sequential_site": 460.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00036, "escape": 0.04628, "mature_H5_site": 444.0, "mutant": "L", "mutation": "V444L", "reference_site": "444", "sequential_site": 460.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6685, "escape": -0.02582, "mature_H5_site": 444.0, "mutant": "M", "mutation": "V444M", "reference_site": "444", "sequential_site": 460.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.058, "escape": -0.1045, "mature_H5_site": 444.0, "mutant": "T", "mutation": "V444T", "reference_site": "444", "sequential_site": 460.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02545, "escape": 0.01963, "mature_H5_site": 445.0, "mutant": "H", "mutation": "K445H", "reference_site": "445", "sequential_site": 461.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.711, "escape": -0.02472, "mature_H5_site": 445.0, "mutant": "N", "mutation": "K445N", "reference_site": "445", "sequential_site": 461.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1215, "escape": -0.3176, "mature_H5_site": 445.0, "mutant": "R", "mutation": "K445R", "reference_site": "445", "sequential_site": 461.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2843, "escape": 0.4574, "mature_H5_site": 446.0, "mutant": "A", "mutation": "N446A", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2437, "escape": -0.08108, "mature_H5_site": 446.0, "mutant": "C", "mutation": "N446C", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2193, "escape": -0.05289, "mature_H5_site": 446.0, "mutant": "E", "mutation": "N446E", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.65, "escape": -0.01372, "mature_H5_site": 446.0, "mutant": "F", "mutation": "N446F", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3095, "escape": 0.3154, "mature_H5_site": 446.0, "mutant": "G", "mutation": "N446G", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01017, "escape": 0.0503, "mature_H5_site": 446.0, "mutant": "H", "mutation": "N446H", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03955, "escape": -0.2756, "mature_H5_site": 446.0, "mutant": "I", "mutation": "N446I", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02098, "escape": 0.1943, "mature_H5_site": 446.0, "mutant": "K", "mutation": "N446K", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1061, "escape": -0.05962, "mature_H5_site": 446.0, "mutant": "L", "mutation": "N446L", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02659, "escape": 0.08667, "mature_H5_site": 446.0, "mutant": "M", "mutation": "N446M", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01668, "escape": 0.19, "mature_H5_site": 446.0, "mutant": "Q", "mutation": "N446Q", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05188, "escape": -0.1326, "mature_H5_site": 446.0, "mutant": "R", "mutation": "N446R", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.101, "escape": 0.04875, "mature_H5_site": 446.0, "mutant": "S", "mutation": "N446S", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3255, "escape": 0.1802, "mature_H5_site": 446.0, "mutant": "T", "mutation": "N446T", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3681, "escape": 0.04742, "mature_H5_site": 446.0, "mutant": "V", "mutation": "N446V", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.272, "escape": 0.2306, "mature_H5_site": 446.0, "mutant": "W", "mutation": "N446W", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0834, "escape": -0.1016, "mature_H5_site": 446.0, "mutant": "Y", "mutation": "N446Y", "reference_site": "446", "sequential_site": 462.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0705, "escape": 0.1259, "mature_H5_site": 447.0, "mutant": "I", "mutation": "L447I", "reference_site": "447", "sequential_site": 463.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05356, "escape": 0.1773, "mature_H5_site": 447.0, "mutant": "M", "mutation": "L447M", "reference_site": "447", "sequential_site": 463.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.67, "escape": -0.233, "mature_H5_site": 448.0, "mutant": "W", "mutation": "Y448W", "reference_site": "448", "sequential_site": 464.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00806, "escape": 0.1115, "mature_H5_site": 449.0, "mutant": "E", "mutation": "D449E", "reference_site": "449", "sequential_site": 465.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06767, "escape": 0.3078, "mature_H5_site": 449.0, "mutant": "F", "mutation": "D449F", "reference_site": "449", "sequential_site": 465.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.349, "escape": 0.5019, "mature_H5_site": 449.0, "mutant": "G", "mutation": "D449G", "reference_site": "449", "sequential_site": 465.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.906, "escape": -0.2709, "mature_H5_site": 449.0, "mutant": "K", "mutation": "D449K", "reference_site": "449", "sequential_site": 465.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03253, "escape": -0.1061, "mature_H5_site": 449.0, "mutant": "L", "mutation": "D449L", "reference_site": "449", "sequential_site": 465.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0079, "escape": -0.1827, "mature_H5_site": 449.0, "mutant": "M", "mutation": "D449M", "reference_site": "449", "sequential_site": 465.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04793, "escape": -0.01836, "mature_H5_site": 449.0, "mutant": "N", "mutation": "D449N", "reference_site": "449", "sequential_site": 465.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5868, "escape": 0.1292, "mature_H5_site": 449.0, "mutant": "R", "mutation": "D449R", "reference_site": "449", "sequential_site": 465.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07106, "escape": -0.05667, "mature_H5_site": 449.0, "mutant": "T", "mutation": "D449T", "reference_site": "449", "sequential_site": 465.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5101, "escape": -0.01392, "mature_H5_site": 449.0, "mutant": "V", "mutation": "D449V", "reference_site": "449", "sequential_site": 465.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03921, "escape": 0.00336, "mature_H5_site": 449.0, "mutant": "Y", "mutation": "D449Y", "reference_site": "449", "sequential_site": 465.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.002845, "escape": -0.394, "mature_H5_site": 35.0, "mutant": "A", "mutation": "K45A", "reference_site": "45", "sequential_site": 51.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.193, "escape": -0.04118, "mature_H5_site": 35.0, "mutant": "C", "mutation": "K45C", "reference_site": "45", "sequential_site": 51.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6934, "escape": -0.01852, "mature_H5_site": 35.0, "mutant": "D", "mutation": "K45D", "reference_site": "45", "sequential_site": 51.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.346, "escape": -0.3051, "mature_H5_site": 35.0, "mutant": "F", "mutation": "K45F", "reference_site": "45", "sequential_site": 51.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04934, "escape": 0.1157, "mature_H5_site": 35.0, "mutant": "H", "mutation": "K45H", "reference_site": "45", "sequential_site": 51.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0264, "escape": -0.03266, "mature_H5_site": 35.0, "mutant": "I", "mutation": "K45I", "reference_site": "45", "sequential_site": 51.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7104, "escape": -0.3846, "mature_H5_site": 35.0, "mutant": "L", "mutation": "K45L", "reference_site": "45", "sequential_site": 51.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2496, "escape": -0.06341, "mature_H5_site": 35.0, "mutant": "M", "mutation": "K45M", "reference_site": "45", "sequential_site": 51.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2623, "escape": -0.1456, "mature_H5_site": 35.0, "mutant": "N", "mutation": "K45N", "reference_site": "45", "sequential_site": 51.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07419, "escape": -0.0287, "mature_H5_site": 35.0, "mutant": "Q", "mutation": "K45Q", "reference_site": "45", "sequential_site": 51.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1975, "escape": 0.0005074, "mature_H5_site": 35.0, "mutant": "R", "mutation": "K45R", "reference_site": "45", "sequential_site": 51.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03245, "escape": 0.2199, "mature_H5_site": 35.0, "mutant": "S", "mutation": "K45S", "reference_site": "45", "sequential_site": 51.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02913, "escape": -0.02098, "mature_H5_site": 35.0, "mutant": "T", "mutation": "K45T", "reference_site": "45", "sequential_site": 51.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6207, "escape": 0.01805, "mature_H5_site": 35.0, "mutant": "V", "mutation": "K45V", "reference_site": "45", "sequential_site": 51.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01907, "escape": -0.3333, "mature_H5_site": 450.0, "mutant": "A", "mutation": "K450A", "reference_site": "450", "sequential_site": 466.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.639, "escape": -0.2098, "mature_H5_site": 450.0, "mutant": "D", "mutation": "K450D", "reference_site": "450", "sequential_site": 466.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9716, "escape": -0.1453, "mature_H5_site": 450.0, "mutant": "E", "mutation": "K450E", "reference_site": "450", "sequential_site": 466.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.001765, "escape": 0.1863, "mature_H5_site": 450.0, "mutant": "L", "mutation": "K450L", "reference_site": "450", "sequential_site": 466.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03883, "escape": -0.1823, "mature_H5_site": 450.0, "mutant": "M", "mutation": "K450M", "reference_site": "450", "sequential_site": 466.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04594, "escape": 0.3668, "mature_H5_site": 450.0, "mutant": "N", "mutation": "K450N", "reference_site": "450", "sequential_site": 466.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.004435, "escape": -0.2301, "mature_H5_site": 450.0, "mutant": "Q", "mutation": "K450Q", "reference_site": "450", "sequential_site": 466.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4879, "escape": 0.1036, "mature_H5_site": 450.0, "mutant": "R", "mutation": "K450R", "reference_site": "450", "sequential_site": 466.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04703, "escape": 0.18, "mature_H5_site": 450.0, "mutant": "S", "mutation": "K450S", "reference_site": "450", "sequential_site": 466.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.493, "escape": -0.007329, "mature_H5_site": 450.0, "mutant": "T", "mutation": "K450T", "reference_site": "450", "sequential_site": 466.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1986, "escape": -0.1321, "mature_H5_site": 450.0, "mutant": "Y", "mutation": "K450Y", "reference_site": "450", "sequential_site": 466.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2242, "escape": 0.1835, "mature_H5_site": 451.0, "mutant": "I", "mutation": "V451I", "reference_site": "451", "sequential_site": 467.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1984, "escape": -0.2169, "mature_H5_site": 451.0, "mutant": "L", "mutation": "V451L", "reference_site": "451", "sequential_site": 467.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8446, "escape": -0.02154, "mature_H5_site": 451.0, "mutant": "M", "mutation": "V451M", "reference_site": "451", "sequential_site": 467.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8448, "escape": 0.01909, "mature_H5_site": 451.0, "mutant": "Q", "mutation": "V451Q", "reference_site": "451", "sequential_site": 467.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4827, "escape": -0.3631, "mature_H5_site": 451.0, "mutant": "S", "mutation": "V451S", "reference_site": "451", "sequential_site": 467.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.346, "escape": 0.6369, "mature_H5_site": 452.0, "mutant": "F", "mutation": "R452F", "reference_site": "452", "sequential_site": 468.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7641, "escape": -0.07502, "mature_H5_site": 452.0, "mutant": "G", "mutation": "R452G", "reference_site": "452", "sequential_site": 468.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5593, "escape": -0.3781, "mature_H5_site": 452.0, "mutant": "H", "mutation": "R452H", "reference_site": "452", "sequential_site": 468.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02398, "escape": -0.1765, "mature_H5_site": 452.0, "mutant": "K", "mutation": "R452K", "reference_site": "452", "sequential_site": 468.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.703, "escape": -0.06257, "mature_H5_site": 452.0, "mutant": "N", "mutation": "R452N", "reference_site": "452", "sequential_site": 468.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.507, "escape": 0.2217, "mature_H5_site": 452.0, "mutant": "S", "mutation": "R452S", "reference_site": "452", "sequential_site": 468.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.23, "escape": 0.08071, "mature_H5_site": 452.0, "mutant": "W", "mutation": "R452W", "reference_site": "452", "sequential_site": 468.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9578, "escape": -0.003288, "mature_H5_site": 453.0, "mutant": "C", "mutation": "L453C", "reference_site": "453", "sequential_site": 469.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2931, "escape": 0.02151, "mature_H5_site": 453.0, "mutant": "H", "mutation": "L453H", "reference_site": "453", "sequential_site": 469.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03297, "escape": -0.01633, "mature_H5_site": 453.0, "mutant": "M", "mutation": "L453M", "reference_site": "453", "sequential_site": 469.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1687, "escape": -0.1787, "mature_H5_site": 453.0, "mutant": "Q", "mutation": "L453Q", "reference_site": "453", "sequential_site": 469.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5708, "escape": 0.2763, "mature_H5_site": 453.0, "mutant": "R", "mutation": "L453R", "reference_site": "453", "sequential_site": 469.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.065, "escape": -0.2318, "mature_H5_site": 453.0, "mutant": "S", "mutation": "L453S", "reference_site": "453", "sequential_site": 469.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6917, "escape": 0.07125, "mature_H5_site": 453.0, "mutant": "W", "mutation": "L453W", "reference_site": "453", "sequential_site": 469.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1071, "escape": 0.01095, "mature_H5_site": 454.0, "mutant": "C", "mutation": "Q454C", "reference_site": "454", "sequential_site": 470.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9606, "escape": 0.3927, "mature_H5_site": 454.0, "mutant": "D", "mutation": "Q454D", "reference_site": "454", "sequential_site": 470.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1862, "escape": -0.006704, "mature_H5_site": 454.0, "mutant": "E", "mutation": "Q454E", "reference_site": "454", "sequential_site": 470.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.381, "escape": -0.07607, "mature_H5_site": 454.0, "mutant": "G", "mutation": "Q454G", "reference_site": "454", "sequential_site": 470.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00955, "escape": 0.02659, "mature_H5_site": 454.0, "mutant": "H", "mutation": "Q454H", "reference_site": "454", "sequential_site": 470.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3073, "escape": 0.01517, "mature_H5_site": 454.0, "mutant": "I", "mutation": "Q454I", "reference_site": "454", "sequential_site": 470.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.015, "escape": 0.005711, "mature_H5_site": 454.0, "mutant": "K", "mutation": "Q454K", "reference_site": "454", "sequential_site": 470.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0651, "escape": 0.1088, "mature_H5_site": 454.0, "mutant": "M", "mutation": "Q454M", "reference_site": "454", "sequential_site": 470.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.157, "escape": 0.1865, "mature_H5_site": 454.0, "mutant": "R", "mutation": "Q454R", "reference_site": "454", "sequential_site": 470.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2767, "escape": 0.2956, "mature_H5_site": 454.0, "mutant": "S", "mutation": "Q454S", "reference_site": "454", "sequential_site": 470.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5197, "escape": -0.0154, "mature_H5_site": 454.0, "mutant": "T", "mutation": "Q454T", "reference_site": "454", "sequential_site": 470.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01913, "escape": -0.1417, "mature_H5_site": 454.0, "mutant": "V", "mutation": "Q454V", "reference_site": "454", "sequential_site": 470.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5988, "escape": 0.1136, "mature_H5_site": 455.0, "mutant": "I", "mutation": "L455I", "reference_site": "455", "sequential_site": 471.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.148, "escape": 0.01408, "mature_H5_site": 455.0, "mutant": "M", "mutation": "L455M", "reference_site": "455", "sequential_site": 471.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2562, "escape": -1.19, "mature_H5_site": 455.0, "mutant": "T", "mutation": "L455T", "reference_site": "455", "sequential_site": 471.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1249, "escape": 0.02234, "mature_H5_site": 456.0, "mutant": "A", "mutation": "R456A", "reference_site": "456", "sequential_site": 472.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7026, "escape": -0.1305, "mature_H5_site": 456.0, "mutant": "D", "mutation": "R456D", "reference_site": "456", "sequential_site": 472.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.613, "escape": 0.2687, "mature_H5_site": 456.0, "mutant": "E", "mutation": "R456E", "reference_site": "456", "sequential_site": 472.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1729, "escape": 0.08329, "mature_H5_site": 456.0, "mutant": "I", "mutation": "R456I", "reference_site": "456", "sequential_site": 472.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1463, "escape": -0.193, "mature_H5_site": 456.0, "mutant": "L", "mutation": "R456L", "reference_site": "456", "sequential_site": 472.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04334, "escape": -0.1516, "mature_H5_site": 456.0, "mutant": "M", "mutation": "R456M", "reference_site": "456", "sequential_site": 472.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09277, "escape": 0.04887, "mature_H5_site": 456.0, "mutant": "N", "mutation": "R456N", "reference_site": "456", "sequential_site": 472.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0732, "escape": -0.1746, "mature_H5_site": 456.0, "mutant": "Q", "mutation": "R456Q", "reference_site": "456", "sequential_site": 472.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1887, "escape": -0.1204, "mature_H5_site": 456.0, "mutant": "S", "mutation": "R456S", "reference_site": "456", "sequential_site": 472.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7692, "escape": -0.1352, "mature_H5_site": 456.0, "mutant": "V", "mutation": "R456V", "reference_site": "456", "sequential_site": 472.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5899, "escape": -0.0181, "mature_H5_site": 456.0, "mutant": "W", "mutation": "R456W", "reference_site": "456", "sequential_site": 472.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.381, "escape": 0.1906, "mature_H5_site": 457.0, "mutant": "F", "mutation": "D457F", "reference_site": "457", "sequential_site": 473.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3666, "escape": 0.008961, "mature_H5_site": 457.0, "mutant": "G", "mutation": "D457G", "reference_site": "457", "sequential_site": 473.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.153, "escape": 0.2061, "mature_H5_site": 457.0, "mutant": "M", "mutation": "D457M", "reference_site": "457", "sequential_site": 473.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4259, "escape": -0.01632, "mature_H5_site": 457.0, "mutant": "S", "mutation": "D457S", "reference_site": "457", "sequential_site": 473.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6107, "escape": 0.02907, "mature_H5_site": 457.0, "mutant": "T", "mutation": "D457T", "reference_site": "457", "sequential_site": 473.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.507, "escape": -0.1296, "mature_H5_site": 457.0, "mutant": "Y", "mutation": "D457Y", "reference_site": "457", "sequential_site": 473.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.802, "escape": 0.2191, "mature_H5_site": 458.0, "mutant": "G", "mutation": "N458G", "reference_site": "458", "sequential_site": 474.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1576, "escape": 0.04334, "mature_H5_site": 458.0, "mutant": "H", "mutation": "N458H", "reference_site": "458", "sequential_site": 474.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.574, "escape": -0.1515, "mature_H5_site": 458.0, "mutant": "Q", "mutation": "N458Q", "reference_site": "458", "sequential_site": 474.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1281, "escape": -0.06699, "mature_H5_site": 459.0, "mutant": "G", "mutation": "A459G", "reference_site": "459", "sequential_site": 475.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.177, "escape": -0.312, "mature_H5_site": 459.0, "mutant": "I", "mutation": "A459I", "reference_site": "459", "sequential_site": 475.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06205, "escape": -0.2716, "mature_H5_site": 459.0, "mutant": "S", "mutation": "A459S", "reference_site": "459", "sequential_site": 475.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3183, "escape": 0.1003, "mature_H5_site": 459.0, "mutant": "V", "mutation": "A459V", "reference_site": "459", "sequential_site": 475.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.009955, "escape": -0.3734, "mature_H5_site": 36.0, "mutant": "C", "mutation": "T46C", "reference_site": "46", "sequential_site": 52.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5014, "escape": 0.2353, "mature_H5_site": 36.0, "mutant": "D", "mutation": "T46D", "reference_site": "46", "sequential_site": 52.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03948, "escape": -0.1928, "mature_H5_site": 36.0, "mutant": "F", "mutation": "T46F", "reference_site": "46", "sequential_site": 52.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2944, "escape": 0.01093, "mature_H5_site": 36.0, "mutant": "I", "mutation": "T46I", "reference_site": "46", "sequential_site": 52.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1133, "escape": 0.1745, "mature_H5_site": 36.0, "mutant": "M", "mutation": "T46M", "reference_site": "46", "sequential_site": 52.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02238, "escape": 0.01655, "mature_H5_site": 36.0, "mutant": "N", "mutation": "T46N", "reference_site": "46", "sequential_site": 52.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01962, "escape": -0.2001, "mature_H5_site": 36.0, "mutant": "R", "mutation": "T46R", "reference_site": "46", "sequential_site": 52.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.003142, "escape": -0.2339, "mature_H5_site": 36.0, "mutant": "S", "mutation": "T46S", "reference_site": "46", "sequential_site": 52.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02424, "escape": 0.1149, "mature_H5_site": 36.0, "mutant": "W", "mutation": "T46W", "reference_site": "46", "sequential_site": 52.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02059, "escape": -0.2707, "mature_H5_site": 460.0, "mutant": "C", "mutation": "K460C", "reference_site": "460", "sequential_site": 476.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1981, "escape": 0.4514, "mature_H5_site": 460.0, "mutant": "E", "mutation": "K460E", "reference_site": "460", "sequential_site": 476.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3082, "escape": 0.3319, "mature_H5_site": 460.0, "mutant": "F", "mutation": "K460F", "reference_site": "460", "sequential_site": 476.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3389, "escape": -0.03339, "mature_H5_site": 460.0, "mutant": "M", "mutation": "K460M", "reference_site": "460", "sequential_site": 476.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1367, "escape": 0.1438, "mature_H5_site": 460.0, "mutant": "N", "mutation": "K460N", "reference_site": "460", "sequential_site": 476.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02157, "escape": 0.01797, "mature_H5_site": 460.0, "mutant": "R", "mutation": "K460R", "reference_site": "460", "sequential_site": 476.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.989, "escape": -0.001436, "mature_H5_site": 460.0, "mutant": "S", "mutation": "K460S", "reference_site": "460", "sequential_site": 476.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5993, "escape": 0.1066, "mature_H5_site": 460.0, "mutant": "V", "mutation": "K460V", "reference_site": "460", "sequential_site": 476.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0338, "escape": 0.2768, "mature_H5_site": 460.0, "mutant": "W", "mutation": "K460W", "reference_site": "460", "sequential_site": 476.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00807, "escape": -0.1475, "mature_H5_site": 460.0, "mutant": "Y", "mutation": "K460Y", "reference_site": "460", "sequential_site": 476.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.144, "escape": -0.01056, "mature_H5_site": 461.0, "mutant": "D", "mutation": "E461D", "reference_site": "461", "sequential_site": 477.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": null, "escape": 0.1901, "mature_H5_site": 462.0, "mutant": "A", "mutation": "L462A", "reference_site": "462", "sequential_site": 478.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8518, "escape": -0.009277, "mature_H5_site": 462.0, "mutant": "C", "mutation": "L462C", "reference_site": "462", "sequential_site": 478.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1594, "escape": 0.04951, "mature_H5_site": 462.0, "mutant": "E", "mutation": "L462E", "reference_site": "462", "sequential_site": 478.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1211, "escape": 0.0457, "mature_H5_site": 462.0, "mutant": "I", "mutation": "L462I", "reference_site": "462", "sequential_site": 478.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2561, "escape": -0.01792, "mature_H5_site": 462.0, "mutant": "K", "mutation": "L462K", "reference_site": "462", "sequential_site": 478.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02356, "escape": 0.03395, "mature_H5_site": 462.0, "mutant": "M", "mutation": "L462M", "reference_site": "462", "sequential_site": 478.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5155, "escape": -0.02287, "mature_H5_site": 462.0, "mutant": "N", "mutation": "L462N", "reference_site": "462", "sequential_site": 478.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2969, "escape": 0.04901, "mature_H5_site": 462.0, "mutant": "Q", "mutation": "L462Q", "reference_site": "462", "sequential_site": 478.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5838, "escape": -0.1185, "mature_H5_site": 462.0, "mutant": "S", "mutation": "L462S", "reference_site": "462", "sequential_site": 478.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06068, "escape": -0.07966, "mature_H5_site": 462.0, "mutant": "V", "mutation": "L462V", "reference_site": "462", "sequential_site": 478.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4408, "escape": -0.2012, "mature_H5_site": 462.0, "mutant": "Y", "mutation": "L462Y", "reference_site": "462", "sequential_site": 478.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2323, "escape": 0.002819, "mature_H5_site": 463.0, "mutant": "A", "mutation": "G463A", "reference_site": "463", "sequential_site": 479.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.053, "escape": -0.06441, "mature_H5_site": 463.0, "mutant": "L", "mutation": "G463L", "reference_site": "463", "sequential_site": 479.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.036, "escape": -0.04968, "mature_H5_site": 463.0, "mutant": "N", "mutation": "G463N", "reference_site": "463", "sequential_site": 479.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.705, "escape": -0.686, "mature_H5_site": 463.0, "mutant": "R", "mutation": "G463R", "reference_site": "463", "sequential_site": 479.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.018, "escape": -0.2403, "mature_H5_site": 463.0, "mutant": "Y", "mutation": "G463Y", "reference_site": "463", "sequential_site": 479.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9042, "escape": -0.3018, "mature_H5_site": 464.0, "mutant": "C", "mutation": "N464C", "reference_site": "464", "sequential_site": 480.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5102, "escape": 0.008661, "mature_H5_site": 464.0, "mutant": "F", "mutation": "N464F", "reference_site": "464", "sequential_site": 480.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.29, "escape": -0.02181, "mature_H5_site": 464.0, "mutant": "G", "mutation": "N464G", "reference_site": "464", "sequential_site": 480.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.768, "escape": 0.01387, "mature_H5_site": 464.0, "mutant": "H", "mutation": "N464H", "reference_site": "464", "sequential_site": 480.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.178, "escape": -0.1188, "mature_H5_site": 464.0, "mutant": "K", "mutation": "N464K", "reference_site": "464", "sequential_site": 480.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.017, "escape": -0.09296, "mature_H5_site": 464.0, "mutant": "M", "mutation": "N464M", "reference_site": "464", "sequential_site": 480.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05627, "escape": 0.05492, "mature_H5_site": 464.0, "mutant": "Q", "mutation": "N464Q", "reference_site": "464", "sequential_site": 480.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.164, "escape": 0.09002, "mature_H5_site": 464.0, "mutant": "R", "mutation": "N464R", "reference_site": "464", "sequential_site": 480.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6914, "escape": 0.1288, "mature_H5_site": 464.0, "mutant": "S", "mutation": "N464S", "reference_site": "464", "sequential_site": 480.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.236, "escape": -0.1059, "mature_H5_site": 464.0, "mutant": "Y", "mutation": "N464Y", "reference_site": "464", "sequential_site": 480.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.507, "escape": 0.1975, "mature_H5_site": 465.0, "mutant": "A", "mutation": "G465A", "reference_site": "465", "sequential_site": 481.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.927, "escape": 0.3294, "mature_H5_site": 465.0, "mutant": "M", "mutation": "G465M", "reference_site": "465", "sequential_site": 481.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.277, "escape": -0.09323, "mature_H5_site": 465.0, "mutant": "R", "mutation": "G465R", "reference_site": "465", "sequential_site": 481.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.799, "escape": 0.1405, "mature_H5_site": 465.0, "mutant": "Y", "mutation": "G465Y", "reference_site": "465", "sequential_site": 481.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.08, "escape": 0.1463, "mature_H5_site": 467.0, "mutant": "I", "mutation": "F467I", "reference_site": "467", "sequential_site": 483.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2499, "escape": -0.1805, "mature_H5_site": 467.0, "mutant": "L", "mutation": "F467L", "reference_site": "467", "sequential_site": 483.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1281, "escape": -0.0678, "mature_H5_site": 467.0, "mutant": "M", "mutation": "F467M", "reference_site": "467", "sequential_site": 483.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3004, "escape": -0.08754, "mature_H5_site": 467.0, "mutant": "W", "mutation": "F467W", "reference_site": "467", "sequential_site": 483.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2208, "escape": 0.1712, "mature_H5_site": 467.0, "mutant": "Y", "mutation": "F467Y", "reference_site": "467", "sequential_site": 483.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03044, "escape": 0.1314, "mature_H5_site": 468.0, "mutant": "A", "mutation": "E468A", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7865, "escape": -0.01861, "mature_H5_site": 468.0, "mutant": "C", "mutation": "E468C", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0153, "escape": -0.212, "mature_H5_site": 468.0, "mutant": "D", "mutation": "E468D", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03095, "escape": 0.06392, "mature_H5_site": 468.0, "mutant": "F", "mutation": "E468F", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2032, "escape": 0.09007, "mature_H5_site": 468.0, "mutant": "G", "mutation": "E468G", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.005651, "escape": -0.217, "mature_H5_site": 468.0, "mutant": "H", "mutation": "E468H", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4674, "escape": 0.05244, "mature_H5_site": 468.0, "mutant": "K", "mutation": "E468K", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01707, "escape": 0.1117, "mature_H5_site": 468.0, "mutant": "L", "mutation": "E468L", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2253, "escape": -0.04574, "mature_H5_site": 468.0, "mutant": "N", "mutation": "E468N", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7376, "escape": -0.0608, "mature_H5_site": 468.0, "mutant": "Q", "mutation": "E468Q", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.004885, "escape": -0.184, "mature_H5_site": 468.0, "mutant": "R", "mutation": "E468R", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00313, "escape": 0.6419, "mature_H5_site": 468.0, "mutant": "S", "mutation": "E468S", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8816, "escape": -0.1945, "mature_H5_site": 468.0, "mutant": "T", "mutation": "E468T", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9877, "escape": 0.005071, "mature_H5_site": 468.0, "mutant": "V", "mutation": "E468V", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2617, "escape": -0.05395, "mature_H5_site": 468.0, "mutant": "W", "mutation": "E468W", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04634, "escape": -0.03643, "mature_H5_site": 468.0, "mutant": "Y", "mutation": "E468Y", "reference_site": "468", "sequential_site": 484.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -6.04, "escape": -0.3515, "mature_H5_site": 469.0, "mutant": "G", "mutation": "F469G", "reference_site": "469", "sequential_site": 485.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8797, "escape": -0.01579, "mature_H5_site": 469.0, "mutant": "I", "mutation": "F469I", "reference_site": "469", "sequential_site": 485.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.817, "escape": -0.2716, "mature_H5_site": 469.0, "mutant": "K", "mutation": "F469K", "reference_site": "469", "sequential_site": 485.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1193, "escape": -0.171, "mature_H5_site": 469.0, "mutant": "L", "mutation": "F469L", "reference_site": "469", "sequential_site": 485.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3085, "escape": -0.005965, "mature_H5_site": 469.0, "mutant": "M", "mutation": "F469M", "reference_site": "469", "sequential_site": 485.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.231, "escape": -0.2871, "mature_H5_site": 469.0, "mutant": "T", "mutation": "F469T", "reference_site": "469", "sequential_site": 485.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.939, "escape": 0.09732, "mature_H5_site": 469.0, "mutant": "V", "mutation": "F469V", "reference_site": "469", "sequential_site": 485.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5527, "escape": -0.2809, "mature_H5_site": 469.0, "mutant": "Y", "mutation": "F469Y", "reference_site": "469", "sequential_site": 485.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05332, "escape": -0.04113, "mature_H5_site": 37.0, "mutant": "A", "mutation": "H47A", "reference_site": "47", "sequential_site": 53.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.21, "escape": -0.1847, "mature_H5_site": 37.0, "mutant": "F", "mutation": "H47F", "reference_site": "47", "sequential_site": 53.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.09, "escape": -0.2133, "mature_H5_site": 37.0, "mutant": "G", "mutation": "H47G", "reference_site": "47", "sequential_site": 53.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.181, "escape": -0.1699, "mature_H5_site": 37.0, "mutant": "M", "mutation": "H47M", "reference_site": "47", "sequential_site": 53.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3071, "escape": -0.1274, "mature_H5_site": 37.0, "mutant": "N", "mutation": "H47N", "reference_site": "47", "sequential_site": 53.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.95, "escape": -0.3174, "mature_H5_site": 37.0, "mutant": "P", "mutation": "H47P", "reference_site": "47", "sequential_site": 53.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7665, "escape": -0.1581, "mature_H5_site": 37.0, "mutant": "Q", "mutation": "H47Q", "reference_site": "47", "sequential_site": 53.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3071, "escape": -0.06606, "mature_H5_site": 37.0, "mutant": "S", "mutation": "H47S", "reference_site": "47", "sequential_site": 53.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2926, "escape": 0.04693, "mature_H5_site": 37.0, "mutant": "T", "mutation": "H47T", "reference_site": "47", "sequential_site": 53.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02953, "escape": 0.005128, "mature_H5_site": 37.0, "mutant": "V", "mutation": "H47V", "reference_site": "47", "sequential_site": 53.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4809, "escape": -0.1382, "mature_H5_site": 37.0, "mutant": "Y", "mutation": "H47Y", "reference_site": "47", "sequential_site": 53.0, "wildtype": "H"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.925, "escape": 0.006218, "mature_H5_site": 470.0, "mutant": "A", "mutation": "Y470A", "reference_site": "470", "sequential_site": 486.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.565, "escape": -0.3161, "mature_H5_site": 470.0, "mutant": "E", "mutation": "Y470E", "reference_site": "470", "sequential_site": 486.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01928, "escape": -0.0664, "mature_H5_site": 470.0, "mutant": "F", "mutation": "Y470F", "reference_site": "470", "sequential_site": 486.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.364, "escape": 0.2235, "mature_H5_site": 470.0, "mutant": "I", "mutation": "Y470I", "reference_site": "470", "sequential_site": 486.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8497, "escape": -0.3611, "mature_H5_site": 470.0, "mutant": "K", "mutation": "Y470K", "reference_site": "470", "sequential_site": 486.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4909, "escape": 0.2587, "mature_H5_site": 470.0, "mutant": "L", "mutation": "Y470L", "reference_site": "470", "sequential_site": 486.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9718, "escape": 0.1358, "mature_H5_site": 470.0, "mutant": "M", "mutation": "Y470M", "reference_site": "470", "sequential_site": 486.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.006, "escape": 0.01359, "mature_H5_site": 470.0, "mutant": "N", "mutation": "Y470N", "reference_site": "470", "sequential_site": 486.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6609, "escape": -0.1318, "mature_H5_site": 470.0, "mutant": "R", "mutation": "Y470R", "reference_site": "470", "sequential_site": 486.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.461, "escape": -0.3299, "mature_H5_site": 470.0, "mutant": "V", "mutation": "Y470V", "reference_site": "470", "sequential_site": 486.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6884, "escape": -0.1666, "mature_H5_site": 470.0, "mutant": "W", "mutation": "Y470W", "reference_site": "470", "sequential_site": 486.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08278, "escape": -0.03387, "mature_H5_site": 472.0, "mutant": "A", "mutation": "K472A", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0182, "escape": 0.3843, "mature_H5_site": 472.0, "mutant": "C", "mutation": "K472C", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1708, "escape": 0.1733, "mature_H5_site": 472.0, "mutant": "D", "mutation": "K472D", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.156, "escape": -0.146, "mature_H5_site": 472.0, "mutant": "E", "mutation": "K472E", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0614, "escape": -0.03759, "mature_H5_site": 472.0, "mutant": "F", "mutation": "K472F", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00799, "escape": 0.05472, "mature_H5_site": 472.0, "mutant": "G", "mutation": "K472G", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2637, "escape": -0.0517, "mature_H5_site": 472.0, "mutant": "H", "mutation": "K472H", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02784, "escape": 0.0391, "mature_H5_site": 472.0, "mutant": "I", "mutation": "K472I", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2482, "escape": 0.3606, "mature_H5_site": 472.0, "mutant": "L", "mutation": "K472L", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0753, "escape": 0.08033, "mature_H5_site": 472.0, "mutant": "M", "mutation": "K472M", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04923, "escape": 0.05763, "mature_H5_site": 472.0, "mutant": "N", "mutation": "K472N", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.209, "escape": 0.2051, "mature_H5_site": 472.0, "mutant": "Q", "mutation": "K472Q", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03329, "escape": 0.05828, "mature_H5_site": 472.0, "mutant": "R", "mutation": "K472R", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0997, "escape": 0.04857, "mature_H5_site": 472.0, "mutant": "T", "mutation": "K472T", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3759, "escape": 0.006196, "mature_H5_site": 472.0, "mutant": "V", "mutation": "K472V", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5537, "escape": 0.1855, "mature_H5_site": 472.0, "mutant": "W", "mutation": "K472W", "reference_site": "472", "sequential_site": 488.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2777, "escape": -0.02316, "mature_H5_site": 474.0, "mutant": "A", "mutation": "D474A", "reference_site": "474", "sequential_site": 490.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3002, "escape": -0.1256, "mature_H5_site": 474.0, "mutant": "C", "mutation": "D474C", "reference_site": "474", "sequential_site": 490.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6101, "escape": -0.2842, "mature_H5_site": 474.0, "mutant": "F", "mutation": "D474F", "reference_site": "474", "sequential_site": 490.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1828, "escape": -0.3218, "mature_H5_site": 474.0, "mutant": "G", "mutation": "D474G", "reference_site": "474", "sequential_site": 490.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1123, "escape": -0.07687, "mature_H5_site": 474.0, "mutant": "H", "mutation": "D474H", "reference_site": "474", "sequential_site": 490.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1623, "escape": -0.1332, "mature_H5_site": 474.0, "mutant": "L", "mutation": "D474L", "reference_site": "474", "sequential_site": 490.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.004995, "escape": 0.01346, "mature_H5_site": 474.0, "mutant": "N", "mutation": "D474N", "reference_site": "474", "sequential_site": 490.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05199, "escape": -0.07858, "mature_H5_site": 474.0, "mutant": "P", "mutation": "D474P", "reference_site": "474", "sequential_site": 490.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2171, "escape": -0.1828, "mature_H5_site": 474.0, "mutant": "R", "mutation": "D474R", "reference_site": "474", "sequential_site": 490.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2033, "escape": 0.02115, "mature_H5_site": 474.0, "mutant": "S", "mutation": "D474S", "reference_site": "474", "sequential_site": 490.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3021, "escape": -0.06801, "mature_H5_site": 474.0, "mutant": "T", "mutation": "D474T", "reference_site": "474", "sequential_site": 490.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8531, "escape": 0.03072, "mature_H5_site": 474.0, "mutant": "Y", "mutation": "D474Y", "reference_site": "474", "sequential_site": 490.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4861, "escape": -0.2469, "mature_H5_site": 475.0, "mutant": "A", "mutation": "N475A", "reference_site": "475", "sequential_site": 491.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7183, "escape": -0.2218, "mature_H5_site": 475.0, "mutant": "C", "mutation": "N475C", "reference_site": "475", "sequential_site": 491.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1398, "escape": -0.1345, "mature_H5_site": 475.0, "mutant": "D", "mutation": "N475D", "reference_site": "475", "sequential_site": 491.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9918, "escape": 0.01263, "mature_H5_site": 475.0, "mutant": "G", "mutation": "N475G", "reference_site": "475", "sequential_site": 491.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.089, "escape": 0.1415, "mature_H5_site": 475.0, "mutant": "H", "mutation": "N475H", "reference_site": "475", "sequential_site": 491.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.263, "escape": 0.04326, "mature_H5_site": 475.0, "mutant": "K", "mutation": "N475K", "reference_site": "475", "sequential_site": 491.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7843, "escape": -0.02531, "mature_H5_site": 475.0, "mutant": "L", "mutation": "N475L", "reference_site": "475", "sequential_site": 491.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9446, "escape": -0.0286, "mature_H5_site": 475.0, "mutant": "Q", "mutation": "N475Q", "reference_site": "475", "sequential_site": 491.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6235, "escape": 0.0209, "mature_H5_site": 475.0, "mutant": "S", "mutation": "N475S", "reference_site": "475", "sequential_site": 491.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09094, "escape": -0.2496, "mature_H5_site": 475.0, "mutant": "T", "mutation": "N475T", "reference_site": "475", "sequential_site": 491.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.415, "escape": -0.1752, "mature_H5_site": 475.0, "mutant": "V", "mutation": "N475V", "reference_site": "475", "sequential_site": 491.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04997, "escape": 0.03804, "mature_H5_site": 476.0, "mutant": "A", "mutation": "E476A", "reference_site": "476", "sequential_site": 492.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7759, "escape": 0.02007, "mature_H5_site": 476.0, "mutant": "C", "mutation": "E476C", "reference_site": "476", "sequential_site": 492.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1221, "escape": 0.1065, "mature_H5_site": 476.0, "mutant": "G", "mutation": "E476G", "reference_site": "476", "sequential_site": 492.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05299, "escape": -0.1215, "mature_H5_site": 476.0, "mutant": "H", "mutation": "E476H", "reference_site": "476", "sequential_site": 492.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7167, "escape": 0.1564, "mature_H5_site": 476.0, "mutant": "I", "mutation": "E476I", "reference_site": "476", "sequential_site": 492.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00132, "escape": 0.01354, "mature_H5_site": 476.0, "mutant": "K", "mutation": "E476K", "reference_site": "476", "sequential_site": 492.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01675, "escape": -0.01975, "mature_H5_site": 476.0, "mutant": "L", "mutation": "E476L", "reference_site": "476", "sequential_site": 492.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2813, "escape": 0.1605, "mature_H5_site": 476.0, "mutant": "M", "mutation": "E476M", "reference_site": "476", "sequential_site": 492.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1415, "escape": -0.2332, "mature_H5_site": 476.0, "mutant": "P", "mutation": "E476P", "reference_site": "476", "sequential_site": 492.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07608, "escape": -0.02931, "mature_H5_site": 476.0, "mutant": "Q", "mutation": "E476Q", "reference_site": "476", "sequential_site": 492.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03489, "escape": -0.2714, "mature_H5_site": 476.0, "mutant": "S", "mutation": "E476S", "reference_site": "476", "sequential_site": 492.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.306, "escape": 0.0216, "mature_H5_site": 476.0, "mutant": "T", "mutation": "E476T", "reference_site": "476", "sequential_site": 492.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03134, "escape": 0.04731, "mature_H5_site": 476.0, "mutant": "V", "mutation": "E476V", "reference_site": "476", "sequential_site": 492.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06209, "escape": -0.06639, "mature_H5_site": 476.0, "mutant": "W", "mutation": "E476W", "reference_site": "476", "sequential_site": 492.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01797, "escape": -0.2197, "mature_H5_site": 476.0, "mutant": "Y", "mutation": "E476Y", "reference_site": "476", "sequential_site": 492.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8904, "escape": 0.006445, "mature_H5_site": 478.0, "mutant": "F", "mutation": "M478F", "reference_site": "478", "sequential_site": 494.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7825, "escape": -0.3177, "mature_H5_site": 478.0, "mutant": "I", "mutation": "M478I", "reference_site": "478", "sequential_site": 494.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8727, "escape": -0.2654, "mature_H5_site": 478.0, "mutant": "L", "mutation": "M478L", "reference_site": "478", "sequential_site": 494.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6215, "escape": -0.06173, "mature_H5_site": 478.0, "mutant": "V", "mutation": "M478V", "reference_site": "478", "sequential_site": 494.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3402, "escape": -0.0134, "mature_H5_site": 479.0, "mutant": "A", "mutation": "E479A", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07176, "escape": -0.249, "mature_H5_site": 479.0, "mutant": "C", "mutation": "E479C", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5454, "escape": -0.02261, "mature_H5_site": 479.0, "mutant": "D", "mutation": "E479D", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2217, "escape": 0.08989, "mature_H5_site": 479.0, "mutant": "F", "mutation": "E479F", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5922, "escape": -0.003943, "mature_H5_site": 479.0, "mutant": "G", "mutation": "E479G", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3883, "escape": -0.1082, "mature_H5_site": 479.0, "mutant": "H", "mutation": "E479H", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.162, "escape": -0.2817, "mature_H5_site": 479.0, "mutant": "I", "mutation": "E479I", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5117, "escape": -0.06357, "mature_H5_site": 479.0, "mutant": "K", "mutation": "E479K", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2853, "escape": 0.006918, "mature_H5_site": 479.0, "mutant": "L", "mutation": "E479L", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07452, "escape": 0.1742, "mature_H5_site": 479.0, "mutant": "M", "mutation": "E479M", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1925, "escape": -0.001166, "mature_H5_site": 479.0, "mutant": "N", "mutation": "E479N", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7171, "escape": 0.179, "mature_H5_site": 479.0, "mutant": "Q", "mutation": "E479Q", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.575, "escape": -0.02257, "mature_H5_site": 479.0, "mutant": "R", "mutation": "E479R", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2402, "escape": 0.0461, "mature_H5_site": 479.0, "mutant": "S", "mutation": "E479S", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07883, "escape": -0.7085, "mature_H5_site": 479.0, "mutant": "T", "mutation": "E479T", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02541, "escape": -0.03923, "mature_H5_site": 479.0, "mutant": "V", "mutation": "E479V", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.416, "escape": 0.1217, "mature_H5_site": 479.0, "mutant": "W", "mutation": "E479W", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4616, "escape": 0.03363, "mature_H5_site": 479.0, "mutant": "Y", "mutation": "E479Y", "reference_site": "479", "sequential_site": 495.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3413, "escape": -0.2088, "mature_H5_site": 38.0, "mutant": "D", "mutation": "N48D", "reference_site": "48", "sequential_site": 54.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.069, "escape": -0.2236, "mature_H5_site": 38.0, "mutant": "F", "mutation": "N48F", "reference_site": "48", "sequential_site": 54.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08924, "escape": 0.4258, "mature_H5_site": 38.0, "mutant": "G", "mutation": "N48G", "reference_site": "48", "sequential_site": 54.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.086, "escape": -0.02855, "mature_H5_site": 38.0, "mutant": "H", "mutation": "N48H", "reference_site": "48", "sequential_site": 54.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.234, "escape": -0.0807, "mature_H5_site": 38.0, "mutant": "L", "mutation": "N48L", "reference_site": "48", "sequential_site": 54.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.56, "escape": -0.1351, "mature_H5_site": 38.0, "mutant": "Q", "mutation": "N48Q", "reference_site": "48", "sequential_site": 54.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.246, "escape": -0.09584, "mature_H5_site": 38.0, "mutant": "V", "mutation": "N48V", "reference_site": "48", "sequential_site": 54.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.224, "escape": 0.1854, "mature_H5_site": 38.0, "mutant": "Y", "mutation": "N48Y", "reference_site": "48", "sequential_site": 54.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4241, "escape": -0.009605, "mature_H5_site": 480.0, "mutant": "C", "mutation": "S480C", "reference_site": "480", "sequential_site": 496.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6581, "escape": 0.2085, "mature_H5_site": 480.0, "mutant": "D", "mutation": "S480D", "reference_site": "480", "sequential_site": 496.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08343, "escape": -0.01768, "mature_H5_site": 480.0, "mutant": "E", "mutation": "S480E", "reference_site": "480", "sequential_site": 496.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7335, "escape": -0.06742, "mature_H5_site": 480.0, "mutant": "F", "mutation": "S480F", "reference_site": "480", "sequential_site": 496.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.132, "escape": -0.2669, "mature_H5_site": 480.0, "mutant": "G", "mutation": "S480G", "reference_site": "480", "sequential_site": 496.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.007, "escape": 0.02998, "mature_H5_site": 480.0, "mutant": "L", "mutation": "S480L", "reference_site": "480", "sequential_site": 496.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01755, "escape": 0.09875, "mature_H5_site": 480.0, "mutant": "M", "mutation": "S480M", "reference_site": "480", "sequential_site": 496.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1154, "escape": -0.03027, "mature_H5_site": 480.0, "mutant": "Q", "mutation": "S480Q", "reference_site": "480", "sequential_site": 496.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01786, "escape": 0.3285, "mature_H5_site": 480.0, "mutant": "R", "mutation": "S480R", "reference_site": "480", "sequential_site": 496.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0577, "escape": 0.113, "mature_H5_site": 480.0, "mutant": "T", "mutation": "S480T", "reference_site": "480", "sequential_site": 496.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.135, "escape": -0.01615, "mature_H5_site": 480.0, "mutant": "Y", "mutation": "S480Y", "reference_site": "480", "sequential_site": 496.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07554, "escape": 0.4379, "mature_H5_site": 481.0, "mutant": "I", "mutation": "V481I", "reference_site": "481", "sequential_site": 497.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1209, "escape": 0.03547, "mature_H5_site": 481.0, "mutant": "L", "mutation": "V481L", "reference_site": "481", "sequential_site": 497.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9165, "escape": -0.0389, "mature_H5_site": 482.0, "mutant": "A", "mutation": "R482A", "reference_site": "482", "sequential_site": 498.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3311, "escape": 0.2836, "mature_H5_site": 482.0, "mutant": "C", "mutation": "R482C", "reference_site": "482", "sequential_site": 498.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.506, "escape": -0.04705, "mature_H5_site": 482.0, "mutant": "D", "mutation": "R482D", "reference_site": "482", "sequential_site": 498.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9797, "escape": -0.218, "mature_H5_site": 482.0, "mutant": "E", "mutation": "R482E", "reference_site": "482", "sequential_site": 498.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4458, "escape": 0.00703, "mature_H5_site": 482.0, "mutant": "F", "mutation": "R482F", "reference_site": "482", "sequential_site": 498.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.628, "escape": -0.09242, "mature_H5_site": 482.0, "mutant": "H", "mutation": "R482H", "reference_site": "482", "sequential_site": 498.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4002, "escape": 0.2102, "mature_H5_site": 482.0, "mutant": "K", "mutation": "R482K", "reference_site": "482", "sequential_site": 498.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2461, "escape": -0.0006927, "mature_H5_site": 482.0, "mutant": "M", "mutation": "R482M", "reference_site": "482", "sequential_site": 498.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1832, "escape": -0.06879, "mature_H5_site": 482.0, "mutant": "S", "mutation": "R482S", "reference_site": "482", "sequential_site": 498.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5665, "escape": 0.05325, "mature_H5_site": 482.0, "mutant": "T", "mutation": "R482T", "reference_site": "482", "sequential_site": 498.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2518, "escape": -0.3416, "mature_H5_site": 482.0, "mutant": "V", "mutation": "R482V", "reference_site": "482", "sequential_site": 498.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.54, "escape": 0.1357, "mature_H5_site": 482.0, "mutant": "Y", "mutation": "R482Y", "reference_site": "482", "sequential_site": 498.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01077, "escape": -0.1955, "mature_H5_site": 483.0, "mutant": "A", "mutation": "N483A", "reference_site": "483", "sequential_site": 499.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06985, "escape": -0.01328, "mature_H5_site": 483.0, "mutant": "F", "mutation": "N483F", "reference_site": "483", "sequential_site": 499.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.469, "escape": -0.4455, "mature_H5_site": 483.0, "mutant": "H", "mutation": "N483H", "reference_site": "483", "sequential_site": 499.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2435, "escape": 0.05901, "mature_H5_site": 483.0, "mutant": "I", "mutation": "N483I", "reference_site": "483", "sequential_site": 499.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.313, "escape": 0.0234, "mature_H5_site": 483.0, "mutant": "K", "mutation": "N483K", "reference_site": "483", "sequential_site": 499.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2143, "escape": 0.01527, "mature_H5_site": 483.0, "mutant": "Q", "mutation": "N483Q", "reference_site": "483", "sequential_site": 499.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05613, "escape": -0.03809, "mature_H5_site": 483.0, "mutant": "T", "mutation": "N483T", "reference_site": "483", "sequential_site": 499.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4616, "escape": 0.1424, "mature_H5_site": 483.0, "mutant": "V", "mutation": "N483V", "reference_site": "483", "sequential_site": 499.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.95, "escape": 0.1093, "mature_H5_site": 483.0, "mutant": "W", "mutation": "N483W", "reference_site": "483", "sequential_site": 499.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2218, "escape": 0.07994, "mature_H5_site": 484.0, "mutant": "A", "mutation": "G484A", "reference_site": "484", "sequential_site": 500.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4692, "escape": -0.03748, "mature_H5_site": 484.0, "mutant": "C", "mutation": "G484C", "reference_site": "484", "sequential_site": 500.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05982, "escape": -0.08017, "mature_H5_site": 484.0, "mutant": "D", "mutation": "G484D", "reference_site": "484", "sequential_site": 500.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5809, "escape": 0.192, "mature_H5_site": 484.0, "mutant": "E", "mutation": "G484E", "reference_site": "484", "sequential_site": 500.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.328, "escape": 0.2498, "mature_H5_site": 484.0, "mutant": "L", "mutation": "G484L", "reference_site": "484", "sequential_site": 500.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2729, "escape": -0.01391, "mature_H5_site": 484.0, "mutant": "M", "mutation": "G484M", "reference_site": "484", "sequential_site": 500.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.003895, "escape": -0.04281, "mature_H5_site": 484.0, "mutant": "N", "mutation": "G484N", "reference_site": "484", "sequential_site": 500.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9005, "escape": -0.3534, "mature_H5_site": 484.0, "mutant": "Q", "mutation": "G484Q", "reference_site": "484", "sequential_site": 500.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05835, "escape": -0.03211, "mature_H5_site": 484.0, "mutant": "R", "mutation": "G484R", "reference_site": "484", "sequential_site": 500.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3554, "escape": 0.2317, "mature_H5_site": 484.0, "mutant": "S", "mutation": "G484S", "reference_site": "484", "sequential_site": 500.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2872, "escape": 0.06481, "mature_H5_site": 484.0, "mutant": "T", "mutation": "G484T", "reference_site": "484", "sequential_site": 500.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08666, "escape": -0.03041, "mature_H5_site": 484.0, "mutant": "W", "mutation": "G484W", "reference_site": "484", "sequential_site": 500.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02251, "escape": -0.05793, "mature_H5_site": 485.0, "mutant": "A", "mutation": "T485A", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7313, "escape": 0.1126, "mature_H5_site": 485.0, "mutant": "C", "mutation": "T485C", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05696, "escape": 0.4462, "mature_H5_site": 485.0, "mutant": "D", "mutation": "T485D", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2538, "escape": 0.1116, "mature_H5_site": 485.0, "mutant": "E", "mutation": "T485E", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4218, "escape": 0.4215, "mature_H5_site": 485.0, "mutant": "G", "mutation": "T485G", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.003445, "escape": -0.4454, "mature_H5_site": 485.0, "mutant": "H", "mutation": "T485H", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6316, "escape": 0.1736, "mature_H5_site": 485.0, "mutant": "K", "mutation": "T485K", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4477, "escape": 0.2046, "mature_H5_site": 485.0, "mutant": "L", "mutation": "T485L", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1615, "escape": -0.03291, "mature_H5_site": 485.0, "mutant": "M", "mutation": "T485M", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02644, "escape": -0.1797, "mature_H5_site": 485.0, "mutant": "N", "mutation": "T485N", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5237, "escape": -0.1151, "mature_H5_site": 485.0, "mutant": "Q", "mutation": "T485Q", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08727, "escape": -0.06239, "mature_H5_site": 485.0, "mutant": "R", "mutation": "T485R", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04661, "escape": -0.0488, "mature_H5_site": 485.0, "mutant": "S", "mutation": "T485S", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5876, "escape": 0.136, "mature_H5_site": 485.0, "mutant": "V", "mutation": "T485V", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5887, "escape": -0.2239, "mature_H5_site": 485.0, "mutant": "W", "mutation": "T485W", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.011, "escape": 0.1493, "mature_H5_site": 485.0, "mutant": "Y", "mutation": "T485Y", "reference_site": "485", "sequential_site": 501.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4682, "escape": -0.3118, "mature_H5_site": 487.0, "mutant": "A", "mutation": "D487A", "reference_site": "487", "sequential_site": 503.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.173, "escape": 0.009254, "mature_H5_site": 487.0, "mutant": "C", "mutation": "D487C", "reference_site": "487", "sequential_site": 503.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1731, "escape": 0.03483, "mature_H5_site": 487.0, "mutant": "E", "mutation": "D487E", "reference_site": "487", "sequential_site": 503.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2668, "escape": 0.04474, "mature_H5_site": 487.0, "mutant": "H", "mutation": "D487H", "reference_site": "487", "sequential_site": 503.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5252, "escape": -0.1939, "mature_H5_site": 487.0, "mutant": "I", "mutation": "D487I", "reference_site": "487", "sequential_site": 503.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.261, "escape": 0.04864, "mature_H5_site": 487.0, "mutant": "L", "mutation": "D487L", "reference_site": "487", "sequential_site": 503.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.007755, "escape": 0.08794, "mature_H5_site": 487.0, "mutant": "M", "mutation": "D487M", "reference_site": "487", "sequential_site": 503.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2084, "escape": -0.2244, "mature_H5_site": 487.0, "mutant": "N", "mutation": "D487N", "reference_site": "487", "sequential_site": 503.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7202, "escape": 0.1462, "mature_H5_site": 487.0, "mutant": "Q", "mutation": "D487Q", "reference_site": "487", "sequential_site": 503.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.934, "escape": 0.104, "mature_H5_site": 487.0, "mutant": "R", "mutation": "D487R", "reference_site": "487", "sequential_site": 503.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.332, "escape": 0.08725, "mature_H5_site": 487.0, "mutant": "S", "mutation": "D487S", "reference_site": "487", "sequential_site": 503.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8407, "escape": 0.2217, "mature_H5_site": 487.0, "mutant": "T", "mutation": "D487T", "reference_site": "487", "sequential_site": 503.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0038, "escape": -0.02044, "mature_H5_site": 487.0, "mutant": "Y", "mutation": "D487Y", "reference_site": "487", "sequential_site": 503.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07365, "escape": 0.03479, "mature_H5_site": 488.0, "mutant": "A", "mutation": "Y488A", "reference_site": "488", "sequential_site": 504.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.084, "escape": -0.136, "mature_H5_site": 488.0, "mutant": "E", "mutation": "Y488E", "reference_site": "488", "sequential_site": 504.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05038, "escape": 0.2182, "mature_H5_site": 488.0, "mutant": "H", "mutation": "Y488H", "reference_site": "488", "sequential_site": 504.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.344, "escape": -0.03403, "mature_H5_site": 488.0, "mutant": "I", "mutation": "Y488I", "reference_site": "488", "sequential_site": 504.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1512, "escape": 0.004533, "mature_H5_site": 488.0, "mutant": "L", "mutation": "Y488L", "reference_site": "488", "sequential_site": 504.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4111, "escape": 0.1082, "mature_H5_site": 488.0, "mutant": "N", "mutation": "Y488N", "reference_site": "488", "sequential_site": 504.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6532, "escape": 0.008414, "mature_H5_site": 488.0, "mutant": "Q", "mutation": "Y488Q", "reference_site": "488", "sequential_site": 504.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7654, "escape": -0.0004218, "mature_H5_site": 488.0, "mutant": "S", "mutation": "Y488S", "reference_site": "488", "sequential_site": 504.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7161, "escape": 0.1511, "mature_H5_site": 488.0, "mutant": "V", "mutation": "Y488V", "reference_site": "488", "sequential_site": 504.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04519, "escape": 0.2287, "mature_H5_site": 488.0, "mutant": "W", "mutation": "Y488W", "reference_site": "488", "sequential_site": 504.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04013, "escape": 0.1241, "mature_H5_site": 489.0, "mutant": "D", "mutation": "P489D", "reference_site": "489", "sequential_site": 505.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01254, "escape": -0.1405, "mature_H5_site": 489.0, "mutant": "F", "mutation": "P489F", "reference_site": "489", "sequential_site": 505.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02938, "escape": 0.1752, "mature_H5_site": 489.0, "mutant": "G", "mutation": "P489G", "reference_site": "489", "sequential_site": 505.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04882, "escape": -0.043, "mature_H5_site": 489.0, "mutant": "H", "mutation": "P489H", "reference_site": "489", "sequential_site": 505.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02565, "escape": 0.1258, "mature_H5_site": 489.0, "mutant": "I", "mutation": "P489I", "reference_site": "489", "sequential_site": 505.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1846, "escape": 0.05165, "mature_H5_site": 489.0, "mutant": "K", "mutation": "P489K", "reference_site": "489", "sequential_site": 505.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3002, "escape": -0.07597, "mature_H5_site": 489.0, "mutant": "L", "mutation": "P489L", "reference_site": "489", "sequential_site": 505.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05812, "escape": -0.03743, "mature_H5_site": 489.0, "mutant": "M", "mutation": "P489M", "reference_site": "489", "sequential_site": 505.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03125, "escape": 0.02366, "mature_H5_site": 489.0, "mutant": "N", "mutation": "P489N", "reference_site": "489", "sequential_site": 505.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.001623, "escape": 0.1183, "mature_H5_site": 489.0, "mutant": "R", "mutation": "P489R", "reference_site": "489", "sequential_site": 505.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1684, "escape": -0.0691, "mature_H5_site": 489.0, "mutant": "S", "mutation": "P489S", "reference_site": "489", "sequential_site": 505.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00477, "escape": 0.024, "mature_H5_site": 489.0, "mutant": "T", "mutation": "P489T", "reference_site": "489", "sequential_site": 505.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07207, "escape": 0.5963, "mature_H5_site": 489.0, "mutant": "V", "mutation": "P489V", "reference_site": "489", "sequential_site": 505.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04756, "escape": -0.1588, "mature_H5_site": 489.0, "mutant": "W", "mutation": "P489W", "reference_site": "489", "sequential_site": 505.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7819, "escape": -0.1514, "mature_H5_site": 489.0, "mutant": "Y", "mutation": "P489Y", "reference_site": "489", "sequential_site": 505.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05816, "escape": 0.07638, "mature_H5_site": 39.0, "mutant": "A", "mutation": "G49A", "reference_site": "49", "sequential_site": 55.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9058, "escape": -0.2846, "mature_H5_site": 39.0, "mutant": "C", "mutation": "G49C", "reference_site": "49", "sequential_site": 55.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6956, "escape": -0.03807, "mature_H5_site": 39.0, "mutant": "D", "mutation": "G49D", "reference_site": "49", "sequential_site": 55.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4272, "escape": -0.07334, "mature_H5_site": 39.0, "mutant": "E", "mutation": "G49E", "reference_site": "49", "sequential_site": 55.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06056, "escape": 0.2037, "mature_H5_site": 39.0, "mutant": "F", "mutation": "G49F", "reference_site": "49", "sequential_site": 55.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05038, "escape": 0.08659, "mature_H5_site": 39.0, "mutant": "K", "mutation": "G49K", "reference_site": "49", "sequential_site": 55.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2848, "escape": -0.2995, "mature_H5_site": 39.0, "mutant": "P", "mutation": "G49P", "reference_site": "49", "sequential_site": 55.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2613, "escape": 0.07978, "mature_H5_site": 39.0, "mutant": "R", "mutation": "G49R", "reference_site": "49", "sequential_site": 55.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03599, "escape": -0.1426, "mature_H5_site": 39.0, "mutant": "S", "mutation": "G49S", "reference_site": "49", "sequential_site": 55.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1132, "escape": 0.09622, "mature_H5_site": 39.0, "mutant": "T", "mutation": "G49T", "reference_site": "49", "sequential_site": 55.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": null, "escape": -0.2619, "mature_H5_site": 490.0, "mutant": "A", "mutation": "Q490A", "reference_site": "490", "sequential_site": 506.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04284, "escape": -0.2237, "mature_H5_site": 490.0, "mutant": "E", "mutation": "Q490E", "reference_site": "490", "sequential_site": 506.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1291, "escape": -0.1225, "mature_H5_site": 490.0, "mutant": "F", "mutation": "Q490F", "reference_site": "490", "sequential_site": 506.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05589, "escape": -0.2122, "mature_H5_site": 490.0, "mutant": "G", "mutation": "Q490G", "reference_site": "490", "sequential_site": 506.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02865, "escape": -0.2249, "mature_H5_site": 490.0, "mutant": "K", "mutation": "Q490K", "reference_site": "490", "sequential_site": 506.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3354, "escape": -0.005213, "mature_H5_site": 490.0, "mutant": "L", "mutation": "Q490L", "reference_site": "490", "sequential_site": 506.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06731, "escape": 0.2621, "mature_H5_site": 490.0, "mutant": "M", "mutation": "Q490M", "reference_site": "490", "sequential_site": 506.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02872, "escape": -0.02722, "mature_H5_site": 490.0, "mutant": "N", "mutation": "Q490N", "reference_site": "490", "sequential_site": 506.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07169, "escape": 0.1577, "mature_H5_site": 490.0, "mutant": "S", "mutation": "Q490S", "reference_site": "490", "sequential_site": 506.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2175, "escape": 0.1187, "mature_H5_site": 490.0, "mutant": "T", "mutation": "Q490T", "reference_site": "490", "sequential_site": 506.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.852, "escape": -0.0224, "mature_H5_site": 490.0, "mutant": "Y", "mutation": "Q490Y", "reference_site": "490", "sequential_site": 506.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0366, "escape": -0.02378, "mature_H5_site": 491.0, "mutant": "F", "mutation": "Y491F", "reference_site": "491", "sequential_site": 507.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4017, "escape": 0.05395, "mature_H5_site": 491.0, "mutant": "H", "mutation": "Y491H", "reference_site": "491", "sequential_site": 507.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.453, "escape": -0.02638, "mature_H5_site": 491.0, "mutant": "K", "mutation": "Y491K", "reference_site": "491", "sequential_site": 507.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.141, "escape": 0.0007693, "mature_H5_site": 491.0, "mutant": "R", "mutation": "Y491R", "reference_site": "491", "sequential_site": 507.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06918, "escape": -0.1313, "mature_H5_site": 492.0, "mutant": "A", "mutation": "S492A", "reference_site": "492", "sequential_site": 508.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5055, "escape": 0.05398, "mature_H5_site": 492.0, "mutant": "D", "mutation": "S492D", "reference_site": "492", "sequential_site": 508.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09166, "escape": -0.4216, "mature_H5_site": 492.0, "mutant": "E", "mutation": "S492E", "reference_site": "492", "sequential_site": 508.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0695, "escape": -0.1049, "mature_H5_site": 492.0, "mutant": "G", "mutation": "S492G", "reference_site": "492", "sequential_site": 508.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1219, "escape": 0.01087, "mature_H5_site": 492.0, "mutant": "H", "mutation": "S492H", "reference_site": "492", "sequential_site": 508.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1893, "escape": 0.002819, "mature_H5_site": 492.0, "mutant": "I", "mutation": "S492I", "reference_site": "492", "sequential_site": 508.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1648, "escape": 0.04776, "mature_H5_site": 492.0, "mutant": "K", "mutation": "S492K", "reference_site": "492", "sequential_site": 508.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07809, "escape": 0.1114, "mature_H5_site": 492.0, "mutant": "M", "mutation": "S492M", "reference_site": "492", "sequential_site": 508.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.193, "escape": 0.3351, "mature_H5_site": 492.0, "mutant": "N", "mutation": "S492N", "reference_site": "492", "sequential_site": 508.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06974, "escape": 0.2019, "mature_H5_site": 492.0, "mutant": "Q", "mutation": "S492Q", "reference_site": "492", "sequential_site": 508.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04308, "escape": -0.0835, "mature_H5_site": 492.0, "mutant": "R", "mutation": "S492R", "reference_site": "492", "sequential_site": 508.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08991, "escape": 0.04813, "mature_H5_site": 492.0, "mutant": "V", "mutation": "S492V", "reference_site": "492", "sequential_site": 508.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05597, "escape": -0.1608, "mature_H5_site": 492.0, "mutant": "Y", "mutation": "S492Y", "reference_site": "492", "sequential_site": 508.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02256, "escape": -0.05927, "mature_H5_site": 493.0, "mutant": "A", "mutation": "E493A", "reference_site": "493", "sequential_site": 509.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00506, "escape": -0.06331, "mature_H5_site": 493.0, "mutant": "D", "mutation": "E493D", "reference_site": "493", "sequential_site": 509.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1969, "escape": -0.03288, "mature_H5_site": 493.0, "mutant": "G", "mutation": "E493G", "reference_site": "493", "sequential_site": 509.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8727, "escape": 0.2121, "mature_H5_site": 493.0, "mutant": "H", "mutation": "E493H", "reference_site": "493", "sequential_site": 509.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02653, "escape": 0.09429, "mature_H5_site": 493.0, "mutant": "I", "mutation": "E493I", "reference_site": "493", "sequential_site": 509.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05364, "escape": -0.01678, "mature_H5_site": 493.0, "mutant": "K", "mutation": "E493K", "reference_site": "493", "sequential_site": 509.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1879, "escape": 0.01737, "mature_H5_site": 493.0, "mutant": "L", "mutation": "E493L", "reference_site": "493", "sequential_site": 509.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6119, "escape": 0.01845, "mature_H5_site": 493.0, "mutant": "N", "mutation": "E493N", "reference_site": "493", "sequential_site": 509.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1191, "escape": -0.04453, "mature_H5_site": 493.0, "mutant": "P", "mutation": "E493P", "reference_site": "493", "sequential_site": 509.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01898, "escape": -0.3534, "mature_H5_site": 493.0, "mutant": "Q", "mutation": "E493Q", "reference_site": "493", "sequential_site": 509.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04886, "escape": 0.02664, "mature_H5_site": 493.0, "mutant": "S", "mutation": "E493S", "reference_site": "493", "sequential_site": 509.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06264, "escape": 0.05863, "mature_H5_site": 493.0, "mutant": "T", "mutation": "E493T", "reference_site": "493", "sequential_site": 509.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1598, "escape": -0.1296, "mature_H5_site": 493.0, "mutant": "V", "mutation": "E493V", "reference_site": "493", "sequential_site": 509.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3478, "escape": -0.1282, "mature_H5_site": 494.0, "mutant": "A", "mutation": "E494A", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1606, "escape": -0.003943, "mature_H5_site": 494.0, "mutant": "C", "mutation": "E494C", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1087, "escape": -0.1979, "mature_H5_site": 494.0, "mutant": "F", "mutation": "E494F", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5398, "escape": 0.1009, "mature_H5_site": 494.0, "mutant": "G", "mutation": "E494G", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05363, "escape": -0.2028, "mature_H5_site": 494.0, "mutant": "H", "mutation": "E494H", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2148, "escape": -0.003248, "mature_H5_site": 494.0, "mutant": "I", "mutation": "E494I", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3865, "escape": 0.07746, "mature_H5_site": 494.0, "mutant": "K", "mutation": "E494K", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1426, "escape": -0.09114, "mature_H5_site": 494.0, "mutant": "L", "mutation": "E494L", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.19, "escape": -0.06054, "mature_H5_site": 494.0, "mutant": "M", "mutation": "E494M", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4734, "escape": 0.03945, "mature_H5_site": 494.0, "mutant": "N", "mutation": "E494N", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02692, "escape": 0.043, "mature_H5_site": 494.0, "mutant": "P", "mutation": "E494P", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.005685, "escape": -0.1846, "mature_H5_site": 494.0, "mutant": "Q", "mutation": "E494Q", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4497, "escape": -0.001138, "mature_H5_site": 494.0, "mutant": "R", "mutation": "E494R", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1459, "escape": 0.08789, "mature_H5_site": 494.0, "mutant": "S", "mutation": "E494S", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04645, "escape": -0.01363, "mature_H5_site": 494.0, "mutant": "T", "mutation": "E494T", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01831, "escape": -0.0295, "mature_H5_site": 494.0, "mutant": "V", "mutation": "E494V", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09479, "escape": 0.06582, "mature_H5_site": 494.0, "mutant": "Y", "mutation": "E494Y", "reference_site": "494", "sequential_site": 510.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00379, "escape": 0.06128, "mature_H5_site": 495.0, "mutant": "I", "mutation": "A495I", "reference_site": "495", "sequential_site": 511.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.599, "escape": -0.004077, "mature_H5_site": 495.0, "mutant": "K", "mutation": "A495K", "reference_site": "495", "sequential_site": 511.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3244, "escape": -0.2344, "mature_H5_site": 495.0, "mutant": "L", "mutation": "A495L", "reference_site": "495", "sequential_site": 511.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2422, "escape": -0.1252, "mature_H5_site": 495.0, "mutant": "M", "mutation": "A495M", "reference_site": "495", "sequential_site": 511.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.281, "escape": 0.3695, "mature_H5_site": 495.0, "mutant": "R", "mutation": "A495R", "reference_site": "495", "sequential_site": 511.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7931, "escape": 0.1336, "mature_H5_site": 495.0, "mutant": "S", "mutation": "A495S", "reference_site": "495", "sequential_site": 511.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.129, "escape": 0.1087, "mature_H5_site": 495.0, "mutant": "T", "mutation": "A495T", "reference_site": "495", "sequential_site": 511.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2765, "escape": 0.08629, "mature_H5_site": 495.0, "mutant": "V", "mutation": "A495V", "reference_site": "495", "sequential_site": 511.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.57, "escape": 0.01633, "mature_H5_site": 495.0, "mutant": "W", "mutation": "A495W", "reference_site": "495", "sequential_site": 511.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.583, "escape": -0.04002, "mature_H5_site": 496.0, "mutant": "C", "mutation": "R496C", "reference_site": "496", "sequential_site": 512.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1516, "escape": 0.1267, "mature_H5_site": 496.0, "mutant": "E", "mutation": "R496E", "reference_site": "496", "sequential_site": 512.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.21, "escape": 0.01831, "mature_H5_site": 496.0, "mutant": "F", "mutation": "R496F", "reference_site": "496", "sequential_site": 512.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.526, "escape": 0.04508, "mature_H5_site": 496.0, "mutant": "G", "mutation": "R496G", "reference_site": "496", "sequential_site": 512.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.757, "escape": 0.1609, "mature_H5_site": 496.0, "mutant": "H", "mutation": "R496H", "reference_site": "496", "sequential_site": 512.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5592, "escape": 0.1236, "mature_H5_site": 496.0, "mutant": "K", "mutation": "R496K", "reference_site": "496", "sequential_site": 512.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3315, "escape": 0.2484, "mature_H5_site": 496.0, "mutant": "N", "mutation": "R496N", "reference_site": "496", "sequential_site": 512.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06183, "escape": 0.01788, "mature_H5_site": 496.0, "mutant": "Q", "mutation": "R496Q", "reference_site": "496", "sequential_site": 512.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2787, "escape": -0.01561, "mature_H5_site": 496.0, "mutant": "S", "mutation": "R496S", "reference_site": "496", "sequential_site": 512.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.131, "escape": -0.03515, "mature_H5_site": 496.0, "mutant": "T", "mutation": "R496T", "reference_site": "496", "sequential_site": 512.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.166, "escape": 0.06092, "mature_H5_site": 496.0, "mutant": "V", "mutation": "R496V", "reference_site": "496", "sequential_site": 512.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.151, "escape": 0.05251, "mature_H5_site": 496.0, "mutant": "W", "mutation": "R496W", "reference_site": "496", "sequential_site": 512.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4927, "escape": -0.07946, "mature_H5_site": 496.0, "mutant": "Y", "mutation": "R496Y", "reference_site": "496", "sequential_site": 512.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.008565, "escape": -0.1105, "mature_H5_site": 497.0, "mutant": "C", "mutation": "L497C", "reference_site": "497", "sequential_site": 513.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6236, "escape": 0.2585, "mature_H5_site": 497.0, "mutant": "D", "mutation": "L497D", "reference_site": "497", "sequential_site": 513.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4429, "escape": -0.03132, "mature_H5_site": 497.0, "mutant": "E", "mutation": "L497E", "reference_site": "497", "sequential_site": 513.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.235, "escape": 0.05259, "mature_H5_site": 497.0, "mutant": "F", "mutation": "L497F", "reference_site": "497", "sequential_site": 513.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06297, "escape": -0.03563, "mature_H5_site": 497.0, "mutant": "H", "mutation": "L497H", "reference_site": "497", "sequential_site": 513.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05432, "escape": 0.1975, "mature_H5_site": 497.0, "mutant": "I", "mutation": "L497I", "reference_site": "497", "sequential_site": 513.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02366, "escape": 0.231, "mature_H5_site": 497.0, "mutant": "K", "mutation": "L497K", "reference_site": "497", "sequential_site": 513.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0541, "escape": -0.1446, "mature_H5_site": 497.0, "mutant": "M", "mutation": "L497M", "reference_site": "497", "sequential_site": 513.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7451, "escape": -0.1716, "mature_H5_site": 497.0, "mutant": "P", "mutation": "L497P", "reference_site": "497", "sequential_site": 513.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07033, "escape": -0.105, "mature_H5_site": 497.0, "mutant": "R", "mutation": "L497R", "reference_site": "497", "sequential_site": 513.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2087, "escape": 0.1568, "mature_H5_site": 497.0, "mutant": "T", "mutation": "L497T", "reference_site": "497", "sequential_site": 513.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2893, "escape": -0.001995, "mature_H5_site": 497.0, "mutant": "V", "mutation": "L497V", "reference_site": "497", "sequential_site": 513.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00332, "escape": -0.1242, "mature_H5_site": 497.0, "mutant": "Y", "mutation": "L497Y", "reference_site": "497", "sequential_site": 513.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4897, "escape": -0.1619, "mature_H5_site": 498.0, "mutant": "C", "mutation": "K498C", "reference_site": "498", "sequential_site": 514.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2255, "escape": -0.1448, "mature_H5_site": 498.0, "mutant": "F", "mutation": "K498F", "reference_site": "498", "sequential_site": 514.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3829, "escape": -0.07756, "mature_H5_site": 498.0, "mutant": "G", "mutation": "K498G", "reference_site": "498", "sequential_site": 514.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06501, "escape": 0.1772, "mature_H5_site": 498.0, "mutant": "H", "mutation": "K498H", "reference_site": "498", "sequential_site": 514.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1194, "escape": -0.1226, "mature_H5_site": 498.0, "mutant": "L", "mutation": "K498L", "reference_site": "498", "sequential_site": 514.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01002, "escape": 0.1273, "mature_H5_site": 498.0, "mutant": "M", "mutation": "K498M", "reference_site": "498", "sequential_site": 514.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09131, "escape": 0.05159, "mature_H5_site": 498.0, "mutant": "N", "mutation": "K498N", "reference_site": "498", "sequential_site": 514.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.386, "escape": -0.1978, "mature_H5_site": 498.0, "mutant": "P", "mutation": "K498P", "reference_site": "498", "sequential_site": 514.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1485, "escape": 0.03449, "mature_H5_site": 498.0, "mutant": "Q", "mutation": "K498Q", "reference_site": "498", "sequential_site": 514.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2218, "escape": -0.3068, "mature_H5_site": 498.0, "mutant": "S", "mutation": "K498S", "reference_site": "498", "sequential_site": 514.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02015, "escape": -0.1108, "mature_H5_site": 498.0, "mutant": "T", "mutation": "K498T", "reference_site": "498", "sequential_site": 514.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6544, "escape": 0.07563, "mature_H5_site": 498.0, "mutant": "V", "mutation": "K498V", "reference_site": "498", "sequential_site": 514.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07562, "escape": 0.1648, "mature_H5_site": 498.0, "mutant": "Y", "mutation": "K498Y", "reference_site": "498", "sequential_site": 514.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.041, "escape": -0.1502, "mature_H5_site": 499.0, "mutant": "A", "mutation": "R499A", "reference_site": "499", "sequential_site": 515.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.446, "escape": -0.3455, "mature_H5_site": 499.0, "mutant": "D", "mutation": "R499D", "reference_site": "499", "sequential_site": 515.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5095, "escape": -0.3988, "mature_H5_site": 499.0, "mutant": "E", "mutation": "R499E", "reference_site": "499", "sequential_site": 515.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3064, "escape": -0.1799, "mature_H5_site": 499.0, "mutant": "F", "mutation": "R499F", "reference_site": "499", "sequential_site": 515.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7707, "escape": -0.1238, "mature_H5_site": 499.0, "mutant": "H", "mutation": "R499H", "reference_site": "499", "sequential_site": 515.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5152, "escape": 0.004546, "mature_H5_site": 499.0, "mutant": "L", "mutation": "R499L", "reference_site": "499", "sequential_site": 515.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4061, "escape": 0.1768, "mature_H5_site": 499.0, "mutant": "N", "mutation": "R499N", "reference_site": "499", "sequential_site": 515.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3311, "escape": 0.1149, "mature_H5_site": 499.0, "mutant": "Q", "mutation": "R499Q", "reference_site": "499", "sequential_site": 515.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3597, "escape": -0.2864, "mature_H5_site": 499.0, "mutant": "S", "mutation": "R499S", "reference_site": "499", "sequential_site": 515.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.903, "escape": 0.0793, "mature_H5_site": 499.0, "mutant": "T", "mutation": "R499T", "reference_site": "499", "sequential_site": 515.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.189, "escape": -0.1269, "mature_H5_site": 499.0, "mutant": "V", "mutation": "R499V", "reference_site": "499", "sequential_site": 515.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6838, "escape": -0.0572, "mature_H5_site": 499.0, "mutant": "W", "mutation": "R499W", "reference_site": "499", "sequential_site": 515.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2148, "escape": -0.1203, "mature_H5_site": 499.0, "mutant": "Y", "mutation": "R499Y", "reference_site": "499", "sequential_site": 515.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8321, "escape": 0.04943, "mature_H5_site": -6.0, "mutant": "A", "mutation": "V5A", "reference_site": "5", "sequential_site": 11.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1513, "escape": -0.141, "mature_H5_site": -6.0, "mutant": "C", "mutation": "V5C", "reference_site": "5", "sequential_site": 11.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4356, "escape": -0.04328, "mature_H5_site": -6.0, "mutant": "F", "mutation": "V5F", "reference_site": "5", "sequential_site": 11.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5053, "escape": -0.1253, "mature_H5_site": -6.0, "mutant": "G", "mutation": "V5G", "reference_site": "5", "sequential_site": 11.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.626, "escape": 0.1063, "mature_H5_site": -6.0, "mutant": "H", "mutation": "V5H", "reference_site": "5", "sequential_site": 11.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.745, "escape": 0.1471, "mature_H5_site": -6.0, "mutant": "L", "mutation": "V5L", "reference_site": "5", "sequential_site": 11.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01567, "escape": -0.2113, "mature_H5_site": -6.0, "mutant": "M", "mutation": "V5M", "reference_site": "5", "sequential_site": 11.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": null, "escape": 0.5569, "mature_H5_site": -6.0, "mutant": "Q", "mutation": "V5Q", "reference_site": "5", "sequential_site": 11.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3184, "escape": -0.03526, "mature_H5_site": -6.0, "mutant": "T", "mutation": "V5T", "reference_site": "5", "sequential_site": 11.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4115, "escape": 0.009921, "mature_H5_site": -6.0, "mutant": "W", "mutation": "V5W", "reference_site": "5", "sequential_site": 11.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1183, "escape": -0.4486, "mature_H5_site": -6.0, "mutant": "Y", "mutation": "V5Y", "reference_site": "5", "sequential_site": 11.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05976, "escape": -0.05121, "mature_H5_site": 40.0, "mutant": "A", "mutation": "K50A", "reference_site": "50", "sequential_site": 56.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1095, "escape": -0.01984, "mature_H5_site": 40.0, "mutant": "F", "mutation": "K50F", "reference_site": "50", "sequential_site": 56.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3245, "escape": -0.1712, "mature_H5_site": 40.0, "mutant": "I", "mutation": "K50I", "reference_site": "50", "sequential_site": 56.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02824, "escape": 0.03493, "mature_H5_site": 40.0, "mutant": "L", "mutation": "K50L", "reference_site": "50", "sequential_site": 56.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1249, "escape": -0.1145, "mature_H5_site": 40.0, "mutant": "Q", "mutation": "K50Q", "reference_site": "50", "sequential_site": 56.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03866, "escape": 0.009686, "mature_H5_site": 40.0, "mutant": "R", "mutation": "K50R", "reference_site": "50", "sequential_site": 56.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4268, "escape": -0.09986, "mature_H5_site": 40.0, "mutant": "V", "mutation": "K50V", "reference_site": "50", "sequential_site": 56.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5956, "escape": 0.03696, "mature_H5_site": 40.0, "mutant": "Y", "mutation": "K50Y", "reference_site": "50", "sequential_site": 56.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1615, "escape": 0.2661, "mature_H5_site": 500.0, "mutant": "A", "mutation": "E500A", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.315, "escape": -0.02841, "mature_H5_site": 500.0, "mutant": "C", "mutation": "E500C", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01179, "escape": -0.1658, "mature_H5_site": 500.0, "mutant": "D", "mutation": "E500D", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6934, "escape": -0.007109, "mature_H5_site": 500.0, "mutant": "F", "mutation": "E500F", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09315, "escape": -0.08474, "mature_H5_site": 500.0, "mutant": "G", "mutation": "E500G", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02537, "escape": 0.6958, "mature_H5_site": 500.0, "mutant": "H", "mutation": "E500H", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9311, "escape": -0.2056, "mature_H5_site": 500.0, "mutant": "I", "mutation": "E500I", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1361, "escape": 0.1938, "mature_H5_site": 500.0, "mutant": "K", "mutation": "E500K", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.45, "escape": 0.05894, "mature_H5_site": 500.0, "mutant": "L", "mutation": "E500L", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05083, "escape": 0.0213, "mature_H5_site": 500.0, "mutant": "M", "mutation": "E500M", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.092, "escape": 0.1572, "mature_H5_site": 500.0, "mutant": "N", "mutation": "E500N", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2163, "escape": -0.1329, "mature_H5_site": 500.0, "mutant": "P", "mutation": "E500P", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5321, "escape": -0.1269, "mature_H5_site": 500.0, "mutant": "Q", "mutation": "E500Q", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8014, "escape": 0.492, "mature_H5_site": 500.0, "mutant": "R", "mutation": "E500R", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1573, "escape": 0.01213, "mature_H5_site": 500.0, "mutant": "S", "mutation": "E500S", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4283, "escape": 0.1315, "mature_H5_site": 500.0, "mutant": "T", "mutation": "E500T", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1775, "escape": 0.019, "mature_H5_site": 500.0, "mutant": "V", "mutation": "E500V", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.0, "escape": 0.4102, "mature_H5_site": 500.0, "mutant": "W", "mutation": "E500W", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4338, "escape": 0.2384, "mature_H5_site": 500.0, "mutant": "Y", "mutation": "E500Y", "reference_site": "500", "sequential_site": 516.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02073, "escape": 0.07867, "mature_H5_site": 501.0, "mutant": "A", "mutation": "E501A", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1677, "escape": 0.03191, "mature_H5_site": 501.0, "mutant": "D", "mutation": "E501D", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5825, "escape": -1.156, "mature_H5_site": 501.0, "mutant": "F", "mutation": "E501F", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04225, "escape": -0.1154, "mature_H5_site": 501.0, "mutant": "G", "mutation": "E501G", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.698, "escape": 0.1803, "mature_H5_site": 501.0, "mutant": "H", "mutation": "E501H", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.364, "escape": -0.006559, "mature_H5_site": 501.0, "mutant": "I", "mutation": "E501I", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4753, "escape": -0.4441, "mature_H5_site": 501.0, "mutant": "K", "mutation": "E501K", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00811, "escape": -0.02042, "mature_H5_site": 501.0, "mutant": "L", "mutation": "E501L", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4849, "escape": -1.371, "mature_H5_site": 501.0, "mutant": "M", "mutation": "E501M", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4322, "escape": 0.07399, "mature_H5_site": 501.0, "mutant": "N", "mutation": "E501N", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2273, "escape": -0.08451, "mature_H5_site": 501.0, "mutant": "P", "mutation": "E501P", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1893, "escape": 0.1008, "mature_H5_site": 501.0, "mutant": "Q", "mutation": "E501Q", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4944, "escape": 0.2322, "mature_H5_site": 501.0, "mutant": "S", "mutation": "E501S", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1152, "escape": -0.06045, "mature_H5_site": 501.0, "mutant": "T", "mutation": "E501T", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4811, "escape": -0.003794, "mature_H5_site": 501.0, "mutant": "V", "mutation": "E501V", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.315, "escape": 0.2344, "mature_H5_site": 501.0, "mutant": "W", "mutation": "E501W", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9951, "escape": 0.01842, "mature_H5_site": 501.0, "mutant": "Y", "mutation": "E501Y", "reference_site": "501", "sequential_site": 517.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02552, "escape": -0.01696, "mature_H5_site": 502.0, "mutant": "L", "mutation": "I502L", "reference_site": "502", "sequential_site": 518.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2473, "escape": -0.07345, "mature_H5_site": 502.0, "mutant": "V", "mutation": "I502V", "reference_site": "502", "sequential_site": 518.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4825, "escape": 0.01851, "mature_H5_site": 503.0, "mutant": "A", "mutation": "S503A", "reference_site": "503", "sequential_site": 519.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01054, "escape": 0.009785, "mature_H5_site": 503.0, "mutant": "D", "mutation": "S503D", "reference_site": "503", "sequential_site": 519.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2407, "escape": 0.1131, "mature_H5_site": 503.0, "mutant": "E", "mutation": "S503E", "reference_site": "503", "sequential_site": 519.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2629, "escape": -0.3344, "mature_H5_site": 503.0, "mutant": "F", "mutation": "S503F", "reference_site": "503", "sequential_site": 519.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05104, "escape": -0.2086, "mature_H5_site": 503.0, "mutant": "G", "mutation": "S503G", "reference_site": "503", "sequential_site": 519.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.003905, "escape": -0.08468, "mature_H5_site": 503.0, "mutant": "H", "mutation": "S503H", "reference_site": "503", "sequential_site": 519.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1962, "escape": 0.0434, "mature_H5_site": 503.0, "mutant": "I", "mutation": "S503I", "reference_site": "503", "sequential_site": 519.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.917, "escape": 0.4048, "mature_H5_site": 503.0, "mutant": "L", "mutation": "S503L", "reference_site": "503", "sequential_site": 519.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1007, "escape": 0.1607, "mature_H5_site": 503.0, "mutant": "N", "mutation": "S503N", "reference_site": "503", "sequential_site": 519.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2142, "escape": 0.3214, "mature_H5_site": 503.0, "mutant": "P", "mutation": "S503P", "reference_site": "503", "sequential_site": 519.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06417, "escape": -0.04958, "mature_H5_site": 503.0, "mutant": "Q", "mutation": "S503Q", "reference_site": "503", "sequential_site": 519.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1256, "escape": -0.1789, "mature_H5_site": 503.0, "mutant": "R", "mutation": "S503R", "reference_site": "503", "sequential_site": 519.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05039, "escape": -0.1879, "mature_H5_site": 503.0, "mutant": "V", "mutation": "S503V", "reference_site": "503", "sequential_site": 519.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01874, "escape": -0.07644, "mature_H5_site": 503.0, "mutant": "Y", "mutation": "S503Y", "reference_site": "503", "sequential_site": 519.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05732, "escape": 0.1311, "mature_H5_site": 504.0, "mutant": "A", "mutation": "G504A", "reference_site": "504", "sequential_site": 520.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3519, "escape": -0.08159, "mature_H5_site": 504.0, "mutant": "D", "mutation": "G504D", "reference_site": "504", "sequential_site": 520.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4668, "escape": 0.2098, "mature_H5_site": 504.0, "mutant": "F", "mutation": "G504F", "reference_site": "504", "sequential_site": 520.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5598, "escape": 0.1434, "mature_H5_site": 504.0, "mutant": "K", "mutation": "G504K", "reference_site": "504", "sequential_site": 520.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3764, "escape": 0.01313, "mature_H5_site": 504.0, "mutant": "M", "mutation": "G504M", "reference_site": "504", "sequential_site": 520.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3606, "escape": -0.1578, "mature_H5_site": 504.0, "mutant": "N", "mutation": "G504N", "reference_site": "504", "sequential_site": 520.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1082, "escape": -0.125, "mature_H5_site": 504.0, "mutant": "P", "mutation": "G504P", "reference_site": "504", "sequential_site": 520.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0628, "escape": -0.5046, "mature_H5_site": 504.0, "mutant": "R", "mutation": "G504R", "reference_site": "504", "sequential_site": 520.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.254, "escape": -0.07133, "mature_H5_site": 504.0, "mutant": "T", "mutation": "G504T", "reference_site": "504", "sequential_site": 520.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2858, "escape": -0.1156, "mature_H5_site": 504.0, "mutant": "V", "mutation": "G504V", "reference_site": "504", "sequential_site": 520.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6058, "escape": 0.0497, "mature_H5_site": 504.0, "mutant": "W", "mutation": "G504W", "reference_site": "504", "sequential_site": 520.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.7, "escape": 0.09811, "mature_H5_site": 504.0, "mutant": "Y", "mutation": "G504Y", "reference_site": "504", "sequential_site": 520.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03402, "escape": 0.17, "mature_H5_site": 505.0, "mutant": "A", "mutation": "V505A", "reference_site": "505", "sequential_site": 521.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.535, "escape": -0.2367, "mature_H5_site": 505.0, "mutant": "D", "mutation": "V505D", "reference_site": "505", "sequential_site": 521.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1692, "escape": 0.02593, "mature_H5_site": 505.0, "mutant": "F", "mutation": "V505F", "reference_site": "505", "sequential_site": 521.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.837, "escape": 0.1572, "mature_H5_site": 505.0, "mutant": "G", "mutation": "V505G", "reference_site": "505", "sequential_site": 521.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3118, "escape": 0.1787, "mature_H5_site": 505.0, "mutant": "I", "mutation": "V505I", "reference_site": "505", "sequential_site": 521.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.448, "escape": -0.03299, "mature_H5_site": 505.0, "mutant": "K", "mutation": "V505K", "reference_site": "505", "sequential_site": 521.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06217, "escape": 0.01888, "mature_H5_site": 505.0, "mutant": "L", "mutation": "V505L", "reference_site": "505", "sequential_site": 521.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8361, "escape": -0.2089, "mature_H5_site": 505.0, "mutant": "M", "mutation": "V505M", "reference_site": "505", "sequential_site": 521.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.893, "escape": -0.1511, "mature_H5_site": 505.0, "mutant": "N", "mutation": "V505N", "reference_site": "505", "sequential_site": 521.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.583, "escape": -0.1281, "mature_H5_site": 505.0, "mutant": "P", "mutation": "V505P", "reference_site": "505", "sequential_site": 521.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.424, "escape": -0.2694, "mature_H5_site": 505.0, "mutant": "S", "mutation": "V505S", "reference_site": "505", "sequential_site": 521.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.263, "escape": 0.0004056, "mature_H5_site": 505.0, "mutant": "T", "mutation": "V505T", "reference_site": "505", "sequential_site": 521.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.982, "escape": -0.04297, "mature_H5_site": 505.0, "mutant": "W", "mutation": "V505W", "reference_site": "505", "sequential_site": 521.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2801, "escape": 0.0003768, "mature_H5_site": 506.0, "mutant": "A", "mutation": "K506A", "reference_site": "506", "sequential_site": 522.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5555, "escape": -0.1468, "mature_H5_site": 506.0, "mutant": "D", "mutation": "K506D", "reference_site": "506", "sequential_site": 522.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.111, "escape": -0.1915, "mature_H5_site": 506.0, "mutant": "E", "mutation": "K506E", "reference_site": "506", "sequential_site": 522.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8389, "escape": -0.1807, "mature_H5_site": 506.0, "mutant": "F", "mutation": "K506F", "reference_site": "506", "sequential_site": 522.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1898, "escape": 0.2631, "mature_H5_site": 506.0, "mutant": "H", "mutation": "K506H", "reference_site": "506", "sequential_site": 522.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8564, "escape": -0.2864, "mature_H5_site": 506.0, "mutant": "I", "mutation": "K506I", "reference_site": "506", "sequential_site": 522.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06916, "escape": -0.05404, "mature_H5_site": 506.0, "mutant": "M", "mutation": "K506M", "reference_site": "506", "sequential_site": 522.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7509, "escape": 0.2262, "mature_H5_site": 506.0, "mutant": "N", "mutation": "K506N", "reference_site": "506", "sequential_site": 522.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.212, "escape": -0.04281, "mature_H5_site": 506.0, "mutant": "P", "mutation": "K506P", "reference_site": "506", "sequential_site": 522.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3191, "escape": -0.06262, "mature_H5_site": 506.0, "mutant": "Q", "mutation": "K506Q", "reference_site": "506", "sequential_site": 522.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3658, "escape": -0.3426, "mature_H5_site": 506.0, "mutant": "R", "mutation": "K506R", "reference_site": "506", "sequential_site": 522.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2971, "escape": 0.005949, "mature_H5_site": 506.0, "mutant": "T", "mutation": "K506T", "reference_site": "506", "sequential_site": 522.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04565, "escape": -0.01407, "mature_H5_site": 506.0, "mutant": "V", "mutation": "K506V", "reference_site": "506", "sequential_site": 522.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.151, "escape": -0.03003, "mature_H5_site": 506.0, "mutant": "W", "mutation": "K506W", "reference_site": "506", "sequential_site": 522.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2867, "escape": 0.05218, "mature_H5_site": 506.0, "mutant": "Y", "mutation": "K506Y", "reference_site": "506", "sequential_site": 522.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.528, "escape": 0.5442, "mature_H5_site": 507.0, "mutant": "D", "mutation": "L507D", "reference_site": "507", "sequential_site": 523.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.454, "escape": 0.1351, "mature_H5_site": 507.0, "mutant": "G", "mutation": "L507G", "reference_site": "507", "sequential_site": 523.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02697, "escape": 0.1049, "mature_H5_site": 507.0, "mutant": "I", "mutation": "L507I", "reference_site": "507", "sequential_site": 523.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.563, "escape": 0.6169, "mature_H5_site": 507.0, "mutant": "K", "mutation": "L507K", "reference_site": "507", "sequential_site": 523.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2904, "escape": 0.005655, "mature_H5_site": 507.0, "mutant": "M", "mutation": "L507M", "reference_site": "507", "sequential_site": 523.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.969, "escape": 0.1723, "mature_H5_site": 507.0, "mutant": "N", "mutation": "L507N", "reference_site": "507", "sequential_site": 523.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.713, "escape": -0.2409, "mature_H5_site": 507.0, "mutant": "P", "mutation": "L507P", "reference_site": "507", "sequential_site": 523.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.672, "escape": 0.05019, "mature_H5_site": 507.0, "mutant": "Q", "mutation": "L507Q", "reference_site": "507", "sequential_site": 523.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.826, "escape": 0.07918, "mature_H5_site": 507.0, "mutant": "R", "mutation": "L507R", "reference_site": "507", "sequential_site": 523.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.036, "escape": 0.001616, "mature_H5_site": 507.0, "mutant": "T", "mutation": "L507T", "reference_site": "507", "sequential_site": 523.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2207, "escape": -0.06042, "mature_H5_site": 507.0, "mutant": "W", "mutation": "L507W", "reference_site": "507", "sequential_site": 523.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3744, "escape": -0.08552, "mature_H5_site": 507.0, "mutant": "Y", "mutation": "L507Y", "reference_site": "507", "sequential_site": 523.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.006375, "escape": 0.1668, "mature_H5_site": 508.0, "mutant": "D", "mutation": "E508D", "reference_site": "508", "sequential_site": 524.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.057, "escape": 0.1991, "mature_H5_site": 508.0, "mutant": "G", "mutation": "E508G", "reference_site": "508", "sequential_site": 524.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.381, "escape": 0.2117, "mature_H5_site": 508.0, "mutant": "H", "mutation": "E508H", "reference_site": "508", "sequential_site": 524.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.091, "escape": -0.04179, "mature_H5_site": 508.0, "mutant": "I", "mutation": "E508I", "reference_site": "508", "sequential_site": 524.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.386, "escape": 0.04446, "mature_H5_site": 508.0, "mutant": "K", "mutation": "E508K", "reference_site": "508", "sequential_site": 524.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.464, "escape": -0.2159, "mature_H5_site": 508.0, "mutant": "M", "mutation": "E508M", "reference_site": "508", "sequential_site": 524.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3241, "escape": -0.05297, "mature_H5_site": 508.0, "mutant": "N", "mutation": "E508N", "reference_site": "508", "sequential_site": 524.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.899, "escape": 0.04335, "mature_H5_site": 508.0, "mutant": "R", "mutation": "E508R", "reference_site": "508", "sequential_site": 524.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4898, "escape": -0.1332, "mature_H5_site": 508.0, "mutant": "S", "mutation": "E508S", "reference_site": "508", "sequential_site": 524.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5888, "escape": -0.01361, "mature_H5_site": 508.0, "mutant": "T", "mutation": "E508T", "reference_site": "508", "sequential_site": 524.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4438, "escape": -0.03301, "mature_H5_site": 508.0, "mutant": "V", "mutation": "E508V", "reference_site": "508", "sequential_site": 524.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08527, "escape": -0.01045, "mature_H5_site": 508.0, "mutant": "W", "mutation": "E508W", "reference_site": "508", "sequential_site": 524.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3224, "escape": 0.2426, "mature_H5_site": 508.0, "mutant": "Y", "mutation": "E508Y", "reference_site": "508", "sequential_site": 524.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2337, "escape": 0.032, "mature_H5_site": 509.0, "mutant": "D", "mutation": "S509D", "reference_site": "509", "sequential_site": 525.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.003676, "escape": 0.0746, "mature_H5_site": 509.0, "mutant": "F", "mutation": "S509F", "reference_site": "509", "sequential_site": 525.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.165, "escape": 0.03851, "mature_H5_site": 509.0, "mutant": "G", "mutation": "S509G", "reference_site": "509", "sequential_site": 525.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4995, "escape": -0.0891, "mature_H5_site": 509.0, "mutant": "H", "mutation": "S509H", "reference_site": "509", "sequential_site": 525.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.000925, "escape": 0.1181, "mature_H5_site": 509.0, "mutant": "I", "mutation": "S509I", "reference_site": "509", "sequential_site": 525.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05769, "escape": 0.07813, "mature_H5_site": 509.0, "mutant": "M", "mutation": "S509M", "reference_site": "509", "sequential_site": 525.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.198, "escape": -0.08563, "mature_H5_site": 509.0, "mutant": "N", "mutation": "S509N", "reference_site": "509", "sequential_site": 525.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4033, "escape": -0.3289, "mature_H5_site": 509.0, "mutant": "P", "mutation": "S509P", "reference_site": "509", "sequential_site": 525.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04827, "escape": 0.04525, "mature_H5_site": 509.0, "mutant": "Q", "mutation": "S509Q", "reference_site": "509", "sequential_site": 525.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2289, "escape": 0.02137, "mature_H5_site": 509.0, "mutant": "R", "mutation": "S509R", "reference_site": "509", "sequential_site": 525.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.386, "escape": -0.3259, "mature_H5_site": 509.0, "mutant": "V", "mutation": "S509V", "reference_site": "509", "sequential_site": 525.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.001205, "escape": 0.02224, "mature_H5_site": 509.0, "mutant": "Y", "mutation": "S509Y", "reference_site": "509", "sequential_site": 525.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1445, "escape": -0.08814, "mature_H5_site": 41.0, "mutant": "F", "mutation": "L51F", "reference_site": "51", "sequential_site": 57.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2439, "escape": 0.102, "mature_H5_site": 41.0, "mutant": "I", "mutation": "L51I", "reference_site": "51", "sequential_site": 57.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04328, "escape": 0.03194, "mature_H5_site": 41.0, "mutant": "M", "mutation": "L51M", "reference_site": "51", "sequential_site": 57.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.15, "escape": -0.05725, "mature_H5_site": 510.0, "mutant": "C", "mutation": "V510C", "reference_site": "510", "sequential_site": 526.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9661, "escape": 0.01279, "mature_H5_site": 510.0, "mutant": "D", "mutation": "V510D", "reference_site": "510", "sequential_site": 526.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3661, "escape": -0.1794, "mature_H5_site": 510.0, "mutant": "E", "mutation": "V510E", "reference_site": "510", "sequential_site": 526.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6906, "escape": 0.006327, "mature_H5_site": 510.0, "mutant": "F", "mutation": "V510F", "reference_site": "510", "sequential_site": 526.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2837, "escape": 0.22, "mature_H5_site": 510.0, "mutant": "G", "mutation": "V510G", "reference_site": "510", "sequential_site": 526.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01828, "escape": 0.07029, "mature_H5_site": 510.0, "mutant": "I", "mutation": "V510I", "reference_site": "510", "sequential_site": 526.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.607, "escape": 0.21, "mature_H5_site": 510.0, "mutant": "K", "mutation": "V510K", "reference_site": "510", "sequential_site": 526.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4676, "escape": -0.001665, "mature_H5_site": 510.0, "mutant": "L", "mutation": "V510L", "reference_site": "510", "sequential_site": 526.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2118, "escape": -0.1321, "mature_H5_site": 510.0, "mutant": "M", "mutation": "V510M", "reference_site": "510", "sequential_site": 526.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04129, "escape": -0.06108, "mature_H5_site": 510.0, "mutant": "Q", "mutation": "V510Q", "reference_site": "510", "sequential_site": 526.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.656, "escape": 0.02889, "mature_H5_site": 510.0, "mutant": "R", "mutation": "V510R", "reference_site": "510", "sequential_site": 526.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.459, "escape": -0.2505, "mature_H5_site": 510.0, "mutant": "S", "mutation": "V510S", "reference_site": "510", "sequential_site": 526.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03982, "escape": 0.0942, "mature_H5_site": 510.0, "mutant": "T", "mutation": "V510T", "reference_site": "510", "sequential_site": 526.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1841, "escape": 0.00414, "mature_H5_site": 510.0, "mutant": "W", "mutation": "V510W", "reference_site": "510", "sequential_site": 526.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06809, "escape": 0.07585, "mature_H5_site": 511.0, "mutant": "A", "mutation": "G510aA", "reference_site": "510a", "sequential_site": 527.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1301, "escape": 0.08992, "mature_H5_site": 511.0, "mutant": "D", "mutation": "G510aD", "reference_site": "510a", "sequential_site": 527.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.086, "escape": 0.1144, "mature_H5_site": 511.0, "mutant": "H", "mutation": "G510aH", "reference_site": "510a", "sequential_site": 527.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3814, "escape": 0.05722, "mature_H5_site": 511.0, "mutant": "I", "mutation": "G510aI", "reference_site": "510a", "sequential_site": 527.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.003, "escape": 0.1431, "mature_H5_site": 511.0, "mutant": "K", "mutation": "G510aK", "reference_site": "510a", "sequential_site": 527.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2961, "escape": 0.1589, "mature_H5_site": 511.0, "mutant": "L", "mutation": "G510aL", "reference_site": "510a", "sequential_site": 527.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0516, "escape": 0.02946, "mature_H5_site": 511.0, "mutant": "M", "mutation": "G510aM", "reference_site": "510a", "sequential_site": 527.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09419, "escape": -0.08056, "mature_H5_site": 511.0, "mutant": "N", "mutation": "G510aN", "reference_site": "510a", "sequential_site": 527.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.172, "escape": -0.01529, "mature_H5_site": 511.0, "mutant": "P", "mutation": "G510aP", "reference_site": "510a", "sequential_site": 527.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5129, "escape": 0.1972, "mature_H5_site": 511.0, "mutant": "Q", "mutation": "G510aQ", "reference_site": "510a", "sequential_site": 527.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.353, "escape": -0.06133, "mature_H5_site": 511.0, "mutant": "R", "mutation": "G510aR", "reference_site": "510a", "sequential_site": 527.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1341, "escape": -0.07572, "mature_H5_site": 511.0, "mutant": "S", "mutation": "G510aS", "reference_site": "510a", "sequential_site": 527.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07283, "escape": -0.005756, "mature_H5_site": 511.0, "mutant": "V", "mutation": "G510aV", "reference_site": "510a", "sequential_site": 527.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3565, "escape": 0.0191, "mature_H5_site": 511.0, "mutant": "W", "mutation": "G510aW", "reference_site": "510a", "sequential_site": 527.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9057, "escape": 0.3575, "mature_H5_site": 512.0, "mutant": "C", "mutation": "T511C", "reference_site": "511", "sequential_site": 528.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.437, "escape": -0.2128, "mature_H5_site": 512.0, "mutant": "D", "mutation": "T511D", "reference_site": "511", "sequential_site": 528.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.442, "escape": -0.4047, "mature_H5_site": 512.0, "mutant": "E", "mutation": "T511E", "reference_site": "511", "sequential_site": 528.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01387, "escape": 0.06746, "mature_H5_site": 512.0, "mutant": "F", "mutation": "T511F", "reference_site": "511", "sequential_site": 528.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.508, "escape": 0.2245, "mature_H5_site": 512.0, "mutant": "G", "mutation": "T511G", "reference_site": "511", "sequential_site": 528.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.369, "escape": 0.2469, "mature_H5_site": 512.0, "mutant": "H", "mutation": "T511H", "reference_site": "511", "sequential_site": 528.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06475, "escape": 0.3989, "mature_H5_site": 512.0, "mutant": "I", "mutation": "T511I", "reference_site": "511", "sequential_site": 528.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.461, "escape": 0.002795, "mature_H5_site": 512.0, "mutant": "K", "mutation": "T511K", "reference_site": "511", "sequential_site": 528.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9485, "escape": 0.1119, "mature_H5_site": 512.0, "mutant": "N", "mutation": "T511N", "reference_site": "511", "sequential_site": 528.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1322, "escape": -0.2351, "mature_H5_site": 512.0, "mutant": "P", "mutation": "T511P", "reference_site": "511", "sequential_site": 528.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.465, "escape": 0.07971, "mature_H5_site": 512.0, "mutant": "R", "mutation": "T511R", "reference_site": "511", "sequential_site": 528.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01817, "escape": 0.05468, "mature_H5_site": 512.0, "mutant": "S", "mutation": "T511S", "reference_site": "511", "sequential_site": 528.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06309, "escape": -0.02946, "mature_H5_site": 512.0, "mutant": "V", "mutation": "T511V", "reference_site": "511", "sequential_site": 528.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07134, "escape": -0.0471, "mature_H5_site": 512.0, "mutant": "W", "mutation": "T511W", "reference_site": "511", "sequential_site": 528.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09866, "escape": 0.07069, "mature_H5_site": 512.0, "mutant": "Y", "mutation": "T511Y", "reference_site": "511", "sequential_site": 528.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.566, "escape": 0.2211, "mature_H5_site": 513.0, "mutant": "C", "mutation": "Y512C", "reference_site": "512", "sequential_site": 529.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.404, "escape": -0.3826, "mature_H5_site": 513.0, "mutant": "E", "mutation": "Y512E", "reference_site": "512", "sequential_site": 529.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01194, "escape": 0.222, "mature_H5_site": 513.0, "mutant": "F", "mutation": "Y512F", "reference_site": "512", "sequential_site": 529.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.068, "escape": 0.2798, "mature_H5_site": 513.0, "mutant": "G", "mutation": "Y512G", "reference_site": "512", "sequential_site": 529.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.412, "escape": -0.2273, "mature_H5_site": 513.0, "mutant": "H", "mutation": "Y512H", "reference_site": "512", "sequential_site": 529.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5964, "escape": -0.2243, "mature_H5_site": 513.0, "mutant": "I", "mutation": "Y512I", "reference_site": "512", "sequential_site": 529.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00766, "escape": -0.4639, "mature_H5_site": 513.0, "mutant": "L", "mutation": "Y512L", "reference_site": "512", "sequential_site": 529.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6298, "escape": -0.1975, "mature_H5_site": 513.0, "mutant": "M", "mutation": "Y512M", "reference_site": "512", "sequential_site": 529.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7171, "escape": 0.1329, "mature_H5_site": 513.0, "mutant": "Q", "mutation": "Y512Q", "reference_site": "512", "sequential_site": 529.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7799, "escape": -0.1755, "mature_H5_site": 513.0, "mutant": "V", "mutation": "Y512V", "reference_site": "512", "sequential_site": 529.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06133, "escape": -0.03312, "mature_H5_site": 513.0, "mutant": "W", "mutation": "Y512W", "reference_site": "512", "sequential_site": 529.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6407, "escape": -0.1323, "mature_H5_site": 514.0, "mutant": "A", "mutation": "Q513A", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.848, "escape": -0.06164, "mature_H5_site": 514.0, "mutant": "C", "mutation": "Q513C", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2224, "escape": 0.006131, "mature_H5_site": 514.0, "mutant": "E", "mutation": "Q513E", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2705, "escape": 0.0294, "mature_H5_site": 514.0, "mutant": "F", "mutation": "Q513F", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4027, "escape": 0.1229, "mature_H5_site": 514.0, "mutant": "H", "mutation": "Q513H", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.577, "escape": 0.04441, "mature_H5_site": 514.0, "mutant": "K", "mutation": "Q513K", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.03, "escape": 0.04283, "mature_H5_site": 514.0, "mutant": "L", "mutation": "Q513L", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02108, "escape": 0.04118, "mature_H5_site": 514.0, "mutant": "M", "mutation": "Q513M", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7373, "escape": -0.03813, "mature_H5_site": 514.0, "mutant": "N", "mutation": "Q513N", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.946, "escape": 0.004557, "mature_H5_site": 514.0, "mutant": "P", "mutation": "Q513P", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.167, "escape": 0.05704, "mature_H5_site": 514.0, "mutant": "R", "mutation": "Q513R", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.828, "escape": -0.1854, "mature_H5_site": 514.0, "mutant": "S", "mutation": "Q513S", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5694, "escape": -0.07909, "mature_H5_site": 514.0, "mutant": "T", "mutation": "Q513T", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8354, "escape": 0.166, "mature_H5_site": 514.0, "mutant": "V", "mutation": "Q513V", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2589, "escape": 0.06478, "mature_H5_site": 514.0, "mutant": "W", "mutation": "Q513W", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.395, "escape": 0.01916, "mature_H5_site": 514.0, "mutant": "Y", "mutation": "Q513Y", "reference_site": "513", "sequential_site": 530.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5839, "escape": 0.06795, "mature_H5_site": 515.0, "mutant": "A", "mutation": "I514A", "reference_site": "514", "sequential_site": 531.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4273, "escape": 0.09988, "mature_H5_site": 515.0, "mutant": "F", "mutation": "I514F", "reference_site": "514", "sequential_site": 531.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.463, "escape": -0.08176, "mature_H5_site": 515.0, "mutant": "G", "mutation": "I514G", "reference_site": "514", "sequential_site": 531.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6142, "escape": 0.3737, "mature_H5_site": 515.0, "mutant": "L", "mutation": "I514L", "reference_site": "514", "sequential_site": 531.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9195, "escape": 0.08319, "mature_H5_site": 515.0, "mutant": "M", "mutation": "I514M", "reference_site": "514", "sequential_site": 531.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3844, "escape": 0.07242, "mature_H5_site": 515.0, "mutant": "Y", "mutation": "I514Y", "reference_site": "514", "sequential_site": 531.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.748, "escape": -0.3427, "mature_H5_site": 516.0, "mutant": "F", "mutation": "L515F", "reference_site": "515", "sequential_site": 532.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.565, "escape": -0.2921, "mature_H5_site": 516.0, "mutant": "I", "mutation": "L515I", "reference_site": "515", "sequential_site": 532.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01683, "escape": -0.03411, "mature_H5_site": 516.0, "mutant": "M", "mutation": "L515M", "reference_site": "515", "sequential_site": 532.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2904, "escape": 0.03847, "mature_H5_site": 517.0, "mutant": "N", "mutation": "S516N", "reference_site": "516", "sequential_site": 533.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.867, "escape": -0.3079, "mature_H5_site": 518.0, "mutant": "F", "mutation": "I517F", "reference_site": "517", "sequential_site": 534.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.327, "escape": -0.07128, "mature_H5_site": 518.0, "mutant": "L", "mutation": "I517L", "reference_site": "517", "sequential_site": 534.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.228, "escape": -0.01173, "mature_H5_site": 518.0, "mutant": "M", "mutation": "I517M", "reference_site": "517", "sequential_site": 534.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3729, "escape": -0.06064, "mature_H5_site": 518.0, "mutant": "V", "mutation": "I517V", "reference_site": "517", "sequential_site": 534.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4182, "escape": -0.09921, "mature_H5_site": 518.0, "mutant": "W", "mutation": "I517W", "reference_site": "517", "sequential_site": 534.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.194, "escape": 0.04896, "mature_H5_site": 518.0, "mutant": "Y", "mutation": "I517Y", "reference_site": "517", "sequential_site": 534.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6794, "escape": 0.05005, "mature_H5_site": 520.0, "mutant": "G", "mutation": "S519G", "reference_site": "519", "sequential_site": 536.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.862, "escape": -0.2211, "mature_H5_site": 520.0, "mutant": "N", "mutation": "S519N", "reference_site": "519", "sequential_site": 536.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3999, "escape": 0.04755, "mature_H5_site": 521.0, "mutant": "A", "mutation": "T520A", "reference_site": "520", "sequential_site": 537.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.003055, "escape": -0.1045, "mature_H5_site": 521.0, "mutant": "C", "mutation": "T520C", "reference_site": "520", "sequential_site": 537.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.89, "escape": -0.1705, "mature_H5_site": 521.0, "mutant": "M", "mutation": "T520M", "reference_site": "520", "sequential_site": 537.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.913, "escape": 0.1052, "mature_H5_site": 521.0, "mutant": "S", "mutation": "T520S", "reference_site": "520", "sequential_site": 537.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7542, "escape": 0.07504, "mature_H5_site": 521.0, "mutant": "V", "mutation": "T520V", "reference_site": "520", "sequential_site": 537.0, "wildtype": "T"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7254, "escape": -0.01763, "mature_H5_site": 522.0, "mutant": "G", "mutation": "A521G", "reference_site": "521", "sequential_site": 538.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.359, "escape": -0.315, "mature_H5_site": 522.0, "mutant": "S", "mutation": "A521S", "reference_site": "521", "sequential_site": 538.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.04, "escape": -0.1427, "mature_H5_site": 522.0, "mutant": "T", "mutation": "A521T", "reference_site": "521", "sequential_site": 538.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.453, "escape": -0.1043, "mature_H5_site": 523.0, "mutant": "C", "mutation": "A522C", "reference_site": "522", "sequential_site": 539.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.22, "escape": -0.1596, "mature_H5_site": 523.0, "mutant": "M", "mutation": "A522M", "reference_site": "522", "sequential_site": 539.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.862, "escape": 0.4269, "mature_H5_site": 523.0, "mutant": "S", "mutation": "A522S", "reference_site": "522", "sequential_site": 539.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.805, "escape": -0.1787, "mature_H5_site": 523.0, "mutant": "T", "mutation": "A522T", "reference_site": "522", "sequential_site": 539.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.237, "escape": -0.1255, "mature_H5_site": 523.0, "mutant": "V", "mutation": "A522V", "reference_site": "522", "sequential_site": 539.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1254, "escape": 0.2232, "mature_H5_site": 524.0, "mutant": "A", "mutation": "S523A", "reference_site": "523", "sequential_site": 540.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.704, "escape": 0.1103, "mature_H5_site": 524.0, "mutant": "G", "mutation": "S523G", "reference_site": "523", "sequential_site": 540.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4592, "escape": 0.03948, "mature_H5_site": 527.0, "mutant": "C", "mutation": "A526C", "reference_site": "526", "sequential_site": 543.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5366, "escape": -0.3246, "mature_H5_site": 527.0, "mutant": "G", "mutation": "A526G", "reference_site": "526", "sequential_site": 543.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8662, "escape": -0.1734, "mature_H5_site": 527.0, "mutant": "I", "mutation": "A526I", "reference_site": "526", "sequential_site": 543.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.476, "escape": -0.0007279, "mature_H5_site": 527.0, "mutant": "N", "mutation": "A526N", "reference_site": "526", "sequential_site": 543.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2572, "escape": 0.003858, "mature_H5_site": 527.0, "mutant": "S", "mutation": "A526S", "reference_site": "526", "sequential_site": 543.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1571, "escape": -0.08218, "mature_H5_site": 527.0, "mutant": "T", "mutation": "A526T", "reference_site": "526", "sequential_site": 543.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6622, "escape": -0.2421, "mature_H5_site": 527.0, "mutant": "V", "mutation": "A526V", "reference_site": "526", "sequential_site": 543.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.034, "escape": -0.164, "mature_H5_site": 528.0, "mutant": "C", "mutation": "L527C", "reference_site": "527", "sequential_site": 544.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.603, "escape": 0.4221, "mature_H5_site": 528.0, "mutant": "M", "mutation": "L527M", "reference_site": "527", "sequential_site": 544.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02856, "escape": 0.08934, "mature_H5_site": 529.0, "mutant": "C", "mutation": "A528C", "reference_site": "528", "sequential_site": 545.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.349, "escape": 0.06955, "mature_H5_site": 529.0, "mutant": "F", "mutation": "A528F", "reference_site": "528", "sequential_site": 545.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.384, "escape": -0.005795, "mature_H5_site": 529.0, "mutant": "G", "mutation": "A528G", "reference_site": "528", "sequential_site": 545.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.389, "escape": -0.2425, "mature_H5_site": 529.0, "mutant": "I", "mutation": "A528I", "reference_site": "528", "sequential_site": 545.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06288, "escape": -0.1252, "mature_H5_site": 529.0, "mutant": "S", "mutation": "A528S", "reference_site": "528", "sequential_site": 545.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05315, "escape": 0.3133, "mature_H5_site": 529.0, "mutant": "T", "mutation": "A528T", "reference_site": "528", "sequential_site": 545.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.339, "escape": 0.191, "mature_H5_site": 529.0, "mutant": "V", "mutation": "A528V", "reference_site": "528", "sequential_site": 545.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.193, "escape": 0.05357, "mature_H5_site": 530.0, "mutant": "L", "mutation": "I529L", "reference_site": "529", "sequential_site": 546.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5203, "escape": -0.02946, "mature_H5_site": 530.0, "mutant": "S", "mutation": "I529S", "reference_site": "529", "sequential_site": 546.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09735, "escape": 0.1587, "mature_H5_site": 530.0, "mutant": "V", "mutation": "I529V", "reference_site": "529", "sequential_site": 546.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6709, "escape": 0.2836, "mature_H5_site": 530.0, "mutant": "Y", "mutation": "I529Y", "reference_site": "529", "sequential_site": 546.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2831, "escape": 0.1224, "mature_H5_site": 43.0, "mutant": "A", "mutation": "D53A", "reference_site": "53", "sequential_site": 59.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06545, "escape": -0.1077, "mature_H5_site": 43.0, "mutant": "C", "mutation": "D53C", "reference_site": "53", "sequential_site": 59.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7098, "escape": 0.1296, "mature_H5_site": 43.0, "mutant": "E", "mutation": "D53E", "reference_site": "53", "sequential_site": 59.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1916, "escape": -0.0329, "mature_H5_site": 43.0, "mutant": "H", "mutation": "D53H", "reference_site": "53", "sequential_site": 59.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0379, "escape": -0.07273, "mature_H5_site": 43.0, "mutant": "M", "mutation": "D53M", "reference_site": "53", "sequential_site": 59.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4213, "escape": -0.008812, "mature_H5_site": 43.0, "mutant": "N", "mutation": "D53N", "reference_site": "53", "sequential_site": 59.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7636, "escape": -0.4474, "mature_H5_site": 43.0, "mutant": "R", "mutation": "D53R", "reference_site": "53", "sequential_site": 59.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1046, "escape": 0.01935, "mature_H5_site": 43.0, "mutant": "S", "mutation": "D53S", "reference_site": "53", "sequential_site": 59.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.304, "escape": -0.05087, "mature_H5_site": 531.0, "mutant": "C", "mutation": "M530C", "reference_site": "530", "sequential_site": 547.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.628, "escape": -0.04951, "mature_H5_site": 531.0, "mutant": "D", "mutation": "M530D", "reference_site": "530", "sequential_site": 547.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.649, "escape": -0.2085, "mature_H5_site": 531.0, "mutant": "G", "mutation": "M530G", "reference_site": "530", "sequential_site": 547.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07698, "escape": 0.01757, "mature_H5_site": 531.0, "mutant": "I", "mutation": "M530I", "reference_site": "530", "sequential_site": 547.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.587, "escape": 0.2123, "mature_H5_site": 531.0, "mutant": "N", "mutation": "M530N", "reference_site": "530", "sequential_site": 547.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.716, "escape": 0.109, "mature_H5_site": 531.0, "mutant": "P", "mutation": "M530P", "reference_site": "530", "sequential_site": 547.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8279, "escape": -0.2104, "mature_H5_site": 531.0, "mutant": "Q", "mutation": "M530Q", "reference_site": "530", "sequential_site": 547.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.057, "escape": -0.3833, "mature_H5_site": 531.0, "mutant": "S", "mutation": "M530S", "reference_site": "530", "sequential_site": 547.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4919, "escape": 0.2917, "mature_H5_site": 531.0, "mutant": "T", "mutation": "M530T", "reference_site": "530", "sequential_site": 547.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06889, "escape": 0.1456, "mature_H5_site": 531.0, "mutant": "V", "mutation": "M530V", "reference_site": "530", "sequential_site": 547.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.478, "escape": 0.3401, "mature_H5_site": 531.0, "mutant": "Y", "mutation": "M530Y", "reference_site": "530", "sequential_site": 547.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06842, "escape": 0.3506, "mature_H5_site": 532.0, "mutant": "C", "mutation": "M531C", "reference_site": "531", "sequential_site": 548.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04019, "escape": 0.08074, "mature_H5_site": 532.0, "mutant": "F", "mutation": "M531F", "reference_site": "531", "sequential_site": 548.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1551, "escape": -0.2174, "mature_H5_site": 532.0, "mutant": "G", "mutation": "M531G", "reference_site": "531", "sequential_site": 548.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02984, "escape": -0.0418, "mature_H5_site": 532.0, "mutant": "I", "mutation": "M531I", "reference_site": "531", "sequential_site": 548.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.288, "escape": 0.058, "mature_H5_site": 532.0, "mutant": "S", "mutation": "M531S", "reference_site": "531", "sequential_site": 548.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6916, "escape": -0.1269, "mature_H5_site": 532.0, "mutant": "T", "mutation": "M531T", "reference_site": "531", "sequential_site": 548.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1233, "escape": 0.3029, "mature_H5_site": 532.0, "mutant": "V", "mutation": "M531V", "reference_site": "531", "sequential_site": 548.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05344, "escape": -0.05719, "mature_H5_site": 532.0, "mutant": "W", "mutation": "M531W", "reference_site": "531", "sequential_site": 548.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6583, "escape": -0.2596, "mature_H5_site": 533.0, "mutant": "C", "mutation": "A532C", "reference_site": "532", "sequential_site": 549.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.118, "escape": -0.01279, "mature_H5_site": 533.0, "mutant": "F", "mutation": "A532F", "reference_site": "532", "sequential_site": 549.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01457, "escape": 0.1876, "mature_H5_site": 533.0, "mutant": "G", "mutation": "A532G", "reference_site": "532", "sequential_site": 549.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.045, "escape": 0.002641, "mature_H5_site": 533.0, "mutant": "I", "mutation": "A532I", "reference_site": "532", "sequential_site": 549.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6654, "escape": -0.1121, "mature_H5_site": 533.0, "mutant": "T", "mutation": "A532T", "reference_site": "532", "sequential_site": 549.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.139, "escape": 0.1451, "mature_H5_site": 533.0, "mutant": "V", "mutation": "A532V", "reference_site": "532", "sequential_site": 549.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.568, "escape": -0.4167, "mature_H5_site": 533.0, "mutant": "W", "mutation": "A532W", "reference_site": "532", "sequential_site": 549.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.934, "escape": -0.4465, "mature_H5_site": 533.0, "mutant": "Y", "mutation": "A532Y", "reference_site": "532", "sequential_site": 549.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5002, "escape": -0.05206, "mature_H5_site": 534.0, "mutant": "S", "mutation": "G533S", "reference_site": "533", "sequential_site": 550.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3951, "escape": -0.05615, "mature_H5_site": 537.0, "mutant": "M", "mutation": "L536M", "reference_site": "536", "sequential_site": 553.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.769, "escape": 0.02366, "mature_H5_site": 538.0, "mutant": "C", "mutation": "W537C", "reference_site": "537", "sequential_site": 554.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.529, "escape": -0.08818, "mature_H5_site": 538.0, "mutant": "H", "mutation": "W537H", "reference_site": "537", "sequential_site": 554.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.967, "escape": -0.3311, "mature_H5_site": 538.0, "mutant": "K", "mutation": "W537K", "reference_site": "537", "sequential_site": 554.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.393, "escape": -0.02933, "mature_H5_site": 538.0, "mutant": "L", "mutation": "W537L", "reference_site": "537", "sequential_site": 554.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.71, "escape": 0.0598, "mature_H5_site": 538.0, "mutant": "V", "mutation": "W537V", "reference_site": "537", "sequential_site": 554.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.573, "escape": -0.2311, "mature_H5_site": 538.0, "mutant": "Y", "mutation": "W537Y", "reference_site": "537", "sequential_site": 554.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5521, "escape": 0.278, "mature_H5_site": 539.0, "mutant": "A", "mutation": "M538A", "reference_site": "538", "sequential_site": 555.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.755, "escape": -0.3292, "mature_H5_site": 539.0, "mutant": "C", "mutation": "M538C", "reference_site": "538", "sequential_site": 555.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.467, "escape": 0.1465, "mature_H5_site": 539.0, "mutant": "I", "mutation": "M538I", "reference_site": "538", "sequential_site": 555.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.311, "escape": 0.1251, "mature_H5_site": 539.0, "mutant": "K", "mutation": "M538K", "reference_site": "538", "sequential_site": 555.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.338, "escape": -0.3688, "mature_H5_site": 539.0, "mutant": "N", "mutation": "M538N", "reference_site": "538", "sequential_site": 555.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5393, "escape": 0.2887, "mature_H5_site": 539.0, "mutant": "S", "mutation": "M538S", "reference_site": "538", "sequential_site": 555.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.533, "escape": 0.2089, "mature_H5_site": 539.0, "mutant": "T", "mutation": "M538T", "reference_site": "538", "sequential_site": 555.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.782, "escape": -0.2899, "mature_H5_site": 539.0, "mutant": "V", "mutation": "M538V", "reference_site": "538", "sequential_site": 555.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.257, "escape": -0.4526, "mature_H5_site": 539.0, "mutant": "W", "mutation": "M538W", "reference_site": "538", "sequential_site": 555.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.696, "escape": -0.08549, "mature_H5_site": 540.0, "mutant": "F", "mutation": "C539F", "reference_site": "539", "sequential_site": 556.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9479, "escape": 0.01199, "mature_H5_site": 540.0, "mutant": "M", "mutation": "C539M", "reference_site": "539", "sequential_site": 556.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06702, "escape": 0.05047, "mature_H5_site": 44.0, "mutant": "I", "mutation": "L54I", "reference_site": "54", "sequential_site": 60.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04107, "escape": -0.3694, "mature_H5_site": 44.0, "mutant": "M", "mutation": "L54M", "reference_site": "54", "sequential_site": 60.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2463, "escape": 0.1011, "mature_H5_site": 44.0, "mutant": "V", "mutation": "L54V", "reference_site": "54", "sequential_site": 60.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.729, "escape": -0.1374, "mature_H5_site": 542.0, "mutant": "K", "mutation": "N541K", "reference_site": "541", "sequential_site": 558.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.421, "escape": 1.054, "mature_H5_site": 543.0, "mutant": "D", "mutation": "G542D", "reference_site": "542", "sequential_site": 559.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.265, "escape": -0.3734, "mature_H5_site": 544.0, "mutant": "C", "mutation": "S543C", "reference_site": "543", "sequential_site": 560.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.64, "escape": 0.03715, "mature_H5_site": 544.0, "mutant": "F", "mutation": "S543F", "reference_site": "543", "sequential_site": 560.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04634, "escape": -0.2102, "mature_H5_site": 544.0, "mutant": "L", "mutation": "S543L", "reference_site": "543", "sequential_site": 560.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.792, "escape": -0.05966, "mature_H5_site": 544.0, "mutant": "M", "mutation": "S543M", "reference_site": "543", "sequential_site": 560.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.06, "escape": -0.1773, "mature_H5_site": 544.0, "mutant": "T", "mutation": "S543T", "reference_site": "543", "sequential_site": 560.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4506, "escape": -0.04475, "mature_H5_site": 544.0, "mutant": "W", "mutation": "S543W", "reference_site": "543", "sequential_site": 560.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.8, "escape": -0.06164, "mature_H5_site": 545.0, "mutant": "G", "mutation": "L544G", "reference_site": "544", "sequential_site": 561.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.076, "escape": -0.2075, "mature_H5_site": 545.0, "mutant": "I", "mutation": "L544I", "reference_site": "544", "sequential_site": 561.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.999, "escape": -0.0369, "mature_H5_site": 545.0, "mutant": "K", "mutation": "L544K", "reference_site": "544", "sequential_site": 561.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5561, "escape": 0.02873, "mature_H5_site": 545.0, "mutant": "M", "mutation": "L544M", "reference_site": "544", "sequential_site": 561.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.931, "escape": -0.1401, "mature_H5_site": 545.0, "mutant": "P", "mutation": "L544P", "reference_site": "544", "sequential_site": 561.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.239, "escape": -0.1211, "mature_H5_site": 545.0, "mutant": "Q", "mutation": "L544Q", "reference_site": "544", "sequential_site": 561.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.448, "escape": -0.3677, "mature_H5_site": 545.0, "mutant": "R", "mutation": "L544R", "reference_site": "544", "sequential_site": 561.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.782, "escape": -0.2803, "mature_H5_site": 545.0, "mutant": "S", "mutation": "L544S", "reference_site": "544", "sequential_site": 561.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.176, "escape": 0.136, "mature_H5_site": 545.0, "mutant": "T", "mutation": "L544T", "reference_site": "544", "sequential_site": 561.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.899, "escape": 0.1735, "mature_H5_site": 546.0, "mutant": "C", "mutation": "Q545C", "reference_site": "545", "sequential_site": 562.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.359, "escape": 0.03204, "mature_H5_site": 546.0, "mutant": "E", "mutation": "Q545E", "reference_site": "545", "sequential_site": 562.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.717, "escape": 0.1759, "mature_H5_site": 546.0, "mutant": "F", "mutation": "Q545F", "reference_site": "545", "sequential_site": 562.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.277, "escape": -0.0971, "mature_H5_site": 546.0, "mutant": "G", "mutation": "Q545G", "reference_site": "545", "sequential_site": 562.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.394, "escape": -0.336, "mature_H5_site": 546.0, "mutant": "H", "mutation": "Q545H", "reference_site": "545", "sequential_site": 562.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.487, "escape": -0.2514, "mature_H5_site": 546.0, "mutant": "N", "mutation": "Q545N", "reference_site": "545", "sequential_site": 562.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.271, "escape": -0.1349, "mature_H5_site": 546.0, "mutant": "R", "mutation": "Q545R", "reference_site": "545", "sequential_site": 562.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2907, "escape": -0.4333, "mature_H5_site": 546.0, "mutant": "T", "mutation": "Q545T", "reference_site": "545", "sequential_site": 562.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.499, "escape": -0.3509, "mature_H5_site": 546.0, "mutant": "W", "mutation": "Q545W", "reference_site": "545", "sequential_site": 562.0, "wildtype": "Q"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.175, "escape": -0.2174, "mature_H5_site": 547.0, "mutant": "G", "mutation": "C546G", "reference_site": "546", "sequential_site": 563.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.716, "escape": -0.4214, "mature_H5_site": 547.0, "mutant": "H", "mutation": "C546H", "reference_site": "546", "sequential_site": 563.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.731, "escape": -0.148, "mature_H5_site": 547.0, "mutant": "I", "mutation": "C546I", "reference_site": "546", "sequential_site": 563.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06454, "escape": -0.3836, "mature_H5_site": 547.0, "mutant": "L", "mutation": "C546L", "reference_site": "546", "sequential_site": 563.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5443, "escape": -0.08891, "mature_H5_site": 547.0, "mutant": "M", "mutation": "C546M", "reference_site": "546", "sequential_site": 563.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.825, "escape": -0.316, "mature_H5_site": 547.0, "mutant": "P", "mutation": "C546P", "reference_site": "546", "sequential_site": 563.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.482, "escape": -0.225, "mature_H5_site": 547.0, "mutant": "R", "mutation": "C546R", "reference_site": "546", "sequential_site": 563.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.131, "escape": -0.2073, "mature_H5_site": 547.0, "mutant": "T", "mutation": "C546T", "reference_site": "546", "sequential_site": 563.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.469, "escape": -0.1925, "mature_H5_site": 547.0, "mutant": "Y", "mutation": "C546Y", "reference_site": "546", "sequential_site": 563.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.336, "escape": 0.1712, "mature_H5_site": 548.0, "mutant": "D", "mutation": "R547D", "reference_site": "547", "sequential_site": 564.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.854, "escape": -0.2468, "mature_H5_site": 548.0, "mutant": "I", "mutation": "R547I", "reference_site": "547", "sequential_site": 564.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4794, "escape": 0.1391, "mature_H5_site": 548.0, "mutant": "K", "mutation": "R547K", "reference_site": "547", "sequential_site": 564.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7174, "escape": -0.5247, "mature_H5_site": 548.0, "mutant": "V", "mutation": "R547V", "reference_site": "547", "sequential_site": 564.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.278, "escape": -0.115, "mature_H5_site": 548.0, "mutant": "W", "mutation": "R547W", "reference_site": "547", "sequential_site": 564.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.143, "escape": 0.05657, "mature_H5_site": 549.0, "mutant": "F", "mutation": "I548F", "reference_site": "548", "sequential_site": 565.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.406, "escape": -0.2151, "mature_H5_site": 549.0, "mutant": "H", "mutation": "I548H", "reference_site": "548", "sequential_site": 565.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.085, "escape": 0.09595, "mature_H5_site": 549.0, "mutant": "L", "mutation": "I548L", "reference_site": "548", "sequential_site": 565.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.614, "escape": 0.09211, "mature_H5_site": 549.0, "mutant": "M", "mutation": "I548M", "reference_site": "548", "sequential_site": 565.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.458, "escape": -0.2214, "mature_H5_site": 549.0, "mutant": "S", "mutation": "I548S", "reference_site": "548", "sequential_site": 565.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.991, "escape": -0.2438, "mature_H5_site": 549.0, "mutant": "T", "mutation": "I548T", "reference_site": "548", "sequential_site": 565.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.376, "escape": 0.1101, "mature_H5_site": 549.0, "mutant": "V", "mutation": "I548V", "reference_site": "548", "sequential_site": 565.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.622, "escape": -0.3387, "mature_H5_site": 549.0, "mutant": "W", "mutation": "I548W", "reference_site": "548", "sequential_site": 565.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.409, "escape": -0.1349, "mature_H5_site": 550.0, "mutant": "E", "mutation": "C549E", "reference_site": "549", "sequential_site": 566.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.553, "escape": -0.01425, "mature_H5_site": 550.0, "mutant": "I", "mutation": "C549I", "reference_site": "549", "sequential_site": 566.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.61, "escape": 0.06162, "mature_H5_site": 550.0, "mutant": "K", "mutation": "C549K", "reference_site": "549", "sequential_site": 566.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.514, "escape": -0.1399, "mature_H5_site": 550.0, "mutant": "N", "mutation": "C549N", "reference_site": "549", "sequential_site": 566.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.96, "escape": -0.1662, "mature_H5_site": 550.0, "mutant": "Y", "mutation": "C549Y", "reference_site": "549", "sequential_site": 566.0, "wildtype": "C"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02412, "escape": -0.1277, "mature_H5_site": 45.0, "mutant": "A", "mutation": "N54aA", "reference_site": "54a", "sequential_site": 61.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1681, "escape": -0.082, "mature_H5_site": 45.0, "mutant": "D", "mutation": "N54aD", "reference_site": "54a", "sequential_site": 61.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02728, "escape": -0.01858, "mature_H5_site": 45.0, "mutant": "G", "mutation": "N54aG", "reference_site": "54a", "sequential_site": 61.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5526, "escape": 0.18, "mature_H5_site": 45.0, "mutant": "I", "mutation": "N54aI", "reference_site": "54a", "sequential_site": 61.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1417, "escape": 0.05258, "mature_H5_site": 45.0, "mutant": "K", "mutation": "N54aK", "reference_site": "54a", "sequential_site": 61.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2206, "escape": 0.9391, "mature_H5_site": 45.0, "mutant": "L", "mutation": "N54aL", "reference_site": "54a", "sequential_site": 61.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4132, "escape": 0.1511, "mature_H5_site": 45.0, "mutant": "M", "mutation": "N54aM", "reference_site": "54a", "sequential_site": 61.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06754, "escape": 0.1125, "mature_H5_site": 45.0, "mutant": "Q", "mutation": "N54aQ", "reference_site": "54a", "sequential_site": 61.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4735, "escape": 0.06285, "mature_H5_site": 45.0, "mutant": "T", "mutation": "N54aT", "reference_site": "54a", "sequential_site": 61.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.472, "escape": 0.01069, "mature_H5_site": 45.0, "mutant": "W", "mutation": "N54aW", "reference_site": "54a", "sequential_site": 61.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03427, "escape": -0.09421, "mature_H5_site": 46.0, "mutant": "D", "mutation": "G55D", "reference_site": "55", "sequential_site": 62.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4624, "escape": -0.1795, "mature_H5_site": 46.0, "mutant": "E", "mutation": "G55E", "reference_site": "55", "sequential_site": 62.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03283, "escape": 0.1047, "mature_H5_site": 46.0, "mutant": "F", "mutation": "G55F", "reference_site": "55", "sequential_site": 62.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3432, "escape": 0.003226, "mature_H5_site": 46.0, "mutant": "H", "mutation": "G55H", "reference_site": "55", "sequential_site": 62.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8, "escape": -0.213, "mature_H5_site": 46.0, "mutant": "L", "mutation": "G55L", "reference_site": "55", "sequential_site": 62.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07944, "escape": 0.03276, "mature_H5_site": 46.0, "mutant": "M", "mutation": "G55M", "reference_site": "55", "sequential_site": 62.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04183, "escape": -0.1818, "mature_H5_site": 46.0, "mutant": "R", "mutation": "G55R", "reference_site": "55", "sequential_site": 62.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6783, "escape": -0.1033, "mature_H5_site": 46.0, "mutant": "T", "mutation": "G55T", "reference_site": "55", "sequential_site": 62.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1528, "escape": -8.474e-05, "mature_H5_site": 46.0, "mutant": "W", "mutation": "G55W", "reference_site": "55", "sequential_site": 62.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.234, "escape": -0.204, "mature_H5_site": 46.0, "mutant": "Y", "mutation": "G55Y", "reference_site": "55", "sequential_site": 62.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.159, "escape": -0.2383, "mature_H5_site": 551.0, "mutant": "A", "mutation": "I550A", "reference_site": "550", "sequential_site": 567.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.053, "escape": 0.05787, "mature_H5_site": 551.0, "mutant": "C", "mutation": "I550C", "reference_site": "550", "sequential_site": 567.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.861, "escape": -0.1773, "mature_H5_site": 551.0, "mutant": "E", "mutation": "I550E", "reference_site": "550", "sequential_site": 567.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.117, "escape": -0.6117, "mature_H5_site": 551.0, "mutant": "G", "mutation": "I550G", "reference_site": "550", "sequential_site": 567.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.091, "escape": -0.3864, "mature_H5_site": 551.0, "mutant": "K", "mutation": "I550K", "reference_site": "550", "sequential_site": 567.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2315, "escape": -0.5554, "mature_H5_site": 551.0, "mutant": "L", "mutation": "I550L", "reference_site": "550", "sequential_site": 567.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.671, "escape": -0.2617, "mature_H5_site": 551.0, "mutant": "Q", "mutation": "I550Q", "reference_site": "550", "sequential_site": 567.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.968, "escape": -0.1868, "mature_H5_site": 551.0, "mutant": "R", "mutation": "I550R", "reference_site": "550", "sequential_site": 567.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.457, "escape": 0.1941, "mature_H5_site": 551.0, "mutant": "S", "mutation": "I550S", "reference_site": "550", "sequential_site": 567.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5749, "escape": 0.1466, "mature_H5_site": 551.0, "mutant": "V", "mutation": "I550V", "reference_site": "550", "sequential_site": 567.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2791, "escape": -0.06835, "mature_H5_site": 47.0, "mutant": "A", "mutation": "V56A", "reference_site": "56", "sequential_site": 63.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04159, "escape": -0.01825, "mature_H5_site": 47.0, "mutant": "C", "mutation": "V56C", "reference_site": "56", "sequential_site": 63.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.597, "escape": -0.03427, "mature_H5_site": 47.0, "mutant": "F", "mutation": "V56F", "reference_site": "56", "sequential_site": 63.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6441, "escape": 0.03584, "mature_H5_site": 47.0, "mutant": "G", "mutation": "V56G", "reference_site": "56", "sequential_site": 63.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2024, "escape": 0.2854, "mature_H5_site": 47.0, "mutant": "H", "mutation": "V56H", "reference_site": "56", "sequential_site": 63.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07137, "escape": -0.1619, "mature_H5_site": 47.0, "mutant": "I", "mutation": "V56I", "reference_site": "56", "sequential_site": 63.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03821, "escape": 0.1527, "mature_H5_site": 47.0, "mutant": "K", "mutation": "V56K", "reference_site": "56", "sequential_site": 63.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.005785, "escape": -0.0005344, "mature_H5_site": 47.0, "mutant": "L", "mutation": "V56L", "reference_site": "56", "sequential_site": 63.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7313, "escape": 0.4153, "mature_H5_site": 47.0, "mutant": "N", "mutation": "V56N", "reference_site": "56", "sequential_site": 63.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00104, "escape": 0.189, "mature_H5_site": 47.0, "mutant": "Q", "mutation": "V56Q", "reference_site": "56", "sequential_site": 63.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8235, "escape": 0.02286, "mature_H5_site": 47.0, "mutant": "R", "mutation": "V56R", "reference_site": "56", "sequential_site": 63.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04526, "escape": 0.1883, "mature_H5_site": 47.0, "mutant": "S", "mutation": "V56S", "reference_site": "56", "sequential_site": 63.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.171, "escape": -0.002112, "mature_H5_site": 47.0, "mutant": "T", "mutation": "V56T", "reference_site": "56", "sequential_site": 63.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1713, "escape": -0.3219, "mature_H5_site": 47.0, "mutant": "W", "mutation": "V56W", "reference_site": "56", "sequential_site": 63.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06962, "escape": 0.2931, "mature_H5_site": 47.0, "mutant": "Y", "mutation": "V56Y", "reference_site": "56", "sequential_site": 63.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07165, "escape": -0.1739, "mature_H5_site": 48.0, "mutant": "A", "mutation": "K57A", "reference_site": "57", "sequential_site": 64.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04136, "escape": 0.1529, "mature_H5_site": 48.0, "mutant": "E", "mutation": "K57E", "reference_site": "57", "sequential_site": 64.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.708, "escape": 0.1173, "mature_H5_site": 48.0, "mutant": "F", "mutation": "K57F", "reference_site": "57", "sequential_site": 64.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1721, "escape": 0.0276, "mature_H5_site": 48.0, "mutant": "G", "mutation": "K57G", "reference_site": "57", "sequential_site": 64.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7405, "escape": -0.2091, "mature_H5_site": 48.0, "mutant": "H", "mutation": "K57H", "reference_site": "57", "sequential_site": 64.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5732, "escape": 0.104, "mature_H5_site": 48.0, "mutant": "I", "mutation": "K57I", "reference_site": "57", "sequential_site": 64.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.13, "escape": -0.1016, "mature_H5_site": 48.0, "mutant": "L", "mutation": "K57L", "reference_site": "57", "sequential_site": 64.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00593, "escape": 0.3247, "mature_H5_site": 48.0, "mutant": "Q", "mutation": "K57Q", "reference_site": "57", "sequential_site": 64.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6365, "escape": 0.09548, "mature_H5_site": 48.0, "mutant": "R", "mutation": "K57R", "reference_site": "57", "sequential_site": 64.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.621, "escape": 0.2142, "mature_H5_site": 48.0, "mutant": "W", "mutation": "K57W", "reference_site": "57", "sequential_site": 64.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.536, "escape": 1.251, "mature_H5_site": 50.0, "mutant": "A", "mutation": "L59A", "reference_site": "59", "sequential_site": 66.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2665, "escape": 1.793, "mature_H5_site": 50.0, "mutant": "F", "mutation": "L59F", "reference_site": "59", "sequential_site": 66.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09156, "escape": 2.414, "mature_H5_site": 50.0, "mutant": "M", "mutation": "L59M", "reference_site": "59", "sequential_site": 66.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.495, "escape": 2.596, "mature_H5_site": 50.0, "mutant": "Q", "mutation": "L59Q", "reference_site": "59", "sequential_site": 66.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5635, "escape": 0.7351, "mature_H5_site": 50.0, "mutant": "V", "mutation": "L59V", "reference_site": "59", "sequential_site": 66.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5858, "escape": 0.07232, "mature_H5_site": -5.0, "mutant": "A", "mutation": "S6A", "reference_site": "6", "sequential_site": 12.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01632, "escape": -0.1229, "mature_H5_site": -5.0, "mutant": "C", "mutation": "S6C", "reference_site": "6", "sequential_site": 12.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3197, "escape": -0.3476, "mature_H5_site": -5.0, "mutant": "D", "mutation": "S6D", "reference_site": "6", "sequential_site": 12.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03886, "escape": -0.06705, "mature_H5_site": -5.0, "mutant": "E", "mutation": "S6E", "reference_site": "6", "sequential_site": 12.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.569, "escape": 0.07844, "mature_H5_site": -5.0, "mutant": "H", "mutation": "S6H", "reference_site": "6", "sequential_site": 12.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7833, "escape": -0.06304, "mature_H5_site": -5.0, "mutant": "K", "mutation": "S6K", "reference_site": "6", "sequential_site": 12.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4491, "escape": 0.01372, "mature_H5_site": -5.0, "mutant": "M", "mutation": "S6M", "reference_site": "6", "sequential_site": 12.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3704, "escape": -0.09616, "mature_H5_site": -5.0, "mutant": "P", "mutation": "S6P", "reference_site": "6", "sequential_site": 12.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2005, "escape": -0.0549, "mature_H5_site": -5.0, "mutant": "Q", "mutation": "S6Q", "reference_site": "6", "sequential_site": 12.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.149, "escape": -0.06952, "mature_H5_site": -5.0, "mutant": "R", "mutation": "S6R", "reference_site": "6", "sequential_site": 12.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06222, "escape": 0.1063, "mature_H5_site": -5.0, "mutant": "T", "mutation": "S6T", "reference_site": "6", "sequential_site": 12.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1581, "escape": 0.0001778, "mature_H5_site": -5.0, "mutant": "V", "mutation": "S6V", "reference_site": "6", "sequential_site": 12.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1547, "escape": -0.03747, "mature_H5_site": -5.0, "mutant": "Y", "mutation": "S6Y", "reference_site": "6", "sequential_site": 12.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.736, "escape": -0.08961, "mature_H5_site": 51.0, "mutant": "A", "mutation": "I60A", "reference_site": "60", "sequential_site": 67.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.633, "escape": -0.2029, "mature_H5_site": 51.0, "mutant": "R", "mutation": "I60R", "reference_site": "60", "sequential_site": 67.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.794, "escape": 0.2272, "mature_H5_site": 51.0, "mutant": "V", "mutation": "I60V", "reference_site": "60", "sequential_site": 67.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9885, "escape": -0.1557, "mature_H5_site": 51.0, "mutant": "W", "mutation": "I60W", "reference_site": "60", "sequential_site": 67.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.458, "escape": 0.04768, "mature_H5_site": 51.0, "mutant": "Y", "mutation": "I60Y", "reference_site": "60", "sequential_site": 67.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.828, "escape": 2.78, "mature_H5_site": 52.0, "mutant": "V", "mutation": "L61V", "reference_site": "61", "sequential_site": 68.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3787, "escape": -0.04676, "mature_H5_site": 53.0, "mutant": "A", "mutation": "K62A", "reference_site": "62", "sequential_site": 69.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6194, "escape": 0.5351, "mature_H5_site": 53.0, "mutant": "E", "mutation": "K62E", "reference_site": "62", "sequential_site": 69.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2031, "escape": 0.1545, "mature_H5_site": 53.0, "mutant": "G", "mutation": "K62G", "reference_site": "62", "sequential_site": 69.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.584, "escape": 1.246, "mature_H5_site": 53.0, "mutant": "L", "mutation": "K62L", "reference_site": "62", "sequential_site": 69.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1051, "escape": -0.3514, "mature_H5_site": 53.0, "mutant": "N", "mutation": "K62N", "reference_site": "62", "sequential_site": 69.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.004185, "escape": 0.482, "mature_H5_site": 53.0, "mutant": "R", "mutation": "K62R", "reference_site": "62", "sequential_site": 69.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3188, "escape": 1.145, "mature_H5_site": 53.0, "mutant": "T", "mutation": "K62T", "reference_site": "62", "sequential_site": 69.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3853, "escape": 1.145, "mature_H5_site": 53.0, "mutant": "W", "mutation": "K62W", "reference_site": "62", "sequential_site": 69.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5438, "escape": 0.4105, "mature_H5_site": 53.0, "mutant": "Y", "mutation": "K62Y", "reference_site": "62", "sequential_site": 69.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.433, "escape": 0.01373, "mature_H5_site": 54.0, "mutant": "A", "mutation": "D63A", "reference_site": "63", "sequential_site": 70.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06985, "escape": 0.001064, "mature_H5_site": 54.0, "mutant": "C", "mutation": "D63C", "reference_site": "63", "sequential_site": 70.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06502, "escape": -0.1742, "mature_H5_site": 54.0, "mutant": "E", "mutation": "D63E", "reference_site": "63", "sequential_site": 70.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.022, "escape": 0.05075, "mature_H5_site": 54.0, "mutant": "G", "mutation": "D63G", "reference_site": "63", "sequential_site": 70.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03997, "escape": -0.3638, "mature_H5_site": 54.0, "mutant": "H", "mutation": "D63H", "reference_site": "63", "sequential_site": 70.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5555, "escape": 0.4936, "mature_H5_site": 54.0, "mutant": "K", "mutation": "D63K", "reference_site": "63", "sequential_site": 70.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0177, "escape": -0.1734, "mature_H5_site": 54.0, "mutant": "M", "mutation": "D63M", "reference_site": "63", "sequential_site": 70.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1133, "escape": -0.1524, "mature_H5_site": 54.0, "mutant": "N", "mutation": "D63N", "reference_site": "63", "sequential_site": 70.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1572, "escape": 0.3732, "mature_H5_site": 54.0, "mutant": "S", "mutation": "D63S", "reference_site": "63", "sequential_site": 70.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.287, "escape": 0.9705, "mature_H5_site": 54.0, "mutant": "V", "mutation": "D63V", "reference_site": "63", "sequential_site": 70.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8444, "escape": 0.3937, "mature_H5_site": 54.0, "mutant": "Y", "mutation": "D63Y", "reference_site": "63", "sequential_site": 70.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2333, "escape": 1.248, "mature_H5_site": 56.0, "mutant": "G", "mutation": "S65G", "reference_site": "65", "sequential_site": 72.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.102, "escape": 3.148, "mature_H5_site": 56.0, "mutant": "N", "mutation": "S65N", "reference_site": "65", "sequential_site": 72.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.696, "escape": 1.541, "mature_H5_site": 57.0, "mutant": "F", "mutation": "V66F", "reference_site": "66", "sequential_site": 73.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5702, "escape": -0.05841, "mature_H5_site": 57.0, "mutant": "I", "mutation": "V66I", "reference_site": "66", "sequential_site": 73.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.322, "escape": 1.04, "mature_H5_site": 57.0, "mutant": "L", "mutation": "V66L", "reference_site": "66", "sequential_site": 73.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5219, "escape": 0.7643, "mature_H5_site": 57.0, "mutant": "M", "mutation": "V66M", "reference_site": "66", "sequential_site": 73.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06935, "escape": 0.504, "mature_H5_site": 57.0, "mutant": "P", "mutation": "V66P", "reference_site": "66", "sequential_site": 73.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08569, "escape": 0.1647, "mature_H5_site": 57.0, "mutant": "T", "mutation": "V66T", "reference_site": "66", "sequential_site": 73.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.671, "escape": 0.4202, "mature_H5_site": 57.0, "mutant": "Y", "mutation": "V66Y", "reference_site": "66", "sequential_site": 73.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2758, "escape": 0.21, "mature_H5_site": 58.0, "mutant": "D", "mutation": "A67D", "reference_site": "67", "sequential_site": 74.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01528, "escape": 0.4469, "mature_H5_site": 58.0, "mutant": "E", "mutation": "A67E", "reference_site": "67", "sequential_site": 74.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07248, "escape": 0.3003, "mature_H5_site": 58.0, "mutant": "G", "mutation": "A67G", "reference_site": "67", "sequential_site": 74.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1648, "escape": -0.09459, "mature_H5_site": 58.0, "mutant": "H", "mutation": "A67H", "reference_site": "67", "sequential_site": 74.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.125, "escape": -0.3916, "mature_H5_site": 58.0, "mutant": "L", "mutation": "A67L", "reference_site": "67", "sequential_site": 74.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3121, "escape": 0.06594, "mature_H5_site": 58.0, "mutant": "M", "mutation": "A67M", "reference_site": "67", "sequential_site": 74.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8889, "escape": -0.05372, "mature_H5_site": 58.0, "mutant": "N", "mutation": "A67N", "reference_site": "67", "sequential_site": 74.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2518, "escape": 0.1651, "mature_H5_site": 58.0, "mutant": "Q", "mutation": "A67Q", "reference_site": "67", "sequential_site": 74.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06757, "escape": 0.2037, "mature_H5_site": 58.0, "mutant": "R", "mutation": "A67R", "reference_site": "67", "sequential_site": 74.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2181, "escape": -0.2374, "mature_H5_site": 58.0, "mutant": "S", "mutation": "A67S", "reference_site": "67", "sequential_site": 74.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9566, "escape": -0.03766, "mature_H5_site": 58.0, "mutant": "V", "mutation": "A67V", "reference_site": "67", "sequential_site": 74.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8814, "escape": 1.757, "mature_H5_site": 59.0, "mutant": "S", "mutation": "G68S", "reference_site": "68", "sequential_site": 75.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.426, "escape": 3.137, "mature_H5_site": 60.0, "mutant": "A", "mutation": "W69A", "reference_site": "69", "sequential_site": 76.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6725, "escape": 2.575, "mature_H5_site": 60.0, "mutant": "F", "mutation": "W69F", "reference_site": "69", "sequential_site": 76.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.392, "escape": 1.874, "mature_H5_site": 60.0, "mutant": "I", "mutation": "W69I", "reference_site": "69", "sequential_site": 76.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.687, "escape": 2.726, "mature_H5_site": 60.0, "mutant": "L", "mutation": "W69L", "reference_site": "69", "sequential_site": 76.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4942, "escape": 2.476, "mature_H5_site": 60.0, "mutant": "M", "mutation": "W69M", "reference_site": "69", "sequential_site": 76.0, "wildtype": "W"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06333, "escape": 0.0809, "mature_H5_site": -4.0, "mutant": "A", "mutation": "L7A", "reference_site": "7", "sequential_site": 13.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06154, "escape": -0.09005, "mature_H5_site": -4.0, "mutant": "C", "mutation": "L7C", "reference_site": "7", "sequential_site": 13.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1975, "escape": 0.07708, "mature_H5_site": -4.0, "mutant": "F", "mutation": "L7F", "reference_site": "7", "sequential_site": 13.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4309, "escape": 0.3728, "mature_H5_site": -4.0, "mutant": "G", "mutation": "L7G", "reference_site": "7", "sequential_site": 13.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.852, "escape": -0.1756, "mature_H5_site": -4.0, "mutant": "H", "mutation": "L7H", "reference_site": "7", "sequential_site": 13.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06029, "escape": 0.04916, "mature_H5_site": -4.0, "mutant": "I", "mutation": "L7I", "reference_site": "7", "sequential_site": 13.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.435, "escape": -0.2955, "mature_H5_site": -4.0, "mutant": "K", "mutation": "L7K", "reference_site": "7", "sequential_site": 13.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07169, "escape": -0.03081, "mature_H5_site": -4.0, "mutant": "M", "mutation": "L7M", "reference_site": "7", "sequential_site": 13.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.682, "escape": -0.1838, "mature_H5_site": -4.0, "mutant": "P", "mutation": "L7P", "reference_site": "7", "sequential_site": 13.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1336, "escape": 0.2306, "mature_H5_site": -4.0, "mutant": "Q", "mutation": "L7Q", "reference_site": "7", "sequential_site": 13.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.316, "escape": -0.01672, "mature_H5_site": -4.0, "mutant": "R", "mutation": "L7R", "reference_site": "7", "sequential_site": 13.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1081, "escape": 0.05097, "mature_H5_site": -4.0, "mutant": "S", "mutation": "L7S", "reference_site": "7", "sequential_site": 13.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05344, "escape": 0.01943, "mature_H5_site": -4.0, "mutant": "T", "mutation": "L7T", "reference_site": "7", "sequential_site": 13.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3272, "escape": 0.4099, "mature_H5_site": -4.0, "mutant": "W", "mutation": "L7W", "reference_site": "7", "sequential_site": 13.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2067, "escape": 0.4991, "mature_H5_site": 61.0, "mutant": "I", "mutation": "L70I", "reference_site": "70", "sequential_site": 77.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1828, "escape": 0.01702, "mature_H5_site": 61.0, "mutant": "M", "mutation": "L70M", "reference_site": "70", "sequential_site": 77.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5242, "escape": 1.089, "mature_H5_site": 61.0, "mutant": "V", "mutation": "L70V", "reference_site": "70", "sequential_site": 77.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02275, "escape": -0.2513, "mature_H5_site": 62.0, "mutant": "I", "mutation": "L71I", "reference_site": "71", "sequential_site": 78.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05026, "escape": 0.1975, "mature_H5_site": 62.0, "mutant": "M", "mutation": "L71M", "reference_site": "71", "sequential_site": 78.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03558, "escape": -0.1856, "mature_H5_site": 62.0, "mutant": "T", "mutation": "L71T", "reference_site": "71", "sequential_site": 78.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.293, "escape": -0.2238, "mature_H5_site": 62.0, "mutant": "V", "mutation": "L71V", "reference_site": "71", "sequential_site": 78.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06073, "escape": 0.06219, "mature_H5_site": 62.0, "mutant": "Y", "mutation": "L71Y", "reference_site": "71", "sequential_site": 78.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.338, "escape": 2.793, "mature_H5_site": 63.0, "mutant": "D", "mutation": "G72D", "reference_site": "72", "sequential_site": 79.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.219, "escape": 3.046, "mature_H5_site": 63.0, "mutant": "E", "mutation": "G72E", "reference_site": "72", "sequential_site": 79.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.643, "escape": 2.612, "mature_H5_site": 63.0, "mutant": "F", "mutation": "G72F", "reference_site": "72", "sequential_site": 79.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.042, "escape": 2.679, "mature_H5_site": 63.0, "mutant": "H", "mutation": "G72H", "reference_site": "72", "sequential_site": 79.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2557, "escape": 0.121, "mature_H5_site": 63.0, "mutant": "L", "mutation": "G72L", "reference_site": "72", "sequential_site": 79.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2674, "escape": -0.00174, "mature_H5_site": 63.0, "mutant": "M", "mutation": "G72M", "reference_site": "72", "sequential_site": 79.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0276, "escape": 1.608, "mature_H5_site": 63.0, "mutant": "N", "mutation": "G72N", "reference_site": "72", "sequential_site": 79.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05225, "escape": 2.785, "mature_H5_site": 63.0, "mutant": "Q", "mutation": "G72Q", "reference_site": "72", "sequential_site": 79.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.003275, "escape": 0.4628, "mature_H5_site": 63.0, "mutant": "S", "mutation": "G72S", "reference_site": "72", "sequential_site": 79.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3665, "escape": 0.1015, "mature_H5_site": 63.0, "mutant": "T", "mutation": "G72T", "reference_site": "72", "sequential_site": 79.0, "wildtype": "G"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.662, "escape": 0.3368, "mature_H5_site": 64.0, "mutant": "C", "mutation": "N73C", "reference_site": "73", "sequential_site": 80.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.006185, "escape": -0.05372, "mature_H5_site": 64.0, "mutant": "H", "mutation": "N73H", "reference_site": "73", "sequential_site": 80.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00931, "escape": 0.1649, "mature_H5_site": 64.0, "mutant": "T", "mutation": "N73T", "reference_site": "73", "sequential_site": 80.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.344, "escape": 0.3023, "mature_H5_site": 65.0, "mutant": "A", "mutation": "P74A", "reference_site": "74", "sequential_site": 81.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.422, "escape": 2.624, "mature_H5_site": 65.0, "mutant": "H", "mutation": "P74H", "reference_site": "74", "sequential_site": 81.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1146, "escape": 3.175, "mature_H5_site": 65.0, "mutant": "K", "mutation": "P74K", "reference_site": "74", "sequential_site": 81.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6854, "escape": 2.815, "mature_H5_site": 65.0, "mutant": "M", "mutation": "P74M", "reference_site": "74", "sequential_site": 81.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5766, "escape": 3.274, "mature_H5_site": 65.0, "mutant": "R", "mutation": "P74R", "reference_site": "74", "sequential_site": 81.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5088, "escape": -0.2474, "mature_H5_site": 65.0, "mutant": "S", "mutation": "P74S", "reference_site": "74", "sequential_site": 81.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7262, "escape": -0.219, "mature_H5_site": 65.0, "mutant": "T", "mutation": "P74T", "reference_site": "74", "sequential_site": 81.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.865, "escape": 0.3872, "mature_H5_site": 65.0, "mutant": "V", "mutation": "P74V", "reference_site": "74", "sequential_site": 81.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06545, "escape": -0.166, "mature_H5_site": 66.0, "mutant": "A", "mutation": "M75A", "reference_site": "75", "sequential_site": 82.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02638, "escape": -0.3945, "mature_H5_site": 66.0, "mutant": "D", "mutation": "M75D", "reference_site": "75", "sequential_site": 82.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.373, "escape": -0.2626, "mature_H5_site": 66.0, "mutant": "E", "mutation": "M75E", "reference_site": "75", "sequential_site": 82.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1639, "escape": 0.4617, "mature_H5_site": 66.0, "mutant": "H", "mutation": "M75H", "reference_site": "75", "sequential_site": 82.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01358, "escape": 0.5857, "mature_H5_site": 66.0, "mutant": "I", "mutation": "M75I", "reference_site": "75", "sequential_site": 82.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04086, "escape": 0.1603, "mature_H5_site": 66.0, "mutant": "L", "mutation": "M75L", "reference_site": "75", "sequential_site": 82.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01276, "escape": -0.07787, "mature_H5_site": 66.0, "mutant": "Q", "mutation": "M75Q", "reference_site": "75", "sequential_site": 82.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3531, "escape": 0.1411, "mature_H5_site": 66.0, "mutant": "R", "mutation": "M75R", "reference_site": "75", "sequential_site": 82.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2357, "escape": 0.04245, "mature_H5_site": 66.0, "mutant": "T", "mutation": "M75T", "reference_site": "75", "sequential_site": 82.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.118, "escape": 0.5713, "mature_H5_site": 66.0, "mutant": "V", "mutation": "M75V", "reference_site": "75", "sequential_site": 82.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03615, "escape": -0.1495, "mature_H5_site": 66.0, "mutant": "W", "mutation": "M75W", "reference_site": "75", "sequential_site": 82.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01911, "escape": -0.02303, "mature_H5_site": 66.0, "mutant": "Y", "mutation": "M75Y", "reference_site": "75", "sequential_site": 82.0, "wildtype": "M"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6153, "escape": 2.93, "mature_H5_site": 68.0, "mutant": "A", "mutation": "D77A", "reference_site": "77", "sequential_site": 84.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6577, "escape": 2.94, "mature_H5_site": 68.0, "mutant": "E", "mutation": "D77E", "reference_site": "77", "sequential_site": 84.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05326, "escape": 2.842, "mature_H5_site": 68.0, "mutant": "G", "mutation": "D77G", "reference_site": "77", "sequential_site": 84.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.517, "escape": 3.702, "mature_H5_site": 68.0, "mutant": "H", "mutation": "D77H", "reference_site": "77", "sequential_site": 84.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1036, "escape": 3.237, "mature_H5_site": 68.0, "mutant": "I", "mutation": "D77I", "reference_site": "77", "sequential_site": 84.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7425, "escape": 3.794, "mature_H5_site": 68.0, "mutant": "L", "mutation": "D77L", "reference_site": "77", "sequential_site": 84.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2082, "escape": 3.145, "mature_H5_site": 68.0, "mutant": "M", "mutation": "D77M", "reference_site": "77", "sequential_site": 84.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.783, "escape": 3.345, "mature_H5_site": 68.0, "mutant": "N", "mutation": "D77N", "reference_site": "77", "sequential_site": 84.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.132, "escape": 3.062, "mature_H5_site": 68.0, "mutant": "R", "mutation": "D77R", "reference_site": "77", "sequential_site": 84.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.233, "escape": 3.127, "mature_H5_site": 68.0, "mutant": "T", "mutation": "D77T", "reference_site": "77", "sequential_site": 84.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08095, "escape": 2.882, "mature_H5_site": 68.0, "mutant": "W", "mutation": "D77W", "reference_site": "77", "sequential_site": 84.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3217, "escape": 3.28, "mature_H5_site": 68.0, "mutant": "Y", "mutation": "D77Y", "reference_site": "77", "sequential_site": 84.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1552, "escape": 0.1937, "mature_H5_site": 69.0, "mutant": "D", "mutation": "E78D", "reference_site": "78", "sequential_site": 85.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04897, "escape": 3.135, "mature_H5_site": 69.0, "mutant": "F", "mutation": "E78F", "reference_site": "78", "sequential_site": 85.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5219, "escape": 2.176, "mature_H5_site": 69.0, "mutant": "K", "mutation": "E78K", "reference_site": "78", "sequential_site": 85.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01281, "escape": 2.852, "mature_H5_site": 69.0, "mutant": "L", "mutation": "E78L", "reference_site": "78", "sequential_site": 85.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01331, "escape": 1.485, "mature_H5_site": 69.0, "mutant": "M", "mutation": "E78M", "reference_site": "78", "sequential_site": 85.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1523, "escape": 2.634, "mature_H5_site": 69.0, "mutant": "N", "mutation": "E78N", "reference_site": "78", "sequential_site": 85.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7681, "escape": 2.664, "mature_H5_site": 69.0, "mutant": "T", "mutation": "E78T", "reference_site": "78", "sequential_site": 85.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02172, "escape": 2.919, "mature_H5_site": 69.0, "mutant": "W", "mutation": "E78W", "reference_site": "78", "sequential_site": 85.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.777, "escape": 3.075, "mature_H5_site": 70.0, "mutant": "H", "mutation": "F79H", "reference_site": "79", "sequential_site": 86.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.373, "escape": 3.277, "mature_H5_site": 70.0, "mutant": "N", "mutation": "F79N", "reference_site": "79", "sequential_site": 86.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1011, "escape": 2.911, "mature_H5_site": 70.0, "mutant": "W", "mutation": "F79W", "reference_site": "79", "sequential_site": 86.0, "wildtype": "F"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1565, "escape": 0.005047, "mature_H5_site": -3.0, "mutant": "A", "mutation": "V8A", "reference_site": "8", "sequential_site": 14.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01557, "escape": -0.08254, "mature_H5_site": -3.0, "mutant": "C", "mutation": "V8C", "reference_site": "8", "sequential_site": 14.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8556, "escape": 0.1385, "mature_H5_site": -3.0, "mutant": "G", "mutation": "V8G", "reference_site": "8", "sequential_site": 14.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.774, "escape": 0.01036, "mature_H5_site": -3.0, "mutant": "I", "mutation": "V8I", "reference_site": "8", "sequential_site": 14.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1548, "escape": -0.09506, "mature_H5_site": -3.0, "mutant": "S", "mutation": "V8S", "reference_site": "8", "sequential_site": 14.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.258, "escape": 0.007838, "mature_H5_site": -3.0, "mutant": "T", "mutation": "V8T", "reference_site": "8", "sequential_site": 14.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3806, "escape": 2.816, "mature_H5_site": 71.0, "mutant": "C", "mutation": "I80C", "reference_site": "80", "sequential_site": 87.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01899, "escape": 2.888, "mature_H5_site": 71.0, "mutant": "E", "mutation": "I80E", "reference_site": "80", "sequential_site": 87.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -3.885, "escape": 1.414, "mature_H5_site": 71.0, "mutant": "F", "mutation": "I80F", "reference_site": "80", "sequential_site": 87.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4549, "escape": 1.511, "mature_H5_site": 71.0, "mutant": "H", "mutation": "I80H", "reference_site": "80", "sequential_site": 87.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.003725, "escape": 3.384, "mature_H5_site": 71.0, "mutant": "K", "mutation": "I80K", "reference_site": "80", "sequential_site": 87.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03972, "escape": -0.08719, "mature_H5_site": 71.0, "mutant": "L", "mutation": "I80L", "reference_site": "80", "sequential_site": 87.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7338, "escape": 1.653, "mature_H5_site": 71.0, "mutant": "R", "mutation": "I80R", "reference_site": "80", "sequential_site": 87.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04411, "escape": 2.009, "mature_H5_site": 71.0, "mutant": "S", "mutation": "I80S", "reference_site": "80", "sequential_site": 87.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9967, "escape": 2.502, "mature_H5_site": 71.0, "mutant": "T", "mutation": "I80T", "reference_site": "80", "sequential_site": 87.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3472, "escape": 1.414, "mature_H5_site": 71.0, "mutant": "V", "mutation": "I80V", "reference_site": "80", "sequential_site": 87.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.884, "escape": 0.8308, "mature_H5_site": 72.0, "mutant": "C", "mutation": "R81C", "reference_site": "81", "sequential_site": 88.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09676, "escape": -0.06079, "mature_H5_site": 72.0, "mutant": "D", "mutation": "R81D", "reference_site": "81", "sequential_site": 88.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02404, "escape": 1.719, "mature_H5_site": 72.0, "mutant": "G", "mutation": "R81G", "reference_site": "81", "sequential_site": 88.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7165, "escape": 0.2859, "mature_H5_site": 72.0, "mutant": "I", "mutation": "R81I", "reference_site": "81", "sequential_site": 88.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1359, "escape": 0.4288, "mature_H5_site": 72.0, "mutant": "L", "mutation": "R81L", "reference_site": "81", "sequential_site": 88.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01525, "escape": 0.5077, "mature_H5_site": 72.0, "mutant": "M", "mutation": "R81M", "reference_site": "81", "sequential_site": 88.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03213, "escape": 0.06973, "mature_H5_site": 72.0, "mutant": "T", "mutation": "R81T", "reference_site": "81", "sequential_site": 88.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03643, "escape": 0.08261, "mature_H5_site": 72.0, "mutant": "V", "mutation": "R81V", "reference_site": "81", "sequential_site": 88.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03675, "escape": -0.02268, "mature_H5_site": 72.0, "mutant": "W", "mutation": "R81W", "reference_site": "81", "sequential_site": 88.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03388, "escape": 0.1411, "mature_H5_site": 72.0, "mutant": "Y", "mutation": "R81Y", "reference_site": "81", "sequential_site": 88.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2373, "escape": 1.821, "mature_H5_site": 73.0, "mutant": "A", "mutation": "V82A", "reference_site": "82", "sequential_site": 89.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.412, "escape": 2.458, "mature_H5_site": 73.0, "mutant": "C", "mutation": "V82C", "reference_site": "82", "sequential_site": 89.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.699, "escape": 3.188, "mature_H5_site": 73.0, "mutant": "D", "mutation": "V82D", "reference_site": "82", "sequential_site": 89.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03844, "escape": 2.121, "mature_H5_site": 73.0, "mutant": "I", "mutation": "V82I", "reference_site": "82", "sequential_site": 89.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7061, "escape": 3.024, "mature_H5_site": 73.0, "mutant": "L", "mutation": "V82L", "reference_site": "82", "sequential_site": 89.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.274, "escape": 2.911, "mature_H5_site": 73.0, "mutant": "M", "mutation": "V82M", "reference_site": "82", "sequential_site": 89.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04147, "escape": 2.662, "mature_H5_site": 73.0, "mutant": "N", "mutation": "V82N", "reference_site": "82", "sequential_site": 89.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": null, "escape": 2.221, "mature_H5_site": 73.0, "mutant": "P", "mutation": "V82P", "reference_site": "82", "sequential_site": 89.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2484, "escape": 0.2114, "mature_H5_site": 73.0, "mutant": "T", "mutation": "V82T", "reference_site": "82", "sequential_site": 89.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.046, "escape": 3.187, "mature_H5_site": 73.0, "mutant": "Y", "mutation": "V82Y", "reference_site": "82", "sequential_site": 89.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.014, "escape": 2.651, "mature_H5_site": 74.0, "mutant": "C", "mutation": "P82aC", "reference_site": "82a", "sequential_site": 90.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.474, "escape": 1.316, "mature_H5_site": 74.0, "mutant": "G", "mutation": "P82aG", "reference_site": "82a", "sequential_site": 90.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.722, "escape": 0.6036, "mature_H5_site": 74.0, "mutant": "S", "mutation": "P82aS", "reference_site": "82a", "sequential_site": 90.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.255, "escape": 2.448, "mature_H5_site": 74.0, "mutant": "W", "mutation": "P82aW", "reference_site": "82a", "sequential_site": 90.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.006, "escape": 0.6809, "mature_H5_site": 75.0, "mutant": "D", "mutation": "E83D", "reference_site": "83", "sequential_site": 91.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5961, "escape": 0.7281, "mature_H5_site": 75.0, "mutant": "H", "mutation": "E83H", "reference_site": "83", "sequential_site": 91.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5213, "escape": 0.3736, "mature_H5_site": 75.0, "mutant": "I", "mutation": "E83I", "reference_site": "83", "sequential_site": 91.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01189, "escape": -0.0853, "mature_H5_site": 75.0, "mutant": "L", "mutation": "E83L", "reference_site": "83", "sequential_site": 91.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1767, "escape": -0.1817, "mature_H5_site": 75.0, "mutant": "P", "mutation": "E83P", "reference_site": "83", "sequential_site": 91.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5903, "escape": 2.064, "mature_H5_site": 75.0, "mutant": "R", "mutation": "E83R", "reference_site": "83", "sequential_site": 91.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.08904, "escape": 0.8964, "mature_H5_site": 77.0, "mutant": "A", "mutation": "S85A", "reference_site": "85", "sequential_site": 93.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6, "escape": 0.3177, "mature_H5_site": 77.0, "mutant": "K", "mutation": "S85K", "reference_site": "85", "sequential_site": 93.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6855, "escape": 1.587, "mature_H5_site": 77.0, "mutant": "P", "mutation": "S85P", "reference_site": "85", "sequential_site": 93.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1737, "escape": 0.1721, "mature_H5_site": 77.0, "mutant": "R", "mutation": "S85R", "reference_site": "85", "sequential_site": 93.0, "wildtype": "S"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.216, "escape": 2.504, "mature_H5_site": 79.0, "mutant": "L", "mutation": "I87L", "reference_site": "87", "sequential_site": 95.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.832, "escape": 0.4389, "mature_H5_site": 79.0, "mutant": "M", "mutation": "I87M", "reference_site": "87", "sequential_site": 95.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6854, "escape": 0.7349, "mature_H5_site": 79.0, "mutant": "V", "mutation": "I87V", "reference_site": "87", "sequential_site": 95.0, "wildtype": "I"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1599, "escape": 0.09848, "mature_H5_site": 80.0, "mutant": "A", "mutation": "V88A", "reference_site": "88", "sequential_site": 96.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.121, "escape": 0.01438, "mature_H5_site": 80.0, "mutant": "H", "mutation": "V88H", "reference_site": "88", "sequential_site": 96.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -4.16, "escape": -0.2331, "mature_H5_site": 80.0, "mutant": "M", "mutation": "V88M", "reference_site": "88", "sequential_site": 96.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.031, "escape": 0.1898, "mature_H5_site": 80.0, "mutant": "S", "mutation": "V88S", "reference_site": "88", "sequential_site": 96.0, "wildtype": "V"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.272, "escape": 1.398, "mature_H5_site": 81.0, "mutant": "F", "mutation": "E89F", "reference_site": "89", "sequential_site": 97.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.008411, "escape": -0.2452, "mature_H5_site": 81.0, "mutant": "H", "mutation": "E89H", "reference_site": "89", "sequential_site": 97.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03879, "escape": 0.145, "mature_H5_site": 81.0, "mutant": "I", "mutation": "E89I", "reference_site": "89", "sequential_site": 97.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.528, "escape": 0.285, "mature_H5_site": 81.0, "mutant": "K", "mutation": "E89K", "reference_site": "89", "sequential_site": 97.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9846, "escape": 1.8, "mature_H5_site": 81.0, "mutant": "L", "mutation": "E89L", "reference_site": "89", "sequential_site": 97.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06451, "escape": 0.463, "mature_H5_site": 81.0, "mutant": "Q", "mutation": "E89Q", "reference_site": "89", "sequential_site": 97.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.333, "escape": 0.7761, "mature_H5_site": 81.0, "mutant": "R", "mutation": "E89R", "reference_site": "89", "sequential_site": 97.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1958, "escape": 0.7178, "mature_H5_site": 81.0, "mutant": "S", "mutation": "E89S", "reference_site": "89", "sequential_site": 97.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2552, "escape": 0.3679, "mature_H5_site": 81.0, "mutant": "V", "mutation": "E89V", "reference_site": "89", "sequential_site": 97.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.2, "escape": 1.579, "mature_H5_site": 81.0, "mutant": "W", "mutation": "E89W", "reference_site": "89", "sequential_site": 97.0, "wildtype": "E"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.02409, "escape": 0.2514, "mature_H5_site": -2.0, "mutant": "A", "mutation": "K9A", "reference_site": "9", "sequential_site": 15.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2777, "escape": -0.02154, "mature_H5_site": -2.0, "mutant": "C", "mutation": "K9C", "reference_site": "9", "sequential_site": 15.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05772, "escape": 0.1149, "mature_H5_site": -2.0, "mutant": "D", "mutation": "K9D", "reference_site": "9", "sequential_site": 15.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04559, "escape": -0.2697, "mature_H5_site": -2.0, "mutant": "E", "mutation": "K9E", "reference_site": "9", "sequential_site": 15.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.8641, "escape": 0.4213, "mature_H5_site": -2.0, "mutant": "F", "mutation": "K9F", "reference_site": "9", "sequential_site": 15.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06421, "escape": -0.0444, "mature_H5_site": -2.0, "mutant": "G", "mutation": "K9G", "reference_site": "9", "sequential_site": 15.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0354, "escape": -0.1178, "mature_H5_site": -2.0, "mutant": "H", "mutation": "K9H", "reference_site": "9", "sequential_site": 15.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9799, "escape": 0.03571, "mature_H5_site": -2.0, "mutant": "M", "mutation": "K9M", "reference_site": "9", "sequential_site": 15.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1282, "escape": -0.03235, "mature_H5_site": -2.0, "mutant": "N", "mutation": "K9N", "reference_site": "9", "sequential_site": 15.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2548, "escape": -0.03585, "mature_H5_site": -2.0, "mutant": "Q", "mutation": "K9Q", "reference_site": "9", "sequential_site": 15.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04892, "escape": -0.2496, "mature_H5_site": -2.0, "mutant": "R", "mutation": "K9R", "reference_site": "9", "sequential_site": 15.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01926, "escape": -0.2246, "mature_H5_site": -2.0, "mutant": "S", "mutation": "K9S", "reference_site": "9", "sequential_site": 15.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.182, "escape": 0.1002, "mature_H5_site": -2.0, "mutant": "T", "mutation": "K9T", "reference_site": "9", "sequential_site": 15.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.785, "escape": -0.0179, "mature_H5_site": -2.0, "mutant": "V", "mutation": "K9V", "reference_site": "9", "sequential_site": 15.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04044, "escape": -0.1878, "mature_H5_site": -2.0, "mutant": "W", "mutation": "K9W", "reference_site": "9", "sequential_site": 15.0, "wildtype": "K"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.124, "escape": 1.475, "mature_H5_site": 82.0, "mutant": "F", "mutation": "R90F", "reference_site": "90", "sequential_site": 98.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1338, "escape": -0.1011, "mature_H5_site": 82.0, "mutant": "G", "mutation": "R90G", "reference_site": "90", "sequential_site": 98.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.325, "escape": -0.1157, "mature_H5_site": 82.0, "mutant": "H", "mutation": "R90H", "reference_site": "90", "sequential_site": 98.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3425, "escape": 0.07512, "mature_H5_site": 82.0, "mutant": "I", "mutation": "R90I", "reference_site": "90", "sequential_site": 98.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05676, "escape": 0.194, "mature_H5_site": 82.0, "mutant": "K", "mutation": "R90K", "reference_site": "90", "sequential_site": 98.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5606, "escape": 0.3291, "mature_H5_site": 82.0, "mutant": "L", "mutation": "R90L", "reference_site": "90", "sequential_site": 98.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.07917, "escape": 0.5523, "mature_H5_site": 82.0, "mutant": "M", "mutation": "R90M", "reference_site": "90", "sequential_site": 98.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.546, "escape": 0.1107, "mature_H5_site": 82.0, "mutant": "N", "mutation": "R90N", "reference_site": "90", "sequential_site": 98.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.202, "escape": 1.807, "mature_H5_site": 82.0, "mutant": "P", "mutation": "R90P", "reference_site": "90", "sequential_site": 98.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07714, "escape": 0.3055, "mature_H5_site": 82.0, "mutant": "Q", "mutation": "R90Q", "reference_site": "90", "sequential_site": 98.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.006, "escape": 0.1277, "mature_H5_site": 82.0, "mutant": "T", "mutation": "R90T", "reference_site": "90", "sequential_site": 98.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2636, "escape": 0.06008, "mature_H5_site": 82.0, "mutant": "V", "mutation": "R90V", "reference_site": "90", "sequential_site": 98.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9419, "escape": 0.2618, "mature_H5_site": 82.0, "mutant": "W", "mutation": "R90W", "reference_site": "90", "sequential_site": 98.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.173, "escape": 0.8071, "mature_H5_site": 82.0, "mutant": "Y", "mutation": "R90Y", "reference_site": "90", "sequential_site": 98.0, "wildtype": "R"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.04047, "escape": 0.03753, "mature_H5_site": 83.0, "mutant": "C", "mutation": "A91C", "reference_site": "91", "sequential_site": 99.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.01268, "escape": -0.133, "mature_H5_site": 83.0, "mutant": "D", "mutation": "A91D", "reference_site": "91", "sequential_site": 99.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.0737, "escape": -0.0009369, "mature_H5_site": 83.0, "mutant": "E", "mutation": "A91E", "reference_site": "91", "sequential_site": 99.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1452, "escape": 0.1512, "mature_H5_site": 83.0, "mutant": "F", "mutation": "A91F", "reference_site": "91", "sequential_site": 99.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1753, "escape": -0.09434, "mature_H5_site": 83.0, "mutant": "G", "mutation": "A91G", "reference_site": "91", "sequential_site": 99.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.05037, "escape": 0.06948, "mature_H5_site": 83.0, "mutant": "H", "mutation": "A91H", "reference_site": "91", "sequential_site": 99.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03243, "escape": -0.09407, "mature_H5_site": 83.0, "mutant": "K", "mutation": "A91K", "reference_site": "91", "sequential_site": 99.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.624, "escape": 0.1439, "mature_H5_site": 83.0, "mutant": "L", "mutation": "A91L", "reference_site": "91", "sequential_site": 99.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0534, "escape": 0.1289, "mature_H5_site": 83.0, "mutant": "M", "mutation": "A91M", "reference_site": "91", "sequential_site": 99.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.06868, "escape": 0.1115, "mature_H5_site": 83.0, "mutant": "Q", "mutation": "A91Q", "reference_site": "91", "sequential_site": 99.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3265, "escape": -0.1103, "mature_H5_site": 83.0, "mutant": "R", "mutation": "A91R", "reference_site": "91", "sequential_site": 99.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1533, "escape": 0.02357, "mature_H5_site": 83.0, "mutant": "S", "mutation": "A91S", "reference_site": "91", "sequential_site": 99.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03071, "escape": 0.01539, "mature_H5_site": 83.0, "mutant": "V", "mutation": "A91V", "reference_site": "91", "sequential_site": 99.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03401, "escape": -0.1633, "mature_H5_site": 83.0, "mutant": "W", "mutation": "A91W", "reference_site": "91", "sequential_site": 99.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03381, "escape": -0.03772, "mature_H5_site": 84.0, "mutant": "A", "mutation": "N92A", "reference_site": "92", "sequential_site": 100.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1521, "escape": 0.1456, "mature_H5_site": 84.0, "mutant": "E", "mutation": "N92E", "reference_site": "92", "sequential_site": 100.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1454, "escape": 0.1128, "mature_H5_site": 84.0, "mutant": "F", "mutation": "N92F", "reference_site": "92", "sequential_site": 100.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06958, "escape": 0.1978, "mature_H5_site": 84.0, "mutant": "G", "mutation": "N92G", "reference_site": "92", "sequential_site": 100.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.00283, "escape": 0.1273, "mature_H5_site": 84.0, "mutant": "I", "mutation": "N92I", "reference_site": "92", "sequential_site": 100.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2718, "escape": 0.102, "mature_H5_site": 84.0, "mutant": "K", "mutation": "N92K", "reference_site": "92", "sequential_site": 100.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03568, "escape": -0.003443, "mature_H5_site": 84.0, "mutant": "L", "mutation": "N92L", "reference_site": "92", "sequential_site": 100.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3279, "escape": 0.6214, "mature_H5_site": 84.0, "mutant": "M", "mutation": "N92M", "reference_site": "92", "sequential_site": 100.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1077, "escape": 1.59, "mature_H5_site": 84.0, "mutant": "S", "mutation": "N92S", "reference_site": "92", "sequential_site": 100.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4673, "escape": -0.09777, "mature_H5_site": 84.0, "mutant": "T", "mutation": "N92T", "reference_site": "92", "sequential_site": 100.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.53, "escape": 0.4108, "mature_H5_site": 84.0, "mutant": "V", "mutation": "N92V", "reference_site": "92", "sequential_site": 100.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04895, "escape": -0.162, "mature_H5_site": 84.0, "mutant": "W", "mutation": "N92W", "reference_site": "92", "sequential_site": 100.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1667, "escape": 0.2837, "mature_H5_site": 84.0, "mutant": "Y", "mutation": "N92Y", "reference_site": "92", "sequential_site": 100.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.001035, "escape": 0.1258, "mature_H5_site": 85.0, "mutant": "A", "mutation": "P92aA", "reference_site": "92a", "sequential_site": 101.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.121, "escape": 0.4912, "mature_H5_site": 85.0, "mutant": "C", "mutation": "P92aC", "reference_site": "92a", "sequential_site": 101.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3433, "escape": 0.7367, "mature_H5_site": 85.0, "mutant": "F", "mutation": "P92aF", "reference_site": "92a", "sequential_site": 101.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.684, "escape": 2.862, "mature_H5_site": 85.0, "mutant": "G", "mutation": "P92aG", "reference_site": "92a", "sequential_site": 101.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.805, "escape": 0.8213, "mature_H5_site": 85.0, "mutant": "Q", "mutation": "P92aQ", "reference_site": "92a", "sequential_site": 101.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02319, "escape": 0.1509, "mature_H5_site": 85.0, "mutant": "S", "mutation": "P92aS", "reference_site": "92a", "sequential_site": 101.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4175, "escape": 0.3308, "mature_H5_site": 85.0, "mutant": "T", "mutation": "P92aT", "reference_site": "92a", "sequential_site": 101.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4852, "escape": 1.347, "mature_H5_site": 85.0, "mutant": "V", "mutation": "P92aV", "reference_site": "92a", "sequential_site": 101.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3186, "escape": 0.1662, "mature_H5_site": 85.0, "mutant": "W", "mutation": "P92aW", "reference_site": "92a", "sequential_site": 101.0, "wildtype": "P"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.06434, "escape": -0.372, "mature_H5_site": 86.0, "mutant": "C", "mutation": "A93C", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03087, "escape": 0.1611, "mature_H5_site": 86.0, "mutant": "D", "mutation": "A93D", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1596, "escape": -0.1274, "mature_H5_site": 86.0, "mutant": "E", "mutation": "A93E", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05131, "escape": -0.08959, "mature_H5_site": 86.0, "mutant": "F", "mutation": "A93F", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04196, "escape": 0.003293, "mature_H5_site": 86.0, "mutant": "G", "mutation": "A93G", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.04509, "escape": 0.03516, "mature_H5_site": 86.0, "mutant": "H", "mutation": "A93H", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3655, "escape": -0.0031, "mature_H5_site": 86.0, "mutant": "I", "mutation": "A93I", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.09542, "escape": -0.2175, "mature_H5_site": 86.0, "mutant": "L", "mutation": "A93L", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.00597, "escape": 0.06369, "mature_H5_site": 86.0, "mutant": "N", "mutation": "A93N", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07659, "escape": -0.1447, "mature_H5_site": 86.0, "mutant": "P", "mutation": "A93P", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.29, "escape": 0.03019, "mature_H5_site": 86.0, "mutant": "Q", "mutation": "A93Q", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2769, "escape": -0.1039, "mature_H5_site": 86.0, "mutant": "R", "mutation": "A93R", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.01831, "escape": 0.09336, "mature_H5_site": 86.0, "mutant": "S", "mutation": "A93S", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.07981, "escape": 0.1962, "mature_H5_site": 86.0, "mutant": "T", "mutation": "A93T", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0435, "escape": -0.1302, "mature_H5_site": 86.0, "mutant": "V", "mutation": "A93V", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.174, "escape": -0.02966, "mature_H5_site": 86.0, "mutant": "W", "mutation": "A93W", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4142, "escape": -0.05573, "mature_H5_site": 86.0, "mutant": "Y", "mutation": "A93Y", "reference_site": "93", "sequential_site": 102.0, "wildtype": "A"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.05408, "escape": -0.367, "mature_H5_site": 87.0, "mutant": "D", "mutation": "N94D", "reference_site": "94", "sequential_site": 103.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6562, "escape": -0.2056, "mature_H5_site": 87.0, "mutant": "E", "mutation": "N94E", "reference_site": "94", "sequential_site": 103.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.002635, "escape": -0.07865, "mature_H5_site": 87.0, "mutant": "H", "mutation": "N94H", "reference_site": "94", "sequential_site": 103.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4251, "escape": 0.1196, "mature_H5_site": 87.0, "mutant": "I", "mutation": "N94I", "reference_site": "94", "sequential_site": 103.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2878, "escape": 1.84, "mature_H5_site": 87.0, "mutant": "K", "mutation": "N94K", "reference_site": "94", "sequential_site": 103.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1805, "escape": 1.537, "mature_H5_site": 87.0, "mutant": "L", "mutation": "N94L", "reference_site": "94", "sequential_site": 103.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3004, "escape": 0.5504, "mature_H5_site": 87.0, "mutant": "M", "mutation": "N94M", "reference_site": "94", "sequential_site": 103.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1262, "escape": 0.1442, "mature_H5_site": 87.0, "mutant": "R", "mutation": "N94R", "reference_site": "94", "sequential_site": 103.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1472, "escape": 0.06439, "mature_H5_site": 87.0, "mutant": "S", "mutation": "N94S", "reference_site": "94", "sequential_site": 103.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4122, "escape": 0.4563, "mature_H5_site": 87.0, "mutant": "T", "mutation": "N94T", "reference_site": "94", "sequential_site": 103.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.6813, "escape": 0.2359, "mature_H5_site": 87.0, "mutant": "V", "mutation": "N94V", "reference_site": "94", "sequential_site": 103.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.03282, "escape": 0.2685, "mature_H5_site": 87.0, "mutant": "W", "mutation": "N94W", "reference_site": "94", "sequential_site": 103.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3207, "escape": 0.06094, "mature_H5_site": 87.0, "mutant": "Y", "mutation": "N94Y", "reference_site": "94", "sequential_site": 103.0, "wildtype": "N"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7204, "escape": 0.2337, "mature_H5_site": 88.0, "mutant": "A", "mutation": "D95A", "reference_site": "95", "sequential_site": 104.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.02697, "escape": 0.09306, "mature_H5_site": 88.0, "mutant": "E", "mutation": "D95E", "reference_site": "95", "sequential_site": 104.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1866, "escape": 0.2881, "mature_H5_site": 88.0, "mutant": "G", "mutation": "D95G", "reference_site": "95", "sequential_site": 104.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4527, "escape": 0.2375, "mature_H5_site": 88.0, "mutant": "H", "mutation": "D95H", "reference_site": "95", "sequential_site": 104.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.321, "escape": 1.094, "mature_H5_site": 88.0, "mutant": "I", "mutation": "D95I", "reference_site": "95", "sequential_site": 104.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2198, "escape": 0.4521, "mature_H5_site": 88.0, "mutant": "K", "mutation": "D95K", "reference_site": "95", "sequential_site": 104.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.247, "escape": 0.5631, "mature_H5_site": 88.0, "mutant": "L", "mutation": "D95L", "reference_site": "95", "sequential_site": 104.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7498, "escape": 0.2961, "mature_H5_site": 88.0, "mutant": "M", "mutation": "D95M", "reference_site": "95", "sequential_site": 104.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5195, "escape": 0.4272, "mature_H5_site": 88.0, "mutant": "Q", "mutation": "D95Q", "reference_site": "95", "sequential_site": 104.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.5123, "escape": 0.5312, "mature_H5_site": 88.0, "mutant": "R", "mutation": "D95R", "reference_site": "95", "sequential_site": 104.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.3749, "escape": 0.2249, "mature_H5_site": 88.0, "mutant": "S", "mutation": "D95S", "reference_site": "95", "sequential_site": 104.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2005, "escape": 0.1644, "mature_H5_site": 88.0, "mutant": "T", "mutation": "D95T", "reference_site": "95", "sequential_site": 104.0, "wildtype": "D"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1603, "escape": 0.04131, "mature_H5_site": 89.0, "mutant": "C", "mutation": "L96C", "reference_site": "96", "sequential_site": 105.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4363, "escape": -0.08898, "mature_H5_site": 89.0, "mutant": "F", "mutation": "L96F", "reference_site": "96", "sequential_site": 105.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.1441, "escape": -0.1317, "mature_H5_site": 89.0, "mutant": "H", "mutation": "L96H", "reference_site": "96", "sequential_site": 105.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.7077, "escape": 0.2452, "mature_H5_site": 89.0, "mutant": "I", "mutation": "L96I", "reference_site": "96", "sequential_site": 105.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.036, "escape": 0.01967, "mature_H5_site": 89.0, "mutant": "K", "mutation": "L96K", "reference_site": "96", "sequential_site": 105.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03343, "escape": 0.7131, "mature_H5_site": 89.0, "mutant": "M", "mutation": "L96M", "reference_site": "96", "sequential_site": 105.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.2566, "escape": 0.5011, "mature_H5_site": 89.0, "mutant": "N", "mutation": "L96N", "reference_site": "96", "sequential_site": 105.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4283, "escape": -0.07239, "mature_H5_site": 89.0, "mutant": "Q", "mutation": "L96Q", "reference_site": "96", "sequential_site": 105.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.0235, "escape": -0.03596, "mature_H5_site": 89.0, "mutant": "R", "mutation": "L96R", "reference_site": "96", "sequential_site": 105.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -2.114, "escape": -0.3506, "mature_H5_site": 89.0, "mutant": "T", "mutation": "L96T", "reference_site": "96", "sequential_site": 105.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.4146, "escape": 1.104, "mature_H5_site": 89.0, "mutant": "V", "mutation": "L96V", "reference_site": "96", "sequential_site": 105.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -0.9464, "escape": -0.1168, "mature_H5_site": 89.0, "mutant": "W", "mutation": "L96W", "reference_site": "96", "sequential_site": 105.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": 0.03098, "escape": -0.1763, "mature_H5_site": 89.0, "mutant": "Y", "mutation": "L96Y", "reference_site": "96", "sequential_site": 105.0, "wildtype": "L"}, {"antibody": "310-018-13-7D11", "cell_entry": -5.723, "escape": -0.3106, "mature_H5_site": 91.0, "mutant": "H", "mutation": "Y98H", "reference_site": "98", "sequential_site": 107.0, "wildtype": "Y"}, {"antibody": "310-018-13-7D11", "cell_entry": -1.033, "escape": -0.3334, "mature_H5_site": 92.0, "mutant": "A", "mutation": "P99A", "reference_site": "99", "sequential_site": 108.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03853, "escape": 0.2571, "mature_H5_site": -11.0, "mutant": "C", "mutation": "L-1C", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.07267, "escape": 0.08809, "mature_H5_site": -11.0, "mutant": "F", "mutation": "L-1F", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3239, "escape": -0.08453, "mature_H5_site": -11.0, "mutant": "G", "mutation": "L-1G", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9294, "escape": 0.0477, "mature_H5_site": -11.0, "mutant": "H", "mutation": "L-1H", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04745, "escape": -0.003009, "mature_H5_site": -11.0, "mutant": "I", "mutation": "L-1I", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1128, "escape": -0.2161, "mature_H5_site": -11.0, "mutant": "K", "mutation": "L-1K", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2653, "escape": -0.1369, "mature_H5_site": -11.0, "mutant": "Q", "mutation": "L-1Q", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4204, "escape": -0.5323, "mature_H5_site": -11.0, "mutant": "R", "mutation": "L-1R", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.324, "escape": 0.04642, "mature_H5_site": -11.0, "mutant": "S", "mutation": "L-1S", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.451, "escape": 0.2458, "mature_H5_site": -11.0, "mutant": "T", "mutation": "L-1T", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3508, "escape": 0.311, "mature_H5_site": -11.0, "mutant": "V", "mutation": "L-1V", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.00238, "escape": -0.03879, "mature_H5_site": -11.0, "mutant": "W", "mutation": "L-1W", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1909, "escape": 0.1948, "mature_H5_site": -11.0, "mutant": "Y", "mutation": "L-1Y", "reference_site": "-1", "sequential_site": 6.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4358, "escape": 0.1267, "mature_H5_site": -12.0, "mutant": "A", "mutation": "V-2A", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01653, "escape": 0.2708, "mature_H5_site": -12.0, "mutant": "F", "mutation": "V-2F", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.05354, "escape": -0.1196, "mature_H5_site": -12.0, "mutant": "G", "mutation": "V-2G", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1321, "escape": -0.2099, "mature_H5_site": -12.0, "mutant": "H", "mutation": "V-2H", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.06828, "escape": -0.06122, "mature_H5_site": -12.0, "mutant": "I", "mutation": "V-2I", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.523, "escape": -0.1055, "mature_H5_site": -12.0, "mutant": "K", "mutation": "V-2K", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6403, "escape": 0.3989, "mature_H5_site": -12.0, "mutant": "M", "mutation": "V-2M", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2955, "escape": 0.06444, "mature_H5_site": -12.0, "mutant": "N", "mutation": "V-2N", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.437, "escape": 0.05517, "mature_H5_site": -12.0, "mutant": "P", "mutation": "V-2P", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7976, "escape": -0.1159, "mature_H5_site": -12.0, "mutant": "Q", "mutation": "V-2Q", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5964, "escape": 0.22, "mature_H5_site": -12.0, "mutant": "R", "mutation": "V-2R", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.278, "escape": -0.1284, "mature_H5_site": -12.0, "mutant": "S", "mutation": "V-2S", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.236, "escape": 0.001952, "mature_H5_site": -12.0, "mutant": "T", "mutation": "V-2T", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02014, "escape": -0.1083, "mature_H5_site": -12.0, "mutant": "W", "mutation": "V-2W", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2677, "escape": -0.0848, "mature_H5_site": -12.0, "mutant": "Y", "mutation": "V-2Y", "reference_site": "-2", "sequential_site": 5.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.694, "escape": 0.01913, "mature_H5_site": -13.0, "mutant": "E", "mutation": "I-3E", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2824, "escape": -0.285, "mature_H5_site": -13.0, "mutant": "F", "mutation": "I-3F", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5239, "escape": -0.1042, "mature_H5_site": -13.0, "mutant": "K", "mutation": "I-3K", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.347, "escape": -0.2181, "mature_H5_site": -13.0, "mutant": "M", "mutation": "I-3M", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4002, "escape": -0.1091, "mature_H5_site": -13.0, "mutant": "N", "mutation": "I-3N", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.08928, "escape": -0.01359, "mature_H5_site": -13.0, "mutant": "P", "mutation": "I-3P", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.24, "escape": -0.2163, "mature_H5_site": -13.0, "mutant": "Q", "mutation": "I-3Q", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3754, "escape": -0.06294, "mature_H5_site": -13.0, "mutant": "R", "mutation": "I-3R", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04928, "escape": 0.1597, "mature_H5_site": -13.0, "mutant": "S", "mutation": "I-3S", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.228, "escape": -0.1026, "mature_H5_site": -13.0, "mutant": "T", "mutation": "I-3T", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.216, "escape": -0.3611, "mature_H5_site": -13.0, "mutant": "V", "mutation": "I-3V", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05539, "escape": 0.1663, "mature_H5_site": -13.0, "mutant": "W", "mutation": "I-3W", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06426, "escape": -0.06563, "mature_H5_site": -13.0, "mutant": "Y", "mutation": "I-3Y", "reference_site": "-3", "sequential_site": 4.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05586, "escape": 0.264, "mature_H5_site": -14.0, "mutant": "A", "mutation": "N-4A", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.003655, "escape": 0.07365, "mature_H5_site": -14.0, "mutant": "C", "mutation": "N-4C", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.08413, "escape": 0.2139, "mature_H5_site": -14.0, "mutant": "D", "mutation": "N-4D", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04051, "escape": -0.1688, "mature_H5_site": -14.0, "mutant": "E", "mutation": "N-4E", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06012, "escape": -0.03617, "mature_H5_site": -14.0, "mutant": "F", "mutation": "N-4F", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.586, "escape": -0.123, "mature_H5_site": -14.0, "mutant": "G", "mutation": "N-4G", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05198, "escape": 0.03189, "mature_H5_site": -14.0, "mutant": "H", "mutation": "N-4H", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01491, "escape": -0.05512, "mature_H5_site": -14.0, "mutant": "I", "mutation": "N-4I", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1131, "escape": 0.1297, "mature_H5_site": -14.0, "mutant": "K", "mutation": "N-4K", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02193, "escape": -0.1626, "mature_H5_site": -14.0, "mutant": "L", "mutation": "N-4L", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4973, "escape": -0.03228, "mature_H5_site": -14.0, "mutant": "M", "mutation": "N-4M", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05024, "escape": 0.2508, "mature_H5_site": -14.0, "mutant": "Q", "mutation": "N-4Q", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2761, "escape": -0.1339, "mature_H5_site": -14.0, "mutant": "R", "mutation": "N-4R", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.25, "escape": -0.2074, "mature_H5_site": -14.0, "mutant": "T", "mutation": "N-4T", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07004, "escape": -0.09517, "mature_H5_site": -14.0, "mutant": "V", "mutation": "N-4V", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0767, "escape": 0.3232, "mature_H5_site": -14.0, "mutant": "W", "mutation": "N-4W", "reference_site": "-4", "sequential_site": 3.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2561, "escape": 0.1001, "mature_H5_site": -15.0, "mutant": "A", "mutation": "E-5A", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06022, "escape": 0.06216, "mature_H5_site": -15.0, "mutant": "C", "mutation": "E-5C", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.09452, "escape": -0.1867, "mature_H5_site": -15.0, "mutant": "F", "mutation": "E-5F", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1468, "escape": 0.0657, "mature_H5_site": -15.0, "mutant": "G", "mutation": "E-5G", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01327, "escape": 0.2848, "mature_H5_site": -15.0, "mutant": "H", "mutation": "E-5H", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0358, "escape": -0.2281, "mature_H5_site": -15.0, "mutant": "I", "mutation": "E-5I", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.07079, "escape": -0.01, "mature_H5_site": -15.0, "mutant": "K", "mutation": "E-5K", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.07343, "escape": 0.07036, "mature_H5_site": -15.0, "mutant": "L", "mutation": "E-5L", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.166, "escape": 0.2713, "mature_H5_site": -15.0, "mutant": "M", "mutation": "E-5M", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1724, "escape": 0.1382, "mature_H5_site": -15.0, "mutant": "N", "mutation": "E-5N", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02672, "escape": 0.09447, "mature_H5_site": -15.0, "mutant": "P", "mutation": "E-5P", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02099, "escape": -0.06022, "mature_H5_site": -15.0, "mutant": "Q", "mutation": "E-5Q", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02275, "escape": -0.02019, "mature_H5_site": -15.0, "mutant": "R", "mutation": "E-5R", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05347, "escape": 0.2211, "mature_H5_site": -15.0, "mutant": "S", "mutation": "E-5S", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05712, "escape": -0.241, "mature_H5_site": -15.0, "mutant": "T", "mutation": "E-5T", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.000975, "escape": -0.2321, "mature_H5_site": -15.0, "mutant": "V", "mutation": "E-5V", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03492, "escape": 0.28, "mature_H5_site": -15.0, "mutant": "W", "mutation": "E-5W", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3705, "escape": -0.05481, "mature_H5_site": -15.0, "mutant": "Y", "mutation": "E-5Y", "reference_site": "-5", "sequential_site": 2.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2586, "escape": 0.09925, "mature_H5_site": -10.0, "mutant": "C", "mutation": "L1C", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.003785, "escape": 0.0896, "mature_H5_site": -10.0, "mutant": "G", "mutation": "L1G", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.514, "escape": -0.3937, "mature_H5_site": -10.0, "mutant": "H", "mutation": "L1H", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.001975, "escape": -0.07119, "mature_H5_site": -10.0, "mutant": "I", "mutation": "L1I", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.755, "escape": -0.2416, "mature_H5_site": -10.0, "mutant": "M", "mutation": "L1M", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5069, "escape": -0.06719, "mature_H5_site": -10.0, "mutant": "S", "mutation": "L1S", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3497, "escape": -0.1066, "mature_H5_site": -10.0, "mutant": "T", "mutation": "L1T", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06815, "escape": 0.1851, "mature_H5_site": -10.0, "mutant": "V", "mutation": "L1V", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06074, "escape": -0.2955, "mature_H5_site": -10.0, "mutant": "W", "mutation": "L1W", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.239, "escape": -0.06839, "mature_H5_site": -10.0, "mutant": "Y", "mutation": "L1Y", "reference_site": "1", "sequential_site": 7.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.179, "escape": -0.2688, "mature_H5_site": -1.0, "mutant": "A", "mutation": "S10A", "reference_site": "10", "sequential_site": 16.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01148, "escape": 0.1946, "mature_H5_site": -1.0, "mutant": "C", "mutation": "S10C", "reference_site": "10", "sequential_site": 16.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2729, "escape": -0.1442, "mature_H5_site": -1.0, "mutant": "G", "mutation": "S10G", "reference_site": "10", "sequential_site": 16.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.337, "escape": 0.3693, "mature_H5_site": -1.0, "mutant": "N", "mutation": "S10N", "reference_site": "10", "sequential_site": 16.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.418, "escape": -0.09977, "mature_H5_site": -1.0, "mutant": "P", "mutation": "S10P", "reference_site": "10", "sequential_site": 16.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6802, "escape": -0.1158, "mature_H5_site": -1.0, "mutant": "T", "mutation": "S10T", "reference_site": "10", "sequential_site": 16.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3704, "escape": -0.1457, "mature_H5_site": 93.0, "mutant": "A", "mutation": "G100A", "reference_site": "100", "sequential_site": 109.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.103, "escape": 0.2301, "mature_H5_site": 93.0, "mutant": "S", "mutation": "G100S", "reference_site": "100", "sequential_site": 109.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0956, "escape": -0.1117, "mature_H5_site": 94.0, "mutant": "C", "mutation": "S101C", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02678, "escape": -0.1558, "mature_H5_site": 94.0, "mutant": "D", "mutation": "S101D", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02001, "escape": -0.145, "mature_H5_site": 94.0, "mutant": "F", "mutation": "S101F", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.088, "escape": -0.008742, "mature_H5_site": 94.0, "mutant": "G", "mutation": "S101G", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02848, "escape": -0.1541, "mature_H5_site": 94.0, "mutant": "H", "mutation": "S101H", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2838, "escape": -0.2407, "mature_H5_site": 94.0, "mutant": "L", "mutation": "S101L", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0626, "escape": 0.04761, "mature_H5_site": 94.0, "mutant": "M", "mutation": "S101M", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05616, "escape": 0.003014, "mature_H5_site": 94.0, "mutant": "N", "mutation": "S101N", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06219, "escape": -0.3976, "mature_H5_site": 94.0, "mutant": "Q", "mutation": "S101Q", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06874, "escape": -0.07837, "mature_H5_site": 94.0, "mutant": "R", "mutation": "S101R", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7448, "escape": -0.02176, "mature_H5_site": 94.0, "mutant": "T", "mutation": "S101T", "reference_site": "101", "sequential_site": 110.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3681, "escape": 0.09102, "mature_H5_site": 95.0, "mutant": "C", "mutation": "L102C", "reference_site": "102", "sequential_site": 111.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4405, "escape": -0.003875, "mature_H5_site": 95.0, "mutant": "F", "mutation": "L102F", "reference_site": "102", "sequential_site": 111.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04134, "escape": 0.1213, "mature_H5_site": 95.0, "mutant": "M", "mutation": "L102M", "reference_site": "102", "sequential_site": 111.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3189, "escape": -0.07073, "mature_H5_site": 96.0, "mutant": "A", "mutation": "N103A", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.084, "escape": 0.25, "mature_H5_site": 96.0, "mutant": "D", "mutation": "N103D", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02871, "escape": 0.08311, "mature_H5_site": 96.0, "mutant": "E", "mutation": "N103E", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7171, "escape": -0.01005, "mature_H5_site": 96.0, "mutant": "H", "mutation": "N103H", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4207, "escape": 0.0008075, "mature_H5_site": 96.0, "mutant": "I", "mutation": "N103I", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9121, "escape": -0.05696, "mature_H5_site": 96.0, "mutant": "K", "mutation": "N103K", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1763, "escape": 0.08877, "mature_H5_site": 96.0, "mutant": "M", "mutation": "N103M", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02512, "escape": -0.2603, "mature_H5_site": 96.0, "mutant": "P", "mutation": "N103P", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9675, "escape": -0.00543, "mature_H5_site": 96.0, "mutant": "Q", "mutation": "N103Q", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.003446, "escape": 0.1415, "mature_H5_site": 96.0, "mutant": "R", "mutation": "N103R", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3932, "escape": -0.0312, "mature_H5_site": 96.0, "mutant": "T", "mutation": "N103T", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02977, "escape": -0.07372, "mature_H5_site": 96.0, "mutant": "V", "mutation": "N103V", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01744, "escape": -0.1288, "mature_H5_site": 96.0, "mutant": "W", "mutation": "N103W", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2094, "escape": -0.0388, "mature_H5_site": 96.0, "mutant": "Y", "mutation": "N103Y", "reference_site": "103", "sequential_site": 112.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2377, "escape": -0.06362, "mature_H5_site": 97.0, "mutant": "C", "mutation": "D104C", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01429, "escape": 0.002942, "mature_H5_site": 97.0, "mutant": "E", "mutation": "D104E", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.251, "escape": 0.04931, "mature_H5_site": 97.0, "mutant": "F", "mutation": "D104F", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2573, "escape": -0.1743, "mature_H5_site": 97.0, "mutant": "G", "mutation": "D104G", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7358, "escape": -0.1112, "mature_H5_site": 97.0, "mutant": "H", "mutation": "D104H", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7713, "escape": 0.08732, "mature_H5_site": 97.0, "mutant": "I", "mutation": "D104I", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4873, "escape": 0.06106, "mature_H5_site": 97.0, "mutant": "N", "mutation": "D104N", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.051, "escape": 0.01601, "mature_H5_site": 97.0, "mutant": "P", "mutation": "D104P", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.07743, "escape": -0.1388, "mature_H5_site": 97.0, "mutant": "Q", "mutation": "D104Q", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.084, "escape": -0.02313, "mature_H5_site": 97.0, "mutant": "S", "mutation": "D104S", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5111, "escape": -0.01686, "mature_H5_site": 97.0, "mutant": "V", "mutation": "D104V", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2975, "escape": -0.2415, "mature_H5_site": 97.0, "mutant": "W", "mutation": "D104W", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.177, "escape": -0.06578, "mature_H5_site": 97.0, "mutant": "Y", "mutation": "D104Y", "reference_site": "104", "sequential_site": 113.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3245, "escape": -0.09188, "mature_H5_site": 98.0, "mutant": "E", "mutation": "Y105E", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.05183, "escape": -0.07532, "mature_H5_site": 98.0, "mutant": "H", "mutation": "Y105H", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.09787, "escape": -0.09688, "mature_H5_site": 98.0, "mutant": "I", "mutation": "Y105I", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1983, "escape": 0.1932, "mature_H5_site": 98.0, "mutant": "L", "mutation": "Y105L", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.06217, "escape": 0.1921, "mature_H5_site": 98.0, "mutant": "N", "mutation": "Y105N", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6564, "escape": -0.007485, "mature_H5_site": 98.0, "mutant": "Q", "mutation": "Y105Q", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4109, "escape": 0.2447, "mature_H5_site": 98.0, "mutant": "R", "mutation": "Y105R", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.07614, "escape": -0.209, "mature_H5_site": 98.0, "mutant": "V", "mutation": "Y105V", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01433, "escape": -0.1251, "mature_H5_site": 98.0, "mutant": "W", "mutation": "Y105W", "reference_site": "105", "sequential_site": 114.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6726, "escape": -0.2559, "mature_H5_site": 99.0, "mutant": "D", "mutation": "E106D", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7146, "escape": 0.09416, "mature_H5_site": 99.0, "mutant": "F", "mutation": "E106F", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3959, "escape": -0.08955, "mature_H5_site": 99.0, "mutant": "G", "mutation": "E106G", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3512, "escape": 0.1754, "mature_H5_site": 99.0, "mutant": "H", "mutation": "E106H", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5907, "escape": -0.008678, "mature_H5_site": 99.0, "mutant": "L", "mutation": "E106L", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.09538, "escape": 0.1704, "mature_H5_site": 99.0, "mutant": "M", "mutation": "E106M", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.649, "escape": -0.2046, "mature_H5_site": 99.0, "mutant": "N", "mutation": "E106N", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1303, "escape": 0.04916, "mature_H5_site": 99.0, "mutant": "Q", "mutation": "E106Q", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.537, "escape": -0.3171, "mature_H5_site": 99.0, "mutant": "Y", "mutation": "E106Y", "reference_site": "106", "sequential_site": 115.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2334, "escape": 0.03889, "mature_H5_site": 101.0, "mutant": "M", "mutation": "L108M", "reference_site": "108", "sequential_site": 117.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07599, "escape": -0.3662, "mature_H5_site": 102.0, "mutant": "A", "mutation": "K109A", "reference_site": "109", "sequential_site": 118.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6565, "escape": -0.3883, "mature_H5_site": 102.0, "mutant": "C", "mutation": "K109C", "reference_site": "109", "sequential_site": 118.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1584, "escape": -0.2296, "mature_H5_site": 102.0, "mutant": "Q", "mutation": "K109Q", "reference_site": "109", "sequential_site": 118.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1504, "escape": 0.05152, "mature_H5_site": 102.0, "mutant": "R", "mutation": "K109R", "reference_site": "109", "sequential_site": 118.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.366, "escape": -0.2696, "mature_H5_site": 103.0, "mutant": "A", "mutation": "H110A", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.888, "escape": -0.1394, "mature_H5_site": 103.0, "mutant": "C", "mutation": "H110C", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.331, "escape": -0.5258, "mature_H5_site": 103.0, "mutant": "E", "mutation": "H110E", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.883, "escape": 0.244, "mature_H5_site": 103.0, "mutant": "M", "mutation": "H110M", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7925, "escape": -0.2456, "mature_H5_site": 103.0, "mutant": "N", "mutation": "H110N", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.601, "escape": -0.1011, "mature_H5_site": 103.0, "mutant": "Q", "mutation": "H110Q", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5953, "escape": -0.08937, "mature_H5_site": 103.0, "mutant": "S", "mutation": "H110S", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.135, "escape": 0.1118, "mature_H5_site": 103.0, "mutant": "T", "mutation": "H110T", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -4.351, "escape": 0.02715, "mature_H5_site": 103.0, "mutant": "Y", "mutation": "H110Y", "reference_site": "110", "sequential_site": 119.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -3.491, "escape": -0.7175, "mature_H5_site": 104.0, "mutant": "A", "mutation": "M111A", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8764, "escape": -0.2809, "mature_H5_site": 104.0, "mutant": "C", "mutation": "M111C", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-054-13-12D03", "cell_entry": -3.17, "escape": -0.4749, "mature_H5_site": 104.0, "mutant": "D", "mutation": "M111D", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02311, "escape": 0.002871, "mature_H5_site": 104.0, "mutant": "G", "mutation": "M111G", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01186, "escape": -0.2845, "mature_H5_site": 104.0, "mutant": "H", "mutation": "M111H", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01526, "escape": -0.1648, "mature_H5_site": 104.0, "mutant": "I", "mutation": "M111I", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01373, "escape": -0.17, "mature_H5_site": 104.0, "mutant": "L", "mutation": "M111L", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4343, "escape": -0.03816, "mature_H5_site": 104.0, "mutant": "S", "mutation": "M111S", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.037, "escape": -0.05702, "mature_H5_site": 104.0, "mutant": "T", "mutation": "M111T", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.444, "escape": 0.04601, "mature_H5_site": 104.0, "mutant": "W", "mutation": "M111W", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2695, "escape": -0.1194, "mature_H5_site": 104.0, "mutant": "Y", "mutation": "M111Y", "reference_site": "111", "sequential_site": 120.0, "wildtype": "M"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5001, "escape": 0.1174, "mature_H5_site": 105.0, "mutant": "C", "mutation": "L112C", "reference_site": "112", "sequential_site": 121.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4761, "escape": 0.1169, "mature_H5_site": 105.0, "mutant": "I", "mutation": "L112I", "reference_site": "112", "sequential_site": 121.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07681, "escape": 0.05062, "mature_H5_site": 105.0, "mutant": "M", "mutation": "L112M", "reference_site": "112", "sequential_site": 121.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.913, "escape": -0.5388, "mature_H5_site": 105.0, "mutant": "S", "mutation": "L112S", "reference_site": "112", "sequential_site": 121.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.093, "escape": 0.09947, "mature_H5_site": 105.0, "mutant": "V", "mutation": "L112V", "reference_site": "112", "sequential_site": 121.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04543, "escape": 0.1411, "mature_H5_site": 106.0, "mutant": "A", "mutation": "S113A", "reference_site": "113", "sequential_site": 122.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.981, "escape": -0.725, "mature_H5_site": 106.0, "mutant": "G", "mutation": "S113G", "reference_site": "113", "sequential_site": 122.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04878, "escape": 0.1372, "mature_H5_site": 107.0, "mutant": "C", "mutation": "R114C", "reference_site": "114", "sequential_site": 123.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.285, "escape": -0.2964, "mature_H5_site": 107.0, "mutant": "K", "mutation": "R114K", "reference_site": "114", "sequential_site": 123.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -4.156, "escape": 0.02299, "mature_H5_site": 107.0, "mutant": "Q", "mutation": "R114Q", "reference_site": "114", "sequential_site": 123.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4584, "escape": 0.1208, "mature_H5_site": 107.0, "mutant": "W", "mutation": "R114W", "reference_site": "114", "sequential_site": 123.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5778, "escape": -0.2307, "mature_H5_site": 107.0, "mutant": "Y", "mutation": "R114Y", "reference_site": "114", "sequential_site": 123.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9204, "escape": 0.2502, "mature_H5_site": 108.0, "mutant": "L", "mutation": "I115L", "reference_site": "115", "sequential_site": 124.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.07, "escape": 0.1849, "mature_H5_site": 109.0, "mutant": "H", "mutation": "N116H", "reference_site": "116", "sequential_site": 125.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.00154, "escape": -0.08785, "mature_H5_site": 109.0, "mutant": "K", "mutation": "N116K", "reference_site": "116", "sequential_site": 125.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7297, "escape": 0.293, "mature_H5_site": 109.0, "mutant": "M", "mutation": "N116M", "reference_site": "116", "sequential_site": 125.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.405, "escape": 0.1432, "mature_H5_site": 109.0, "mutant": "P", "mutation": "N116P", "reference_site": "116", "sequential_site": 125.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0768, "escape": 0.03389, "mature_H5_site": 109.0, "mutant": "Q", "mutation": "N116Q", "reference_site": "116", "sequential_site": 125.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.368, "escape": -0.437, "mature_H5_site": 109.0, "mutant": "S", "mutation": "N116S", "reference_site": "116", "sequential_site": 125.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.449, "escape": 0.1209, "mature_H5_site": 110.0, "mutant": "C", "mutation": "H117C", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2694, "escape": 0.1097, "mature_H5_site": 110.0, "mutant": "D", "mutation": "H117D", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03195, "escape": -0.02914, "mature_H5_site": 110.0, "mutant": "N", "mutation": "H117N", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3424, "escape": -0.03861, "mature_H5_site": 110.0, "mutant": "Q", "mutation": "H117Q", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3956, "escape": 0.08315, "mature_H5_site": 110.0, "mutant": "R", "mutation": "H117R", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03186, "escape": 0.08603, "mature_H5_site": 110.0, "mutant": "S", "mutation": "H117S", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5314, "escape": -0.02113, "mature_H5_site": 110.0, "mutant": "T", "mutation": "H117T", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03752, "escape": -0.129, "mature_H5_site": 110.0, "mutant": "W", "mutation": "H117W", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5233, "escape": 0.2661, "mature_H5_site": 110.0, "mutant": "Y", "mutation": "H117Y", "reference_site": "117", "sequential_site": 126.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9971, "escape": 0.08301, "mature_H5_site": 111.0, "mutant": "C", "mutation": "F118C", "reference_site": "118", "sequential_site": 127.0, "wildtype": "F"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5722, "escape": 0.4639, "mature_H5_site": 111.0, "mutant": "H", "mutation": "F118H", "reference_site": "118", "sequential_site": 127.0, "wildtype": "F"}, {"antibody": "310-054-13-12D03", "cell_entry": -3.001, "escape": -0.1526, "mature_H5_site": 111.0, "mutant": "T", "mutation": "F118T", "reference_site": "118", "sequential_site": 127.0, "wildtype": "F"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8548, "escape": 0.4924, "mature_H5_site": 111.0, "mutant": "Y", "mutation": "F118Y", "reference_site": "118", "sequential_site": 127.0, "wildtype": "F"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3972, "escape": 0.1688, "mature_H5_site": 112.0, "mutant": "D", "mutation": "E119D", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.011, "escape": -0.04521, "mature_H5_site": 112.0, "mutant": "F", "mutation": "E119F", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.479, "escape": -0.004264, "mature_H5_site": 112.0, "mutant": "G", "mutation": "E119G", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.07822, "escape": 0.1007, "mature_H5_site": 112.0, "mutant": "H", "mutation": "E119H", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.161, "escape": -0.288, "mature_H5_site": 112.0, "mutant": "K", "mutation": "E119K", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0783, "escape": 0.2291, "mature_H5_site": 112.0, "mutant": "M", "mutation": "E119M", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4814, "escape": -0.1015, "mature_H5_site": 112.0, "mutant": "N", "mutation": "E119N", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06823, "escape": 0.4629, "mature_H5_site": 112.0, "mutant": "R", "mutation": "E119R", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5659, "escape": -0.05993, "mature_H5_site": 112.0, "mutant": "S", "mutation": "E119S", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3562, "escape": 0.22, "mature_H5_site": 112.0, "mutant": "T", "mutation": "E119T", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4491, "escape": -0.1258, "mature_H5_site": 112.0, "mutant": "V", "mutation": "E119V", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.804, "escape": 0.1471, "mature_H5_site": 112.0, "mutant": "W", "mutation": "E119W", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6957, "escape": 0.005611, "mature_H5_site": 112.0, "mutant": "Y", "mutation": "E119Y", "reference_site": "119", "sequential_site": 128.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.06322, "escape": -0.106, "mature_H5_site": 2.0, "mutant": "C", "mutation": "Q12C", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4799, "escape": -0.02427, "mature_H5_site": 2.0, "mutant": "E", "mutation": "Q12E", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.00978, "escape": -0.07196, "mature_H5_site": 2.0, "mutant": "F", "mutation": "Q12F", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2583, "escape": -0.1101, "mature_H5_site": 2.0, "mutant": "H", "mutation": "Q12H", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0239, "escape": -0.07101, "mature_H5_site": 2.0, "mutant": "I", "mutation": "Q12I", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03238, "escape": -0.07639, "mature_H5_site": 2.0, "mutant": "K", "mutation": "Q12K", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05822, "escape": -0.01726, "mature_H5_site": 2.0, "mutant": "N", "mutation": "Q12N", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1152, "escape": 0.3876, "mature_H5_site": 2.0, "mutant": "R", "mutation": "Q12R", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.372, "escape": 0.06059, "mature_H5_site": 2.0, "mutant": "S", "mutation": "Q12S", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01009, "escape": -0.1774, "mature_H5_site": 2.0, "mutant": "V", "mutation": "Q12V", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9424, "escape": 0.02933, "mature_H5_site": 2.0, "mutant": "Y", "mutation": "Q12Y", "reference_site": "12", "sequential_site": 18.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01951, "escape": 0.1127, "mature_H5_site": 113.0, "mutant": "A", "mutation": "K120A", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2547, "escape": -0.373, "mature_H5_site": 113.0, "mutant": "E", "mutation": "K120E", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8044, "escape": -0.3264, "mature_H5_site": 113.0, "mutant": "G", "mutation": "K120G", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5709, "escape": -0.02316, "mature_H5_site": 113.0, "mutant": "H", "mutation": "K120H", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3311, "escape": 0.06419, "mature_H5_site": 113.0, "mutant": "I", "mutation": "K120I", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03023, "escape": 0.02815, "mature_H5_site": 113.0, "mutant": "M", "mutation": "K120M", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.05283, "escape": -0.2997, "mature_H5_site": 113.0, "mutant": "P", "mutation": "K120P", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02981, "escape": -0.287, "mature_H5_site": 113.0, "mutant": "Q", "mutation": "K120Q", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.692, "escape": -0.3344, "mature_H5_site": 113.0, "mutant": "R", "mutation": "K120R", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0716, "escape": -0.23, "mature_H5_site": 113.0, "mutant": "T", "mutation": "K120T", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.438, "escape": -0.02799, "mature_H5_site": 113.0, "mutant": "Y", "mutation": "K120Y", "reference_site": "120", "sequential_site": 129.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03422, "escape": 0.2641, "mature_H5_site": 114.0, "mutant": "A", "mutation": "I121A", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.531, "escape": 0.00111, "mature_H5_site": 114.0, "mutant": "C", "mutation": "I121C", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3542, "escape": 0.2904, "mature_H5_site": 114.0, "mutant": "E", "mutation": "I121E", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1405, "escape": -0.09126, "mature_H5_site": 114.0, "mutant": "F", "mutation": "I121F", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0355, "escape": -0.1298, "mature_H5_site": 114.0, "mutant": "K", "mutation": "I121K", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03692, "escape": -0.03933, "mature_H5_site": 114.0, "mutant": "M", "mutation": "I121M", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.06919, "escape": -0.1199, "mature_H5_site": 114.0, "mutant": "N", "mutation": "I121N", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2019, "escape": -0.06289, "mature_H5_site": 114.0, "mutant": "R", "mutation": "I121R", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03352, "escape": 0.000182, "mature_H5_site": 114.0, "mutant": "T", "mutation": "I121T", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6371, "escape": 0.04959, "mature_H5_site": 114.0, "mutant": "V", "mutation": "I121V", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2212, "escape": -0.1021, "mature_H5_site": 114.0, "mutant": "W", "mutation": "I121W", "reference_site": "121", "sequential_site": 130.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4973, "escape": -0.356, "mature_H5_site": 115.0, "mutant": "E", "mutation": "L122E", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3482, "escape": -0.05873, "mature_H5_site": 115.0, "mutant": "F", "mutation": "L122F", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02544, "escape": -0.0383, "mature_H5_site": 115.0, "mutant": "H", "mutation": "L122H", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3065, "escape": -0.03616, "mature_H5_site": 115.0, "mutant": "I", "mutation": "L122I", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.163, "escape": 0.1148, "mature_H5_site": 115.0, "mutant": "K", "mutation": "L122K", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4126, "escape": 0.1185, "mature_H5_site": 115.0, "mutant": "M", "mutation": "L122M", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3185, "escape": -0.07306, "mature_H5_site": 115.0, "mutant": "N", "mutation": "L122N", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.001835, "escape": 0.03524, "mature_H5_site": 115.0, "mutant": "P", "mutation": "L122P", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07306, "escape": 0.08942, "mature_H5_site": 115.0, "mutant": "Q", "mutation": "L122Q", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01141, "escape": 0.2449, "mature_H5_site": 115.0, "mutant": "R", "mutation": "L122R", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1468, "escape": 0.2343, "mature_H5_site": 115.0, "mutant": "W", "mutation": "L122W", "reference_site": "122", "sequential_site": 131.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1908, "escape": 0.07409, "mature_H5_site": 116.0, "mutant": "A", "mutation": "I123A", "reference_site": "123", "sequential_site": 132.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1483, "escape": -0.2029, "mature_H5_site": 116.0, "mutant": "F", "mutation": "I123F", "reference_site": "123", "sequential_site": 132.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1876, "escape": 0.02385, "mature_H5_site": 116.0, "mutant": "L", "mutation": "I123L", "reference_site": "123", "sequential_site": 132.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.001085, "escape": -0.07821, "mature_H5_site": 116.0, "mutant": "M", "mutation": "I123M", "reference_site": "123", "sequential_site": 132.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.579, "escape": 0.1024, "mature_H5_site": 116.0, "mutant": "S", "mutation": "I123S", "reference_site": "123", "sequential_site": 132.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2315, "escape": -0.003811, "mature_H5_site": 116.0, "mutant": "V", "mutation": "I123V", "reference_site": "123", "sequential_site": 132.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06524, "escape": -0.4893, "mature_H5_site": 116.0, "mutant": "W", "mutation": "I123W", "reference_site": "123", "sequential_site": 132.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.06385, "escape": 0.2115, "mature_H5_site": 117.0, "mutant": "A", "mutation": "I124A", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5464, "escape": 0.1879, "mature_H5_site": 117.0, "mutant": "D", "mutation": "I124D", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1112, "escape": 0.07232, "mature_H5_site": 117.0, "mutant": "H", "mutation": "I124H", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4002, "escape": 0.41, "mature_H5_site": 117.0, "mutant": "K", "mutation": "I124K", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1626, "escape": -0.05525, "mature_H5_site": 117.0, "mutant": "L", "mutation": "I124L", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0379, "escape": 0.3053, "mature_H5_site": 117.0, "mutant": "N", "mutation": "I124N", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.078, "escape": -0.1424, "mature_H5_site": 117.0, "mutant": "Q", "mutation": "I124Q", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2653, "escape": 0.3213, "mature_H5_site": 117.0, "mutant": "R", "mutation": "I124R", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6515, "escape": 0.1712, "mature_H5_site": 117.0, "mutant": "S", "mutation": "I124S", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07219, "escape": 0.2671, "mature_H5_site": 117.0, "mutant": "T", "mutation": "I124T", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01622, "escape": 0.153, "mature_H5_site": 117.0, "mutant": "V", "mutation": "I124V", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0936, "escape": 0.08686, "mature_H5_site": 117.0, "mutant": "W", "mutation": "I124W", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3624, "escape": 0.2596, "mature_H5_site": 117.0, "mutant": "Y", "mutation": "I124Y", "reference_site": "124", "sequential_site": 133.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03685, "escape": 0.09286, "mature_H5_site": 118.0, "mutant": "A", "mutation": "P125A", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0963, "escape": -0.06851, "mature_H5_site": 118.0, "mutant": "D", "mutation": "P125D", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0373, "escape": 0.02022, "mature_H5_site": 118.0, "mutant": "G", "mutation": "P125G", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6355, "escape": 0.1297, "mature_H5_site": 118.0, "mutant": "H", "mutation": "P125H", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3328, "escape": -0.03751, "mature_H5_site": 118.0, "mutant": "K", "mutation": "P125K", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06372, "escape": -0.1835, "mature_H5_site": 118.0, "mutant": "N", "mutation": "P125N", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.00216, "escape": 0.1174, "mature_H5_site": 118.0, "mutant": "Q", "mutation": "P125Q", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1268, "escape": -0.1314, "mature_H5_site": 118.0, "mutant": "R", "mutation": "P125R", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.06537, "escape": 0.1304, "mature_H5_site": 118.0, "mutant": "S", "mutation": "P125S", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.00919, "escape": -0.06569, "mature_H5_site": 118.0, "mutant": "T", "mutation": "P125T", "reference_site": "125", "sequential_site": 134.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0403, "escape": -0.1512, "mature_H5_site": 119.0, "mutant": "D", "mutation": "K125aD", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.483, "escape": -0.3547, "mature_H5_site": 119.0, "mutant": "E", "mutation": "K125aE", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07407, "escape": -0.3042, "mature_H5_site": 119.0, "mutant": "F", "mutation": "K125aF", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.04975, "escape": -0.2856, "mature_H5_site": 119.0, "mutant": "G", "mutation": "K125aG", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2167, "escape": -0.3087, "mature_H5_site": 119.0, "mutant": "H", "mutation": "K125aH", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06885, "escape": 0.02671, "mature_H5_site": 119.0, "mutant": "I", "mutation": "K125aI", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2719, "escape": -0.1225, "mature_H5_site": 119.0, "mutant": "M", "mutation": "K125aM", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.00878, "escape": -0.3031, "mature_H5_site": 119.0, "mutant": "N", "mutation": "K125aN", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02823, "escape": -0.1547, "mature_H5_site": 119.0, "mutant": "P", "mutation": "K125aP", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.195, "escape": -0.5967, "mature_H5_site": 119.0, "mutant": "Q", "mutation": "K125aQ", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06646, "escape": 0.156, "mature_H5_site": 119.0, "mutant": "R", "mutation": "K125aR", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.05916, "escape": -0.01053, "mature_H5_site": 119.0, "mutant": "S", "mutation": "K125aS", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1732, "escape": -0.1032, "mature_H5_site": 119.0, "mutant": "T", "mutation": "K125aT", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2305, "escape": -0.1932, "mature_H5_site": 119.0, "mutant": "V", "mutation": "K125aV", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2351, "escape": -0.3986, "mature_H5_site": 119.0, "mutant": "Y", "mutation": "K125aY", "reference_site": "125a", "sequential_site": 135.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4078, "escape": 0.3693, "mature_H5_site": 120.0, "mutant": "F", "mutation": "S125bF", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07065, "escape": -0.1613, "mature_H5_site": 120.0, "mutant": "G", "mutation": "S125bG", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06391, "escape": -0.1005, "mature_H5_site": 120.0, "mutant": "I", "mutation": "S125bI", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.758, "escape": 0.3758, "mature_H5_site": 120.0, "mutant": "K", "mutation": "S125bK", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3458, "escape": -0.006322, "mature_H5_site": 120.0, "mutant": "N", "mutation": "S125bN", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.04187, "escape": -0.3842, "mature_H5_site": 120.0, "mutant": "P", "mutation": "S125bP", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02757, "escape": 0.06269, "mature_H5_site": 120.0, "mutant": "Q", "mutation": "S125bQ", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1137, "escape": 0.01022, "mature_H5_site": 120.0, "mutant": "T", "mutation": "S125bT", "reference_site": "125b", "sequential_site": 136.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.05417, "escape": -0.05794, "mature_H5_site": 121.0, "mutant": "D", "mutation": "S126D", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07494, "escape": -0.04968, "mature_H5_site": 121.0, "mutant": "E", "mutation": "S126E", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06291, "escape": 0.12, "mature_H5_site": 121.0, "mutant": "F", "mutation": "S126F", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06282, "escape": -0.5892, "mature_H5_site": 121.0, "mutant": "G", "mutation": "S126G", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.05087, "escape": 0.09876, "mature_H5_site": 121.0, "mutant": "H", "mutation": "S126H", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3866, "escape": 0.09305, "mature_H5_site": 121.0, "mutant": "I", "mutation": "S126I", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4674, "escape": -0.09511, "mature_H5_site": 121.0, "mutant": "K", "mutation": "S126K", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02509, "escape": 0.1056, "mature_H5_site": 121.0, "mutant": "N", "mutation": "S126N", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4739, "escape": 0.04664, "mature_H5_site": 121.0, "mutant": "V", "mutation": "S126V", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3799, "escape": 0.4457, "mature_H5_site": 121.0, "mutant": "W", "mutation": "S126W", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2207, "escape": 0.1326, "mature_H5_site": 121.0, "mutant": "Y", "mutation": "S126Y", "reference_site": "126", "sequential_site": 137.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.167, "escape": 0.2774, "mature_H5_site": 122.0, "mutant": "C", "mutation": "W127C", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03642, "escape": 0.09798, "mature_H5_site": 122.0, "mutant": "H", "mutation": "W127H", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1673, "escape": 0.08811, "mature_H5_site": 122.0, "mutant": "L", "mutation": "W127L", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1395, "escape": 0.3427, "mature_H5_site": 122.0, "mutant": "M", "mutation": "W127M", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.015, "escape": 0.4917, "mature_H5_site": 122.0, "mutant": "N", "mutation": "W127N", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.579, "escape": -0.1545, "mature_H5_site": 122.0, "mutant": "Q", "mutation": "W127Q", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3057, "escape": 0.464, "mature_H5_site": 122.0, "mutant": "T", "mutation": "W127T", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2977, "escape": 0.07767, "mature_H5_site": 122.0, "mutant": "V", "mutation": "W127V", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3755, "escape": 0.1588, "mature_H5_site": 122.0, "mutant": "Y", "mutation": "W127Y", "reference_site": "127", "sequential_site": 138.0, "wildtype": "W"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02553, "escape": 0.03374, "mature_H5_site": 123.0, "mutant": "A", "mutation": "P128A", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.00625, "escape": 0.08147, "mature_H5_site": 123.0, "mutant": "F", "mutation": "P128F", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.08099, "escape": -0.253, "mature_H5_site": 123.0, "mutant": "G", "mutation": "P128G", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03691, "escape": 0.1619, "mature_H5_site": 123.0, "mutant": "H", "mutation": "P128H", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4396, "escape": -0.003412, "mature_H5_site": 123.0, "mutant": "K", "mutation": "P128K", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.04475, "escape": -0.134, "mature_H5_site": 123.0, "mutant": "L", "mutation": "P128L", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05714, "escape": -0.1921, "mature_H5_site": 123.0, "mutant": "N", "mutation": "P128N", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04128, "escape": 0.09261, "mature_H5_site": 123.0, "mutant": "Q", "mutation": "P128Q", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.006287, "escape": -0.1271, "mature_H5_site": 123.0, "mutant": "R", "mutation": "P128R", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.07457, "escape": -0.04336, "mature_H5_site": 123.0, "mutant": "S", "mutation": "P128S", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.449, "escape": -0.3539, "mature_H5_site": 123.0, "mutant": "T", "mutation": "P128T", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05711, "escape": -0.0657, "mature_H5_site": 123.0, "mutant": "V", "mutation": "P128V", "reference_site": "128", "sequential_site": 139.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06982, "escape": -0.01846, "mature_H5_site": 124.0, "mutant": "A", "mutation": "N129A", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1366, "escape": -0.0382, "mature_H5_site": 124.0, "mutant": "E", "mutation": "N129E", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07839, "escape": 0.09904, "mature_H5_site": 124.0, "mutant": "G", "mutation": "N129G", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07043, "escape": -0.04419, "mature_H5_site": 124.0, "mutant": "H", "mutation": "N129H", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4981, "escape": 0.04075, "mature_H5_site": 124.0, "mutant": "I", "mutation": "N129I", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3603, "escape": -0.08442, "mature_H5_site": 124.0, "mutant": "K", "mutation": "N129K", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0653, "escape": 0.2827, "mature_H5_site": 124.0, "mutant": "M", "mutation": "N129M", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2513, "escape": 0.02455, "mature_H5_site": 124.0, "mutant": "R", "mutation": "N129R", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1108, "escape": 0.1544, "mature_H5_site": 124.0, "mutant": "S", "mutation": "N129S", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05205, "escape": 0.1805, "mature_H5_site": 124.0, "mutant": "T", "mutation": "N129T", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3927, "escape": 0.09665, "mature_H5_site": 124.0, "mutant": "Y", "mutation": "N129Y", "reference_site": "129", "sequential_site": 140.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8341, "escape": -0.1642, "mature_H5_site": 3.0, "mutant": "F", "mutation": "I13F", "reference_site": "13", "sequential_site": 19.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05027, "escape": 0.3138, "mature_H5_site": 3.0, "mutant": "L", "mutation": "I13L", "reference_site": "13", "sequential_site": 19.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3934, "escape": 0.1304, "mature_H5_site": 3.0, "mutant": "M", "mutation": "I13M", "reference_site": "13", "sequential_site": 19.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8262, "escape": 0.1115, "mature_H5_site": 3.0, "mutant": "V", "mutation": "I13V", "reference_site": "13", "sequential_site": 19.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1142, "escape": 0.6061, "mature_H5_site": 125.0, "mutant": "F", "mutation": "H130F", "reference_site": "130", "sequential_site": 141.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0569, "escape": -0.2112, "mature_H5_site": 125.0, "mutant": "L", "mutation": "H130L", "reference_site": "130", "sequential_site": 141.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.07983, "escape": 0.4272, "mature_H5_site": 125.0, "mutant": "Q", "mutation": "H130Q", "reference_site": "130", "sequential_site": 141.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.488, "escape": 0.3484, "mature_H5_site": 125.0, "mutant": "W", "mutation": "H130W", "reference_site": "130", "sequential_site": 141.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02402, "escape": -0.6451, "mature_H5_site": 126.0, "mutant": "A", "mutation": "E131A", "reference_site": "131", "sequential_site": 142.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1736, "escape": -0.332, "mature_H5_site": 126.0, "mutant": "F", "mutation": "E131F", "reference_site": "131", "sequential_site": 142.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5302, "escape": 1.522, "mature_H5_site": 126.0, "mutant": "K", "mutation": "E131K", "reference_site": "131", "sequential_site": 142.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0582, "escape": 2.0, "mature_H5_site": 126.0, "mutant": "N", "mutation": "E131N", "reference_site": "131", "sequential_site": 142.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4504, "escape": 0.6919, "mature_H5_site": 126.0, "mutant": "R", "mutation": "E131R", "reference_site": "131", "sequential_site": 142.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0516, "escape": -0.3204, "mature_H5_site": 126.0, "mutant": "S", "mutation": "E131S", "reference_site": "131", "sequential_site": 142.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02217, "escape": 0.96, "mature_H5_site": 127.0, "mutant": "C", "mutation": "T132C", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1347, "escape": 0.858, "mature_H5_site": 127.0, "mutant": "E", "mutation": "T132E", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7645, "escape": 0.8906, "mature_H5_site": 127.0, "mutant": "F", "mutation": "T132F", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06669, "escape": 0.05862, "mature_H5_site": 127.0, "mutant": "G", "mutation": "T132G", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6061, "escape": 0.2034, "mature_H5_site": 127.0, "mutant": "H", "mutation": "T132H", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5881, "escape": -0.0006376, "mature_H5_site": 127.0, "mutant": "I", "mutation": "T132I", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1391, "escape": 0.6038, "mature_H5_site": 127.0, "mutant": "K", "mutation": "T132K", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.523, "escape": 1.151, "mature_H5_site": 127.0, "mutant": "L", "mutation": "T132L", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.00575, "escape": 0.8584, "mature_H5_site": 127.0, "mutant": "M", "mutation": "T132M", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2738, "escape": 0.4358, "mature_H5_site": 127.0, "mutant": "N", "mutation": "T132N", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3375, "escape": 0.5811, "mature_H5_site": 127.0, "mutant": "Q", "mutation": "T132Q", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.08433, "escape": 0.2659, "mature_H5_site": 127.0, "mutant": "R", "mutation": "T132R", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01629, "escape": 0.5198, "mature_H5_site": 127.0, "mutant": "S", "mutation": "T132S", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1557, "escape": 0.02908, "mature_H5_site": 127.0, "mutant": "V", "mutation": "T132V", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1217, "escape": 0.4555, "mature_H5_site": 127.0, "mutant": "W", "mutation": "T132W", "reference_site": "132", "sequential_site": 143.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06721, "escape": -0.7981, "mature_H5_site": 128.0, "mutant": "E", "mutation": "S133E", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0365, "escape": 0.1659, "mature_H5_site": 128.0, "mutant": "H", "mutation": "S133H", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1876, "escape": -0.3303, "mature_H5_site": 128.0, "mutant": "I", "mutation": "S133I", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01511, "escape": -0.07233, "mature_H5_site": 128.0, "mutant": "K", "mutation": "S133K", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4726, "escape": -0.6378, "mature_H5_site": 128.0, "mutant": "N", "mutation": "S133N", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4765, "escape": 0.1198, "mature_H5_site": 128.0, "mutant": "R", "mutation": "S133R", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0368, "escape": 0.3675, "mature_H5_site": 128.0, "mutant": "T", "mutation": "S133T", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.09649, "escape": 0.2372, "mature_H5_site": 128.0, "mutant": "Y", "mutation": "S133Y", "reference_site": "133", "sequential_site": 144.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1198, "escape": 1.986, "mature_H5_site": 129.0, "mutant": "D", "mutation": "L133aD", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03465, "escape": 1.98, "mature_H5_site": 129.0, "mutant": "E", "mutation": "L133aE", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.57, "escape": 1.707, "mature_H5_site": 129.0, "mutant": "F", "mutation": "L133aF", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1576, "escape": 1.622, "mature_H5_site": 129.0, "mutant": "G", "mutation": "L133aG", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03911, "escape": 1.748, "mature_H5_site": 129.0, "mutant": "H", "mutation": "L133aH", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.42, "escape": 1.555, "mature_H5_site": 129.0, "mutant": "K", "mutation": "L133aK", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.09832, "escape": 1.051, "mature_H5_site": 129.0, "mutant": "M", "mutation": "L133aM", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02306, "escape": 2.199, "mature_H5_site": 129.0, "mutant": "N", "mutation": "L133aN", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02408, "escape": 1.429, "mature_H5_site": 129.0, "mutant": "P", "mutation": "L133aP", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.234, "escape": 1.842, "mature_H5_site": 129.0, "mutant": "Q", "mutation": "L133aQ", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5591, "escape": 0.7974, "mature_H5_site": 129.0, "mutant": "R", "mutation": "L133aR", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.795, "escape": 0.4009, "mature_H5_site": 129.0, "mutant": "S", "mutation": "L133aS", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1648, "escape": 0.9138, "mature_H5_site": 129.0, "mutant": "V", "mutation": "L133aV", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2945, "escape": 2.208, "mature_H5_site": 129.0, "mutant": "W", "mutation": "L133aW", "reference_site": "133a", "sequential_site": 145.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.06, "escape": 0.728, "mature_H5_site": 130.0, "mutant": "A", "mutation": "G134A", "reference_site": "134", "sequential_site": 146.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0584, "escape": 0.358, "mature_H5_site": 131.0, "mutant": "A", "mutation": "V135A", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1314, "escape": 2.184, "mature_H5_site": 131.0, "mutant": "D", "mutation": "V135D", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06537, "escape": 0.9847, "mature_H5_site": 131.0, "mutant": "E", "mutation": "V135E", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1621, "escape": 0.8925, "mature_H5_site": 131.0, "mutant": "F", "mutation": "V135F", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1416, "escape": 1.728, "mature_H5_site": 131.0, "mutant": "H", "mutation": "V135H", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03009, "escape": 0.6635, "mature_H5_site": 131.0, "mutant": "I", "mutation": "V135I", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.19, "escape": -0.7988, "mature_H5_site": 131.0, "mutant": "M", "mutation": "V135M", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1167, "escape": -0.1362, "mature_H5_site": 131.0, "mutant": "Q", "mutation": "V135Q", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.06751, "escape": 2.171, "mature_H5_site": 131.0, "mutant": "T", "mutation": "V135T", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7648, "escape": 1.539, "mature_H5_site": 131.0, "mutant": "W", "mutation": "V135W", "reference_site": "135", "sequential_site": 147.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4091, "escape": -0.3966, "mature_H5_site": 132.0, "mutant": "T", "mutation": "S136T", "reference_site": "136", "sequential_site": 148.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.06001, "escape": 2.036, "mature_H5_site": 133.0, "mutant": "C", "mutation": "A137C", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4466, "escape": 2.405, "mature_H5_site": 133.0, "mutant": "D", "mutation": "A137D", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7334, "escape": 2.55, "mature_H5_site": 133.0, "mutant": "E", "mutation": "A137E", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.04292, "escape": 1.948, "mature_H5_site": 133.0, "mutant": "F", "mutation": "A137F", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5479, "escape": 2.116, "mature_H5_site": 133.0, "mutant": "K", "mutation": "A137K", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05262, "escape": 1.997, "mature_H5_site": 133.0, "mutant": "L", "mutation": "A137L", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04101, "escape": 1.828, "mature_H5_site": 133.0, "mutant": "M", "mutation": "A137M", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.425, "escape": 1.944, "mature_H5_site": 133.0, "mutant": "R", "mutation": "A137R", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02125, "escape": -1.136, "mature_H5_site": 133.0, "mutant": "S", "mutation": "A137S", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1539, "escape": 0.9282, "mature_H5_site": 133.0, "mutant": "T", "mutation": "A137T", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4816, "escape": 2.724, "mature_H5_site": 133.0, "mutant": "V", "mutation": "A137V", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.06102, "escape": 2.214, "mature_H5_site": 133.0, "mutant": "W", "mutation": "A137W", "reference_site": "137", "sequential_site": 149.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -3.296, "escape": -0.2314, "mature_H5_site": 134.0, "mutant": "I", "mutation": "A138I", "reference_site": "138", "sequential_site": 150.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04583, "escape": 0.1861, "mature_H5_site": 134.0, "mutant": "S", "mutation": "A138S", "reference_site": "138", "sequential_site": 150.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1186, "escape": 1.546, "mature_H5_site": 134.0, "mutant": "T", "mutation": "A138T", "reference_site": "138", "sequential_site": 150.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.014, "escape": 1.737, "mature_H5_site": 134.0, "mutant": "V", "mutation": "A138V", "reference_site": "138", "sequential_site": 150.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -5.101, "escape": -0.2973, "mature_H5_site": 135.0, "mutant": "G", "mutation": "C139G", "reference_site": "139", "sequential_site": 151.0, "wildtype": "C"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03188, "escape": 1.856, "mature_H5_site": 136.0, "mutant": "C", "mutation": "P140C", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.009375, "escape": 1.935, "mature_H5_site": 136.0, "mutant": "D", "mutation": "P140D", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07475, "escape": 0.6929, "mature_H5_site": 136.0, "mutant": "F", "mutation": "P140F", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06391, "escape": -0.3215, "mature_H5_site": 136.0, "mutant": "H", "mutation": "P140H", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0757, "escape": 1.916, "mature_H5_site": 136.0, "mutant": "K", "mutation": "P140K", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3775, "escape": -1.478, "mature_H5_site": 136.0, "mutant": "L", "mutation": "P140L", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3911, "escape": 0.095, "mature_H5_site": 136.0, "mutant": "M", "mutation": "P140M", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4926, "escape": 0.4333, "mature_H5_site": 136.0, "mutant": "N", "mutation": "P140N", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02771, "escape": 1.722, "mature_H5_site": 136.0, "mutant": "R", "mutation": "P140R", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01783, "escape": 0.5632, "mature_H5_site": 136.0, "mutant": "S", "mutation": "P140S", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1215, "escape": -0.6678, "mature_H5_site": 136.0, "mutant": "T", "mutation": "P140T", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.158, "escape": -0.7844, "mature_H5_site": 136.0, "mutant": "V", "mutation": "P140V", "reference_site": "140", "sequential_site": 152.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05672, "escape": 0.3758, "mature_H5_site": 137.0, "mutant": "A", "mutation": "Y141A", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.19, "escape": 0.3966, "mature_H5_site": 137.0, "mutant": "C", "mutation": "Y141C", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05149, "escape": 0.523, "mature_H5_site": 137.0, "mutant": "D", "mutation": "Y141D", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2139, "escape": 0.685, "mature_H5_site": 137.0, "mutant": "E", "mutation": "Y141E", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1863, "escape": 0.04663, "mature_H5_site": 137.0, "mutant": "F", "mutation": "Y141F", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.003315, "escape": -0.1764, "mature_H5_site": 137.0, "mutant": "I", "mutation": "Y141I", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1364, "escape": 0.3564, "mature_H5_site": 137.0, "mutant": "K", "mutation": "Y141K", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02181, "escape": 0.4822, "mature_H5_site": 137.0, "mutant": "N", "mutation": "Y141N", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04773, "escape": 0.7776, "mature_H5_site": 137.0, "mutant": "P", "mutation": "Y141P", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3758, "escape": 0.615, "mature_H5_site": 137.0, "mutant": "R", "mutation": "Y141R", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6931, "escape": 0.366, "mature_H5_site": 137.0, "mutant": "S", "mutation": "Y141S", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4748, "escape": 0.4698, "mature_H5_site": 137.0, "mutant": "T", "mutation": "Y141T", "reference_site": "141", "sequential_site": 153.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.003485, "escape": -0.1362, "mature_H5_site": 138.0, "mutant": "E", "mutation": "Q142E", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03895, "escape": 0.2883, "mature_H5_site": 138.0, "mutant": "G", "mutation": "Q142G", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07071, "escape": -0.03012, "mature_H5_site": 138.0, "mutant": "H", "mutation": "Q142H", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05583, "escape": 0.1561, "mature_H5_site": 138.0, "mutant": "I", "mutation": "Q142I", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.06843, "escape": -0.02266, "mature_H5_site": 138.0, "mutant": "M", "mutation": "Q142M", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05586, "escape": 0.4939, "mature_H5_site": 138.0, "mutant": "N", "mutation": "Q142N", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9557, "escape": 0.7612, "mature_H5_site": 138.0, "mutant": "P", "mutation": "Q142P", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07433, "escape": -0.01435, "mature_H5_site": 138.0, "mutant": "S", "mutation": "Q142S", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03931, "escape": 0.3772, "mature_H5_site": 138.0, "mutant": "V", "mutation": "Q142V", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2743, "escape": 0.8359, "mature_H5_site": 138.0, "mutant": "W", "mutation": "Q142W", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02496, "escape": 0.4637, "mature_H5_site": 138.0, "mutant": "Y", "mutation": "Q142Y", "reference_site": "142", "sequential_site": 154.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0359, "escape": 0.3055, "mature_H5_site": 139.0, "mutant": "E", "mutation": "G143E", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3977, "escape": 0.01863, "mature_H5_site": 139.0, "mutant": "F", "mutation": "G143F", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8786, "escape": -0.153, "mature_H5_site": 139.0, "mutant": "H", "mutation": "G143H", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2626, "escape": 0.04501, "mature_H5_site": 139.0, "mutant": "K", "mutation": "G143K", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06516, "escape": 0.86, "mature_H5_site": 139.0, "mutant": "L", "mutation": "G143L", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1142, "escape": 0.2156, "mature_H5_site": 139.0, "mutant": "N", "mutation": "G143N", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.009535, "escape": -0.4754, "mature_H5_site": 139.0, "mutant": "R", "mutation": "G143R", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1981, "escape": -0.1693, "mature_H5_site": 139.0, "mutant": "S", "mutation": "G143S", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3401, "escape": 0.3288, "mature_H5_site": 139.0, "mutant": "V", "mutation": "G143V", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1149, "escape": 0.525, "mature_H5_site": 139.0, "mutant": "W", "mutation": "G143W", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.00378, "escape": -0.0155, "mature_H5_site": 139.0, "mutant": "Y", "mutation": "G143Y", "reference_site": "143", "sequential_site": 155.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4667, "escape": -0.5989, "mature_H5_site": 140.0, "mutant": "D", "mutation": "A144D", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.07616, "escape": -0.557, "mature_H5_site": 140.0, "mutant": "E", "mutation": "A144E", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.403, "escape": 0.4996, "mature_H5_site": 140.0, "mutant": "F", "mutation": "A144F", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01749, "escape": 0.1127, "mature_H5_site": 140.0, "mutant": "G", "mutation": "A144G", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3443, "escape": 0.2284, "mature_H5_site": 140.0, "mutant": "H", "mutation": "A144H", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5277, "escape": -0.2209, "mature_H5_site": 140.0, "mutant": "I", "mutation": "A144I", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.293, "escape": 1.542, "mature_H5_site": 140.0, "mutant": "K", "mutation": "A144K", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.002535, "escape": -0.1669, "mature_H5_site": 140.0, "mutant": "M", "mutation": "A144M", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04423, "escape": 0.1108, "mature_H5_site": 140.0, "mutant": "N", "mutation": "A144N", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3302, "escape": 2.189, "mature_H5_site": 140.0, "mutant": "P", "mutation": "A144P", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.00594, "escape": 0.3684, "mature_H5_site": 140.0, "mutant": "Q", "mutation": "A144Q", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1412, "escape": 1.651, "mature_H5_site": 140.0, "mutant": "R", "mutation": "A144R", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.04508, "escape": -0.0002006, "mature_H5_site": 140.0, "mutant": "S", "mutation": "A144S", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2714, "escape": -0.3177, "mature_H5_site": 140.0, "mutant": "T", "mutation": "A144T", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.00038, "escape": -0.439, "mature_H5_site": 140.0, "mutant": "V", "mutation": "A144V", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2538, "escape": 1.859, "mature_H5_site": 140.0, "mutant": "W", "mutation": "A144W", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3796, "escape": 0.6231, "mature_H5_site": 140.0, "mutant": "Y", "mutation": "A144Y", "reference_site": "144", "sequential_site": 156.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03934, "escape": 1.968, "mature_H5_site": 141.0, "mutant": "I", "mutation": "P145I", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.704, "escape": 2.077, "mature_H5_site": 141.0, "mutant": "L", "mutation": "P145L", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -3.045, "escape": 1.86, "mature_H5_site": 141.0, "mutant": "M", "mutation": "P145M", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.513, "escape": 2.1, "mature_H5_site": 141.0, "mutant": "N", "mutation": "P145N", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1068, "escape": 2.292, "mature_H5_site": 141.0, "mutant": "Q", "mutation": "P145Q", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8528, "escape": 1.915, "mature_H5_site": 141.0, "mutant": "R", "mutation": "P145R", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07675, "escape": 2.123, "mature_H5_site": 141.0, "mutant": "T", "mutation": "P145T", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2869, "escape": -0.816, "mature_H5_site": 141.0, "mutant": "V", "mutation": "P145V", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0126, "escape": 2.128, "mature_H5_site": 141.0, "mutant": "W", "mutation": "P145W", "reference_site": "145", "sequential_site": 157.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01503, "escape": 0.457, "mature_H5_site": 142.0, "mutant": "F", "mutation": "S146F", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.134, "escape": 0.4068, "mature_H5_site": 142.0, "mutant": "G", "mutation": "S146G", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.04789, "escape": 0.03986, "mature_H5_site": 142.0, "mutant": "H", "mutation": "S146H", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8817, "escape": -0.5269, "mature_H5_site": 142.0, "mutant": "I", "mutation": "S146I", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03554, "escape": -0.0547, "mature_H5_site": 142.0, "mutant": "L", "mutation": "S146L", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3524, "escape": 0.6693, "mature_H5_site": 142.0, "mutant": "N", "mutation": "S146N", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.09551, "escape": 0.4206, "mature_H5_site": 142.0, "mutant": "R", "mutation": "S146R", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3361, "escape": -0.212, "mature_H5_site": 142.0, "mutant": "T", "mutation": "S146T", "reference_site": "146", "sequential_site": 158.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.917, "escape": -0.7151, "mature_H5_site": 143.0, "mutant": "H", "mutation": "F147H", "reference_site": "147", "sequential_site": 159.0, "wildtype": "F"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8665, "escape": 0.703, "mature_H5_site": 143.0, "mutant": "L", "mutation": "F147L", "reference_site": "147", "sequential_site": 159.0, "wildtype": "F"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3293, "escape": 0.6683, "mature_H5_site": 143.0, "mutant": "M", "mutation": "F147M", "reference_site": "147", "sequential_site": 159.0, "wildtype": "F"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.869, "escape": -0.2874, "mature_H5_site": 143.0, "mutant": "W", "mutation": "F147W", "reference_site": "147", "sequential_site": 159.0, "wildtype": "F"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4523, "escape": -0.005429, "mature_H5_site": 144.0, "mutant": "M", "mutation": "F148M", "reference_site": "148", "sequential_site": 160.0, "wildtype": "F"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9477, "escape": -0.1028, "mature_H5_site": 144.0, "mutant": "N", "mutation": "F148N", "reference_site": "148", "sequential_site": 160.0, "wildtype": "F"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.119, "escape": -0.146, "mature_H5_site": 144.0, "mutant": "Q", "mutation": "F148Q", "reference_site": "148", "sequential_site": 160.0, "wildtype": "F"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.186, "escape": -0.3243, "mature_H5_site": 144.0, "mutant": "V", "mutation": "F148V", "reference_site": "148", "sequential_site": 160.0, "wildtype": "F"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.278, "escape": 0.1234, "mature_H5_site": 144.0, "mutant": "W", "mutation": "F148W", "reference_site": "148", "sequential_site": 160.0, "wildtype": "F"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03205, "escape": -0.1896, "mature_H5_site": 145.0, "mutant": "A", "mutation": "R149A", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1535, "escape": -0.221, "mature_H5_site": 145.0, "mutant": "C", "mutation": "R149C", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2118, "escape": 0.3207, "mature_H5_site": 145.0, "mutant": "F", "mutation": "R149F", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.007755, "escape": -0.1017, "mature_H5_site": 145.0, "mutant": "G", "mutation": "R149G", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.162, "escape": 0.2745, "mature_H5_site": 145.0, "mutant": "K", "mutation": "R149K", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07247, "escape": 0.2946, "mature_H5_site": 145.0, "mutant": "M", "mutation": "R149M", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07749, "escape": 0.2858, "mature_H5_site": 145.0, "mutant": "Q", "mutation": "R149Q", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07515, "escape": -0.1608, "mature_H5_site": 145.0, "mutant": "T", "mutation": "R149T", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04122, "escape": -0.5484, "mature_H5_site": 145.0, "mutant": "W", "mutation": "R149W", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07486, "escape": -0.4098, "mature_H5_site": 145.0, "mutant": "Y", "mutation": "R149Y", "reference_site": "149", "sequential_site": 161.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2574, "escape": -0.01177, "mature_H5_site": 5.0, "mutant": "C", "mutation": "I15C", "reference_site": "15", "sequential_site": 21.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.427, "escape": 0.07011, "mature_H5_site": 5.0, "mutant": "L", "mutation": "I15L", "reference_site": "15", "sequential_site": 21.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3174, "escape": 0.1106, "mature_H5_site": 5.0, "mutant": "T", "mutation": "I15T", "reference_site": "15", "sequential_site": 21.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.366, "escape": -0.2243, "mature_H5_site": 146.0, "mutant": "A", "mutation": "N150A", "reference_site": "150", "sequential_site": 162.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4099, "escape": -0.5431, "mature_H5_site": 146.0, "mutant": "I", "mutation": "N150I", "reference_site": "150", "sequential_site": 162.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04587, "escape": -0.2041, "mature_H5_site": 146.0, "mutant": "L", "mutation": "N150L", "reference_site": "150", "sequential_site": 162.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04971, "escape": -0.1052, "mature_H5_site": 146.0, "mutant": "S", "mutation": "N150S", "reference_site": "150", "sequential_site": 162.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06692, "escape": -0.01268, "mature_H5_site": 146.0, "mutant": "V", "mutation": "N150V", "reference_site": "150", "sequential_site": 162.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.254, "escape": 0.09886, "mature_H5_site": 146.0, "mutant": "Y", "mutation": "N150Y", "reference_site": "150", "sequential_site": 162.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0663, "escape": 0.2064, "mature_H5_site": 147.0, "mutant": "C", "mutation": "V151C", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.163, "escape": -0.04618, "mature_H5_site": 147.0, "mutant": "E", "mutation": "V151E", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05281, "escape": 0.07688, "mature_H5_site": 147.0, "mutant": "G", "mutation": "V151G", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.332, "escape": -0.135, "mature_H5_site": 147.0, "mutant": "H", "mutation": "V151H", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0214, "escape": -0.1166, "mature_H5_site": 147.0, "mutant": "I", "mutation": "V151I", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03836, "escape": -0.1791, "mature_H5_site": 147.0, "mutant": "L", "mutation": "V151L", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03176, "escape": -0.1597, "mature_H5_site": 147.0, "mutant": "M", "mutation": "V151M", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4025, "escape": 0.2447, "mature_H5_site": 147.0, "mutant": "Q", "mutation": "V151Q", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02103, "escape": -0.01511, "mature_H5_site": 147.0, "mutant": "S", "mutation": "V151S", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.954, "escape": 0.0346, "mature_H5_site": 147.0, "mutant": "Y", "mutation": "V151Y", "reference_site": "151", "sequential_site": 163.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5331, "escape": 0.2448, "mature_H5_site": 148.0, "mutant": "A", "mutation": "V152A", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02353, "escape": -0.0379, "mature_H5_site": 148.0, "mutant": "D", "mutation": "V152D", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.536, "escape": -0.05383, "mature_H5_site": 148.0, "mutant": "E", "mutation": "V152E", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2452, "escape": 0.3698, "mature_H5_site": 148.0, "mutant": "G", "mutation": "V152G", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.00141, "escape": -0.08043, "mature_H5_site": 148.0, "mutant": "L", "mutation": "V152L", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06008, "escape": -0.106, "mature_H5_site": 148.0, "mutant": "M", "mutation": "V152M", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07074, "escape": 0.1858, "mature_H5_site": 148.0, "mutant": "N", "mutation": "V152N", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.305, "escape": -0.2188, "mature_H5_site": 148.0, "mutant": "Q", "mutation": "V152Q", "reference_site": "152", "sequential_site": 164.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3185, "escape": 0.7573, "mature_H5_site": 150.0, "mutant": "A", "mutation": "L154A", "reference_site": "154", "sequential_site": 166.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01898, "escape": 0.3087, "mature_H5_site": 150.0, "mutant": "I", "mutation": "L154I", "reference_site": "154", "sequential_site": 166.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2172, "escape": 0.8763, "mature_H5_site": 150.0, "mutant": "M", "mutation": "L154M", "reference_site": "154", "sequential_site": 166.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.08693, "escape": 0.1297, "mature_H5_site": 150.0, "mutant": "V", "mutation": "L154V", "reference_site": "154", "sequential_site": 166.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9856, "escape": 2.063, "mature_H5_site": 151.0, "mutant": "A", "mutation": "I155A", "reference_site": "155", "sequential_site": 167.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.06386, "escape": 1.082, "mature_H5_site": 151.0, "mutant": "C", "mutation": "I155C", "reference_site": "155", "sequential_site": 167.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06906, "escape": -0.1393, "mature_H5_site": 151.0, "mutant": "L", "mutation": "I155L", "reference_site": "155", "sequential_site": 167.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.283, "escape": 0.1212, "mature_H5_site": 151.0, "mutant": "M", "mutation": "I155M", "reference_site": "155", "sequential_site": 167.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1159, "escape": 2.08, "mature_H5_site": 151.0, "mutant": "N", "mutation": "I155N", "reference_site": "155", "sequential_site": 167.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.106, "escape": 1.5, "mature_H5_site": 151.0, "mutant": "S", "mutation": "I155S", "reference_site": "155", "sequential_site": 167.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0539, "escape": 0.499, "mature_H5_site": 151.0, "mutant": "V", "mutation": "I155V", "reference_site": "155", "sequential_site": 167.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06617, "escape": 2.009, "mature_H5_site": 152.0, "mutant": "C", "mutation": "K156C", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.347, "escape": 2.008, "mature_H5_site": 152.0, "mutant": "G", "mutation": "K156G", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7739, "escape": 1.879, "mature_H5_site": 152.0, "mutant": "I", "mutation": "K156I", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04545, "escape": 1.992, "mature_H5_site": 152.0, "mutant": "M", "mutation": "K156M", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1758, "escape": 2.035, "mature_H5_site": 152.0, "mutant": "N", "mutation": "K156N", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1166, "escape": 1.95, "mature_H5_site": 152.0, "mutant": "Q", "mutation": "K156Q", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.05433, "escape": 0.411, "mature_H5_site": 152.0, "mutant": "R", "mutation": "K156R", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04606, "escape": 1.992, "mature_H5_site": 152.0, "mutant": "S", "mutation": "K156S", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5045, "escape": 2.158, "mature_H5_site": 152.0, "mutant": "T", "mutation": "K156T", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4253, "escape": 2.201, "mature_H5_site": 152.0, "mutant": "V", "mutation": "K156V", "reference_site": "156", "sequential_site": 168.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.00304, "escape": 0.3159, "mature_H5_site": 153.0, "mutant": "A", "mutation": "K157A", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04705, "escape": 0.8612, "mature_H5_site": 153.0, "mutant": "E", "mutation": "K157E", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05504, "escape": 0.3117, "mature_H5_site": 153.0, "mutant": "F", "mutation": "K157F", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01434, "escape": 0.3343, "mature_H5_site": 153.0, "mutant": "H", "mutation": "K157H", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7618, "escape": 0.04867, "mature_H5_site": 153.0, "mutant": "M", "mutation": "K157M", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3925, "escape": 0.9186, "mature_H5_site": 153.0, "mutant": "N", "mutation": "K157N", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1694, "escape": -0.7882, "mature_H5_site": 153.0, "mutant": "T", "mutation": "K157T", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6327, "escape": 0.7392, "mature_H5_site": 153.0, "mutant": "W", "mutation": "K157W", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03411, "escape": 0.1389, "mature_H5_site": 153.0, "mutant": "Y", "mutation": "K157Y", "reference_site": "157", "sequential_site": 169.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2676, "escape": -0.2743, "mature_H5_site": 154.0, "mutant": "A", "mutation": "N158A", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.00687, "escape": 0.4341, "mature_H5_site": 154.0, "mutant": "D", "mutation": "N158D", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02899, "escape": 0.1403, "mature_H5_site": 154.0, "mutant": "E", "mutation": "N158E", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0964, "escape": 0.1233, "mature_H5_site": 154.0, "mutant": "F", "mutation": "N158F", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0458, "escape": -0.06891, "mature_H5_site": 154.0, "mutant": "G", "mutation": "N158G", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1074, "escape": 0.01098, "mature_H5_site": 154.0, "mutant": "H", "mutation": "N158H", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2683, "escape": 0.4747, "mature_H5_site": 154.0, "mutant": "I", "mutation": "N158I", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.133, "escape": 0.3663, "mature_H5_site": 154.0, "mutant": "K", "mutation": "N158K", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.08541, "escape": 0.7141, "mature_H5_site": 154.0, "mutant": "L", "mutation": "N158L", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.82, "escape": 1.979, "mature_H5_site": 154.0, "mutant": "P", "mutation": "N158P", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2995, "escape": -0.145, "mature_H5_site": 154.0, "mutant": "R", "mutation": "N158R", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.00284, "escape": 0.1238, "mature_H5_site": 154.0, "mutant": "S", "mutation": "N158S", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01745, "escape": 0.1216, "mature_H5_site": 154.0, "mutant": "W", "mutation": "N158W", "reference_site": "158", "sequential_site": 170.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7079, "escape": 1.139, "mature_H5_site": 155.0, "mutant": "F", "mutation": "D159F", "reference_site": "159", "sequential_site": 171.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.346, "escape": -0.3449, "mature_H5_site": 155.0, "mutant": "L", "mutation": "D159L", "reference_site": "159", "sequential_site": 171.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5137, "escape": -0.5525, "mature_H5_site": 155.0, "mutant": "N", "mutation": "D159N", "reference_site": "159", "sequential_site": 171.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3926, "escape": -0.2112, "mature_H5_site": 155.0, "mutant": "Q", "mutation": "D159Q", "reference_site": "159", "sequential_site": 171.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.594, "escape": 1.18, "mature_H5_site": 155.0, "mutant": "W", "mutation": "D159W", "reference_site": "159", "sequential_site": 171.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8296, "escape": 1.713, "mature_H5_site": 155.0, "mutant": "Y", "mutation": "D159Y", "reference_site": "159", "sequential_site": 171.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.495, "escape": 0.2388, "mature_H5_site": 156.0, "mutant": "C", "mutation": "A160C", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4254, "escape": 0.01931, "mature_H5_site": 156.0, "mutant": "E", "mutation": "A160E", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1028, "escape": -0.4442, "mature_H5_site": 156.0, "mutant": "F", "mutation": "A160F", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01629, "escape": 0.2053, "mature_H5_site": 156.0, "mutant": "H", "mutation": "A160H", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5497, "escape": -0.1327, "mature_H5_site": 156.0, "mutant": "K", "mutation": "A160K", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07211, "escape": -0.1102, "mature_H5_site": 156.0, "mutant": "M", "mutation": "A160M", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3024, "escape": -0.1859, "mature_H5_site": 156.0, "mutant": "N", "mutation": "A160N", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1073, "escape": 0.3162, "mature_H5_site": 156.0, "mutant": "Q", "mutation": "A160Q", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0654, "escape": -0.2826, "mature_H5_site": 156.0, "mutant": "S", "mutation": "A160S", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03709, "escape": -0.528, "mature_H5_site": 156.0, "mutant": "T", "mutation": "A160T", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2059, "escape": 0.1127, "mature_H5_site": 156.0, "mutant": "V", "mutation": "A160V", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03065, "escape": 0.3947, "mature_H5_site": 156.0, "mutant": "W", "mutation": "A160W", "reference_site": "160", "sequential_site": 172.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.179, "escape": 0.276, "mature_H5_site": 157.0, "mutant": "W", "mutation": "Y161W", "reference_site": "161", "sequential_site": 173.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.414, "escape": 0.2707, "mature_H5_site": 158.0, "mutant": "A", "mutation": "P162A", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5694, "escape": -0.1567, "mature_H5_site": 158.0, "mutant": "E", "mutation": "P162E", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2397, "escape": 0.1114, "mature_H5_site": 158.0, "mutant": "G", "mutation": "P162G", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5207, "escape": -0.01108, "mature_H5_site": 158.0, "mutant": "H", "mutation": "P162H", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02312, "escape": -0.1232, "mature_H5_site": 158.0, "mutant": "K", "mutation": "P162K", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4015, "escape": -0.3545, "mature_H5_site": 158.0, "mutant": "M", "mutation": "P162M", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02878, "escape": 0.134, "mature_H5_site": 158.0, "mutant": "N", "mutation": "P162N", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3961, "escape": -0.1343, "mature_H5_site": 158.0, "mutant": "R", "mutation": "P162R", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1376, "escape": 0.04741, "mature_H5_site": 158.0, "mutant": "S", "mutation": "P162S", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6296, "escape": 0.2229, "mature_H5_site": 158.0, "mutant": "T", "mutation": "P162T", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5012, "escape": -0.4642, "mature_H5_site": 158.0, "mutant": "V", "mutation": "P162V", "reference_site": "162", "sequential_site": 174.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3744, "escape": -0.1723, "mature_H5_site": 159.0, "mutant": "A", "mutation": "T163A", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06918, "escape": 0.2644, "mature_H5_site": 159.0, "mutant": "D", "mutation": "T163D", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.032, "escape": 0.4117, "mature_H5_site": 159.0, "mutant": "E", "mutation": "T163E", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4447, "escape": -0.1452, "mature_H5_site": 159.0, "mutant": "G", "mutation": "T163G", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1646, "escape": -0.1108, "mature_H5_site": 159.0, "mutant": "H", "mutation": "T163H", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01755, "escape": 0.1025, "mature_H5_site": 159.0, "mutant": "I", "mutation": "T163I", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.06674, "escape": -0.3323, "mature_H5_site": 159.0, "mutant": "K", "mutation": "T163K", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03057, "escape": -0.008378, "mature_H5_site": 159.0, "mutant": "M", "mutation": "T163M", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1049, "escape": -0.05357, "mature_H5_site": 159.0, "mutant": "N", "mutation": "T163N", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07433, "escape": -0.02179, "mature_H5_site": 159.0, "mutant": "P", "mutation": "T163P", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.09958, "escape": -0.2285, "mature_H5_site": 159.0, "mutant": "Q", "mutation": "T163Q", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01879, "escape": -0.2542, "mature_H5_site": 159.0, "mutant": "V", "mutation": "T163V", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01324, "escape": -0.3404, "mature_H5_site": 159.0, "mutant": "W", "mutation": "T163W", "reference_site": "163", "sequential_site": 175.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.06499, "escape": -0.05959, "mature_H5_site": 160.0, "mutant": "A", "mutation": "I164A", "reference_site": "164", "sequential_site": 176.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1712, "escape": -0.3499, "mature_H5_site": 160.0, "mutant": "H", "mutation": "I164H", "reference_site": "164", "sequential_site": 176.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.936, "escape": -0.5444, "mature_H5_site": 160.0, "mutant": "K", "mutation": "I164K", "reference_site": "164", "sequential_site": 176.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6973, "escape": -0.4201, "mature_H5_site": 160.0, "mutant": "W", "mutation": "I164W", "reference_site": "164", "sequential_site": 176.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.667, "escape": 0.7302, "mature_H5_site": 161.0, "mutant": "A", "mutation": "K165A", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3008, "escape": 0.4574, "mature_H5_site": 161.0, "mutant": "C", "mutation": "K165C", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0386, "escape": 0.3839, "mature_H5_site": 161.0, "mutant": "D", "mutation": "K165D", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1588, "escape": 0.872, "mature_H5_site": 161.0, "mutant": "E", "mutation": "K165E", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01622, "escape": 0.3963, "mature_H5_site": 161.0, "mutant": "F", "mutation": "K165F", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01079, "escape": 0.1442, "mature_H5_site": 161.0, "mutant": "H", "mutation": "K165H", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04642, "escape": 0.6047, "mature_H5_site": 161.0, "mutant": "I", "mutation": "K165I", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7407, "escape": 0.3683, "mature_H5_site": 161.0, "mutant": "M", "mutation": "K165M", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05429, "escape": 0.1832, "mature_H5_site": 161.0, "mutant": "N", "mutation": "K165N", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07213, "escape": 0.292, "mature_H5_site": 161.0, "mutant": "Q", "mutation": "K165Q", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07884, "escape": -0.06961, "mature_H5_site": 161.0, "mutant": "R", "mutation": "K165R", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04617, "escape": 0.5592, "mature_H5_site": 161.0, "mutant": "V", "mutation": "K165V", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0739, "escape": 0.4529, "mature_H5_site": 161.0, "mutant": "Y", "mutation": "K165Y", "reference_site": "165", "sequential_site": 177.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.235, "escape": 0.08447, "mature_H5_site": 162.0, "mutant": "A", "mutation": "I166A", "reference_site": "166", "sequential_site": 178.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03416, "escape": -0.0584, "mature_H5_site": 162.0, "mutant": "L", "mutation": "I166L", "reference_site": "166", "sequential_site": 178.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03975, "escape": 0.3492, "mature_H5_site": 162.0, "mutant": "S", "mutation": "I166S", "reference_site": "166", "sequential_site": 178.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.06066, "escape": 0.28, "mature_H5_site": 162.0, "mutant": "W", "mutation": "I166W", "reference_site": "166", "sequential_site": 178.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01236, "escape": 0.004215, "mature_H5_site": 163.0, "mutant": "A", "mutation": "S167A", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6672, "escape": 0.3072, "mature_H5_site": 163.0, "mutant": "C", "mutation": "S167C", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01852, "escape": 0.1103, "mature_H5_site": 163.0, "mutant": "D", "mutation": "S167D", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.00225, "escape": 0.3021, "mature_H5_site": 163.0, "mutant": "E", "mutation": "S167E", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.495, "escape": -0.3702, "mature_H5_site": 163.0, "mutant": "F", "mutation": "S167F", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1599, "escape": -0.04928, "mature_H5_site": 163.0, "mutant": "G", "mutation": "S167G", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6193, "escape": -0.2558, "mature_H5_site": 163.0, "mutant": "I", "mutation": "S167I", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1715, "escape": -0.1938, "mature_H5_site": 163.0, "mutant": "K", "mutation": "S167K", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1144, "escape": -0.1086, "mature_H5_site": 163.0, "mutant": "L", "mutation": "S167L", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.05107, "escape": -0.1488, "mature_H5_site": 163.0, "mutant": "M", "mutation": "S167M", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1458, "escape": -0.1097, "mature_H5_site": 163.0, "mutant": "N", "mutation": "S167N", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01687, "escape": -0.06321, "mature_H5_site": 163.0, "mutant": "Q", "mutation": "S167Q", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3122, "escape": -0.5916, "mature_H5_site": 163.0, "mutant": "R", "mutation": "S167R", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1629, "escape": -0.05757, "mature_H5_site": 163.0, "mutant": "T", "mutation": "S167T", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.00976, "escape": -0.1691, "mature_H5_site": 163.0, "mutant": "V", "mutation": "S167V", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1233, "escape": -0.619, "mature_H5_site": 163.0, "mutant": "W", "mutation": "S167W", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03838, "escape": -0.09702, "mature_H5_site": 163.0, "mutant": "Y", "mutation": "S167Y", "reference_site": "167", "sequential_site": 179.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1239, "escape": -0.8939, "mature_H5_site": 165.0, "mutant": "A", "mutation": "N169A", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8375, "escape": -0.2612, "mature_H5_site": 165.0, "mutant": "D", "mutation": "N169D", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.044, "escape": -0.7265, "mature_H5_site": 165.0, "mutant": "E", "mutation": "N169E", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8632, "escape": -0.8161, "mature_H5_site": 165.0, "mutant": "F", "mutation": "N169F", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6752, "escape": -0.9533, "mature_H5_site": 165.0, "mutant": "G", "mutation": "N169G", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3942, "escape": -0.5154, "mature_H5_site": 165.0, "mutant": "H", "mutation": "N169H", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5725, "escape": -0.6378, "mature_H5_site": 165.0, "mutant": "I", "mutation": "N169I", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5608, "escape": -0.7179, "mature_H5_site": 165.0, "mutant": "K", "mutation": "N169K", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1149, "escape": -0.7815, "mature_H5_site": 165.0, "mutant": "L", "mutation": "N169L", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.62, "escape": -0.7113, "mature_H5_site": 165.0, "mutant": "M", "mutation": "N169M", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9624, "escape": -0.7943, "mature_H5_site": 165.0, "mutant": "P", "mutation": "N169P", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4913, "escape": -0.7784, "mature_H5_site": 165.0, "mutant": "Q", "mutation": "N169Q", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8052, "escape": -0.8638, "mature_H5_site": 165.0, "mutant": "R", "mutation": "N169R", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3594, "escape": -0.6539, "mature_H5_site": 165.0, "mutant": "S", "mutation": "N169S", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.203, "escape": -0.7203, "mature_H5_site": 165.0, "mutant": "T", "mutation": "N169T", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.061, "escape": -0.6771, "mature_H5_site": 165.0, "mutant": "V", "mutation": "N169V", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.636, "escape": -0.5948, "mature_H5_site": 165.0, "mutant": "W", "mutation": "N169W", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1939, "escape": -0.4837, "mature_H5_site": 165.0, "mutant": "Y", "mutation": "N169Y", "reference_site": "169", "sequential_site": 181.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.573, "escape": -0.003224, "mature_H5_site": 7.0, "mutant": "C", "mutation": "Y17C", "reference_site": "17", "sequential_site": 23.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -3.0, "escape": 0.3709, "mature_H5_site": 7.0, "mutant": "F", "mutation": "Y17F", "reference_site": "17", "sequential_site": 23.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2625, "escape": -0.09173, "mature_H5_site": 7.0, "mutant": "M", "mutation": "Y17M", "reference_site": "17", "sequential_site": 23.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.791, "escape": -0.09218, "mature_H5_site": 7.0, "mutant": "Q", "mutation": "Y17Q", "reference_site": "17", "sequential_site": 23.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.212, "escape": -0.256, "mature_H5_site": 7.0, "mutant": "T", "mutation": "Y17T", "reference_site": "17", "sequential_site": 23.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9518, "escape": 0.007761, "mature_H5_site": 7.0, "mutant": "W", "mutation": "Y17W", "reference_site": "17", "sequential_site": 23.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2983, "escape": -0.7487, "mature_H5_site": 167.0, "mutant": "A", "mutation": "T171A", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.056, "escape": -0.4668, "mature_H5_site": 167.0, "mutant": "D", "mutation": "T171D", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4069, "escape": -0.7864, "mature_H5_site": 167.0, "mutant": "G", "mutation": "T171G", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4696, "escape": -0.6691, "mature_H5_site": 167.0, "mutant": "I", "mutation": "T171I", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.103, "escape": -0.557, "mature_H5_site": 167.0, "mutant": "K", "mutation": "T171K", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.549, "escape": -0.91, "mature_H5_site": 167.0, "mutant": "L", "mutation": "T171L", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5026, "escape": -1.082, "mature_H5_site": 167.0, "mutant": "N", "mutation": "T171N", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2303, "escape": -0.2925, "mature_H5_site": 167.0, "mutant": "Q", "mutation": "T171Q", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8508, "escape": -0.6204, "mature_H5_site": 167.0, "mutant": "R", "mutation": "T171R", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8176, "escape": -0.4342, "mature_H5_site": 167.0, "mutant": "W", "mutation": "T171W", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3792, "escape": -0.6589, "mature_H5_site": 167.0, "mutant": "Y", "mutation": "T171Y", "reference_site": "171", "sequential_site": 183.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01337, "escape": -0.1137, "mature_H5_site": 168.0, "mutant": "A", "mutation": "N172A", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9611, "escape": -0.5098, "mature_H5_site": 168.0, "mutant": "C", "mutation": "N172C", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1689, "escape": 0.1458, "mature_H5_site": 168.0, "mutant": "E", "mutation": "N172E", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2781, "escape": 0.1698, "mature_H5_site": 168.0, "mutant": "F", "mutation": "N172F", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07389, "escape": -0.1004, "mature_H5_site": 168.0, "mutant": "I", "mutation": "N172I", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07534, "escape": -0.06471, "mature_H5_site": 168.0, "mutant": "K", "mutation": "N172K", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.05631, "escape": -0.3693, "mature_H5_site": 168.0, "mutant": "L", "mutation": "N172L", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1514, "escape": 0.03364, "mature_H5_site": 168.0, "mutant": "M", "mutation": "N172M", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1487, "escape": -0.03673, "mature_H5_site": 168.0, "mutant": "R", "mutation": "N172R", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1809, "escape": -0.3814, "mature_H5_site": 168.0, "mutant": "V", "mutation": "N172V", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.00201, "escape": 0.3038, "mature_H5_site": 168.0, "mutant": "W", "mutation": "N172W", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07883, "escape": 0.2066, "mature_H5_site": 168.0, "mutant": "Y", "mutation": "N172Y", "reference_site": "172", "sequential_site": 184.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1192, "escape": 0.07803, "mature_H5_site": 169.0, "mutant": "A", "mutation": "R173A", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8701, "escape": 0.006682, "mature_H5_site": 169.0, "mutant": "D", "mutation": "R173D", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01784, "escape": 0.02186, "mature_H5_site": 169.0, "mutant": "E", "mutation": "R173E", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.00217, "escape": -0.1497, "mature_H5_site": 169.0, "mutant": "F", "mutation": "R173F", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4831, "escape": -0.3265, "mature_H5_site": 169.0, "mutant": "G", "mutation": "R173G", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.09069, "escape": -0.06175, "mature_H5_site": 169.0, "mutant": "I", "mutation": "R173I", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03937, "escape": 0.05124, "mature_H5_site": 169.0, "mutant": "K", "mutation": "R173K", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.214, "escape": 0.192, "mature_H5_site": 169.0, "mutant": "M", "mutation": "R173M", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3454, "escape": 0.004733, "mature_H5_site": 169.0, "mutant": "N", "mutation": "R173N", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1161, "escape": 0.05702, "mature_H5_site": 169.0, "mutant": "P", "mutation": "R173P", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.196, "escape": -0.186, "mature_H5_site": 169.0, "mutant": "Q", "mutation": "R173Q", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.05164, "escape": 0.2187, "mature_H5_site": 169.0, "mutant": "S", "mutation": "R173S", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.499, "escape": 0.2171, "mature_H5_site": 169.0, "mutant": "T", "mutation": "R173T", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1727, "escape": 0.0911, "mature_H5_site": 169.0, "mutant": "V", "mutation": "R173V", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02192, "escape": -0.006356, "mature_H5_site": 169.0, "mutant": "W", "mutation": "R173W", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0249, "escape": 0.3591, "mature_H5_site": 169.0, "mutant": "Y", "mutation": "R173Y", "reference_site": "173", "sequential_site": 185.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07123, "escape": 0.01164, "mature_H5_site": 170.0, "mutant": "D", "mutation": "E174D", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06942, "escape": -0.1953, "mature_H5_site": 170.0, "mutant": "F", "mutation": "E174F", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5007, "escape": 0.0008114, "mature_H5_site": 170.0, "mutant": "G", "mutation": "E174G", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1451, "escape": -0.02413, "mature_H5_site": 170.0, "mutant": "H", "mutation": "E174H", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.00608, "escape": -0.3416, "mature_H5_site": 170.0, "mutant": "K", "mutation": "E174K", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02964, "escape": -0.02643, "mature_H5_site": 170.0, "mutant": "L", "mutation": "E174L", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4166, "escape": -0.164, "mature_H5_site": 170.0, "mutant": "M", "mutation": "E174M", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2261, "escape": 0.06771, "mature_H5_site": 170.0, "mutant": "N", "mutation": "E174N", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02478, "escape": 0.1821, "mature_H5_site": 170.0, "mutant": "Q", "mutation": "E174Q", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2184, "escape": -0.1078, "mature_H5_site": 170.0, "mutant": "R", "mutation": "E174R", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07085, "escape": -0.4344, "mature_H5_site": 170.0, "mutant": "S", "mutation": "E174S", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.62, "escape": -0.8326, "mature_H5_site": 170.0, "mutant": "T", "mutation": "E174T", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2008, "escape": -0.1712, "mature_H5_site": 170.0, "mutant": "V", "mutation": "E174V", "reference_site": "174", "sequential_site": 186.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01863, "escape": -0.02997, "mature_H5_site": 171.0, "mutant": "A", "mutation": "D175A", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.501, "escape": 0.08265, "mature_H5_site": 171.0, "mutant": "E", "mutation": "D175E", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1506, "escape": 0.04263, "mature_H5_site": 171.0, "mutant": "F", "mutation": "D175F", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4955, "escape": 0.0972, "mature_H5_site": 171.0, "mutant": "G", "mutation": "D175G", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07175, "escape": -0.1485, "mature_H5_site": 171.0, "mutant": "K", "mutation": "D175K", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02339, "escape": -0.03087, "mature_H5_site": 171.0, "mutant": "M", "mutation": "D175M", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05921, "escape": 0.1526, "mature_H5_site": 171.0, "mutant": "Q", "mutation": "D175Q", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.877, "escape": -0.1746, "mature_H5_site": 171.0, "mutant": "R", "mutation": "D175R", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05575, "escape": -0.08186, "mature_H5_site": 171.0, "mutant": "S", "mutation": "D175S", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3582, "escape": -0.2877, "mature_H5_site": 171.0, "mutant": "V", "mutation": "D175V", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1897, "escape": 0.09313, "mature_H5_site": 171.0, "mutant": "Y", "mutation": "D175Y", "reference_site": "175", "sequential_site": 187.0, "wildtype": "D"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.828, "escape": -0.005732, "mature_H5_site": 172.0, "mutant": "C", "mutation": "L176C", "reference_site": "176", "sequential_site": 188.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4143, "escape": 0.2414, "mature_H5_site": 172.0, "mutant": "I", "mutation": "L176I", "reference_site": "176", "sequential_site": 188.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.09796, "escape": 0.2433, "mature_H5_site": 172.0, "mutant": "M", "mutation": "L176M", "reference_site": "176", "sequential_site": 188.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06912, "escape": 0.06189, "mature_H5_site": 172.0, "mutant": "V", "mutation": "L176V", "reference_site": "176", "sequential_site": 188.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.134, "escape": -0.6181, "mature_H5_site": 172.0, "mutant": "Y", "mutation": "L176Y", "reference_site": "176", "sequential_site": 188.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1164, "escape": 0.1431, "mature_H5_site": 173.0, "mutant": "I", "mutation": "L177I", "reference_site": "177", "sequential_site": 189.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06807, "escape": 0.03721, "mature_H5_site": 173.0, "mutant": "V", "mutation": "L177V", "reference_site": "177", "sequential_site": 189.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.24, "escape": -0.1017, "mature_H5_site": 174.0, "mutant": "F", "mutation": "I178F", "reference_site": "178", "sequential_site": 190.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.373, "escape": 0.09997, "mature_H5_site": 174.0, "mutant": "M", "mutation": "I178M", "reference_site": "178", "sequential_site": 190.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.728, "escape": 0.3803, "mature_H5_site": 174.0, "mutant": "W", "mutation": "I178W", "reference_site": "178", "sequential_site": 190.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03488, "escape": -0.0751, "mature_H5_site": 175.0, "mutant": "A", "mutation": "L179A", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.889, "escape": -0.1222, "mature_H5_site": 175.0, "mutant": "F", "mutation": "L179F", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.869, "escape": -0.2079, "mature_H5_site": 175.0, "mutant": "H", "mutation": "L179H", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4528, "escape": 0.1094, "mature_H5_site": 175.0, "mutant": "I", "mutation": "L179I", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02475, "escape": 0.09534, "mature_H5_site": 175.0, "mutant": "M", "mutation": "L179M", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.542, "escape": -0.3414, "mature_H5_site": 175.0, "mutant": "N", "mutation": "L179N", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.047, "escape": -0.5824, "mature_H5_site": 175.0, "mutant": "P", "mutation": "L179P", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7952, "escape": -0.1283, "mature_H5_site": 175.0, "mutant": "Q", "mutation": "L179Q", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06563, "escape": -0.1203, "mature_H5_site": 175.0, "mutant": "S", "mutation": "L179S", "reference_site": "179", "sequential_site": 191.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3407, "escape": 0.05484, "mature_H5_site": 8.0, "mutant": "C", "mutation": "H18C", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2797, "escape": 0.05539, "mature_H5_site": 8.0, "mutant": "F", "mutation": "H18F", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -3.165, "escape": -0.006446, "mature_H5_site": 8.0, "mutant": "G", "mutation": "H18G", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.253, "escape": -0.004773, "mature_H5_site": 8.0, "mutant": "L", "mutation": "H18L", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.227, "escape": -0.04661, "mature_H5_site": 8.0, "mutant": "M", "mutation": "H18M", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2332, "escape": -0.1696, "mature_H5_site": 8.0, "mutant": "N", "mutation": "H18N", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3651, "escape": -0.111, "mature_H5_site": 8.0, "mutant": "R", "mutation": "H18R", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.04067, "escape": -0.02889, "mature_H5_site": 8.0, "mutant": "S", "mutation": "H18S", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0621, "escape": 0.06571, "mature_H5_site": 8.0, "mutant": "T", "mutation": "H18T", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.355, "escape": -0.2055, "mature_H5_site": 8.0, "mutant": "Y", "mutation": "H18Y", "reference_site": "18", "sequential_site": 24.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9538, "escape": 0.381, "mature_H5_site": 176.0, "mutant": "Y", "mutation": "W180Y", "reference_site": "180", "sequential_site": 192.0, "wildtype": "W"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04537, "escape": -0.3032, "mature_H5_site": 177.0, "mutant": "A", "mutation": "G181A", "reference_site": "181", "sequential_site": 193.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.07884, "escape": -0.395, "mature_H5_site": 178.0, "mutant": "C", "mutation": "I182C", "reference_site": "182", "sequential_site": 194.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.806, "escape": -0.1806, "mature_H5_site": 178.0, "mutant": "E", "mutation": "I182E", "reference_site": "182", "sequential_site": 194.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06189, "escape": -0.04453, "mature_H5_site": 178.0, "mutant": "L", "mutation": "I182L", "reference_site": "182", "sequential_site": 194.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07634, "escape": -0.1987, "mature_H5_site": 178.0, "mutant": "M", "mutation": "I182M", "reference_site": "182", "sequential_site": 194.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2174, "escape": -0.3956, "mature_H5_site": 178.0, "mutant": "Q", "mutation": "I182Q", "reference_site": "182", "sequential_site": 194.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5711, "escape": -0.4115, "mature_H5_site": 178.0, "mutant": "T", "mutation": "I182T", "reference_site": "182", "sequential_site": 194.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.411, "escape": -0.8989, "mature_H5_site": 179.0, "mutant": "Q", "mutation": "H183Q", "reference_site": "183", "sequential_site": 195.0, "wildtype": "H"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.86, "escape": -0.9656, "mature_H5_site": 181.0, "mutant": "G", "mutation": "S185G", "reference_site": "185", "sequential_site": 197.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7509, "escape": -0.7751, "mature_H5_site": 181.0, "mutant": "I", "mutation": "S185I", "reference_site": "185", "sequential_site": 197.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6169, "escape": -0.9217, "mature_H5_site": 181.0, "mutant": "N", "mutation": "S185N", "reference_site": "185", "sequential_site": 197.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4204, "escape": -0.5368, "mature_H5_site": 181.0, "mutant": "V", "mutation": "S185V", "reference_site": "185", "sequential_site": 197.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8998, "escape": -1.021, "mature_H5_site": 182.0, "mutant": "A", "mutation": "N186A", "reference_site": "186", "sequential_site": 198.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.398, "escape": -0.09144, "mature_H5_site": 182.0, "mutant": "D", "mutation": "N186D", "reference_site": "186", "sequential_site": 198.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.444, "escape": -0.9654, "mature_H5_site": 182.0, "mutant": "Q", "mutation": "N186Q", "reference_site": "186", "sequential_site": 198.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01905, "escape": -0.4451, "mature_H5_site": 182.0, "mutant": "S", "mutation": "N186S", "reference_site": "186", "sequential_site": 198.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -3.564, "escape": -0.5445, "mature_H5_site": 182.0, "mutant": "Y", "mutation": "N186Y", "reference_site": "186", "sequential_site": 198.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.205, "escape": -0.7378, "mature_H5_site": 183.0, "mutant": "A", "mutation": "N187A", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1002, "escape": -0.2151, "mature_H5_site": 183.0, "mutant": "C", "mutation": "N187C", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2446, "escape": 1.431, "mature_H5_site": 183.0, "mutant": "D", "mutation": "N187D", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07847, "escape": 0.7816, "mature_H5_site": 183.0, "mutant": "E", "mutation": "N187E", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06036, "escape": -0.7222, "mature_H5_site": 183.0, "mutant": "G", "mutation": "N187G", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.08441, "escape": -0.4456, "mature_H5_site": 183.0, "mutant": "H", "mutation": "N187H", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4657, "escape": -0.9909, "mature_H5_site": 183.0, "mutant": "K", "mutation": "N187K", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -3.098, "escape": -0.7903, "mature_H5_site": 183.0, "mutant": "R", "mutation": "N187R", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07217, "escape": -0.2476, "mature_H5_site": 183.0, "mutant": "T", "mutation": "N187T", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4867, "escape": -0.9171, "mature_H5_site": 183.0, "mutant": "V", "mutation": "N187V", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3038, "escape": -0.9144, "mature_H5_site": 183.0, "mutant": "W", "mutation": "N187W", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01341, "escape": -0.5562, "mature_H5_site": 183.0, "mutant": "Y", "mutation": "N187Y", "reference_site": "187", "sequential_site": 199.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.009199, "escape": 0.1936, "mature_H5_site": 184.0, "mutant": "C", "mutation": "A188C", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03025, "escape": 0.5925, "mature_H5_site": 184.0, "mutant": "D", "mutation": "A188D", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06724, "escape": 0.4177, "mature_H5_site": 184.0, "mutant": "E", "mutation": "A188E", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1551, "escape": -0.08338, "mature_H5_site": 184.0, "mutant": "F", "mutation": "A188F", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06618, "escape": -0.006729, "mature_H5_site": 184.0, "mutant": "G", "mutation": "A188G", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01178, "escape": -0.1378, "mature_H5_site": 184.0, "mutant": "H", "mutation": "A188H", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.002775, "escape": -0.04434, "mature_H5_site": 184.0, "mutant": "I", "mutation": "A188I", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5312, "escape": -0.3308, "mature_H5_site": 184.0, "mutant": "K", "mutation": "A188K", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1761, "escape": -0.03632, "mature_H5_site": 184.0, "mutant": "M", "mutation": "A188M", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.04956, "escape": -0.03045, "mature_H5_site": 184.0, "mutant": "N", "mutation": "A188N", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.09303, "escape": -0.1536, "mature_H5_site": 184.0, "mutant": "P", "mutation": "A188P", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06341, "escape": -0.1884, "mature_H5_site": 184.0, "mutant": "Q", "mutation": "A188Q", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.05409, "escape": -0.3352, "mature_H5_site": 184.0, "mutant": "R", "mutation": "A188R", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01764, "escape": -0.193, "mature_H5_site": 184.0, "mutant": "V", "mutation": "A188V", "reference_site": "188", "sequential_site": 200.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1052, "escape": -0.258, "mature_H5_site": 185.0, "mutant": "D", "mutation": "E189D", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7629, "escape": -0.6114, "mature_H5_site": 185.0, "mutant": "G", "mutation": "E189G", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5244, "escape": -1.031, "mature_H5_site": 185.0, "mutant": "H", "mutation": "E189H", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.341, "escape": -0.7508, "mature_H5_site": 185.0, "mutant": "K", "mutation": "E189K", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.232, "escape": -0.6449, "mature_H5_site": 185.0, "mutant": "L", "mutation": "E189L", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0163, "escape": -0.7953, "mature_H5_site": 185.0, "mutant": "M", "mutation": "E189M", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7946, "escape": -0.713, "mature_H5_site": 185.0, "mutant": "N", "mutation": "E189N", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7278, "escape": -0.5379, "mature_H5_site": 185.0, "mutant": "P", "mutation": "E189P", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1914, "escape": -0.9032, "mature_H5_site": 185.0, "mutant": "V", "mutation": "E189V", "reference_site": "189", "sequential_site": 201.0, "wildtype": "E"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8216, "escape": -0.1639, "mature_H5_site": 9.0, "mutant": "N", "mutation": "A19N", "reference_site": "19", "sequential_site": 25.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07206, "escape": -0.05336, "mature_H5_site": 9.0, "mutant": "Q", "mutation": "A19Q", "reference_site": "19", "sequential_site": 25.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7174, "escape": 0.06414, "mature_H5_site": 9.0, "mutant": "T", "mutation": "A19T", "reference_site": "19", "sequential_site": 25.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.204, "escape": -0.01964, "mature_H5_site": 9.0, "mutant": "W", "mutation": "A19W", "reference_site": "19", "sequential_site": 25.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.004065, "escape": -0.6129, "mature_H5_site": 187.0, "mutant": "N", "mutation": "Q191N", "reference_site": "191", "sequential_site": 203.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01022, "escape": -0.06975, "mature_H5_site": 188.0, "mutant": "A", "mutation": "T192A", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.289, "escape": 0.4015, "mature_H5_site": 188.0, "mutant": "C", "mutation": "T192C", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07811, "escape": 0.1728, "mature_H5_site": 188.0, "mutant": "D", "mutation": "T192D", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03511, "escape": -0.6334, "mature_H5_site": 188.0, "mutant": "H", "mutation": "T192H", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03367, "escape": 0.05836, "mature_H5_site": 188.0, "mutant": "I", "mutation": "T192I", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7805, "escape": -0.4244, "mature_H5_site": 188.0, "mutant": "K", "mutation": "T192K", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05107, "escape": -0.117, "mature_H5_site": 188.0, "mutant": "M", "mutation": "T192M", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03194, "escape": -0.6235, "mature_H5_site": 188.0, "mutant": "N", "mutation": "T192N", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03218, "escape": -0.2918, "mature_H5_site": 188.0, "mutant": "Q", "mutation": "T192Q", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.154, "escape": -0.7424, "mature_H5_site": 188.0, "mutant": "R", "mutation": "T192R", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0295, "escape": -0.003837, "mature_H5_site": 188.0, "mutant": "S", "mutation": "T192S", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3159, "escape": 0.226, "mature_H5_site": 188.0, "mutant": "V", "mutation": "T192V", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2659, "escape": 0.3654, "mature_H5_site": 188.0, "mutant": "W", "mutation": "T192W", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.002195, "escape": -0.5701, "mature_H5_site": 188.0, "mutant": "Y", "mutation": "T192Y", "reference_site": "192", "sequential_site": 204.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03588, "escape": 1.424, "mature_H5_site": 189.0, "mutant": "A", "mutation": "N193A", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3979, "escape": -0.9449, "mature_H5_site": 189.0, "mutant": "F", "mutation": "N193F", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2481, "escape": -0.9164, "mature_H5_site": 189.0, "mutant": "K", "mutation": "N193K", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1422, "escape": -0.8657, "mature_H5_site": 189.0, "mutant": "M", "mutation": "N193M", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01775, "escape": -0.7474, "mature_H5_site": 189.0, "mutant": "Q", "mutation": "N193Q", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.397, "escape": -0.8169, "mature_H5_site": 189.0, "mutant": "R", "mutation": "N193R", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07625, "escape": 1.103, "mature_H5_site": 189.0, "mutant": "S", "mutation": "N193S", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2069, "escape": -0.9085, "mature_H5_site": 189.0, "mutant": "W", "mutation": "N193W", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4655, "escape": -1.156, "mature_H5_site": 189.0, "mutant": "Y", "mutation": "N193Y", "reference_site": "193", "sequential_site": 205.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1717, "escape": -0.5074, "mature_H5_site": 190.0, "mutant": "M", "mutation": "L194M", "reference_site": "194", "sequential_site": 206.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.869, "escape": -0.196, "mature_H5_site": 190.0, "mutant": "N", "mutation": "L194N", "reference_site": "194", "sequential_site": 206.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2559, "escape": 1.421, "mature_H5_site": 192.0, "mutant": "D", "mutation": "K196D", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07444, "escape": 0.9264, "mature_H5_site": 192.0, "mutant": "H", "mutation": "K196H", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07812, "escape": 1.307, "mature_H5_site": 192.0, "mutant": "L", "mutation": "K196L", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02107, "escape": 1.516, "mature_H5_site": 192.0, "mutant": "M", "mutation": "K196M", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01249, "escape": 1.33, "mature_H5_site": 192.0, "mutant": "N", "mutation": "K196N", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07326, "escape": 1.961, "mature_H5_site": 192.0, "mutant": "Q", "mutation": "K196Q", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.09238, "escape": -0.191, "mature_H5_site": 192.0, "mutant": "R", "mutation": "K196R", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06693, "escape": 1.189, "mature_H5_site": 192.0, "mutant": "S", "mutation": "K196S", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07787, "escape": 1.402, "mature_H5_site": 192.0, "mutant": "V", "mutation": "K196V", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.05117, "escape": 1.055, "mature_H5_site": 192.0, "mutant": "W", "mutation": "K196W", "reference_site": "196", "sequential_site": 208.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04911, "escape": 0.3699, "mature_H5_site": 193.0, "mutant": "E", "mutation": "N197E", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8245, "escape": 0.1979, "mature_H5_site": 193.0, "mutant": "G", "mutation": "N197G", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7363, "escape": 0.01281, "mature_H5_site": 193.0, "mutant": "K", "mutation": "N197K", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1396, "escape": 0.1184, "mature_H5_site": 193.0, "mutant": "M", "mutation": "N197M", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03522, "escape": 0.4841, "mature_H5_site": 193.0, "mutant": "Q", "mutation": "N197Q", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02481, "escape": 0.6448, "mature_H5_site": 193.0, "mutant": "R", "mutation": "N197R", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01479, "escape": 0.5284, "mature_H5_site": 193.0, "mutant": "S", "mutation": "N197S", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.219, "escape": 0.3737, "mature_H5_site": 193.0, "mutant": "T", "mutation": "N197T", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.439, "escape": 0.1881, "mature_H5_site": 193.0, "mutant": "V", "mutation": "N197V", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.09866, "escape": 0.9419, "mature_H5_site": 193.0, "mutant": "Y", "mutation": "N197Y", "reference_site": "197", "sequential_site": 209.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.076, "escape": 0.2844, "mature_H5_site": 194.0, "mutant": "E", "mutation": "P198E", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2687, "escape": 0.1142, "mature_H5_site": 194.0, "mutant": "G", "mutation": "P198G", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3047, "escape": -0.1488, "mature_H5_site": 194.0, "mutant": "H", "mutation": "P198H", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3696, "escape": -0.1918, "mature_H5_site": 194.0, "mutant": "I", "mutation": "P198I", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.459, "escape": -0.004301, "mature_H5_site": 194.0, "mutant": "L", "mutation": "P198L", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02524, "escape": -0.2077, "mature_H5_site": 194.0, "mutant": "M", "mutation": "P198M", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0473, "escape": -0.123, "mature_H5_site": 194.0, "mutant": "Q", "mutation": "P198Q", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05373, "escape": -0.01226, "mature_H5_site": 194.0, "mutant": "S", "mutation": "P198S", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.09659, "escape": -0.2124, "mature_H5_site": 194.0, "mutant": "V", "mutation": "P198V", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03991, "escape": -0.101, "mature_H5_site": 194.0, "mutant": "Y", "mutation": "P198Y", "reference_site": "198", "sequential_site": 210.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.566, "escape": 0.08237, "mature_H5_site": 195.0, "mutant": "C", "mutation": "T199C", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.05215, "escape": 0.06393, "mature_H5_site": 195.0, "mutant": "D", "mutation": "T199D", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2546, "escape": -0.03207, "mature_H5_site": 195.0, "mutant": "F", "mutation": "T199F", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1286, "escape": -0.0292, "mature_H5_site": 195.0, "mutant": "G", "mutation": "T199G", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03299, "escape": -0.1106, "mature_H5_site": 195.0, "mutant": "H", "mutation": "T199H", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1948, "escape": -0.2689, "mature_H5_site": 195.0, "mutant": "I", "mutation": "T199I", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03725, "escape": -0.1663, "mature_H5_site": 195.0, "mutant": "K", "mutation": "T199K", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.00957, "escape": 0.003597, "mature_H5_site": 195.0, "mutant": "L", "mutation": "T199L", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2989, "escape": 0.09604, "mature_H5_site": 195.0, "mutant": "Q", "mutation": "T199Q", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03191, "escape": -0.08883, "mature_H5_site": 195.0, "mutant": "S", "mutation": "T199S", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07707, "escape": 0.5394, "mature_H5_site": 195.0, "mutant": "V", "mutation": "T199V", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0692, "escape": 0.008039, "mature_H5_site": 195.0, "mutant": "Y", "mutation": "T199Y", "reference_site": "199", "sequential_site": 211.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5433, "escape": -0.3043, "mature_H5_site": -9.0, "mutant": "F", "mutation": "L2F", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4676, "escape": -0.3944, "mature_H5_site": -9.0, "mutant": "G", "mutation": "L2G", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.057, "escape": -0.1734, "mature_H5_site": -9.0, "mutant": "H", "mutation": "L2H", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5281, "escape": -0.1485, "mature_H5_site": -9.0, "mutant": "I", "mutation": "L2I", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06773, "escape": 0.09135, "mature_H5_site": -9.0, "mutant": "M", "mutation": "L2M", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -3.256, "escape": -0.3269, "mature_H5_site": -9.0, "mutant": "Q", "mutation": "L2Q", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01022, "escape": 0.1501, "mature_H5_site": -9.0, "mutant": "S", "mutation": "L2S", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.608, "escape": 0.1402, "mature_H5_site": -9.0, "mutant": "V", "mutation": "L2V", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2817, "escape": -0.06681, "mature_H5_site": -9.0, "mutant": "W", "mutation": "L2W", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3166, "escape": 0.1165, "mature_H5_site": -9.0, "mutant": "Y", "mutation": "L2Y", "reference_site": "2", "sequential_site": 8.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.053, "escape": 0.1664, "mature_H5_site": 10.0, "mutant": "T", "mutation": "N20T", "reference_site": "20", "sequential_site": 26.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1878, "escape": 0.6217, "mature_H5_site": 196.0, "mutant": "A", "mutation": "T200A", "reference_site": "200", "sequential_site": 212.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5365, "escape": 0.2037, "mature_H5_site": 196.0, "mutant": "C", "mutation": "T200C", "reference_site": "200", "sequential_site": 212.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03888, "escape": 0.3827, "mature_H5_site": 196.0, "mutant": "G", "mutation": "T200G", "reference_site": "200", "sequential_site": 212.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.07342, "escape": 0.3808, "mature_H5_site": 196.0, "mutant": "P", "mutation": "T200P", "reference_site": "200", "sequential_site": 212.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01604, "escape": 0.2203, "mature_H5_site": 196.0, "mutant": "V", "mutation": "T200V", "reference_site": "200", "sequential_site": 212.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.04903, "escape": -0.5274, "mature_H5_site": 197.0, "mutant": "A", "mutation": "Y201A", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.773, "escape": -0.1862, "mature_H5_site": 197.0, "mutant": "C", "mutation": "Y201C", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4882, "escape": -0.1822, "mature_H5_site": 197.0, "mutant": "D", "mutation": "Y201D", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04513, "escape": -0.1414, "mature_H5_site": 197.0, "mutant": "E", "mutation": "Y201E", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1835, "escape": -0.03857, "mature_H5_site": 197.0, "mutant": "F", "mutation": "Y201F", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4292, "escape": -0.5161, "mature_H5_site": 197.0, "mutant": "G", "mutation": "Y201G", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01717, "escape": -0.2653, "mature_H5_site": 197.0, "mutant": "M", "mutation": "Y201M", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0749, "escape": -0.2242, "mature_H5_site": 197.0, "mutant": "R", "mutation": "Y201R", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07129, "escape": 0.01489, "mature_H5_site": 197.0, "mutant": "S", "mutation": "Y201S", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.041, "escape": -0.5615, "mature_H5_site": 197.0, "mutant": "V", "mutation": "Y201V", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.004945, "escape": -0.02095, "mature_H5_site": 197.0, "mutant": "W", "mutation": "Y201W", "reference_site": "201", "sequential_site": 213.0, "wildtype": "Y"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.325, "escape": 0.003157, "mature_H5_site": 198.0, "mutant": "C", "mutation": "I202C", "reference_site": "202", "sequential_site": 214.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4756, "escape": -0.05515, "mature_H5_site": 198.0, "mutant": "L", "mutation": "I202L", "reference_site": "202", "sequential_site": 214.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03982, "escape": -0.1517, "mature_H5_site": 198.0, "mutant": "M", "mutation": "I202M", "reference_site": "202", "sequential_site": 214.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.184, "escape": -0.363, "mature_H5_site": 198.0, "mutant": "S", "mutation": "I202S", "reference_site": "202", "sequential_site": 214.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.007615, "escape": -0.04012, "mature_H5_site": 198.0, "mutant": "T", "mutation": "I202T", "reference_site": "202", "sequential_site": 214.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.215, "escape": -0.03076, "mature_H5_site": 198.0, "mutant": "V", "mutation": "I202V", "reference_site": "202", "sequential_site": 214.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02631, "escape": -0.919, "mature_H5_site": 199.0, "mutant": "F", "mutation": "S203F", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5688, "escape": -0.262, "mature_H5_site": 199.0, "mutant": "G", "mutation": "S203G", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3072, "escape": -0.2056, "mature_H5_site": 199.0, "mutant": "H", "mutation": "S203H", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.499, "escape": -0.6088, "mature_H5_site": 199.0, "mutant": "I", "mutation": "S203I", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.05166, "escape": -0.1893, "mature_H5_site": 199.0, "mutant": "L", "mutation": "S203L", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4317, "escape": 0.582, "mature_H5_site": 199.0, "mutant": "N", "mutation": "S203N", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.09187, "escape": -0.4516, "mature_H5_site": 199.0, "mutant": "Q", "mutation": "S203Q", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6649, "escape": -0.2293, "mature_H5_site": 199.0, "mutant": "V", "mutation": "S203V", "reference_site": "203", "sequential_site": 215.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02779, "escape": -0.04599, "mature_H5_site": 200.0, "mutant": "A", "mutation": "V204A", "reference_site": "204", "sequential_site": 216.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9364, "escape": -0.07725, "mature_H5_site": 200.0, "mutant": "C", "mutation": "V204C", "reference_site": "204", "sequential_site": 216.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.667, "escape": -0.5204, "mature_H5_site": 200.0, "mutant": "F", "mutation": "V204F", "reference_site": "204", "sequential_site": 216.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.056, "escape": 0.01819, "mature_H5_site": 200.0, "mutant": "G", "mutation": "V204G", "reference_site": "204", "sequential_site": 216.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3403, "escape": -0.2213, "mature_H5_site": 200.0, "mutant": "S", "mutation": "V204S", "reference_site": "204", "sequential_site": 216.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06503, "escape": -0.02135, "mature_H5_site": 200.0, "mutant": "T", "mutation": "V204T", "reference_site": "204", "sequential_site": 216.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.938, "escape": -0.3269, "mature_H5_site": 200.0, "mutant": "W", "mutation": "V204W", "reference_site": "204", "sequential_site": 216.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.012, "escape": -1.052, "mature_H5_site": 201.0, "mutant": "C", "mutation": "G205C", "reference_site": "205", "sequential_site": 217.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.443, "escape": -0.9581, "mature_H5_site": 201.0, "mutant": "S", "mutation": "G205S", "reference_site": "205", "sequential_site": 217.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5742, "escape": -0.8567, "mature_H5_site": 201.0, "mutant": "T", "mutation": "G205T", "reference_site": "205", "sequential_site": 217.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.1, "escape": -0.8553, "mature_H5_site": 202.0, "mutant": "C", "mutation": "T206C", "reference_site": "206", "sequential_site": 218.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2482, "escape": -0.2995, "mature_H5_site": 202.0, "mutant": "H", "mutation": "T206H", "reference_site": "206", "sequential_site": 218.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7795, "escape": -0.1023, "mature_H5_site": 203.0, "mutant": "A", "mutation": "S207A", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.002705, "escape": -0.2129, "mature_H5_site": 203.0, "mutant": "C", "mutation": "S207C", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1294, "escape": 0.1202, "mature_H5_site": 203.0, "mutant": "D", "mutation": "S207D", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06497, "escape": 0.2098, "mature_H5_site": 203.0, "mutant": "E", "mutation": "S207E", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3525, "escape": -0.1979, "mature_H5_site": 203.0, "mutant": "G", "mutation": "S207G", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02117, "escape": -0.1822, "mature_H5_site": 203.0, "mutant": "I", "mutation": "S207I", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06246, "escape": 0.2889, "mature_H5_site": 203.0, "mutant": "K", "mutation": "S207K", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02478, "escape": -0.396, "mature_H5_site": 203.0, "mutant": "N", "mutation": "S207N", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2801, "escape": 0.5863, "mature_H5_site": 203.0, "mutant": "Q", "mutation": "S207Q", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1829, "escape": 0.3954, "mature_H5_site": 203.0, "mutant": "T", "mutation": "S207T", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9663, "escape": -0.04591, "mature_H5_site": 203.0, "mutant": "W", "mutation": "S207W", "reference_site": "207", "sequential_site": 219.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4845, "escape": -0.3459, "mature_H5_site": 204.0, "mutant": "C", "mutation": "T208C", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04, "escape": 0.157, "mature_H5_site": 204.0, "mutant": "D", "mutation": "T208D", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07075, "escape": 0.002703, "mature_H5_site": 204.0, "mutant": "E", "mutation": "T208E", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03211, "escape": -0.3954, "mature_H5_site": 204.0, "mutant": "G", "mutation": "T208G", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05084, "escape": 0.05134, "mature_H5_site": 204.0, "mutant": "I", "mutation": "T208I", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.00554, "escape": -0.04015, "mature_H5_site": 204.0, "mutant": "K", "mutation": "T208K", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0802, "escape": -0.1506, "mature_H5_site": 204.0, "mutant": "L", "mutation": "T208L", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3923, "escape": -0.2299, "mature_H5_site": 204.0, "mutant": "M", "mutation": "T208M", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2482, "escape": -0.09147, "mature_H5_site": 204.0, "mutant": "R", "mutation": "T208R", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2978, "escape": -0.01777, "mature_H5_site": 204.0, "mutant": "S", "mutation": "T208S", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0459, "escape": -0.1208, "mature_H5_site": 204.0, "mutant": "W", "mutation": "T208W", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4254, "escape": 0.08762, "mature_H5_site": 204.0, "mutant": "Y", "mutation": "T208Y", "reference_site": "208", "sequential_site": 220.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2622, "escape": 0.4722, "mature_H5_site": 205.0, "mutant": "E", "mutation": "L209E", "reference_site": "209", "sequential_site": 221.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1419, "escape": -0.1811, "mature_H5_site": 205.0, "mutant": "M", "mutation": "L209M", "reference_site": "209", "sequential_site": 221.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2147, "escape": -0.1456, "mature_H5_site": 205.0, "mutant": "T", "mutation": "L209T", "reference_site": "209", "sequential_site": 221.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.382, "escape": 0.1261, "mature_H5_site": 205.0, "mutant": "V", "mutation": "L209V", "reference_site": "209", "sequential_site": 221.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": null, "escape": -0.36, "mature_H5_site": 205.0, "mutant": "Y", "mutation": "L209Y", "reference_site": "209", "sequential_site": 221.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6686, "escape": -0.1195, "mature_H5_site": 11.0, "mutant": "G", "mutation": "N21G", "reference_site": "21", "sequential_site": 27.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.355, "escape": 0.6548, "mature_H5_site": 11.0, "mutant": "K", "mutation": "N21K", "reference_site": "21", "sequential_site": 27.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.05349, "escape": -0.03098, "mature_H5_site": 11.0, "mutant": "L", "mutation": "N21L", "reference_site": "21", "sequential_site": 27.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.708, "escape": -0.7267, "mature_H5_site": 206.0, "mutant": "L", "mutation": "N210L", "reference_site": "210", "sequential_site": 222.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.603, "escape": -0.7554, "mature_H5_site": 206.0, "mutant": "T", "mutation": "N210T", "reference_site": "210", "sequential_site": 222.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1783, "escape": 0.1649, "mature_H5_site": 207.0, "mutant": "C", "mutation": "Q211C", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1263, "escape": 0.01927, "mature_H5_site": 207.0, "mutant": "D", "mutation": "Q211D", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06217, "escape": 0.3352, "mature_H5_site": 207.0, "mutant": "E", "mutation": "Q211E", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.061, "escape": -0.2994, "mature_H5_site": 207.0, "mutant": "F", "mutation": "Q211F", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.219, "escape": 0.2764, "mature_H5_site": 207.0, "mutant": "G", "mutation": "Q211G", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06265, "escape": -0.1561, "mature_H5_site": 207.0, "mutant": "H", "mutation": "Q211H", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7477, "escape": -0.1107, "mature_H5_site": 207.0, "mutant": "K", "mutation": "Q211K", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1064, "escape": -0.09339, "mature_H5_site": 207.0, "mutant": "L", "mutation": "Q211L", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.06665, "escape": -0.007835, "mature_H5_site": 207.0, "mutant": "N", "mutation": "Q211N", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1399, "escape": -0.03263, "mature_H5_site": 207.0, "mutant": "R", "mutation": "Q211R", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04676, "escape": -0.06288, "mature_H5_site": 207.0, "mutant": "S", "mutation": "Q211S", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.475, "escape": -0.03927, "mature_H5_site": 207.0, "mutant": "T", "mutation": "Q211T", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4775, "escape": 0.2646, "mature_H5_site": 207.0, "mutant": "V", "mutation": "Q211V", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04648, "escape": -0.653, "mature_H5_site": 207.0, "mutant": "W", "mutation": "Q211W", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1633, "escape": 0.03226, "mature_H5_site": 207.0, "mutant": "Y", "mutation": "Q211Y", "reference_site": "211", "sequential_site": 223.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05157, "escape": 0.2572, "mature_H5_site": 208.0, "mutant": "A", "mutation": "R212A", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1094, "escape": -0.04318, "mature_H5_site": 208.0, "mutant": "C", "mutation": "R212C", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.009905, "escape": -0.2657, "mature_H5_site": 208.0, "mutant": "F", "mutation": "R212F", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0764, "escape": 0.3508, "mature_H5_site": 208.0, "mutant": "I", "mutation": "R212I", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.351, "escape": -0.2506, "mature_H5_site": 208.0, "mutant": "K", "mutation": "R212K", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.001365, "escape": 0.2214, "mature_H5_site": 208.0, "mutant": "N", "mutation": "R212N", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3394, "escape": 0.2935, "mature_H5_site": 208.0, "mutant": "Q", "mutation": "R212Q", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.86, "escape": 0.2586, "mature_H5_site": 208.0, "mutant": "S", "mutation": "R212S", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06514, "escape": -0.5236, "mature_H5_site": 208.0, "mutant": "Y", "mutation": "R212Y", "reference_site": "212", "sequential_site": 224.0, "wildtype": "R"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03875, "escape": -0.3201, "mature_H5_site": 209.0, "mutant": "C", "mutation": "L213C", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2292, "escape": -0.1113, "mature_H5_site": 209.0, "mutant": "E", "mutation": "L213E", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.855, "escape": -0.01723, "mature_H5_site": 209.0, "mutant": "G", "mutation": "L213G", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.006395, "escape": -0.3048, "mature_H5_site": 209.0, "mutant": "H", "mutation": "L213H", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6634, "escape": -0.192, "mature_H5_site": 209.0, "mutant": "I", "mutation": "L213I", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9553, "escape": -0.715, "mature_H5_site": 209.0, "mutant": "K", "mutation": "L213K", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1603, "escape": -0.2651, "mature_H5_site": 209.0, "mutant": "Q", "mutation": "L213Q", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.638, "escape": -0.1273, "mature_H5_site": 209.0, "mutant": "R", "mutation": "L213R", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1492, "escape": -0.3374, "mature_H5_site": 209.0, "mutant": "S", "mutation": "L213S", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.061, "escape": -0.02786, "mature_H5_site": 209.0, "mutant": "T", "mutation": "L213T", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.03, "escape": -0.3711, "mature_H5_site": 209.0, "mutant": "V", "mutation": "L213V", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.302, "escape": -0.581, "mature_H5_site": 209.0, "mutant": "W", "mutation": "L213W", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.002795, "escape": -0.1537, "mature_H5_site": 209.0, "mutant": "Y", "mutation": "L213Y", "reference_site": "213", "sequential_site": 225.0, "wildtype": "L"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.07426, "escape": -0.02001, "mature_H5_site": 210.0, "mutant": "C", "mutation": "A214C", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02426, "escape": 0.09098, "mature_H5_site": 210.0, "mutant": "D", "mutation": "A214D", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01068, "escape": 0.0919, "mature_H5_site": 210.0, "mutant": "E", "mutation": "A214E", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05656, "escape": -0.004028, "mature_H5_site": 210.0, "mutant": "K", "mutation": "A214K", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06172, "escape": 0.06395, "mature_H5_site": 210.0, "mutant": "L", "mutation": "A214L", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02643, "escape": 0.1265, "mature_H5_site": 210.0, "mutant": "M", "mutation": "A214M", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01319, "escape": -0.3264, "mature_H5_site": 210.0, "mutant": "N", "mutation": "A214N", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1523, "escape": -0.1432, "mature_H5_site": 210.0, "mutant": "Q", "mutation": "A214Q", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6893, "escape": -0.4494, "mature_H5_site": 210.0, "mutant": "R", "mutation": "A214R", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3456, "escape": 0.1108, "mature_H5_site": 210.0, "mutant": "S", "mutation": "A214S", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0005658, "escape": 0.2155, "mature_H5_site": 210.0, "mutant": "T", "mutation": "A214T", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1736, "escape": -0.1323, "mature_H5_site": 210.0, "mutant": "V", "mutation": "A214V", "reference_site": "214", "sequential_site": 226.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.634, "escape": 0.3311, "mature_H5_site": 211.0, "mutant": "C", "mutation": "P215C", "reference_site": "215", "sequential_site": 227.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.431, "escape": -0.2786, "mature_H5_site": 211.0, "mutant": "V", "mutation": "P215V", "reference_site": "215", "sequential_site": 227.0, "wildtype": "P"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0329, "escape": 0.07576, "mature_H5_site": 212.0, "mutant": "C", "mutation": "K216C", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.08566, "escape": -0.6356, "mature_H5_site": 212.0, "mutant": "F", "mutation": "K216F", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.03417, "escape": -0.04147, "mature_H5_site": 212.0, "mutant": "H", "mutation": "K216H", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3852, "escape": -0.1105, "mature_H5_site": 212.0, "mutant": "I", "mutation": "K216I", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07761, "escape": -0.1493, "mature_H5_site": 212.0, "mutant": "L", "mutation": "K216L", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02587, "escape": -0.5612, "mature_H5_site": 212.0, "mutant": "M", "mutation": "K216M", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.257, "escape": -0.8968, "mature_H5_site": 212.0, "mutant": "N", "mutation": "K216N", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.04816, "escape": 0.4966, "mature_H5_site": 212.0, "mutant": "R", "mutation": "K216R", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05051, "escape": -0.5126, "mature_H5_site": 212.0, "mutant": "S", "mutation": "K216S", "reference_site": "216", "sequential_site": 228.0, "wildtype": "K"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3187, "escape": -0.5146, "mature_H5_site": 213.0, "mutant": "A", "mutation": "I217A", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4126, "escape": -0.4663, "mature_H5_site": 213.0, "mutant": "C", "mutation": "I217C", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2592, "escape": 0.1669, "mature_H5_site": 213.0, "mutant": "E", "mutation": "I217E", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06098, "escape": -0.3805, "mature_H5_site": 213.0, "mutant": "F", "mutation": "I217F", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1569, "escape": -0.8381, "mature_H5_site": 213.0, "mutant": "H", "mutation": "I217H", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3126, "escape": -0.8804, "mature_H5_site": 213.0, "mutant": "K", "mutation": "I217K", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6056, "escape": -0.8256, "mature_H5_site": 213.0, "mutant": "R", "mutation": "I217R", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.04, "escape": -0.1797, "mature_H5_site": 213.0, "mutant": "S", "mutation": "I217S", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4957, "escape": -0.5544, "mature_H5_site": 213.0, "mutant": "T", "mutation": "I217T", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.216, "escape": 0.227, "mature_H5_site": 213.0, "mutant": "V", "mutation": "I217V", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0001195, "escape": -0.8597, "mature_H5_site": 213.0, "mutant": "W", "mutation": "I217W", "reference_site": "217", "sequential_site": 229.0, "wildtype": "I"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2463, "escape": 0.6159, "mature_H5_site": 214.0, "mutant": "C", "mutation": "A218C", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0487, "escape": -1.038, "mature_H5_site": 214.0, "mutant": "F", "mutation": "A218F", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2427, "escape": -0.2515, "mature_H5_site": 214.0, "mutant": "G", "mutation": "A218G", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.29, "escape": -0.6928, "mature_H5_site": 214.0, "mutant": "H", "mutation": "A218H", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8935, "escape": 0.2507, "mature_H5_site": 214.0, "mutant": "L", "mutation": "A218L", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.8063, "escape": 0.2875, "mature_H5_site": 214.0, "mutant": "M", "mutation": "A218M", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.03717, "escape": -0.585, "mature_H5_site": 214.0, "mutant": "N", "mutation": "A218N", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1621, "escape": 0.05542, "mature_H5_site": 214.0, "mutant": "S", "mutation": "A218S", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3872, "escape": 0.1147, "mature_H5_site": 214.0, "mutant": "T", "mutation": "A218T", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6792, "escape": 0.6845, "mature_H5_site": 214.0, "mutant": "V", "mutation": "A218V", "reference_site": "218", "sequential_site": 230.0, "wildtype": "A"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01311, "escape": -0.63, "mature_H5_site": 215.0, "mutant": "A", "mutation": "T219A", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.02908, "escape": 0.02274, "mature_H5_site": 215.0, "mutant": "C", "mutation": "T219C", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.07375, "escape": -0.1525, "mature_H5_site": 215.0, "mutant": "D", "mutation": "T219D", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06439, "escape": -0.2878, "mature_H5_site": 215.0, "mutant": "E", "mutation": "T219E", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0208, "escape": -0.5348, "mature_H5_site": 215.0, "mutant": "F", "mutation": "T219F", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6563, "escape": -0.3843, "mature_H5_site": 215.0, "mutant": "K", "mutation": "T219K", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01552, "escape": 0.1241, "mature_H5_site": 215.0, "mutant": "L", "mutation": "T219L", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3844, "escape": 0.05822, "mature_H5_site": 215.0, "mutant": "M", "mutation": "T219M", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01061, "escape": -0.4879, "mature_H5_site": 215.0, "mutant": "P", "mutation": "T219P", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1603, "escape": -0.305, "mature_H5_site": 215.0, "mutant": "R", "mutation": "T219R", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0449, "escape": -0.7796, "mature_H5_site": 215.0, "mutant": "W", "mutation": "T219W", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02245, "escape": -0.5196, "mature_H5_site": 215.0, "mutant": "Y", "mutation": "T219Y", "reference_site": "219", "sequential_site": 231.0, "wildtype": "T"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.261, "escape": -0.09524, "mature_H5_site": 12.0, "mutant": "E", "mutation": "S22E", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.01645, "escape": -0.3256, "mature_H5_site": 12.0, "mutant": "G", "mutation": "S22G", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.0678, "escape": 0.08276, "mature_H5_site": 12.0, "mutant": "H", "mutation": "S22H", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.093, "escape": -0.3376, "mature_H5_site": 12.0, "mutant": "K", "mutation": "S22K", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3824, "escape": 0.3063, "mature_H5_site": 12.0, "mutant": "N", "mutation": "S22N", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2029, "escape": -0.2622, "mature_H5_site": 12.0, "mutant": "Q", "mutation": "S22Q", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6728, "escape": 0.226, "mature_H5_site": 12.0, "mutant": "T", "mutation": "S22T", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1991, "escape": -0.1045, "mature_H5_site": 12.0, "mutant": "V", "mutation": "S22V", "reference_site": "22", "sequential_site": 28.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3714, "escape": -0.5614, "mature_H5_site": 217.0, "mutant": "N", "mutation": "S221N", "reference_site": "221", "sequential_site": 233.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.726, "escape": -0.9427, "mature_H5_site": 217.0, "mutant": "Q", "mutation": "S221Q", "reference_site": "221", "sequential_site": 233.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.06572, "escape": -0.4757, "mature_H5_site": 217.0, "mutant": "T", "mutation": "S221T", "reference_site": "221", "sequential_site": 233.0, "wildtype": "S"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2128, "escape": 0.6024, "mature_H5_site": 218.0, "mutant": "A", "mutation": "Q222A", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0449, "escape": 0.6071, "mature_H5_site": 218.0, "mutant": "C", "mutation": "Q222C", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2266, "escape": 0.8148, "mature_H5_site": 218.0, "mutant": "D", "mutation": "Q222D", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.052, "escape": 1.942, "mature_H5_site": 218.0, "mutant": "E", "mutation": "Q222E", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4377, "escape": 0.1558, "mature_H5_site": 218.0, "mutant": "G", "mutation": "Q222G", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1208, "escape": 0.03716, "mature_H5_site": 218.0, "mutant": "I", "mutation": "Q222I", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.164, "escape": 1.841, "mature_H5_site": 218.0, "mutant": "K", "mutation": "Q222K", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3618, "escape": -0.4945, "mature_H5_site": 218.0, "mutant": "L", "mutation": "Q222L", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.00794, "escape": -1.224, "mature_H5_site": 218.0, "mutant": "M", "mutation": "Q222M", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7274, "escape": 0.4957, "mature_H5_site": 218.0, "mutant": "N", "mutation": "Q222N", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2373, "escape": 0.7645, "mature_H5_site": 218.0, "mutant": "P", "mutation": "Q222P", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6401, "escape": -0.3379, "mature_H5_site": 218.0, "mutant": "R", "mutation": "Q222R", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.05038, "escape": 0.2349, "mature_H5_site": 218.0, "mutant": "S", "mutation": "Q222S", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3952, "escape": 0.2862, "mature_H5_site": 218.0, "mutant": "T", "mutation": "Q222T", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.04258, "escape": 0.2918, "mature_H5_site": 218.0, "mutant": "V", "mutation": "Q222V", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.07365, "escape": -0.9942, "mature_H5_site": 218.0, "mutant": "W", "mutation": "Q222W", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7141, "escape": -1.196, "mature_H5_site": 218.0, "mutant": "Y", "mutation": "Q222Y", "reference_site": "222", "sequential_site": 234.0, "wildtype": "Q"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4831, "escape": 0.3536, "mature_H5_site": 219.0, "mutant": "C", "mutation": "V223C", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.7263, "escape": -0.004775, "mature_H5_site": 219.0, "mutant": "F", "mutation": "V223F", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.585, "escape": -0.5499, "mature_H5_site": 219.0, "mutant": "H", "mutation": "V223H", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6187, "escape": -0.2653, "mature_H5_site": 219.0, "mutant": "M", "mutation": "V223M", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.577, "escape": 0.1564, "mature_H5_site": 219.0, "mutant": "N", "mutation": "V223N", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5101, "escape": -0.2074, "mature_H5_site": 219.0, "mutant": "Q", "mutation": "V223Q", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2131, "escape": 0.3712, "mature_H5_site": 219.0, "mutant": "R", "mutation": "V223R", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -1.241, "escape": 0.3584, "mature_H5_site": 219.0, "mutant": "S", "mutation": "V223S", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6693, "escape": 0.4404, "mature_H5_site": 219.0, "mutant": "W", "mutation": "V223W", "reference_site": "223", "sequential_site": 235.0, "wildtype": "V"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.02828, "escape": 0.09777, "mature_H5_site": 220.0, "mutant": "A", "mutation": "N224A", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6787, "escape": 0.08273, "mature_H5_site": 220.0, "mutant": "C", "mutation": "N224C", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -4.381, "escape": -0.1992, "mature_H5_site": 220.0, "mutant": "E", "mutation": "N224E", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.6112, "escape": 0.4732, "mature_H5_site": 220.0, "mutant": "F", "mutation": "N224F", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1535, "escape": -0.001572, "mature_H5_site": 220.0, "mutant": "G", "mutation": "N224G", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.008507, "escape": -0.08879, "mature_H5_site": 220.0, "mutant": "K", "mutation": "N224K", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.0627, "escape": -0.3708, "mature_H5_site": 220.0, "mutant": "M", "mutation": "N224M", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9023, "escape": 0.1861, "mature_H5_site": 220.0, "mutant": "R", "mutation": "N224R", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.1981, "escape": 0.4415, "mature_H5_site": 220.0, "mutant": "S", "mutation": "N224S", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3341, "escape": 0.09388, "mature_H5_site": 220.0, "mutant": "Y", "mutation": "N224Y", "reference_site": "224", "sequential_site": 236.0, "wildtype": "N"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.5885, "escape": 1.817, "mature_H5_site": 221.0, "mutant": "A", "mutation": "G225A", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -2.563, "escape": 2.114, "mature_H5_site": 221.0, "mutant": "E", "mutation": "G225E", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.4221, "escape": 1.944, "mature_H5_site": 221.0, "mutant": "F", "mutation": "G225F", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": 0.01002, "escape": 1.801, "mature_H5_site": 221.0, "mutant": "H", "mutation": "G225H", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.3914, "escape": 1.882, "mature_H5_site": 221.0, "mutant": "N", "mutation": "G225N", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.9766, "escape": 1.806, "mature_H5_site": 221.0, "mutant": "Q", "mutation": "G225Q", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2233, "escape": 2.47, "mature_H5_site": 221.0, "mutant": "R", "mutation": "G225R", "reference_site": "225", "sequential_site": 237.0, "wildtype": "G"}, {"antibody": "310-054-13-12D03", "cell_entry": -0.2021, "escape": 1.279, "mature_H5_site": 221.0, "mutant": "